wangyan 发表于 2006-7-24 11:13

请问大侠们:morlet小波变换的模平方和实部的时频分布图是怎么画出来的呀?

morlet小波变换的模平方和实部的时频分布图是怎么画出来的呀?我买的书上并没有讲这一块,请大侠们帮忙,有类似程序更是感激不尽,谢谢,谢谢,小女子将非常感谢

jasonwu 发表于 2007-4-27 14:39

困难解决没有?

困难解决没,可以联系
QQ86914202

zhangnan3509 发表于 2007-4-27 14:46

回复 #2 jasonwu 的帖子

有什么问题可以在帖子上说呀!我们大家还能看看呢:handshake

simon21 发表于 2007-4-27 14:51

function tfrview(tfr,sig,t,method,param,p1,p2,p3,p4,p5);
%TFRVIEW Visualization of time-frequency representations.
%      TFRVIEW(TFR,SIG,T,METHOD,PARAM,P1,P2,P3,P4,P5)
%      allows to visualize a time-frequency representation.
%      TFRVIEW is called through TFRQVIEW from any TFR* function.
%
%      TFR    : time-frequency representation.
%      SIG    : signal in the time-domain.
%      T      : time instants.
%      METHOD : chosen representation (name of the corresponding M-file)
%      PARAM: visualization parameter vector :
%         PARAM= where
%         DISPLAY=1..5 for contour, imagesc, pcolor, surf or mesh
%         LINLOG =0/1 for linearly/logarithmically spaced levels
%                  
%         THRESHOLDis the visualization threshold, in %
%         LEVELNUMBis the number of levels used with contour
%         NF2      is the number of frequency bins displayed
%         LAYOUT determines the layout of the figure : TFR alone (1),
%                TFR and SIG (2), TFR and spectrum (3), TFR and SIG and
%                spectrum (4), add 4 if you want a colorbar
%         FS   is the sampling frequency (may be set to 1.0)
%         ISGRID depends on the grids' presence :
%                isgrid=isgridsig+2*isgridspec+4*isgridtfr
%                where isgridsig=1 if a grid is present on the signal
%                and =0 if not, and so on
%         fmin   smallest normalized frequency
%         fmax   highestnormalized frequency
%      P1..P5: parameters of the representation. Run the file
%                TFRPARAM(METHOD) to know the meaning of P1..P5.         
%
%    TFRVIEW is called through TFRQVIEW by any file TFR*.
%
%            Use TFRQVIEW preferably.
%            ------------------------
%
%    See also TFRQVIEW, TFRPARAM.

%    F. Auger, July 1994, July 1995 -
%    O. Lemoine, October-November 1995, May-June 1996.
%       F. Auger, May 1998.
%    Copyright (c) CNRS - France 1996.
%
%    ------------------- CONFIDENTIAL PROGRAM --------------------
%    This program can not be used without the authorization of its
%    author(s). For any comment or bug report, please send e-mail to
%    f.auger@ieee.org

comp=computer; % so as to know the running computer
MatlabVersion=version; MatlabVersion=5;
% I hope that future Matlab versions will be more compatible
if (MatlabVersion==4),
TickLabelStr='TickLabels';
else (MatlabVersion==5),
TickLabelStr='Ticklabel';

end;

if ( nargin < 5 ),
error ('at least 5 parameters are required');
end;

= size(tfr); % the size of tfr
   = size(t);   % the size of t
   = size(sig); % the size of sig
maxi=max(max(tfr));

% Extraction of the elements of param
display   = param( 1);      % contour, imagesc, pcolor, surf, or mesh
linlog      = param( 2);      % linear or logarithmic scale
threshold   = param( 3);      % visualization threshold
levelnumb   = param( 4);      % number of levels
Nf2         = param( 5);      % number of frequency points
layout      = param( 6);      % figure layout
fs          = param( 7);      % sampling frequency
isgrid      = param( 8);      % grid(s)
fmin      = param( 9);      % smallest displayed frequency
fmax      = param(10);      % highest displayed frequency

if (fmin>=fmax),
error('fmin should be lower than fmax');
elseif (fmax>0.5),
error('fmax is a normalized frequency, and should be lower than 0.5');
end

if fs<1000, unitHz=1;                            % display ins andHz
elseif (fs>=1e3 & fs<1e6), fs=fs/1e3; unitHz=2;% display in ms and kHz
elseif (fs>=1e6), fs=fs/1e6; unitHz=3;         % display in us and MHz
end

linlogtfr=rem(linlog,2);
linlogspec=rem(linlog-linlogtfr,4)/2;
sigenveloppe=rem(linlog-linlogtfr-linlogspec*2,8)/4;

issig=rem(layout-1,2);
isspec=rem(layout-1-issig,4)/2;
iscolorbar=rem(layout-1-issig-isspec*2,8)/4;
if isempty(sig),                        % I can't make miracles
issig=0; isspec=0; layout=issig+isspec*2+1;
else
layout=layout-4*iscolorbar;
end;

isgridsig =rem(isgrid,2);
isgridspec=rem(isgrid-isgridsig,4)/2;
isgridtfr =rem(isgrid-isgridsig-isgridspec*2,8)/4;

% Computation of isaffine and freq (vector of frequency samples)
if istfraff(method),
freq=eval(['p',num2str(nargin-5)]);       % last input argument is freqs.
isaffine=1;
if display==2,                            % imagesc not allowed
display=3;                            % non linear scales for the axes.
disp('Imagesc does not support non-linear scales for axes. We use pcolor instead');
end
else
isaffine=0;                            % weyl-heisenberg group of distributions
freq=(0.5*(0:Nf2-1)/Nf2);            % dispaly only the positive frequencies
end
freqr=freq*fs; ts=t/fs;               % real time and frequency


% Update variables mini, levels, LinLogStr according to linlog
if ~linlogtfr,
if (display==4)|(display==5),          % surf or mesh
mini=min(min(tfr));
else
mini=max(min(min(tfr)),maxi*threshold/100.0);
end
levels=linspace(mini,maxi,levelnumb+1);
LinLogStr=', lin. scale';
else
mini=max(min(min(tfr)),maxi*threshold/100.0);
levels=logspace(log10(mini),log10(maxi),levelnumb+1);
LinLogStr=', log. scale';
end;

% Initialization of the current figure
zoom off; clf;
set(gcf,'Resize','On','NextPlot','Add');

% Initialization of the axes
if iscolorbar,
axcb   = axes('Units','normal','Visible','off','Box','On');
set(gcf,'UserData',);
end;

if issig,
axsig= axes('Units','normal','Visible','off','Box','On');
if comp(1:2)=='PC', set(axsig ,'fontsize',10); end
set(gcf,'UserData',);
end;

if isspec,
axspec = axes('Units','normal','Visible','off','Box','On');
if comp(1:2)=='PC', set(axspec,'fontsize',10); end;
set(gcf,'UserData',);
end;

axtfr= axes('Units','normal','Visible','off','Box','On');
if comp(1:2)=='PC', set(axtfr ,'fontsize',10); end
set(gcf,'UserData',);

% Test of analycity and computation of spec
if ~isempty(sig),
for k=1:Ncol,
   isana=1; alpha=2; Lt=max(t)-min(t)+1;      
   if 2*Nf2>=Lt,
    spec(:,k)=abs(fft(sig(min(t):max(t),k),2*Nf2)).^2;
   else
    % modifications :F. Auger (fog), 30/11/97
    Nb_tranches_fog = floor(Lt/(2*Nf2));
    % fprintf('%f \n',Nb_tranches_fog);
    spec(:,k)=zeros(2*Nf2,1);
    for Num_tranche_fog=0:Nb_tranches_fog-1,
   % fprintf('%f \n',Num_tranche_fog);
   spec(:,k)=spec(:,k)+abs(fft(sig(min(t)+2*Nf2*Num_tranche_fog+(0:2*Nf2-1),k))).^2;
    end;

    if (Lt>Nb_tranches_fog*2*Nf2),
   spectre_fog=fft(sig(min(t)+tfrrow*Nb_tranches_fog:max(t),k),2*Nf2);
   spectre_fog=spectre_fog(:);
   spec(:,k)=spec(:,k)+abs(spectre_fog).^2;
    end;   
    % sp=abs(fft(sig(min(t):max(t),k))).^2;
    % fr1=(0.5*(0:Lt-1)/Lt)*fs;
    % fr2=(0.5*(0:2*Nf2-1)/2/Nf2)*fs;
    % spec(:,k)=interp1(fr1,sp,fr2);
   end
   spec1=sum(spec(1:Nf2,k));
   spec2=sum(spec(Nf2+1:2*Nf2,k));
   if spec2>0.1*spec1,
    isana=0;
    if ~isreal(sig(min(t):max(t),k)),
   alpha=1;
    end
   end
end
end

if layout==1,                        % Time-Frequency Representation only
set(axtfr,'Position',);

elseif layout==2,            % TFR + Signal
set(axtfr,'Position',);
set(axsig,'Position',);
axes(axsig);
if sigenveloppe,
   plot((min(t):max(t))/fs,real(sig(min(t):max(t),:)),...
      (min(t):max(t))/fs, abs(sig(min(t):max(t),:)));
else
   plot((min(t):max(t))/fs,real(sig(min(t):max(t),:)));
end;
set(gca,['X' TickLabelStr],[]);
ylabel('Real part');
title('Signal in time');
Min=min(min(real(sig))); Max=max(max(real(sig)));
axis();

elseif layout==3,            % TFR + spectrum
set(axspec,'Position',);
set(axtfr ,'Position',);

axes(axspec);
if isaffine,
   f1=freqr(1); f2=freqr(Nf2); df=f2-f1;
   Nf4=round((Nf2-1)*fs/(2*df))+1;
   for k=1:Ncol,
    spec(1:alpha*Nf4,k)=abs(fft(sig(min(t):max(t),k),alpha*Nf4)).^2;
   end
   spec=spec((round(f1*2*(Nf4-1)/fs)+1):(round(f1*2*(Nf4-1)/fs)+Nf2),:);
   freqs=linspace(f1,f2,Nf2);
else
   freqs=freqr;
   spec=spec(1:Nf2,:);
end
Maxsp=max(max(spec));
if linlogspec==0,
   plot(freqs,spec);
   title('Linear scale');
   % set(axspec,'ytick',);
   set(axspec,'YTickMode', 'auto');
   set(axspec,'Ylim', );
   set(axspec,'Xlim', );
else
   plot(freqs,10*log10(spec/Maxsp));
   title('Log. scale ');
   set(axspec,'YTickMode', 'auto');
   set(axspec,'Ylim',);
   set(axspec,'Xlim', );
end
xlabel('Energy spectral density');
Nsp=length(spec);
set(gca, ['X' TickLabelStr],[],'view',[-90 90]);

elseif layout==4,            % TFR + signal + spectrum

set(axspec,'Position',);
set(axsig ,'Position',);
set(axtfr ,'Position',);

axes(axsig);
if sigenveloppe,
   plot((min(t):max(t))/fs,real(sig(min(t):max(t),:)),...
      (min(t):max(t))/fs, abs(sig(min(t):max(t),:)));
else
   plot((min(t):max(t))/fs,real(sig(min(t):max(t),:)));
end;
ylabel('Real part');
title('Signal in time');
set(gca,['X' TickLabelStr],[]);

Min=min(min(real(sig))); Max=max(max(real(sig)));
axis();

axes(axspec);
if isaffine,
% IF YOU UNDERSTAND SOMETHING TO THAT, PLEASE EXPLAIN ME (f. auger)
%   f1=freqr(1); f2=freqr(Nf2); df=f2-f1;
%   Nf4=round((Nf2-1)*fs/(2*df))+1;
%   for k=1:Ncol,
%    spec(1:alpha*Nf4,k)=abs(fft(sig(min(t):max(t),k),alpha*Nf4)).^2;
%   end
%   spec=spec((round(f1*2*(Nf4-1)/fs)+1):(round(f1*2*(Nf4-1)/fs)+Nf2),:);
%   freqs=linspace(f1,f2,Nf2);
   for k=1:Ncol,
    freqs=linspace(freqr(1),freqr(Nf2),Nf2);
    spec=interp1(0.5*fs*(0:Nf2-1)/Nf2,spec(1:Nf2,k),freqs);
   end;
else
   freqs=freqr;
   spec=spec(1:Nf2,:);
end
Maxsp=max(max(spec));
if linlogspec==0,
   plot(freqs,spec);
   title('Linear scale');
   set(axspec,'YTickMode', 'auto');
   set(axspec,'Ylim', );
   set(axspec,'Xlim', );
else
   plot(freqs,10*log10(spec/Maxsp));
   title('Log. scale ');
   set(axspec,'Ytickmode','auto');
   set(axspec,'Ylim',);
   set(axspec,'Xlim', );
end
xlabel('Energy spectral density');
Nsp=length(spec);
set(gca,['X' TickLabelStr],[],'view',[-90 90]);

end;

if iscolorbar,                     % Is there a color bar ?
   PositionTfr=get(axtfr,'Position');
   set(axtfr,'Position',PositionTfr-);
   set(axcb, 'Position',[PositionTfr(1)+PositionTfr(3)-0.01,...
                         PositionTfr(2) 0.01 PositionTfr(4)]);
   axes(axcb);
   Ncolors=length(colormap);
   =caxis; colorvect=linspace(cmax,cmin,Ncolors);
   imagesc(colorvect'); axis('off');
   if issig,                        % there is a signal
    PositionSig=get(axsig,'Position');
    set(axsig,'Position',PositionSig-);
   end
end

axes(axtfr);                         % Display the tfr
if (tcol==1),
plot(freqr,tfr(1:Nf2));
set(axtfr,'Xlim', );

else
if strcmp(computer,'MAC'),
   tfr=flipud(tfr(1:Nf2,:));
else
   tfr=tfr(1:Nf2,:);
end;

indmin=find(tfr<mini);
tfr(indmin)=mini*ones(1,length(indmin));

indmax=find(tfr>maxi);
tfr(indmax)=maxi*ones(1,length(indmax));
if isaffine & (display==2),
   fprintf('imagesc does not support non-linear scales for axes. Replaced by pcolor.\n');
   display=3;
end;

if display==1,                  % contour
   contour(ts,freqr,tfr,levels);% contour(tfr,levels,ts,freqr);
   set(axtfr,'Ylim', );
   DisplayStr=', contour';
elseif display==2,            % imagesc
   if linlogtfr==0,
    imagesc(ts,freqr,tfr); axis('xy');
   else
    imagesc(ts,freqr,log10(tfr));axis('xy');
   end
   set(axtfr,'Ylim', );
   DisplayStr=', imagesc';

elseif display==3,            % pcolor
   if linlogtfr==0,
    pcolor(ts,freqr,tfr); shading interp;
   else
    pcolor(ts,freqr,log10(tfr)); shading interp;
   end
   set(axtfr,'Ylim', );
   DisplayStr=', pcolor';

elseif display==4,            % surf
   if linlogtfr==0,
    surf(ts,freqr,tfr); shading interp;
    zlabel('Amplitude');
    axis();
   else
    surf(ts,freqr,log10(tfr)); shading interp;
    zlabel('Positive values');
    axis();
   end
   DisplayStr=', surf';

elseif display==5,            % mesh
   if linlogtfr==0,
    mesh(ts,freqr,tfr); shading interp;
    zlabel('Amplitude');
    axis();
   else
    mesh(ts,freqr,log10(tfr));shading interp;
    zlabel('Positive values');
    axis();
   end
   DisplayStr=', mesh';
end

% Define the title and check the input arguments depending on 'method'

method=method(4:length(method));

if nargin==5, % if there is no additional parameters, do the best.
title([method, LinLogStr,DisplayStr,...
         ', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'WV') | strcmp(method,'MH') | ...
      strcmp(method,'PAGE'), % no parameters
title([method,', Nf=',num2str(Nf2), LinLogStr,DisplayStr,...
      ', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'PWV')|strcmp(method,'PMH')| ...
      strcmp(method,'SP'   )|strcmp(method,'PPAGE')| ...
      strcmp(method,'RSP')|strcmp(method,'RPPAG')| ...
      strcmp(method,'RPWV' )|strcmp(method,'RPMH' ),
h=p1;=size(h); Lh=(hrow-1)/2; % one parameter
if (hcol~=1)|(rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
title([method, ', Lh=',num2str(Lh), ', Nf=',num2str(Nf2),...
      LinLogStr, DisplayStr,', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'STFT'), % short-time fourier transform case
h=p1;=size(h); Lh=(hrow-1)/2;
if (hcol~=1)|(rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
title(['|',method, '|^2, Lh=',num2str(Lh),...
      ', Nf=',num2str(Nf2), LinLogStr, DisplayStr,', Thld=',...
      num2str(threshold),'%']);

elseif strcmp(method,'SPWV' ) | strcmp(method,'MHS')| ...
      strcmp(method,'RSPWV') | strcmp(method,'RMHS' )| ...
      strcmp(method,'ZAM') | strcmp(method,'RIDBN')|...
      strcmp(method,'BJ'   ) | strcmp(method,'RIDB' )| ...
      strcmp(method,'RIDH' ) | strcmp(method,'RIDT' ),
g=p1; =size(g); Lg=(grow-1)/2;
if (gcol~=1)|(rem(grow,2)==0),
   error('g must be a smoothing window with odd length'); end;
h=p2; =size(h); Lh=(hrow-1)/2;
if (hcol~=1)|(rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
title([method,', Lg=',num2str(Lg),', Lh=',num2str(Lh),...
         ', Nf=',num2str(Nf2),LinLogStr, DisplayStr,...
         ', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'MMCE'),
h=p1;=size(h); Lh=(hrow-1)/2;
if (rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
title([method, ', Lh=',num2str(Lh), ', Nf=',num2str(Nf2),...
      LinLogStr, DisplayStr,', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'CW' ) | strcmp(method,'BUD'),
g=p1; =size(g); Lg=(grow-1)/2;
if (gcol~=1)|(rem(grow,2)==0),
   error('g must be a smoothing window with odd length'); end;
h=p2; =size(h); Lh=(hrow-1)/2;
if (hcol~=1)|(rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
sigma=p3;
title([method,', Lg=',num2str(Lg),', Lh=',num2str(Lh),...
         ' sigma=',num2str(sigma),', Nf=',num2str(Nf2),...
         LinLogStr, DisplayStr, ', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'GRD')
g=p1; =size(g); Lg=(grow-1)/2;
if (gcol~=1)|(rem(grow,2)==0),
   error('g must be a smoothing window with odd length'); end;
h=p2; =size(h); Lh=(hrow-1)/2;
if (hcol~=1)|(rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
title([method,', Lg=',num2str(Lg),', Lh=',num2str(Lh),...
         ', rs =',num2str(p3), ', M/N =',num2str(p4), ...
         ', Nf =',num2str(Nf2), ...
         LinLogStr, DisplayStr, ', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'MSC' ) | strcmp(method,'RMSC' )
f0T=p1; if (f0T<=0), error('f0T must be positive'); end;
title([method, ', f0T=',num2str(f0T), ', Nf=',num2str(Nf2),...
      LinLogStr, DisplayStr, ', Threshold=',num2str(threshold),'%']);

elseif strcmp(method,'RGAB' )
Nh=p1; if (Nh<=0), error('Nh must be positive'); end;
title([method, ', Nh=',num2str(Nh), ', Nf=',num2str(Nf2),...
      LinLogStr, DisplayStr, ', Threshold=',num2str(threshold),'%']);


elseif strcmp(method,'DFLA' ) | strcmp(method,'UNTER' )| ...
      strcmp(method,'BERT' ),
N=p1;
if (N<=0),                error('N must be positive'); end;
title([method, ', N=',num2str(N), LinLogStr, DisplayStr, ', Threshold=',...
         num2str(threshold), '%']);

elseif strcmp(method,'SCALO'),
Nh0=p1; N=p2;
if (Nh0<0),               error('Nh0 must be positive'); end;
if (N<=0),                error('N must be positive'); end;
if (Nh0>0),
   title([method, ', Morlet wavelet, Nh0=', num2str(Nh0), ...
         ', N=',num2str(N), LinLogStr, DisplayStr, ', Thld=',...
         num2str(threshold), '%']);
else
   title([method, ', Mexican hat, N=',num2str(N), LinLogStr, DisplayStr, ...
          ', Thld=', num2str(threshold), '%']);
end

elseif strcmp(method,'ASPW'),
Nh0=p1; Ng0=p2; N=p3;
if (Nh0<0),               error('Nh0 must be positive'); end;
if (Ng0<0),               error('Ng0 must be positive'); end;
if (N<=0),                error('N must be positive'); end;
if (Nh0>0),
   title([method, ', Morlet wlt, Nh0=', num2str(Nh0), ', Ng0=',...
         num2str(Ng0), ', N=',num2str(N), LinLogStr, DisplayStr, ', Thld=',...
         num2str(threshold), '%']);
else
   title([method, ', Mexican hat, Ng0=',num2str(Ng0),...
         ', N=',num2str(N), LinLogStr, DisplayStr, ', Thld=',...
         num2str(threshold), '%']);
end

elseif strcmp(method,'SPAW'),
K=p1; Nh0=p2; Ng0=p3; N=p4;
if (Nh0<0),               error('Nh0 must be positive'); end;
if (Ng0<0),               error('Ng0 must be positive'); end;
if (N<=0),                error('N must be positive'); end;
if (Nh0>0),
   title([method, ', K=', num2str(K), ', Morlet wlt, Nh0=',...
         num2str(Nh0), ', Ng0=',...
         num2str(Ng0), ', N=',num2str(N), LinLogStr, DisplayStr, ', Thld=',...
         num2str(threshold), '%']);
else
   title([method, ', K=', num2str(K), ', Mexican hat, Ng0=',...
         num2str(Ng0),', N=',num2str(N), LinLogStr, DisplayStr, ', Thld=',...
         num2str(threshold), '%']);
end


elseif strcmp(method,'GABOR'),
N=p1; Q=p2; h=p3; =size(h); Lh=(hrow-1)/2;
if (hcol~=1)|(rem(hrow,2)==0),
   error('h must be a smoothing window with odd length'); end;
title([method, ', Lh=',num2str(Lh), ', Nf=',...
         num2str(Nf2),', N=',num2str(N),', Q=',num2str(Q),...
         LinLogStr, DisplayStr, ', Thld=',num2str(threshold),'%']);

end;
end

% add the correct legend on the axes
if unitHz==1,
xlabel('Time '); ylabel('Frequency ');
elseif unitHz==2,
xlabel('Time '); ylabel('Frequency ');
elseif unitHz==3,
xlabel('Time [祍]'); ylabel('Frequency ');
end


if (isgridsig & issig),      % Updating of the grids
axes(axsig); grid on   
elseif (~isgridsig & issig),
axes(axsig); grid off
end
if (isgridspec & isspec),
axes(axspec); grid on
elseif (~isgridspec & isspec),
axes(axspec); grid off
end

if (isgridtfr),            % upating of the grid on the tfr
axes(axtfr); grid on
elseif (~isgridtfr),
axes(axtfr); grid off
end

jasonwu 发表于 2007-4-28 20:51

回复 #3 zhangnan3509 的帖子

就是我在matlab中输入命令:coefs=cwt(r,scales,'cmor 1-1.5'),得到小波变换系数,是一个81*32的矩阵,然后求其实部和模平方分别为:x=real(coefs),y=abs(coefs).^2,同样x,y也是81*32的矩阵,然后画等值线图:contour(x),contour(y)。
    问题1就是,在matlab中画出来的等直线图,我不会调疏密,还有就是值小于0的线调成虚线,还有上式中1-1.5是什么意思啊?
    问题2就是,我今天尝试用surfer来画等直线图,但我不知道怎么把x一个81*32的矩阵转化成surfer合法的输入,还请大侠不吝赐教。

oppo 发表于 2008-1-14 15:42

有谁知道?感谢ing~~~~~~~~~~

stao136 发表于 2010-9-9 09:47

也有同样的疑问

stao136 发表于 2010-9-9 09:47

多学习学习?小波方差是怎么做的?

fudy10 发表于 2010-9-9 14:30

回复 jasonwu 的帖子
建议你在版内搜索“连续小波变换”

   
页: [1]
查看完整版本: 请问大侠们:morlet小波变换的模平方和实部的时频分布图是怎么画出来的呀?