基于Matlab----RSSI测距定位技术性能仿真
一、题目
RSSI测距定位技术性能仿真
二、仿真要求
要求一:RSSI的测量值由对数路径损耗模型产生,为减小波动造成的误差,其值可由多次测量取平均值来得到。
 要求二:对数路径损耗模型中的参考距离路径损耗和路径损耗因子可通过参考点相互之间的测量值估计。
 要求三:完成理想情况下(参考距离路径损耗和路径损耗因子已知)与实际情况下的RMSE曲线对比图,横坐标为噪声方差,纵坐标为RMSE。
三、主要代码
3.1函数parameter_est主要代码
函数parameter_est主要代码:
% parameter_est部分:
function [pd0_est,n_est]=parameter_est(A,sigma) 
% A is the coordinate of BSs 
% sigma is the standard deviation of RSSI measurement 
[m,~]=size(A); 
pd0=0;
n=3; 
d=zeros(m,m); 
tt=5; 
% the number of RSSI measurement for each BS 
sigma1=10^(sigma/10); 
h1=[];
G1=[]; 
for i=1:m 
    for j=1:m 
        if i~=j 
           d(i,j)=norm(A(i,:)-A(j,:));
           for k=1:tt 
               prd(k)=pd0-10*n*log10(d(i,j))-sigma1*randn; 
           end 
           RSSI=mean(prd);
           d_distance=-10*log10(d(i,j)); 
           h1=[h1;RSSI];
           G1=[G1;d_distance]; 
        end
     end
end
h=h1;
[m1,~]=size(h); 
G=[ones(m1,1),G1];
x=inv(G'*G)*G'*h; 
pd0_est=x(1,1);
n_est=x(2,1);
end
3.2函数TOALLOP主要代码
函数parameter_est主要代码
% TOALLOP部分:
function theta=TOALLOP(A,p,j)
 % A is the coordinate of BSs 
 %A是BBS的坐标
% p is the range measurement 
%P是范围测量
% j is the index of reference BS 
%J是参考BS的索引
[m,~]=size(A);  %size得到A的行列数赋值给[m,~],~表示占位,就是只要行m的值!
k=sum(A.^2,2);%矩阵A每个元素分别平方,得到新矩阵,在行求和,最为矩阵K
k1=k([1:j-1,j+1:m],:); %取出J行
A1=A([1:j-1,j+1:m],:); %取出J行
A2=A1-ones(m-1,1)*A(j,:); %得到D,就是j行与其余行对应值相减
p1=p([1:j-1,j+1:m],:); %取出J行
p2=p(j).^2*ones(m-1,1)-p1.^2-(k(j)*ones(m-1,1)-k1); %得到b,(Rn*Rn-R1*R1-Kn+K1)其中Kn为对应第n个x^2+y^2
theta=1/2*inv(A2'*A2)*A2'*p2; %利用最小二乘解,得
theta=theta';%转换为(x,y)形式
end
3.3全部代码
全部代码:
% RSSI:
% %% the simulation of RSSI localization algorithm 
clear all; 
clc; 
BS1=[0,0];
BS2=[500,0];
BS3=[500,500];
BS4=[0,500]; 
MS=[100,100]; 
std_var=[0,2,4,6]; 
A=[BS1;BS2;BS3;BS4]; 
number=300; 
pd0=0;
n=3; 
tt=5; 
% the number of RSSI measurement for each BS
for j=1:length(std_var)
    error1=0;
    error2=0; 
    std_var1=std_var(j); 
    for i=1:number 
        r1=A-ones(4,1)*MS; 
        r2=(sum(r1.^2,2)).^(1/2); 
        for k=1:tt 
            rssi(:,k)=pd0-10*n*log10(r2)-10^(std_var1/10)*randn(4,1); 
        end 
        RSSI1=mean(rssi,2);
        % ideal situation 
        r1=10.^((RSSI1-pd0)/(-10*n)); 
        % real situation 
        [p_est,n_est]=parameter_est(A,std_var1); 
        r2=10.^((RSSI1-p_est)/(-10*n_est)); 
        theta1=TOALLOP(A,r1,1); 
        theta2=TOALLOP(A,r2,1); 
        error1=error1+norm(MS-theta1)^2; 
        error2=error2+norm(MS-theta2)^2; 
    end 
    RMSE1(j)=(error1/number)^(1/2); 
    RMSE2(j)=(error2/number)^(1/2); 
end
% plot 
plot(std_var,RMSE1,'-O',std_var,RMSE2,'-s') 
xlabel('The standard deviation of RSS measurement (db)'); 
ylabel('RMSE'); 
legend('Ideal','Real');
% parameter_est部分:
function [pd0_est,n_est]=parameter_est(A,sigma) 
% A is the coordinate of BSs 
% sigma is the standard deviation of RSSI measurement 
[m,~]=size(A); 
pd0=0;
n=3; 
d=zeros(m,m); 
tt=5; 
% the number of RSSI measurement for each BS 
sigma1=10^(sigma/10); 
h1=[];
G1=[]; 
for i=1:m 
    for j=1:m 
        if i~=j 
           d(i,j)=norm(A(i,:)-A(j,:));
           for k=1:tt 
               prd(k)=pd0-10*n*log10(d(i,j))-sigma1*randn; 
           end 
           RSSI=mean(prd);
           d_distance=-10*log10(d(i,j)); 
           h1=[h1;RSSI];
           G1=[G1;d_distance]; 
        end
     end
end
h=h1;
[m1,~]=size(h); 
G=[ones(m1,1),G1];
x=inv(G'*G)*G'*h; 
pd0_est=x(1,1);
n_est=x(2,1);
end
% TOALLOP部分:
function theta=TOALLOP(A,p,j)
 % A is the coordinate of BSs 
 %A是BBS的坐标
% p is the range measurement 
%P是范围测量
% j is the index of reference BS 
%J是参考BS的索引
[m,~]=size(A);  %size得到A的行列数赋值给[m,~],~表示占位,就是只要行m的值!
k=sum(A.^2,2);%矩阵A每个元素分别平方,得到新矩阵,在行求和,最为矩阵K
k1=k([1:j-1,j+1:m],:); %取出J行
A1=A([1:j-1,j+1:m],:); %取出J行
A2=A1-ones(m-1,1)*A(j,:); %得到D,就是j行与其余行对应值相减
p1=p([1:j-1,j+1:m],:); %取出J行
p2=p(j).^2*ones(m-1,1)-p1.^2-(k(j)*ones(m-1,1)-k1); %得到b,(Rn*Rn-R1*R1-Kn+K1)其中Kn为对应第n个x^2+y^2
theta=1/2*inv(A2'*A2)*A2'*p2; %利用最小二乘解,得
theta=theta';%转换为(x,y)形式
end
四、仿真结果

版权声明:本文为weixin_44606638原创文章,遵循CC 4.0 BY-SA版权协议,转载请附上原文出处链接和本声明。