Solutions. Chapter 5. Problem 5.1. Solution. Consider the driven, two-well Duffing s oscillator. which can be written in state variable form as

Size: px
Start display at page:

Download "Solutions. Chapter 5. Problem 5.1. Solution. Consider the driven, two-well Duffing s oscillator. which can be written in state variable form as"

Transcription

1 Chapter 5 Solutions Problem 5.1 Consider the driven, two-well Duffing s oscillator which can be written in state variable form as ẍ + ɛγẋ x + x 3 = ɛf cos(ωt) ẋ = v v = x x 3 + ɛ( γv + F cos(ωt)). In the above expressions, γ is the linear (viscous) damping coefficient, F is the forcing amplitude, and ω is the forcing frequency. 1 Develop a MATLAB code to simulate this system. You need to be able to generate uniformly sampled time series of any length, with any sampling time t s (recall that the sampling frequency is f s = 1/t s, and be very careful when choosing your sampling time). Experiment with the simulations, and by varying the system parameters and examples of: 1. a periodic, approximately simple harmonic response; 2. a periodic response that is not simple harmonic; and 3. a chaotic (i.e. aperiodic) response. Plot the steady state results in the time domain and in the x v phase plane. To help you get started, reasonable values for the parameters to use in the simulations are ɛ =.1, γ [.7; 2.], ω [.9; 1, 1], F [1.5; 2.8]. Solution %% Problem 5.1 figure(1), clf % set parameters for P-1 orbits epsilon =.1; gamma = 2; omega = 1.1; f = 1.5; 11 The parameter ɛ is included here only for convenience when comparing our results to certain theoretical treatments. In particular, the damping and forcing are scaled by ɛ to indicate that the oscillator can be thought of as a perturbation of of a conservative system, with the conservative system corresponding to the case ɛ =. See, for example, Guckenheimer and Holmes (1983). 29

2 Amplitude x Amplitude v 3 CHAPTER 5. SOLUTIONS Time Amplitude x 5 Approximatly simple harmonic response: =.1, = 2, = 1.1, f = Figure 5.1: Simple, close to harmonic response. % integrate 5 forcing cycles to get rid of transients [t,y]=ode45(@duff,[ 5*2*pi/omega],[;;],[],epsilon,gamma,f,omega); % now take the last point in y as new initial condition, get steady state [t,y1]=ode45(@duff,[:2*pi/omega/36:4*2*pi/omega],y(,:),[],epsilon,gamma,f,omega); % plot the results set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); subplot(221), plot(t(1:94),y1(1:94,1), linewidth,1) xlabel( Time ),ylabel( Amplitude x ), ylim([ ]) subplot(222), plot(y1(:,1),y1(:,2), linewidth,1) xlabel( Amplitude x ),ylabel( Amplitude v ) subplot(2,2,[3,4]) pwelch(y1(1:1:,1),window(@hann,2*124),[],2*124,.48) set(get(gca, children ), linewidth,1) title([ Approximatly simple harmonic response: \epsilon = num2str(epsilon)..., \gamma = num2str(gamma), \omega = num2str(omega), f = num2str(f)]); print -dpdf Prob_5_1_1 %% Now let s try for periodic, not simple harmonic response figure(2),clf epsilon =.1; gamma = 2; omega = 1.1; f = 1.78; % integrate 1 forcing cycles to get rid of transients [t,y]=ode45(@duff,[ 1*2*pi/omega],[;;],[],epsilon,gamma,f,omega); % now take the last point in y as new initial condition, get steady state

3 Amplitude x Amplitude v Time Amplitude x 5 Period-2 response: =.1, = 2, = 1.1, f = Figure 5.2: Period-2 orbit. [t,y2]=ode45(@duff,[:2*pi/omega/36:4*2*pi/omega],y(,:),[],epsilon,gamma,f,omega); % plot the results set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); subplot(221), plot(t(1:94),y2(1:94,1), linewidth,1) xlabel( Time ),ylabel( Amplitude x ), % ylim([.7 1.3]) subplot(222), plot(y2(:,1),y2(:,2), linewidth,1) xlabel( Amplitude x ),ylabel( Amplitude v ) subplot(2,2,[3,4]) pwelch(y2(1:1:,1),window(@hann,2*124),[],2*124,.48) set(get(gca, children ), linewidth,1) title([ Period-2 response: \epsilon = num2str(epsilon)..., \gamma = num2str(gamma), \omega = num2str(omega), f = num2str(f)]); print -dpdf Prob_5_1_2 %% Finally, let s try for chaotic response figure(3),clf epsilon =.1; gamma = 2; omega = 1.1; f = 2; % integrate 1 forcing cycles to get rid of transients [t,y]=ode45(@duff,[ 1*2*pi/omega],[;;],[],epsilon,gamma,f,omega); % now take the last point in y as new initial condition, get steady state [t,y3]=ode45(@duff,[:2*pi/omega/36:4*2*pi/omega],y(,:),[],epsilon,gamma,f,omega); % plot the results set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]);

4 Amplitude x Amplitude v 32 CHAPTER 5. SOLUTIONS Time Amplitude x 4 Chaotic response: =.1, = 2, = 1.1, f = Figure 5.3: Chaotic orbit. subplot(221), plot(t(1:94),y3(1:94,1), linewidth,1) xlabel( Time ),ylabel( Amplitude x ), % ylim([.7 1.3]) subplot(222), plot(y3(:,1),y3(:,2), linewidth,1) xlabel( Amplitude x ),ylabel( Amplitude v ) subplot(2,2,[3,4]) pwelch(y3(1:1:,1),window(@hann,2*124),[],2*124,.48) set(get(gca, children ), linewidth,1) title([ Chaotic response: \epsilon = num2str(epsilon)..., \gamma = num2str(gamma), \omega = num2str(omega), f = num2str(f)]); print -dpdf Prob_5_1_3

5 33 Problem 5.2 Using the time series {x i } generated in Exercise 1, make an observable via {y i } = {x i + n i }, where the n i are indepent identically-distributed (IID) mean zero Gaussian random variable with variance σ 2 (be careful when choosing your parameters we want to approximate real-life situations). Find the digital Power Spectral Density (PSD) for the three types of response found in Exercise 1, using the MATLAB functions pwelch or periodogram (e.g., at MATLAB prompt type help pwelch ). By experimentation, examine the effect of σ, t s, the number of points used in the FFT, and windowing (including no window, which is called rectwin in MATLAB). A good window to use is the Hanning, however you can experiment to see the differences. Type help window at the command line for more information. Plot your results using a semilog or Decibel (db) scale. Discuss your results: what do you see? Solution Results of the simulation and analysis are shown in P521P523. As seen from these figures with the introduction of even level our PSD acquires a noise floor at approximately -65 db. With the increase in the noise level the noise floor rises, and at high noise levels can obscure the important information (observe the loss of third peak in the top rows). We explored the effects of three different windowing functions: (1) Rectangular, (2) Hanning, and (3) Hamming. With just rectangular windowing the effects of the finite size of data manifest itself in a rising energy levels at low frequencies even for values where there is no observed frequency content, since the peaks are wide and spread widely (spectral leakage). Adding a Hamming window helps a situation considerably, since we have more clear peaks, however there is still some spread at the base of the peaks. With Hanning window we see that situation improves considerably with the thickness of the peaks at P-1 signal, Rectangular Window 2 2 P-1 signal, Hanning Window 2 P-1 signal, Hamming Window -2 5% noise -2 5% noise -2 5% noise P-2 signal, Rectangular Window P-2 signal, Hanning Window P-2 signal, Hamming Window Chaotic Signal, Rectangular Window Chaotic Signal, Hanning Window Chaotic Signal, Hamming Window Figure 5.4: PSDs of signal in Problem 5.1 with different noise level and different windowing function.

6 34 CHAPTER 5. SOLUTIONS the base. However, the peaks themselves are not as defined (pointy) as before. These are really important for periodic data. However, for the chaotic data the effects are less pronounced. We know that increasing the sampling time period, causes the loss of information in high frequencies and may lead to the aliasing. As we see from plots in Fig. 5.5 and previous PSD plots, our systems bandwidth is approximately 1/2 of its normalized frequency range. Thus, by downsampling the signal by factor of 2 we retain important information. However the noise that exists at high frequencies is still folded back onto our signal. So the proper procedure would be to low-pass filter our signal with.5 cutoff frequency and then do the psd estimates. When signals are downsampled by factor of 4, we clearly see the appearance of peaks that were not present before as a result of aliasing (this is most clear in the top raw of plots). P-1 signal, Rectangular Window 2 2 P-1 signal, Hanning Window 2 P-1 signal, Hamming Window P-2 signal, Rectangular Window Chaotic Signal, Rectangular Window P-2 signal, Hanning Window Chaotic Signal, Hanning Window P-2 signal, Hamming Window Chaotic Signal, Hamming Window % noise % noise % noise Figure 5.5: Same as Fig. 5.4 but with data recorded with twice the sampling period. %% Problem 5.2 figure(4),clf set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); % now add noise to see the effects n = randn(size(y1(:,1))); % generate noise signal nl = [.1.1.5]; % three distinct noise levels clas = { P-1 signal, P-2 signal, Chaotic Signal }; clas2 = { Rectangular Window, Hanning Window, Hamming Window }; for i = 1:3 eval([ x = y num2str(i) (:,1); ]); sd = std(x); % define signal and its std subplot(3,3,3*i-2)

7 35 P-1 signal, Rectangular Window 2 2 P-1 signal, Hanning Window 2 P-1 signal, Hamming Window P-2 signal, Rectangular Window Chaotic Signal, Rectangular Window P-2 signal, Hanning Window Chaotic Signal, Hanning Window P-2 signal, Hamming Window Chaotic Signal, Hamming Window % noise % noise % noise Figure 5.6: Same as Fig. 5.4 but with data recorded with four-times the sampling period. [Pxx,F] = pwelch(s(1:2:),window(@rectwin,124),[],124,1*.48/2); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{1}]); xlim([ 12]) xlabel( ) ylabel( ) leg(,, 5% noise ) subplot(3,3,3*i-1) [Pxx,F] = pwelch(s(1:2:),window(@hann,124),[],124,1*.48/2); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{2}]); xlim([ 12]) xlabel( ) ylabel( ) leg(,, 5% noise ) subplot(3,3,3*i) [Pxx,F] = pwelch(s(1:2:),window(@hamming,124),[],124,1*.48/2); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:))

8 36 CHAPTER 5. SOLUTIONS xlabel( ) ylabel( ) ylim([-7 2]);title([clas{i}, clas2{3}]); xlim([ 12]) leg(,, 5% noise ) print -dpdf Prob_5_2_1 %% figure(5),clf set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); % now add noise to see the effects n = randn(size(y1(:,1))); % generate noise signal nl = [.1.1.5]; % three distinct noise levels clas = { P-1 signal, P-2 signal, Chaotic Signal }; clas2 = { Rectangular Window, Hanning Window, Hamming Window }; for i = 1:3 eval([ x = y num2str(i) (:,1); ]); sd = std(x); % define signal and its std subplot(3,3,3*i-2) [Pxx,F] = pwelch(s(1:4:),window(@rectwin,124),[],124,1*.48/4); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{1}]); xlabel( ) ylabel( ) leg(,, 5% noise ) subplot(3,3,3*i-1) [Pxx,F] = pwelch(s(1:4:),window(@hann,124),[],2*124,1*.48/4); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{2}]); xlabel( ) ylabel( ) leg(,, 5% noise ) subplot(3,3,3*i) [Pxx,F] = pwelch(s(1:4:),window(@hamming,124),[],124,1*.48/4); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{3}]); xlabel( ) ylabel( )

9 37 leg(,, 5% noise )%, location, southwest ); print -dpdf Prob_5_2_2 % figure(6),clf set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); % now add noise to see the effects n = randn(size(y1(:,1))); % generate noise signal nl = [.1.1.5]; % three distinct noise levels clas = { P-1 signal, P-2 signal, Chaotic Signal }; clas2 = { Rectangular Window, Hanning Window, Hamming Window }; for i = 1:3 eval([ x = y num2str(i) (:,1); ]); sd = std(x); % define signal and its std subplot(3,3,3*i-2) [Pxx,F] = pwelch(s(1:8:),window(@rectwin,124),[],124,1*.48/8); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{1}]); xlabel( ) ylabel( ) leg(,, 5% noise, location, southwest ); subplot(3,3,3*i-1) [Pxx,F] = pwelch(s(1:8:),window(@hann,124),[],2*124,1*.48/8); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{2}]); xlabel( ) ylabel( ) leg(,, 5% noise, location, southwest ); subplot(3,3,3*i) [Pxx,F] = pwelch(s(1:8:),window(@hamming,124),[],124,1*.48/8); plot(f,1*log1(pxx), linewidth,1, color,co(4-j,:)) ylim([-7 2]);title([clas{i}, clas2{3}]); xlabel( ) ylabel( ) leg(,, 5% noise, location, southwest );

10 38 CHAPTER 5. SOLUTIONS print -dpdf Prob_5_2_3 References John Guckenheimer and Philip Holmes (1983) Nonlinear Oscillations, Dynamical Systems, and Bifurcations of Vector Fields, Springer-Verlag, New York. See in particular Ch. 4.5, Eq. (4.5.18).

11 Chapter 6 Solutions Problem 6.1 [Bifurcation Diagram for Logistics Map] Consider a Logistics map equation: x n+1 = Ax n (1 x n ). (6.1) Run the simulations with the initial condition X =.1, for different values of A starting from A = 2.9 and going up to A = 4. Make increments in A small enough, e.g., A <.1 (e.g., A =.1). For each magnitude of A record long time series and retain only the last 1, (or more, e.g., 4,) points representing its steady state response. Now plot the bifurcation diagram, by plotting all the response points versus the corresponding value of A. What can you see in the diagram? Solution Results of the simulation are shown in Fig %% Problem 6.1 X=zeros(111:1); A = 2.9:.1:4; x=zeros(1,21); for j = 1:111 x(1) =.1; for k = 1:12 x(k+1)=a(j)*x(k)*(1-x(k)); X(j,:) = x(-999:); figure(7) set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); plot(a,x,., markersize,.5, markeredgecolor,co(1,:)) axis([ ]) xlabel( $A$, Interpreter, Latex, FontSize,14) ylabel( $x_n$, Interpreter, Latex, FontSize,14) print -dpdf Prob_6_1 39

12 4 CHAPTER 6. SOLUTIONS Problem 6.2 Figure 6.1: Bifurcation diagram of the Logistics map. Numerically integrate the Lorenz system described in Problem 3.2 and perform a Poincaré section. Namely, record (x, z) every time the y-coordinate equals zero and its derivative is negative. You can accomplish by providing options to ode45 MATLAB program by first setting it through options = odeset( Events,@events);, where events is the function that specifies the when to sample the flow (i.e., you need to specify y = and ẏ < conditions). I would suggest reading ODE Event Location on Mathworks site and following their example. Once you have the points, plot the Poincaré section by plotting z vs x as points. Solution Results of the simulation are shown in Fig %% Problem 6.2 sigma = 1; r = 28; b = 8/3; options = odeset( Events,@events); [~,~,~,ye] = ode45(@lorenz,[ 5],ones(3,1),options); figure(8) set(gcf, PaperSize,[11 7], PaperPosition, [ 11 7]); plot(ye(:,1),ye(:,3),., markersize,1) xlabel( x ) ylabel( z ) title( Poincare Section for y= & y < ) print -dpdf Prob_6_2

13 z 41 Poincare Section for y= & y'< x Figure 6.2: Poincaré section of the Lorenz equation obtained by sampling every time the y-coordinate equals zero and its derivative is negative. function [value,isterminal,direction] = events(~,y) % Locate the time when y passes through zero in a % decreasing direction and record x and z. value = y(2); % Detect y crossing isterminal = ; % Do not stop the integration direction = -1; % Negative direction only function dy = lorenz(~,y) % dy = [ -b*y(1) + y(2)*y(3); % sigma*(y(2) - y(3)); % r*y(2) - y(3) - y(1)*y(2)]; % dy = [-b*y(1) + y(2)*y(3); -sigma*(y(2) - y(3)); -y(1)*y(2) + r*y(2) - y(3)]; Problem 6.3 Numerically integrate the Lorenz system described in Problem 3.2 and collect all the maxima of y variable. Again, you can use events to accomplish this, or use findpeaks command in MATLAB

14 42 CHAPTER 6. SOLUTIONS on y time series that is sampled sufficiently. compare it to the attractor of Problem 6.2. Plot the series of the maxima Y n versus Y n+1 and Solution Results of the simulation are shown in Fig Poincare Section for dy/dt= & y''< 1 Reconstructed Poincare Section z n 5 y n x n y n Figure 6.3: Poincaré section of the Lorenz equation obtained by sampling every time the y-coordinate achieves its local maximum. We can see that the actual and reconstructed Poincaré sections are quite different from the previous problem. This is caused by the fact that on average there are five local maxima before zero crossing occurs for the y variable. options2 = odeset( Events,@events2); [~,~,~,ye] = ode45(@lorenz,[ 5],ones(3,1),options2); figure(9) set(gcf, PaperSize,[11 4.5], PaperPosition, [ ]); subplot(1,2,1) plot(ye(:,1),ye(:,3),., markersize,1) xlabel( x_n ) ylabel( z_n ) title( Poincare Section for dy/dt= & y < ) subplot(1,2,2) plot(ye(1:-1,2),ye(2:,2),., markersize,1) xlabel( y_n ) ylabel( y_{n+1} ) title( Reconstructed Poincare Section ) print -dpdf Prob_6_3 function [value,isterminal,direction] = events2(t,y) % Locate the time when dx/dt passes through zero in a % decreasing direction... dy = lorenz(t,y); value = sigma*(dy(2)-dy(1)); % Detect dx/dt crossing

15 43 isterminal = ; direction = -1; % Do not stop the integration % Negative direction only function dy = lorenz(~,y) % dy = [ -b*y(1) + y(2)*y(3); % sigma*(y(2) - y(3)); % r*y(2) - y(3) - y(1)*y(2)]; % dy = [-b*y(1) + y(2)*y(3); -sigma*(y(2) - y(3)); -y(1)*y(2) + r*y(2) - y(3)];

Experimental Fourier Transforms

Experimental Fourier Transforms Chapter 5 Experimental Fourier Transforms 5.1 Sampling and Aliasing Given x(t), we observe only sampled data x s (t) = x(t)s(t; T s ) (Fig. 5.1), where s is called sampling or comb function and can be

More information

Solutions. Chapter 1. Problem 1.1. Solution. Simulate free response of damped harmonic oscillator

Solutions. Chapter 1. Problem 1.1. Solution. Simulate free response of damped harmonic oscillator Chapter Solutions Problem. Simulate free response of damped harmonic oscillator ẍ + ζẋ + x = for different values of damping ration ζ and initial conditions. Plot the response x(t) and ẋ(t) versus t and

More information

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP In this laboratory session we will learn how to. Use MATLAB solvers for solving scalar IVP 2. Use MATLAB solvers for solving higher order ODEs and

More information

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP MAT 75 Laboratory 4 MATLAB solvers for First-Order IVP In this laboratory session we will learn how to. Use MATLAB solvers for solving scalar IVP. Use MATLAB solvers for solving higher order ODEs and systems

More information

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP MATLAB sessions: Laboratory 4 MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP In this laboratory session we will learn how to. Use MATLAB solvers for solving scalar IVP 2. Use MATLAB solvers for

More information

EEO 401 Digital Signal Processing Prof. Mark Fowler

EEO 401 Digital Signal Processing Prof. Mark Fowler EEO 4 Digital Signal Processing Pro. Mark Fowler ote Set # Using the DFT or Spectral Analysis o Signals Reading Assignment: Sect. 7.4 o Proakis & Manolakis Ch. 6 o Porat s Book /9 Goal o Practical Spectral

More information

APPM 2460 CHAOTIC DYNAMICS

APPM 2460 CHAOTIC DYNAMICS APPM 2460 CHAOTIC DYNAMICS 1. Introduction Today we ll continue our exploration of dynamical systems, focusing in particular upon systems who exhibit a type of strange behavior known as chaos. We will

More information

Lesson 11: Mass-Spring, Resonance and ode45

Lesson 11: Mass-Spring, Resonance and ode45 Lesson 11: Mass-Spring, Resonance and ode45 11.1 Applied Problem. Trucks and cars have springs and shock absorbers to make a comfortable and safe ride. Without good shock absorbers, the truck or car will

More information

Application 6.5B Period Doubling and Chaos in Mechanical Systems

Application 6.5B Period Doubling and Chaos in Mechanical Systems Application 6.5B Period Doubling and Chaos in Mechanical Systems The first objective of this section is the application of the DE plotting techniques of the Section 6. and 6.4 applications to the investigation

More information

Introduction to Signal Analysis Parts I and II

Introduction to Signal Analysis Parts I and II 41614 Dynamics of Machinery 23/03/2005 IFS Introduction to Signal Analysis Parts I and II Contents 1 Topics of the Lecture 11/03/2005 (Part I) 2 2 Fourier Analysis Fourier Series, Integral and Complex

More information

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fourier Series & Transform Summary x[n] = X[k] = 1 N k= n= X[k]e jkω

More information

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding J. McNames Portland State University ECE 223 FFT Ver. 1.03 1 Fourier Series

More information

EEM 409. Random Signals. Problem Set-2: (Power Spectral Density, LTI Systems with Random Inputs) Problem 1: Problem 2:

EEM 409. Random Signals. Problem Set-2: (Power Spectral Density, LTI Systems with Random Inputs) Problem 1: Problem 2: EEM 409 Random Signals Problem Set-2: (Power Spectral Density, LTI Systems with Random Inputs) Problem 1: Consider a random process of the form = + Problem 2: X(t) = b cos(2π t + ), where b is a constant,

More information

Solutions for examination in TSRT78 Digital Signal Processing,

Solutions for examination in TSRT78 Digital Signal Processing, Solutions for examination in TSRT78 Digital Signal Processing, 2014-04-14 1. s(t) is generated by s(t) = 1 w(t), 1 + 0.3q 1 Var(w(t)) = σ 2 w = 2. It is measured as y(t) = s(t) + n(t) where n(t) is white

More information

SNR Calculation and Spectral Estimation [S&T Appendix A]

SNR Calculation and Spectral Estimation [S&T Appendix A] SR Calculation and Spectral Estimation [S&T Appendix A] or, How not to make a mess of an FFT Make sure the input is located in an FFT bin 1 Window the data! A Hann window works well. Compute the FFT 3

More information

Problem Set 9 Solutions

Problem Set 9 Solutions Problem Set 9 Solutions EE23: Digital Signal Processing. From Figure below, we see that the DTFT of the windowed sequence approaches the actual DTFT as the window size increases. Gibb s phenomenon is absent

More information

INTRODUCTION TO DELTA-SIGMA ADCS

INTRODUCTION TO DELTA-SIGMA ADCS ECE37 Advanced Analog Circuits INTRODUCTION TO DELTA-SIGMA ADCS Richard Schreier richard.schreier@analog.com NLCOTD: Level Translator VDD > VDD2, e.g. 3-V logic? -V logic VDD < VDD2, e.g. -V logic? 3-V

More information

Lab 4: Quantization, Oversampling, and Noise Shaping

Lab 4: Quantization, Oversampling, and Noise Shaping Lab 4: Quantization, Oversampling, and Noise Shaping Due Friday 04/21/17 Overview: This assignment should be completed with your assigned lab partner(s). Each group must turn in a report composed using

More information

Why are Discrete Maps Sufficient?

Why are Discrete Maps Sufficient? Why are Discrete Maps Sufficient? Why do dynamical systems specialists study maps of the form x n+ 1 = f ( xn), (time is discrete) when much of the world around us evolves continuously, and is thus well

More information

Using Matlab to integrate Ordinary Differential Equations (ODEs)

Using Matlab to integrate Ordinary Differential Equations (ODEs) Using Matlab to integrate Ordinary Differential Equations (ODEs) Erica McEvoy (Dated: June 17, 2009) 1. INTRODUCTION Ordinary differential equations tend to arise whenever you need to model changing quantities

More information

Numerical Methods with Matlab: Implementations and Applications. Gerald W. Recktenwald

Numerical Methods with Matlab: Implementations and Applications. Gerald W. Recktenwald Selected Solutions for Exercises in Numerical Methods with Matlab: Implementations and Applications Gerald W. Recktenwald Chapter 12 Numerical Integration of Ordinary Differential Equations The following

More information

Centre for Mathematical Sciences HT 2017 Mathematical Statistics

Centre for Mathematical Sciences HT 2017 Mathematical Statistics Lund University Stationary stochastic processes Centre for Mathematical Sciences HT 2017 Mathematical Statistics Computer exercise 3 in Stationary stochastic processes, HT 17. The purpose of this exercise

More information

Lecture 17: variance in a band = log(s xx (f)) df (2) If we want to plot something that is more directly representative of variance, we can try this:

Lecture 17: variance in a band = log(s xx (f)) df (2) If we want to plot something that is more directly representative of variance, we can try this: UCSD SIOC 221A: (Gille) 1 Lecture 17: Recap We ve now spent some time looking closely at coherence and how to assign uncertainties to coherence. Can we think about coherence in a different way? There are

More information

Solutions for examination in TSRT78 Digital Signal Processing,

Solutions for examination in TSRT78 Digital Signal Processing, Solutions for examination in TSRT78 Digital Signal Processing 212-12-2 1. (a) The forgetting factor balances the accuracy and the adaptation speed of the RLS algorithm. This as the forgetting factor controls

More information

The Z-Transform. For a phasor: X(k) = e jωk. We have previously derived: Y = H(z)X

The Z-Transform. For a phasor: X(k) = e jωk. We have previously derived: Y = H(z)X The Z-Transform For a phasor: X(k) = e jωk We have previously derived: Y = H(z)X That is, the output of the filter (Y(k)) is derived by multiplying the input signal (X(k)) by the transfer function (H(z)).

More information

3 rd -order Intercept Point

3 rd -order Intercept Point 1 3 rd -order Intercept Point Anuranjan Jha, Columbia Integrated Systems Lab, Department of Electrical Engineering, Columbia University, New York, NY Last Revised: September 12, 2006 These derivations

More information

UCSD SIO221c: (Gille) 1

UCSD SIO221c: (Gille) 1 UCSD SIO221c: (Gille) 1 Edge effects in spectra: detrending, windowing and pre-whitening One of the big challenges in computing spectra is to figure out how to deal with edge effects. Edge effects matter

More information

Bayesian Analysis - A First Example

Bayesian Analysis - A First Example Bayesian Analysis - A First Example This script works through the example in Hoff (29), section 1.2.1 We are interested in a single parameter: θ, the fraction of individuals in a city population with with

More information

LAB 2: DTFT, DFT, and DFT Spectral Analysis Summer 2011

LAB 2: DTFT, DFT, and DFT Spectral Analysis Summer 2011 University of Illinois at Urbana-Champaign Department of Electrical and Computer Engineering ECE 311: Digital Signal Processing Lab Chandra Radhakrishnan Peter Kairouz LAB 2: DTFT, DFT, and DFT Spectral

More information

Laboratory handout 5 Mode shapes and resonance

Laboratory handout 5 Mode shapes and resonance laboratory handouts, me 34 82 Laboratory handout 5 Mode shapes and resonance In this handout, material and assignments marked as optional can be skipped when preparing for the lab, but may provide a useful

More information

Discrete Fourier Transform

Discrete Fourier Transform Discrete Fourier Transform Virtually all practical signals have finite length (e.g., sensor data, audio records, digital images, stock values, etc). Rather than considering such signals to be zero-padded

More information

Modeling the Duffing Equation with an Analog Computer

Modeling the Duffing Equation with an Analog Computer Modeling the Duffing Equation with an Analog Computer Matt Schmitthenner Physics Department, The College of Wooster, Wooster, Ohio 44691, USA (Dated: December 13, 2011) The goal was to model the Duffing

More information

Statistical methods. Mean value and standard deviations Standard statistical distributions Linear systems Matrix algebra

Statistical methods. Mean value and standard deviations Standard statistical distributions Linear systems Matrix algebra Statistical methods Mean value and standard deviations Standard statistical distributions Linear systems Matrix algebra Statistical methods Generating random numbers MATLAB has many built-in functions

More information

Manifesto on Numerical Integration of Equations of Motion Using Matlab

Manifesto on Numerical Integration of Equations of Motion Using Matlab Manifesto on Numerical Integration of Equations of Motion Using Matlab C. Hall April 11, 2002 This handout is intended to help you understand numerical integration and to put it into practice using Matlab

More information

J. McNames Portland State University ECE 223 DT Fourier Series Ver

J. McNames Portland State University ECE 223 DT Fourier Series Ver Overview of DT Fourier Series Topics Orthogonality of DT exponential harmonics DT Fourier Series as a Design Task Picking the frequencies Picking the range Finding the coefficients Example J. McNames Portland

More information

Vibration Testing. an excitation source a device to measure the response a digital signal processor to analyze the system response

Vibration Testing. an excitation source a device to measure the response a digital signal processor to analyze the system response Vibration Testing For vibration testing, you need an excitation source a device to measure the response a digital signal processor to analyze the system response i) Excitation sources Typically either

More information

Centre for Mathematical Sciences HT 2018 Mathematical Statistics

Centre for Mathematical Sciences HT 2018 Mathematical Statistics Lund University Stationary stochastic processes Centre for Mathematical Sciences HT 2018 Mathematical Statistics Computer exercise 1 in Stationary stochastic processes, HT 18. The purpose of this computer

More information

J. McNames Portland State University ECE 223 Sampling Ver

J. McNames Portland State University ECE 223 Sampling Ver Overview of Sampling Topics (Shannon) sampling theorem Impulse-train sampling Interpolation (continuous-time signal reconstruction) Aliasing Relationship of CTFT to DTFT DT processing of CT signals DT

More information

Vibration Testing. Typically either instrumented hammers or shakers are used.

Vibration Testing. Typically either instrumented hammers or shakers are used. Vibration Testing Vibration Testing Equipment For vibration testing, you need an excitation source a device to measure the response a digital signal processor to analyze the system response Excitation

More information

H 2 Optimal State Feedback Control Synthesis. Raktim Bhattacharya Aerospace Engineering, Texas A&M University

H 2 Optimal State Feedback Control Synthesis. Raktim Bhattacharya Aerospace Engineering, Texas A&M University H 2 Optimal State Feedback Control Synthesis Raktim Bhattacharya Aerospace Engineering, Texas A&M University Motivation Motivation w(t) u(t) G K y(t) z(t) w(t) are exogenous signals reference, process

More information

sinc function T=1 sec T=2 sec angle(f(w)) angle(f(w))

sinc function T=1 sec T=2 sec angle(f(w)) angle(f(w)) T=1 sec sinc function 3 angle(f(w)) T=2 sec angle(f(w)) 1 A quick script to plot mag & phase in MATLAB w=0:0.2:50; Real exponential func b=5; Fourier transform (filter) F=1.0./(b+j*w); subplot(211), plot(w,

More information

CALCULATION OF NONLINEAR VIBRATIONS OF PIECEWISE-LINEAR SYSTEMS USING THE SHOOTING METHOD

CALCULATION OF NONLINEAR VIBRATIONS OF PIECEWISE-LINEAR SYSTEMS USING THE SHOOTING METHOD Vietnam Journal of Mechanics, VAST, Vol. 34, No. 3 (2012), pp. 157 167 CALCULATION OF NONLINEAR VIBRATIONS OF PIECEWISE-LINEAR SYSTEMS USING THE SHOOTING METHOD Nguyen Van Khang, Hoang Manh Cuong, Nguyen

More information

Distortion Analysis T

Distortion Analysis T EE 435 Lecture 32 Spectral Performance Windowing Spectral Performance of Data Converters - Time Quantization - Amplitude Quantization Quantization Noise . Review from last lecture. Distortion Analysis

More information

INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters 4. THE BUTTERWORTH ANALOG FILTER

INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters 4. THE BUTTERWORTH ANALOG FILTER INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters. INTRODUCTION 2. IIR FILTER DESIGN 3. ANALOG FILTERS 4. THE BUTTERWORTH ANALOG FILTER 5. THE CHEBYSHEV-I

More information

Discrete-Time Gaussian Fourier Transform Pair, and Generating a Random Process with Gaussian PDF and Power Spectrum Mark A.

Discrete-Time Gaussian Fourier Transform Pair, and Generating a Random Process with Gaussian PDF and Power Spectrum Mark A. Discrete-Time Gaussian Fourier Transform Pair, and Generating a Random Process with Gaussian PDF and Power Spectrum Mark A. Richards October 3, 6 Updated April 5, Gaussian Transform Pair in Continuous

More information

Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros)

Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros) Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros) J. McNames Portland State University ECE 222 Bode Plots Ver.

More information

MAT 275 Laboratory 6 Forced Equations and Resonance

MAT 275 Laboratory 6 Forced Equations and Resonance MAT 275 Laboratory 6 Forced Equations and Resonance In this laboratory we take a deeper look at second-order nonhomogeneous equations. We will concentrate on equations with a periodic harmonic forcing

More information

Figure 18: Top row: example of a purely continuous spectrum (left) and one realization

Figure 18: Top row: example of a purely continuous spectrum (left) and one realization 1..5 S(). -.2 -.5 -.25..25.5 64 128 64 128 16 32 requency time time Lag 1..5 S(). -.5-1. -.5 -.1.1.5 64 128 64 128 16 32 requency time time Lag Figure 18: Top row: example o a purely continuous spectrum

More information

Laboratory 10 Forced Equations and Resonance

Laboratory 10 Forced Equations and Resonance MATLAB sessions: Laboratory 9 Laboratory Forced Equations and Resonance ( 3.6 of the Edwards/Penney text) In this laboratory we take a deeper look at second-order nonhomogeneous equations. We will concentrate

More information

0 for all other times. Suppose further that we sample the signal with a sampling frequency f ;. We can write x # n =

0 for all other times. Suppose further that we sample the signal with a sampling frequency f ;. We can write x # n = PSD, Autocorrelation, and Noise in MATLAB Aaron Scher Energy and power of a signal Consider a continuous time deterministic signal x t. We are specifically interested in analyzing the characteristics of

More information

Driven Harmonic Oscillator

Driven Harmonic Oscillator Driven Harmonic Oscillator Physics 6B Lab Experiment 1 APPARATUS Computer and interface Mechanical vibrator and spring holder Stands, etc. to hold vibrator Motion sensor C-209 spring Weight holder and

More information

Continuous Fourier transform of a Gaussian Function

Continuous Fourier transform of a Gaussian Function Continuous Fourier transform of a Gaussian Function Gaussian function: e t2 /(2σ 2 ) The CFT of a Gaussian function is also a Gaussian function (i.e., time domain is Gaussian, then the frequency domain

More information

ECE382/ME482 Spring 2005 Homework 7 Solution April 17, K(s + 0.2) s 2 (s + 2)(s + 5) G(s) =

ECE382/ME482 Spring 2005 Homework 7 Solution April 17, K(s + 0.2) s 2 (s + 2)(s + 5) G(s) = ECE382/ME482 Spring 25 Homework 7 Solution April 17, 25 1 Solution to HW7 AP9.5 We are given a system with open loop transfer function G(s) = K(s +.2) s 2 (s + 2)(s + 5) (1) and unity negative feedback.

More information

Maps and differential equations

Maps and differential equations Maps and differential equations Marc R. Roussel November 8, 2005 Maps are algebraic rules for computing the next state of dynamical systems in discrete time. Differential equations and maps have a number

More information

Lecture 10. Numerical Solution in Matlab

Lecture 10. Numerical Solution in Matlab 6. Lecture Numerical Solution in Matlab Spr 6 6. Numerical Solutions Most of the problems of interest so far have been complicated by the need to solve a two point boundary value problem. That plus the

More information

Chirp Transform for FFT

Chirp Transform for FFT Chirp Transform for FFT Since the FFT is an implementation of the DFT, it provides a frequency resolution of 2π/N, where N is the length of the input sequence. If this resolution is not sufficient in a

More information

Introduction to Dynamical Systems. Tuesday, September 9, 14

Introduction to Dynamical Systems. Tuesday, September 9, 14 Introduction to Dynamical Systems 1 Dynamical Systems A dynamical system is a set of related phenomena that change over time in a deterministic way. The future states of the system can be predicted from

More information

Chapter 23. Predicting Chaos The Shift Map and Symbolic Dynamics

Chapter 23. Predicting Chaos The Shift Map and Symbolic Dynamics Chapter 23 Predicting Chaos We have discussed methods for diagnosing chaos, but what about predicting the existence of chaos in a dynamical system. This is a much harder problem, and it seems that the

More information

Practical Spectral Estimation

Practical Spectral Estimation Digital Signal Processing/F.G. Meyer Lecture 4 Copyright 2015 François G. Meyer. All Rights Reserved. Practical Spectral Estimation 1 Introduction The goal of spectral estimation is to estimate how the

More information

Overview of Sampling Topics

Overview of Sampling Topics Overview of Sampling Topics (Shannon) sampling theorem Impulse-train sampling Interpolation (continuous-time signal reconstruction) Aliasing Relationship of CTFT to DTFT DT processing of CT signals DT

More information

MAE143A Signals & Systems - Homework 5, Winter 2013 due by the end of class Tuesday February 12, 2013.

MAE143A Signals & Systems - Homework 5, Winter 2013 due by the end of class Tuesday February 12, 2013. MAE43A Signals & Systems - Homework 5, Winter 23 due by the end of class Tuesday February 2, 23. If left under my door, then straight to the recycling bin with it. This week s homework will be a refresher

More information

Memristor Based Chaotic Circuits

Memristor Based Chaotic Circuits Memristor Based Chaotic Circuits Bharathwaj Muthuswamy Electrical Engineering and Computer Sciences University of California at Berkeley Technical Report No. UCB/EECS-2009-6 http://www.eecs.berkeley.edu/pubs/techrpts/2009/eecs-2009-6.html

More information

Signals, Instruments, and Systems W5. Introduction to Signal Processing Sampling, Reconstruction, and Filters

Signals, Instruments, and Systems W5. Introduction to Signal Processing Sampling, Reconstruction, and Filters Signals, Instruments, and Systems W5 Introduction to Signal Processing Sampling, Reconstruction, and Filters Acknowledgments Recapitulation of Key Concepts from the Last Lecture Dirac delta function (

More information

System Control Engineering 0

System Control Engineering 0 System Control Engineering 0 Koichi Hashimoto Graduate School of Information Sciences Text: Nonlinear Control Systems Analysis and Design, Wiley Author: Horacio J. Marquez Web: http://www.ic.is.tohoku.ac.jp/~koichi/system_control/

More information

New Mexico Tech Hyd 510

New Mexico Tech Hyd 510 Vectors vector - has magnitude and direction (e.g. velocity, specific discharge, hydraulic gradient) scalar - has magnitude only (e.g. porosity, specific yield, storage coefficient) unit vector - a unit

More information

TTT4120 Digital Signal Processing Suggested Solutions for Problem Set 2

TTT4120 Digital Signal Processing Suggested Solutions for Problem Set 2 Norwegian University of Science and Technology Department of Electronics and Telecommunications TTT42 Digital Signal Processing Suggested Solutions for Problem Set 2 Problem (a) The spectrum X(ω) can be

More information

COMPLEX DYNAMICS AND CHAOS CONTROL IN DUFFING-VAN DER POL EQUATION WITH TWO EXTERNAL PERIODIC FORCING TERMS

COMPLEX DYNAMICS AND CHAOS CONTROL IN DUFFING-VAN DER POL EQUATION WITH TWO EXTERNAL PERIODIC FORCING TERMS International J. of Math. Sci. & Engg. Appls. (IJMSEA) ISSN 0973-9424, Vol. 9 No. III (September, 2015), pp. 197-210 COMPLEX DYNAMICS AND CHAOS CONTROL IN DUFFING-VAN DER POL EQUATION WITH TWO EXTERNAL

More information

MAE 143B - Homework 7

MAE 143B - Homework 7 MAE 143B - Homework 7 6.7 Multiplying the first ODE by m u and subtracting the product of the second ODE with m s, we get m s m u (ẍ s ẍ i ) + m u b s (ẋ s ẋ u ) + m u k s (x s x u ) + m s b s (ẋ s ẋ u

More information

EE 435. Lecture 32. Spectral Performance Windowing

EE 435. Lecture 32. Spectral Performance Windowing EE 435 Lecture 32 Spectral Performance Windowing . Review from last lecture. Distortion Analysis T 0 T S THEOREM?: If N P is an integer and x(t) is band limited to f MAX, then 2 Am Χ mnp 1 0 m h N and

More information

LAB 6: FIR Filter Design Summer 2011

LAB 6: FIR Filter Design Summer 2011 University of Illinois at Urbana-Champaign Department of Electrical and Computer Engineering ECE 311: Digital Signal Processing Lab Chandra Radhakrishnan Peter Kairouz LAB 6: FIR Filter Design Summer 011

More information

LAB #6 The Swaying Building

LAB #6 The Swaying Building LAB #6 The Swaying Building Goal: Determine a model of the swaying of a skyscraper; estimating parameters Required tools: Matlab routines pplane, ode45, plot; M-files; systems of differential equations.

More information

1-DOF Forced Harmonic Vibration. MCE371: Vibrations. Prof. Richter. Department of Mechanical Engineering. Handout 8 Fall 2011

1-DOF Forced Harmonic Vibration. MCE371: Vibrations. Prof. Richter. Department of Mechanical Engineering. Handout 8 Fall 2011 MCE371: Vibrations Prof. Richter Department of Mechanical Engineering Handout 8 Fall 2011 Harmonic Forcing Functions Transient vs. Steady Vibration Follow Palm, Sect. 4.1, 4.9 and 4.10 Harmonic forcing

More information

Computer Exercise 0 Simulation of ARMA-processes

Computer Exercise 0 Simulation of ARMA-processes Lund University Time Series Analysis Mathematical Statistics Fall 2018 Centre for Mathematical Sciences Computer Exercise 0 Simulation of ARMA-processes The purpose of this computer exercise is to illustrate

More information

Lesson 4: Non-fading Memory Nonlinearities

Lesson 4: Non-fading Memory Nonlinearities Lesson 4: Non-fading Memory Nonlinearities Nonlinear Signal Processing SS 2017 Christian Knoll Signal Processing and Speech Communication Laboratory Graz University of Technology June 22, 2017 NLSP SS

More information

INTRODUCTION TO DELTA-SIGMA ADCS

INTRODUCTION TO DELTA-SIGMA ADCS ECE1371 Advanced Analog Circuits Lecture 1 INTRODUCTION TO DELTA-SIGMA ADCS Richard Schreier richard.schreier@analog.com Trevor Caldwell trevor.caldwell@utoronto.ca Course Goals Deepen understanding of

More information

Chapter 3. Data Analysis

Chapter 3. Data Analysis Chapter 3 Data Analysis The analysis of the measured track data is described in this chapter. First, information regarding source and content of the measured track data is discussed, followed by the evaluation

More information

3. Lecture. Fourier Transformation Sampling

3. Lecture. Fourier Transformation Sampling 3. Lecture Fourier Transformation Sampling Some slides taken from Digital Image Processing: An Algorithmic Introduction using Java, Wilhelm Burger and Mark James Burge Separability ² The 2D DFT can be

More information

Advanced Laser Technologies Homework #2

Advanced Laser Technologies Homework #2 Advanced Laser Technologies Homework #2 Chih-Han Lin student ID: r99245002 Graduate Institute of Applied Physics, National Taiwan University I. DEMONSTRATION OF MODE-LOCKING PULSES Assume that complex

More information

Chaotic Vibrations. An Introduction for Applied Scientists and Engineers

Chaotic Vibrations. An Introduction for Applied Scientists and Engineers Chaotic Vibrations An Introduction for Applied Scientists and Engineers FRANCIS C. MOON Theoretical and Applied Mechanics Cornell University Ithaca, New York A WILEY-INTERSCIENCE PUBLICATION JOHN WILEY

More information

Notes perso. - cb1 1. Version 3 - November u(t)e i2πft dt u(t) =

Notes perso. - cb1 1. Version 3 - November u(t)e i2πft dt u(t) = Notes perso. - cb1 1 Tutorial : fft, psd & coherence with Matlab Version 3 - November 01 1 Fourier transform by Fast Fourier Transform (FFT) Definition of the Fourier transform : û(f) = F[u(t)] = As an

More information

Windowing Overview Relevance Main lobe/side lobe tradeoff Popular windows Examples

Windowing Overview Relevance Main lobe/side lobe tradeoff Popular windows Examples ing Overview Relevance Main lobe/side lobe tradeoff Popular windows Examples ing In practice, we cannot observe a signal x(n) for n = to n = Thus we must truncate, or window, the signal: x(n) w(n) ing

More information

Filtering via Rank-Reduced Hankel Matrix CEE 690, ME 555 System Identification Fall, 2013 c H.P. Gavin, September 24, 2013

Filtering via Rank-Reduced Hankel Matrix CEE 690, ME 555 System Identification Fall, 2013 c H.P. Gavin, September 24, 2013 Filtering via Rank-Reduced Hankel Matrix CEE 690, ME 555 System Identification Fall, 2013 c H.P. Gavin, September 24, 2013 This method goes by the terms Structured Total Least Squares and Singular Spectrum

More information

Physics with Matlab and Mathematica Exercise #1 28 Aug 2012

Physics with Matlab and Mathematica Exercise #1 28 Aug 2012 Physics with Matlab and Mathematica Exercise #1 28 Aug 2012 You can work this exercise in either matlab or mathematica. Your choice. A simple harmonic oscillator is constructed from a mass m and a spring

More information

Homework 1 Solutions

Homework 1 Solutions 18-9 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 18 Homework 1 Solutions Part One 1. (8 points) Consider the DT signal given by the algorithm: x[] = 1 x[1] = x[n] = x[n 1] x[n ] (a) Plot

More information

AMS 27L LAB #8 Winter 2009

AMS 27L LAB #8 Winter 2009 AMS 27L LAB #8 Winter 29 Solving ODE s in Matlab Objectives:. To use Matlab s ODE Solvers 2. To practice using functions and in-line functions Matlab s ODE Suite Matlab offers a suite of ODE solvers including:

More information

MATLAB crash course 1 / 27. MATLAB crash course. Cesar E. Tamayo Economics - Rutgers. September 27th, /27

MATLAB crash course 1 / 27. MATLAB crash course. Cesar E. Tamayo Economics - Rutgers. September 27th, /27 1/27 MATLAB crash course 1 / 27 MATLAB crash course Cesar E. Tamayo Economics - Rutgers September 27th, 2013 2/27 MATLAB crash course 2 / 27 Program Program I Interface: layout, menus, help, etc.. I Vectors

More information

ELEG 305: Digital Signal Processing

ELEG 305: Digital Signal Processing ELEG 305: Digital Signal Processing Lecture : Design of Digital IIR Filters (Part I) Kenneth E. Barner Department of Electrical and Computer Engineering University of Delaware Fall 008 K. E. Barner (Univ.

More information

Abstract: Complex responses observed in an experimental, nonlinear, moored structural

Abstract: Complex responses observed in an experimental, nonlinear, moored structural AN INDEPENDENT-FLOW-FIELD MODEL FOR A SDOF NONLINEAR STRUCTURAL SYSTEM, PART II: ANALYSIS OF COMPLEX RESPONSES Huan Lin e-mail: linh@engr.orst.edu Solomon C.S. Yim e-mail: solomon.yim@oregonstate.edu Ocean

More information

Lecture 1: A Preliminary to Nonlinear Dynamics and Chaos

Lecture 1: A Preliminary to Nonlinear Dynamics and Chaos Lecture 1: A Preliminary to Nonlinear Dynamics and Chaos Autonomous Systems A set of coupled autonomous 1st-order ODEs. Here "autonomous" means that the right hand side of the equations does not explicitly

More information

Nonlinear Dynamic Systems Homework 1

Nonlinear Dynamic Systems Homework 1 Nonlinear Dynamic Systems Homework 1 1. A particle of mass m is constrained to travel along the path shown in Figure 1, which is described by the following function yx = 5x + 1x 4, 1 where x is defined

More information

HOMEWORK 3: Phase portraits for Mathmatical Models, Analysis and Simulation, Fall 2010 Report due Mon Oct 4, Maximum score 7.0 pts.

HOMEWORK 3: Phase portraits for Mathmatical Models, Analysis and Simulation, Fall 2010 Report due Mon Oct 4, Maximum score 7.0 pts. HOMEWORK 3: Phase portraits for Mathmatical Models, Analysis and Simulation, Fall 2010 Report due Mon Oct 4, 2010. Maximum score 7.0 pts. Three problems are to be solved in this homework assignment. The

More information

Principles of Optimal Control Spring 2008

Principles of Optimal Control Spring 2008 MIT OpenCourseWare http://ocw.mit.edu 16.323 Principles of Optimal Control Spring 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. 16.323 Lecture

More information

[ ], [ ] [ ] [ ] = [ ] [ ] [ ]{ [ 1] [ 2]

[ ], [ ] [ ] [ ] = [ ] [ ] [ ]{ [ 1] [ 2] 4. he discrete Fourier transform (DF). Application goal We study the discrete Fourier transform (DF) and its applications: spectral analysis and linear operations as convolution and correlation. We use

More information

MAT 275 Laboratory 6 Forced Equations and Resonance

MAT 275 Laboratory 6 Forced Equations and Resonance MATLAB sessions: Laboratory 6 MAT 275 Laboratory 6 Forced Equations and Resonance In this laboratory we take a deeper look at second-order nonhomogeneous equations. We will concentrate on equations with

More information

Experiment A11 Chaotic Double Pendulum Procedure

Experiment A11 Chaotic Double Pendulum Procedure AME 21216: Lab I Fall 2017 Experiment A11 Chaotic Double Pendulum Procedure Deliverables: Checked lab notebook, plots with captions Background Measuring and controlling the angular position and velocity

More information

Homework 5 Solutions

Homework 5 Solutions 18-290 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 2017 Homework 5 Solutions Part One 1. (18 points) For each of the following impulse responses, determine whether the corresponding LTI

More information

HW13 Solutions. Pr (a) The DTFT of c[n] is. C(e jω ) = 0.5 m e jωm e jω + 1

HW13 Solutions. Pr (a) The DTFT of c[n] is. C(e jω ) = 0.5 m e jωm e jω + 1 HW3 Solutions Pr..8 (a) The DTFT of c[n] is C(e jω ) = = =.5 n e jωn + n=.5e jω + n= m=.5 n e jωn.5 m e jωm.5e jω +.5e jω.75 =.5 cos(ω) }{{}.5e jω /(.5e jω ) C(e jω ) is the power spectral density. (b)

More information

BME 50500: Image and Signal Processing in Biomedicine. Lecture 5: Correlation and Power-Spectrum CCNY

BME 50500: Image and Signal Processing in Biomedicine. Lecture 5: Correlation and Power-Spectrum CCNY 1 BME 50500: Image and Signal Processing in Biomedicine Lecture 5: Correlation and Power-Spectrum Lucas C. Parra Biomedical Engineering Department CCNY http://bme.ccny.cuny.edu/faculty/parra/teaching/signal-and-image/

More information

Data Assimilation Research Testbed Tutorial. Section 7: Some Additional Low-Order Models

Data Assimilation Research Testbed Tutorial. Section 7: Some Additional Low-Order Models Data Assimilation Research Testbed Tutorial Section 7: Some Additional Low-Order Models Version.: September, 6 /home/jla/dart_tutorial/dart/tutorial/section7/tut_section7.fm 1 7/13/7 Low-order models in

More information

Article (peer-reviewed)

Article (peer-reviewed) Title Author(s) Influence of noise intensity on the spectrum of an oscillator Swain, Rabi Sankar; Gleeson, James P.; Kennedy, Michael Peter Publication date 2005-11 Original citation Type of publication

More information