Welcome![Sign In][Sign Up]
Location:
Search - matlab plot.t

Search list

[Windows DevelopHOS_MIMO

Description: This package contains the MATLAB code for the algorithm proposed in the following papers. The file \"mimo_main.m\" is the implementation of the algorithm in the papers. The goal of this Matlab script is to identify a MIMO system with white inputs based on the second and higher-order statistics of the outputs only. This code will plot the blind estimation results using figures.-This package contains the MATLAB code for t he algorithm proposed in the following papers. The file "mimo_main.m" is the implementation o f the algorithm in the papers. The goal of this Ma tlab script is to identify a MIMO system with whi te inputs based on the second and higher-order's tatistics of the outputs only. This code will pl ot the blind estimation results using figures.
Platform: | Size: 23677 | Author: 刘美 | Hits:

[Windows DevelopHOS_MIMO

Description: This package contains the MATLAB code for the algorithm proposed in the following papers. The file "mimo_main.m" is the implementation of the algorithm in the papers. The goal of this Matlab script is to identify a MIMO system with white inputs based on the second and higher-order statistics of the outputs only. This code will plot the blind estimation results using figures.-This package contains the MATLAB code for t he algorithm proposed in the following papers. The file "mimo_main.m" is the implementation o f the algorithm in the papers. The goal of this Ma tlab script is to identify a MIMO system with whi te inputs based on the second and higher-order's tatistics of the outputs only. This code will pl ot the blind estimation results using figures.
Platform: | Size: 23552 | Author: 刘美 | Hits:

[matlabplot

Description: 关于matalb 中的plot 绘图函数 绘出美观好看的效果-The plot on the matalb mapping function to map the effects of good-looking appearance
Platform: | Size: 1024 | Author: 高亚鲁 | Hits:

[Linux-Unixofdm-tge

Description: OFDM程序,这么安排矩阵的目的是为了构造共轭对称矩阵 共轭对称矩阵的特点是 在ifft/fft的矢量上 N点的矢量 在0,N/2点必须是实数 一般选为0 1至N/2点 与 (N/2)+1至N-1点关于N/2共轭对称- BPSK simulation using a carrier cosine wave with ISI clc close all clear all figure(1) n=160 for i=1:n data(i)= 2*round(rand)-1 end create modulated BPSK signal first expand the bit stream exdata=[] for i=1:length(data) for rep=1:5 exdata= [exdata data(i)] end end ts=.1 t=1:ts:80.9 carrier=cos(pi*t) multiply expanded bitstream by cosine wave with carrier frequency this is the BPSK that is to be transmitted over the channel bpsk=carrier.*exdata bpsk=[bpsk(length(bpsk)-1) bpsk(length(bpsk)) bpsk] plot(bpsk) generating the noise p=rand(1,800)*2*pi p=rand*2*pi snr=10 r=sqrt(-1*(1/snr*log(1- rand))) no = 5*(r.* exp(j*p)) no = (r.* exp(j*p)) value of alpha al=rand+j*rand al=1 Spreading channel with the alpha as the variable for k=5:5:795 for l = 1:5 al=round(rand)+j*round(rand) rec(k+l)=bpsk(k+l)+al*bpsk(k-5+l) end end rxdata=rec+ no begin demodulation first multiply recie
Platform: | Size: 6146048 | Author: 卞敏捷 | Hits:

[matlabqpsksystem_SJSU_mdl

Description: QPSK modulation system with recover loops-This is a model of a QPSK modulation system for transmission over a bandpass channel with fc = 100 Hz and B = 30 Hz and AWGN at the receiver. SRRC fi lters with excess bandwidth α = 0.18 are employed. The receiver includes an NDA timing recovery loop followed by a DD phase recovery loop. The transmitter?s symbol period is T and set to a value of 100 ms. The symbol period at the receiver is Tr. The model will produce six windows: Two constellation plots and two eye diagrams (for the real part only), at the output of the matched fi lters and after the recovery loops a plot of the phase error (output of the NCO) and a plot of the fractional timing error (used in the interpolator). The frequency off set at the receiver is denoted by deltaf. The model simulates the transmission of 8000 QPSK symbols.
Platform: | Size: 15360 | Author: ranbowang | Hits:

[GUI Developuntitled4

Description:  使用 PLOT(T,Y1,Y2,…])命令,绘图命令plot绘制x-y坐标图;  使用HOLD 命令,保持住该图形窗口的内容,再画一条线。并且该线型的颜色、标记符号可以选择。  利用PLOT(X1,Y1,X2,Y2,..XN,YN)语句, X1,Y1,X2,Y2,..XN,YN分别为向量对,每一对X-Y可画出多条图形。  使用PLOTYY命令,可设坐标。  利用二维绘图函数patch函数fill ,可绘制填充图。 - the use of PLOT (T, Y1, Y2, ...]) command, the command plot graphics rendering map xy coordinates  use the HOLD command, to maintain the contents of the graphics window, and then draw a line. And the line color, marker symbols to choose from.  use of PLOT (X1, Y1, X2, Y2, .. XN, YN) statement, X1, Y1, X2, Y2, .. XN, YN vector were right, each of a number of XY can draw graphics.  use PLOTYY order to set the coordinates.  the use of two-dimensional mapping function patch function of fill, can be filled with map drawing.
Platform: | Size: 2048 | Author: 袁明 | Hits:

[matlabXie

Description: 在Matlab中画一个给定参数的T分布的图像。-plot a figure of a data for T distribution.
Platform: | Size: 1024 | Author: xiejiejie | Hits:

[2D GraphicVector_Diagram

Description: Script originally intended for use in oceanography/fluid dynamics. Use: >> ipdv(X,Y) (0,0) default initial position or >> ipdv(X,Y,Xo,Yo) (Xo,Yo) initial position 2D vector components (X,Y) are used to plot the vectors one after another, i.e., next vector starting at the end of the previous one (via Matlab s quiver.m ). This function handles NANs (Not-A-Number) by putting Zeros in their place, thus allowing the Matlab cumsum.m function to compute the progressive positions (Matlab function cumsum.m doesn t skip Nans). NaNs produce discontinuities in the graphic.-Script originally intended for use in oceanography/fluid dynamics. Use: >> ipdv(X,Y) (0,0) default initial position or >> ipdv(X,Y,Xo,Yo) (Xo,Yo) initial position 2D vector components (X,Y) are used to plot the vectors one after another, i.e., next vector starting at the end of the previous one (via Matlab s quiver.m ). This function handles NANs (Not-A-Number) by putting Zeros in their place, thus allowing the Matlab cumsum.m function to compute the progressive positions (Matlab function cumsum.m doesn t skip Nans). NaNs produce discontinuities in the graphic.
Platform: | Size: 2048 | Author: djimy | Hits:

[2D Graphicthermo_plot_diagram

Description: You can plot your own T,s h,s or log p,h-Diagrams of water in MATLAB with the function thermo_diagram_plot.m. Only SI-Units are supported The function is a product of a project at our school to help students understand these diagrams more deeply and to become handier with MATLAB. The function can be used to plot your own diagrams and draw in some thermodynamic cycle. Please refer to the manual in the .zip file for a throughout documentation of the function.-You can plot your own T,s h,s or log p,h-Diagrams of water in MATLAB with the function thermo_diagram_plot.m. Only SI-Units are supported The function is a product of a project at our school to help students understand these diagrams more deeply and to become handier with MATLAB. The function can be used to plot your own diagrams and draw in some thermodynamic cycle. Please refer to the manual in the .zip file for a throughout documentation of the function.
Platform: | Size: 476160 | Author: djimy | Hits:

[Program docuntitled

Description: A bandpass signal is defined by clear all t=-10:0.06:10 m=3*(cos(2*pi*10*t)+4*sin(2*pi*20*t)) x=6*m.*cos(2*pi*100*t) f0=100 fmax=100 NSamples=256 Amplitude Response plot of x(t) figure(1) subplot(211) plot(t,abs(x)) xlabel( time ) ylabel( Amplitude ) subplot(212) plot(t,angle(x- A bandpass signal is defined by clear all t=-10:0.06:10 m=3*(cos(2*pi*10*t)+4*sin(2*pi*20*t)) x=6*m.*cos(2*pi*100*t) f0=100 fmax=100 NSamples=256 Amplitude Response plot of x(t) figure(1) subplot(211) plot(t,abs(x)) xlabel( time ) ylabel( Amplitude ) subplot(212) plot(t,angle(x
Platform: | Size: 78848 | Author: naresh | Hits:

[matlabForcedPendulum

Description: This simulink model simulates the damped driven pendulum, showing it s chaotic motion. theta = angle of pendulum omega = (d/dt)theta = angular velocity Gamma(t) = gcos(phi) = Force omega_d = (d/dt) phi Gamma(t) = (d/dt)omega + omega/Q + sin(theta) Play with the initial conditions (omega_0, theta_0, phi_0 = omega(t=0), theta(t=0), phi(t=0)) and the system parameters (g, Q, omega_d) and the solver parameters/method. Chaos can be seen for Q=2, omega_d=w/3. The program outputs to Matlab time, theta(time) & omega(time). Plot the phase space via: plot(mod(theta+pi, 2*pi)-pi, omega, . ) Plot the Poincare sections using: t_P = (0:2*pi/omega_d:max(time)) plot(mod(spline(time, theta+pi, t_P), 2*pi)-pi, spline(time, omega, t_P), . ) System is described in: "Fractal basin boundaries and intermittency in the driven damped pendulum" E. G. Gwinn and R. M. Westervelt PRA 33(6):4143 (1986) -This simulink model simulates the damped driven pendulum, showing it s chaotic motion. theta = angle of pendulum omega = (d/dt)theta = angular velocity Gamma(t) = gcos(phi) = Force omega_d = (d/dt) phi Gamma(t) = (d/dt)omega+ omega/Q+ sin(theta) Play with the initial conditions (omega_0, theta_0, phi_0 = omega(t=0), theta(t=0), phi(t=0)) and the system parameters (g, Q, omega_d) and the solver parameters/method. Chaos can be seen for Q=2, omega_d=w/3. The program outputs to Matlab time, theta(time) & omega(time). Plot the phase space via: plot(mod(theta+pi, 2*pi)-pi, omega, . ) Plot the Poincare sections using: t_P = (0:2*pi/omega_d:max(time)) plot(mod(spline(time, theta+pi, t_P), 2*pi)-pi, spline(time, omega, t_P), . ) System is described in: "Fractal basin boundaries and intermittency in the driven damped pendulum" E. G. Gwinn and R. M. Westervelt PRA 33(6):4143 (1986)
Platform: | Size: 8192 | Author: Mike Gao | Hits:

[matlabaliasing_for_time_domain_signal.m

Description: This package contains script to calculate aliasing for given time domain signal. Script to plot in time domain the function: x(t)=A0cos(2pif0t)+A1cos(2pif1t) where fs1=300 Hz and fs2=150 Hz (sampling rate) A0 and A1 are amplitude s signal (armónicos). f0 is the maximun component in frecuency of the signal to sample, when it shows X(t) signal with a sampling frecuency 300 Hz, we will see Aliasing :) It s because we aren t meetting with the Nyquist Theorem, because we don t choice Fs>=2FNy Fs(Sampling Frec) FNy(Frec Nyquist) to sample aplying fft(fast fourier transform) with at least 600 Hz. By actinio --vjgonzalezg@gmail.com-This package contains script to calculate aliasing for given time domain signal. Script to plot in time domain the function: x(t)=A0cos(2pif0t)+A1cos(2pif1t) where fs1=300 Hz and fs2=150 Hz (sampling rate) A0 and A1 are amplitude s signal (armónicos). f0 is the maximun component in frecuency of the signal to sample, when it shows X(t) signal with a sampling frecuency 300 Hz, we will see Aliasing :) It s because we aren t meetting with the Nyquist Theorem, because we don t choice Fs>=2FNy Fs(Sampling Frec) FNy(Frec Nyquist) to sample aplying fft(fast fourier transform) with at least 600 Hz. By actinio --vjgonzalezg@gmail.com--
Platform: | Size: 1024 | Author: actinio | Hits:

[Othermatlab

Description: clear num=[0,0,10] den=[1,2,10] p=roots(den) [u,w]=solve( w^2=10 , 2*w*u=2 , u,w ) [y,x,t]=step(num,den) plot(t,y) [yss,n]=max(y) finalvalue=dcgain(num,den) percentovershoot=100*(yss-finalvalue)/finalvalue timetopeak=t(n) k=length(t) while (y(k)>0.98*finalvalue)&(y(k)<1.02*finalvalue) k=k-1 end settlingtime=t(k) p w=vpa(w,4) u=vpa(u,4) yss timetopeak finalvalue settlingtime -clear num = [0,0,10] den = [1,2,10] p = roots (den) [u, w] = solve ( ' w ^ 2 = 10' , ' 2* w* u = 2 ' ,' u, w ' ) [y, x, t] = step (num, den) plot (t, y) [yss, n] = max (y) finalvalue = dcgain (num , den) percentovershoot = 100* (yss-finalvalue)/finalvalue timetopeak = t (n) k = length (t) while (y (k)> 0.98* finalvalue) & (y (k) < 1.02* finalvalue) k = k-1 end settlingtime = t (k) p w = vpa (w, 4) u = vpa (u, 4) yss timetopeak finalvalue settlingtime
Platform: | Size: 2919424 | Author: 董森 | Hits:

[matlabc_v_gdist

Description: procedure un matlab to plot Tanner graph, it´ s not useful to wide matrices, can´ t view de edges of de graph
Platform: | Size: 1024 | Author: Juan | Hits:

[OtherSuc-P-T

Description: 采用matlab语言编写的PR方程计算P-T相图的程序-a program to calculate the P-T plot
Platform: | Size: 11264 | Author: chu peng | Hits:

[OS programplotImpulse

Description: This function plots a Gaussian impulse response, unit impulse and the convolution/deconvolution of both using MATLAB s filter . Specifically it uses filter rather than deconv to do the deconvolution and thereby returns the original Gaussian vector as well as the unit response vector. Vector length is maintained at 16 in all cases, the length of the input data vectors. By specifying a string for a filename you can save your plot to a jpeg file. You can either edit the variables g , h and t to provide your data in row vector format or edit the given inputData.mat file to suit your needs. EX: >> [a b c] = plotImpulses( afigure )-This function plots a Gaussian impulse response, unit impulse and the convolution/deconvolution of both using MATLAB s filter . Specifically it uses filter rather than deconv to do the deconvolution and thereby returns the original Gaussian vector as well as the unit response vector. Vector length is maintained at 16 in all cases, the length of the input data vectors. By specifying a string for a filename you can save your plot to a jpeg file. You can either edit the variables g , h and t to provide your data in row vector format or edit the given inputData.mat file to suit your needs. EX: >> [a b c] = plotImpulses( afigure )
Platform: | Size: 66560 | Author: anish | Hits:

[Other systemstrunk

Description: 为树轮研究开发的数据分析matlab工具箱-Tree-ring and climate-data analysis grplot grouped plots of ring width series skelcrn - skeleton plot crn file or ring-width series climgram - climatogram IO and formatting of tree-ring data crn2vec2 convert .crn file to vectors rwl2tsm convert .rwl file to time series matrix rwlinp - load rwl series as indexed vector into MATLAB IO and formatting of climate data c132tss Thirteen-column monthly climate matrix to time-series structure File and directory management dirfiles list of files with specified suffix Time series analysis acf autocorrelation function and confidence limits arspectrum spectrum of an AR(1) or AR(2) process corrone product-moment correlation of one variable with several others mafilt1 evenly-weighted moving average of an annual time series pdgmraw raw periodogram of a time series pdgmsim exact simulation of Gaussian time series its periodogram specbt1 spectrum of a single time series by Blackman Tukey method whit1 fit an AR model to t
Platform: | Size: 78848 | Author: wuming | Hits:

[matlabAmplitude-Modulation

Description: Amplitude Modulation simulation in Matlab, so here we define s(t) as an AM signal and plot it on the frequency domain for various parameters.
Platform: | Size: 2048 | Author: Augusto Peixoto | Hits:

[Internet-Networkmatlab代码

Description: 在命令行输入%%滞回曲线 t0=0; tf=20; x0=[0 0 0] [t,x]=ode45('Lorenz',[t0 tf],x0); plot(x(:,1),x(:,3)),可得滞回曲线(Enter the%% hysteresis curve on the command line t0=0; tf=20; x0=[0 0 0] [t,x]=ode45('Lorenz',[t0 tf],x0); plot(x(:,1),x(:,3)))
Platform: | Size: 21504 | Author: 土木小生 | Hits:

CodeBus www.codebus.net