-
radon_ambiguity
%radon transform
clear all
%
N=800
n=1:N
fs=200
t=n/fs
x1=exp(j*2*pi*(5*t+0.5*5*t.^2))
x2=exp(j*2*pi*(5*t+0.5*15*t.^2))
x=x1+x2
%N=length(x)
% ambifunb(x )
%*****************************************RAT
naf=ambifunb(x)
htl(abs(naf))
% [wh,rho,theta]=htl(abs(naf))
colormap([0,0,0])
% xlabel( 极半径 )
% ylabel( 角度 )
%**************************************%找出峰值点的坐标,计算初始频率和调频斜率(正确)
%找出峰值点的坐标
b=max(max(wh))
[u,a]=find(wh>=0.8*b)
( Radon transformclear all N = 800 n = 1: N fs = 200 t = n/fs x1 = exp (j* 2* pi* (5* t+ 0.5* 5* t. ^ 2)) x2 = exp ( j* 2* pi* (5* t+ 0.5* 15* t. ^ 2)) x = x1+ x2 N = length (x) ambifunb (x)***************************************** RATnaf = ambifunb (x) htl (abs (naf)) [wh, rho, theta ] = htl (abs (naf)) colormap ([0,0,0]) xlabel (polar radius) ylabel (angle)************************************** to find the coordinates of the peak point, calculating the initial slope of the frequency and FM (right) find the peak point of the coordinates b = max (max ( wh)) [u, a] = find (wh)
- 2008-05-06 21:56:10下载
- 积分:1
-
face-recognition-based-on-pca-method
face recognition based on PCA techniques
- 2011-04-20 16:04:15下载
- 积分:1
-
Near-Field-Beamforming
直线阵进场聚焦波束形成算法,三维作图,伪彩图作图(Linear array approach focused beamforming algorithm, three-dimensional mapping, pseudo-color mapping)
- 2013-09-15 09:13:47下载
- 积分:1
-
城市效率面板数据及案例讲解
说明: 动态面板数据 城市效率面板数据及案例讲解(Dynamic panelDynamic Panel Data Urban Efficiency Panel Data and Case Explanation)
- 2020-06-25 10:20:01下载
- 积分:1
-
LD
说明: 用于计算高频下的金属介电常数,主用侧重应用于有限元分析仿真中金属材料的物理属性。(The metal used to calculate the high frequency dielectric constant, the main emphasis used with finite element analysis simulation of the physical properties of metal materials.)
- 2010-04-10 16:40:11下载
- 积分:1
-
qpsk_rayleigh&awgn_ber&powerspec
说明: qpsk调制在awgn/rayleigh信道下的误码性能比较,以及信号的功率谱和星座图(QPSK modulation in awgn/Rayleigh Channel Performance Comparison of error, and the signal power spectrum and constellation)
- 2005-11-05 22:58:42下载
- 积分:1
-
get_hist_google_stock_data
MATLAB连接GOOGLE数据库的例程,Script to Retrieve Historical Stock Data from Google Finance(Script to Retrieve Historical Stock Data from Google Finance)
- 2013-02-02 09:06:19下载
- 积分:1
-
interpolation-and-fitting
matlab经典算法程序中关于插值和拟合的具体指导资料 给需要的朋友们以启发(classical algorithm matlab program on interpolation and fitting specific guidance information to a friend who needs to inspire)
- 2013-11-13 11:20:13下载
- 积分:1
-
time-frequency-feature
此代码用于故障诊断特征提取,所提取特征包括传统时、频域特征和时频特征三部分,数据为轴承数据(This code is used when troubleshooting feature extraction, the extracted features, including traditional, frequency domain and time-frequency characteristics of three parts, the data is bearing data)
- 2020-07-01 06:00:02下载
- 积分:1
-
huffmandecode
霍夫曼编码的MATLAB程序
对简单序列的编码
(huffman code)
- 2009-05-05 21:20:45下载
- 积分:1