-
rungekutta
用龙贝格积分法计算积分的程序,matlab语言编写,希望能对大家有用。(Romberg integration method with integral calculation procedures, matlab language, hoping to be useful to everyone.)
- 2020-12-16 20:29:12下载
- 积分:1
-
gbvs
gbvs 提取显著区域,进行其他的程序编写。在matlab上运行,先安装,后可以直接运行(gbvs select main object)
- 2013-04-04 16:28:48下载
- 积分:1
-
Prog_OFDM
应用OFDM可以有效地对抗多径时延扩展。循环前缀不仅可以消除符号间干扰(ISI),还能消除子载波间干扰(ICI).本项目完整地仿真了OFDM系统。(Application of OFDM can effectively combat multipath delay spread. Cyclic prefix can not only eliminate inter-symbol interference (ISI), can eliminate Inter-carrier interference (ICI). This project a complete simulation of the OFDM system.)
- 2009-09-09 18:46:03下载
- 积分:1
-
voicebox
mfcc的matlab显示方法,可以直接运行(mfcc s showing by matlab)
- 2012-04-23 01:26:15下载
- 积分:1
-
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
-
code
Simple code for Spectral analysis of speech signal.
- 2015-01-31 01:33:20下载
- 积分:1
-
RKDG2
RKDG(荣格库塔——间断有限元)方法计算一维波动初值间断问题(RKDG (-- Carl Jung Runge Kutta discontinuous finite element method to calculate the initial value) of one dimensional wave discontinuous problems)
- 2021-01-12 17:18:48下载
- 积分:1
-
opticaltransmissionfibonacci
用MATLAB计算Fibonacci超晶格的光透射率(MATLAB computing Fibonacci superlattice with light transmission rate)
- 2010-08-09 17:33:48下载
- 积分:1
-
limitation
可以方便的求极限,对于matlab的初学者有用。(limitation)
- 2010-03-14 11:55:43下载
- 积分:1
-
Sparse-Subspace-Clustering
Sparse Subspace Clustering
- 2014-02-20 08:12:51下载
- 积分:1