日韩黑丝制服一区视频播放|日韩欧美人妻丝袜视频在线观看|九九影院一级蜜桃|亚洲中文在线导航|青草草视频在线观看|婷婷五月色伊人网站|日本一区二区在线|国产AV一二三四区毛片|正在播放久草视频|亚洲色图精品一区

分享

swerling模型三部曲--------swerling 0(Ⅴ)和swerling Ⅰ模型檢測(cè)概率以及MATLAB仿真

 漢無(wú)為 2024-05-10 發(fā)布于湖北

    又到了三部曲系列了,離上一次的三部曲有一段時(shí)間了圖片圖片圖片,這回的三部曲主要分為:swerling 0(Ⅴ)和swerling Ⅰ模型檢測(cè)概率、swerling Ⅱ和swerling Ⅲ模型檢測(cè)概率、swerling Ⅳ0(Ⅴ)檢測(cè)概率和四種swerling模型檢測(cè)概率的對(duì)比。話不多說(shuō),咱們進(jìn)入正題。由于這一系列的文章是上一篇文章的延伸,所以會(huì)引用到上文的公式,提到的公式大家可以參考上一篇文章。

檢測(cè)概率相對(duì)于單個(gè)脈沖的SNR關(guān)系曲線以及MATLAB仿真

白夜思凡,公眾號(hào):白夜尚好檢測(cè)概率相對(duì)于單個(gè)脈沖的SNR關(guān)系曲線以及MATLAB仿真

一、檢測(cè)概率的計(jì)算

    對(duì)于np>1的情況,Marcum定義的虛警概率為:

圖片

    np為積累脈沖數(shù),nfa為Marcum虛警數(shù)。對(duì)于非起伏目標(biāo),單個(gè)脈沖的檢測(cè)概率由公式(2)給出(參考),當(dāng)np>1時(shí),使用Gram-Charlier級(jí)數(shù)計(jì)算檢測(cè)概率。此時(shí)檢測(cè)概率為:

圖片

圖片

    其中,常數(shù)C3、C4和C6是Gram-Charlier級(jí)數(shù)的系數(shù),變量V為

圖片

    其中VT是檢測(cè)門(mén)限值,C3、C4、C6和圖片的數(shù)值根據(jù)目標(biāo)起伏類(lèi)型變化。

二、swerling V(0)型目標(biāo)的檢測(cè)

    對(duì)于這類(lèi)目標(biāo)的起伏,使用公式15計(jì)算檢測(cè)概率。此時(shí),Gram-Charlier級(jí)數(shù)的系數(shù)為:

圖片

例子:計(jì)算swerling Ⅴ型目標(biāo)的檢測(cè)概率:

主函數(shù)

clcclear allclose all%swerling 0型效果圖%顯示np=1,10時(shí)檢測(cè)概率相對(duì)于SNR的曲線pfa = 1e-9; %虛警率b = sqrt(-2.0 * log(pfa));index =0 ;for snr =0:0.1:20 index = index + 1; a = sqrt(2.0 * 10^(snr/10)); pro(index)=marcumsq(a,b); prob(index) = pd_swerling5(pfa,1,10,snr);endx=0:0.1:20;plot(x,pro,'k',x,prob,'k:');axis([0 20 0 1]);xlabel('SNR(dB)');ylabel('檢測(cè)概率');legend('np=1','np=10');grid on title('檢測(cè)概率相對(duì)于SNR的曲線,pfa=10^-9,非相干積累')

marcumsq函數(shù)

function PD = marcumsq(a,b)%該方程運(yùn)用parls方法來(lái)計(jì)算檢測(cè)概率max_test_value = 5000;if(a<b)    alpha0 =1.0;    dn = a/b;else    alpha0 = 0;     dn = b/a;endalpha_1 = 0.0;beta0 = 0.5;beta_1 = 0.0;D1 = dn;n=0;ratio = 2.0/(a*b);r1 = 0.0;beta = 0.0;alpha = 0.0;while beta<1000    n = n+1;    alpha = dn + ratio * n*alpha0+alpha;    beta = 1.0 + ratio * n*beta0 +beta;    alpha_1 = alpha0;    alpha0 = alpha;    beta0 = beta;    dn = dn * D1;endPD = (alpha0/(2.0*beta0)) * exp(-(a-b)^2/2.0);if(a>=b)    PD = 1.0 - PD;endreturn

pd_swerling5函數(shù)

function pd = pd_swerling5(input1,indicator,np,snrbar)%該函數(shù)是用于計(jì)算swerling Ⅴ 或者 0 模型下np>1的目標(biāo)的檢測(cè)概率%input1 Pfa或nfa % Pfa:虛警概率,nfa:Marcum虛警數(shù)%indicator: 當(dāng)input1 = Pfa時(shí),為1,當(dāng)input1 = nfa時(shí),為2%np:脈沖積累數(shù)%snr:信噪比%pd: 檢測(cè)概率if(np == 1) 'stop ,np must be greater than 1' return endformat longsnrbar = 10.0.^(snrbar./10);eps = 1e-8;delmax = 1e-5;delta = 1e4;%計(jì)算門(mén)限值Vt%采用fehlner將虛警數(shù)定義的公式。if(indicator ~= 1) nfa = input1; pfa = np * log(2) / nfa;else pfa = input1; nfa = np * log(2) / pfa;endsqrtpfa = sqrt(-log10(pfa));sqrtnp = sqrt(np);vt0 = np - sqrtnp + 2.3*sqrtpfa * (sqrtpfa + sqrtnp -1.0);vt = vt0;while(abs(delta) >= vt0 ) igf = incomplete_gamma(vt0,np); num = 0.5^(np/nfa)-igf; temp = (np - 1)*log(vt0+eps)-vt0-factor(np - 1); deno = exp(temp); vt = vt0 + (num / (deno +eps)); delta = abs(vt - vt0)*10000.0; vt0 = vt;end%計(jì)算Gram-Charlier系數(shù)temp1 = 2.0.*snrbar+1.0;omegabar = sqrt(np.*temp1);c3 = -(snrbar+1.0/3.0)./(sqrt(np).*temp1.^1.5);c4 = (snrbar + 0.25)./(np.*temp1.^2);c6 = c3 .* c3./2.0;V = (vt - np.*(1.0+snrbar))./omegabar;Vsqr = V.*V;val1 = exp(-Vsqr./2.0)./sqrt(2.0*pi);val2 = c3 .* (V.^2-1.0) + c4.*V.*(3.0-V.^2)-c6.*V.*(V.^4-10.*V.^2 + 15.0);q = 0.5 .* erfc(V./sqrt(2.0));pd = q - val1.*val2;

incomplete_gamma函數(shù)

function [value] = incomplete_gamma(vt,np)%該函數(shù)主要計(jì)算不完全Gamma函數(shù)%vtformat longeps = 1.000000001;%測(cè)試np=1的情況if(np == 1)    value1 = vt * exp(-vt);    value = 1.0-exp(-vt);endsumold = 1.0;sumnew = 1.0;calc1 = 1.0;calc2 = np;xx = np * log(vt + 0.0000000001) - vt - factor(calc2);temp1 = exp(xx);temp2 = np /(vt + 0.0000000001);diff = .0;radio = 1000.0;if(vt >= np)    while(radio >= eps)        diff = diff + 1.0;        calc1 = calc1 *(calc2 - diff)/vt;        sumnew = sumold + calc1;        radio = sumnew / sumold;        sumold = sumnew;    end    value = 1.0 - temp1*sumnew*temp2;else    diff = .0;    sumold =1.;    radio = 1000;    calc1 = 1;    while(radio >= eps)        diff = diff +1.0;        calc1 =calc1*vt/(calc2+diff);sumnew = sumold+calc        radio = sumnew / sumold;        sumold =sumnew;    end    value = temp1 * sumnew;end

factor函數(shù)

function [val] = factor(n)%使用對(duì)數(shù)計(jì)算n的階乘來(lái)避免溢出format longn = n+9.0;n2 = n * n;temp = (n-1)*log(n)-n+log(sqrt(2.0 * pi*n))+((1.0-(1.0/30+(1.0/105)/n2)/n2)/12)/n;val = temp - log((n-1)*(n-2)*(n-3)*(n-4)*(n-5)*(n-6)*(n-7)*(n-8));

圖片

    上圖顯示了np=1,10時(shí)檢測(cè)概率相對(duì)于SNR的曲線,從圖中可以看出,為獲得相同的檢測(cè)概率,10個(gè)脈沖非相干積累需要更少的SNR。


三、 Swerling Ⅰ型目標(biāo)的檢測(cè)

    Swerling Ⅰ型目標(biāo)的檢測(cè)概率準(zhǔn)確公式:

圖片

圖片

例子1:主函數(shù)

clcclear allclose allpfa = 1e-9;nfa = log(2)/pfa;b = sqrt(-2.0 * log(pfa));index = 0;for snr = 0:0.1:22    index = index + 1;    a = sqrt(2.0*10^(snr/10));    pro(index)=marcumsq(a,b);    prob(index) = pd_swerling1(nfa,1,snr);endx=0:0.1:22;plot(x,pro,'k',x,prob,'k:');axis([2 22 0 1]);xlabel('SNR - dB');ylabel('檢測(cè)概率');legend('swerling Ⅴ','swerling Ⅰ')grid on

圖片

    圖中顯示的是np=1和圖片,對(duì)于Swerling Ⅰ和Ⅴ型起伏,檢測(cè)概率作為SNR函數(shù)的曲線。可以看出,為了獲得與無(wú)起伏情況相同的檢測(cè)概率,在有起伏時(shí),需要更高的SNR。

例子2:主函數(shù)

clcclear allclose allpfa = 1e-11;nfa = log(2) / pfa;index = 0;for snr = -10:0.5:30 index = index + 1; prob1(index) = pd_swerling1(nfa,1,snr); prob10(index) = pd_swerling1(nfa,10,snr); prob50(index) = pd_swerling1(nfa,50,snr); prob100(index) = pd_swerling1(nfa,100,snr);endx = -10:0.5:30;plot(x,prob1,'k',x,prob10,'k:',x,prob50,'k--',x,prob100,'k-.');axis([-10 30 0 1]);xlabel('SNR-dB');ylabel('檢測(cè)概率');legend('np=1','np=10','np=50','np=100');grid on;

    圖中顯示了np=1,10,50,100時(shí),檢測(cè)概率相對(duì)于SNR曲線,其中圖片

圖片

pd_swerling1函數(shù)

function pd = pd_swerling1(nfa,np,snrbar)%計(jì)算目標(biāo)起伏模型為swerling Ⅰ型的檢測(cè)概率format longsnrbar = 10.0^(snrbar/10);eps = 0.00000001;delmax = .00001;delta = 10000;%計(jì)算閾值Vtpfa = np*log(2)/nfa;sqrtpfa = sqrt(-log10(pfa));sqrtnp = sqrt(np);vt0=np - sqrtnp + 2.3 * sqrtpfa * (sqrtpfa +  sqrtnp - 1.0);vt = vt0;while(abs(delta) >= vt0)    igf = incomplete_gamma(vt0,np);    num = 0.5^(np/nfa) - igf;    temp = (np - 1)*log(vt0+eps)-vt0-factor(np-1);    deno = exp(temp);    vt = vt0+(num/(deno+eps));    delta = abs(vt - vt0)*10000;    vt0 = vt;endif(np == 1)    temp = -vt/(1.0+snrbar);    pd = exp(temp);    return;endtemp1 = 1.0 + np*snrbar;temp2 = 1.0/(np*snrbar);temp = temp2 + 1;vall = temp^(np-1);igf1 = incomplete_gamma(vt,np-1);igf2 = incomplete_gamma(vt/temp,np-1);pd = 1.0 - igf1 + vall*igf2 * exp(-vt/temp1);


四、總結(jié)

    以上是關(guān)于swerling 0(Ⅴ)和swerling Ⅰ模型相關(guān)的檢測(cè)概率和模型的全部?jī)?nèi)容,其中包括了相關(guān)模型的數(shù)學(xué)公式和matlab仿真。其中swerling 0(Ⅴ)模型介紹中對(duì)照單脈沖和非相參積累,發(fā)現(xiàn)非相參積累只需要很小的SNR就能達(dá)到單脈沖的效果。swerlingⅠ型中對(duì)比了swerling 0和swerlingⅠ型,有起伏和無(wú)起伏相比,要達(dá)到相同的檢測(cè)概率,需要更大的SNR,另外還對(duì)比了不同np條件下,swerlingⅠ模型,檢測(cè)概率和SNR之間的關(guān)系。

五、參考內(nèi)容

      雷達(dá)系統(tǒng)設(shè)計(jì)MATLAB仿真

如有侵權(quán),請(qǐng)聯(lián)系刪除:


?

    本站是提供個(gè)人知識(shí)管理的網(wǎng)絡(luò)存儲(chǔ)空間,所有內(nèi)容均由用戶發(fā)布,不代表本站觀點(diǎn)。請(qǐng)注意甄別內(nèi)容中的聯(lián)系方式、誘導(dǎo)購(gòu)買(mǎi)等信息,謹(jǐn)防詐騙。如發(fā)現(xiàn)有害或侵權(quán)內(nèi)容,請(qǐng)點(diǎn)擊一鍵舉報(bào)。
    轉(zhuǎn)藏 分享 獻(xiàn)花(0

    0條評(píng)論

    發(fā)表

    請(qǐng)遵守用戶 評(píng)論公約

    類(lèi)似文章 更多