Dynamical Systems & Scientic Computing: Homework Assignments

Size: px
Start display at page:

Download "Dynamical Systems & Scientic Computing: Homework Assignments"

Transcription

1 Fakultäten für Informatik & Mathematik Technische Universität München Dr. Tobias Neckel Summer Term Dr. Florian Rupp Exercise Sheet 3 Dynamical Systems & Scientic Computing: Homework Assignments 3. [ ] Application of the Routh-Hurwitz Method) Apply the Routh-Hurwitz method to determine the location of all roots of the following polynomials: a) px) = 3x + 5, b) px) = x 5x, c) px) = 53x 57x + 89, d) px) = x + x )x + x + ), and e) px) = x 3 + 5x + x 3. Solution: In the following the components of the polynomial are denoted as px) = a n x n + a n x n a a) The rst polynomial has degree and hence we only have to determine, which is given by = a n = 5 and a n = 3. Now we calculate the number of sign changes k according to the Routh-Hurwitz theorem as k = V a n, ) = V 3, 5) =. In this case we know, that the only root is in the left half-plane, i.e. it has negative real part and the stability criterion is satised. b) The degree of the second polynomial is. Therefore we have to calculate and : = a n = 5 an = det a n =. a n Thus k calculates as k = V a n,, ) = V a n )) )) 5 = det = 5, 5, 5 ) = V, 5, ) =. 5 This means that all roots are in the left half-plane. For the Routh-Hurwitz theorem we have to consider a n = 5 = and = 5. Both values are positive, which means that all roots have negative real part. c) The degree of this polynomial is as well and the determinants calculate as = 57 )) 57 = det = = a n = 53.

2 By this k is given by k = V 53, 57, 773 ) = V 53, 57, 89) =. 57 Since there are two sign changes k =, we know that both roots are in the right half-plane and hence the Routh-Hurwitz stability criterion is not satised in this case. d) This polynomial is given as the product of two factors. In order to make sure that all roots have negative real part the Routh-Hurwitz stability criterion must be satised for both factors. We denote the factors as follows q x) = x + x q x) = x + x + and our polynomial is then px) = q x) q x). At rst we analyse q. Since the degree of q is, we calculate and as and for k follows k = V = = det a n = )) =,, ) = V,, ) =. This means that there is a root of q in the right half-plane. Because all roots of q are also roots of p, there is at least one root of p in the right half-plane. Thus the Routh-Hurwitz stability criterion cannot be satised for p and we are done here. e) The last polynomial has degree 3 and we need to calculate, and 3 as follows = 5 )) )) an a = det n = det = = 53 a n a n a n a n = det a n a n = det = 5 9 = 59 a n a n a n =. For k we have k = V a n,,, ) 3 = V, 5, 53 5, 59 ) = 53 and hence this polynomial is not stable either, since there is one root with positive real part. 3. [ ] plementation of the Routh-Hurwitz Algorithm) plement the Routh-Hurwitz method for determining the location of the roots of a polynomial of degree 4 within the complex plane in Matlab. Use the Matlab root nding methods to plot the roots in the complex plane. a) Test your code against the analytic results derived in exercise 3.. b) Apply your code to determine the stability of the zero solution of the linear oscillator dierential equation ẍt) + cdẋt) + d xt) =, x C R, R), with constants c =.64 and d = 5.56, cf. exercise.4.

3 c) Finally, consider the parameters c and d from part b) to be arbitrary, i.e., c, d) R. Dene a function depending on c and d that is positive if the origin is asymptotically stable in exercise b), zero if the origin is stable and negative if the origin is unstable. Plot the graph of this function against the c-d-plane. Solution: We implement the Routh-Hurwitz algortihm with the help of MATLABs determinant function det). The notation for the polynomial of degree 4 is fz) = α z 4 + α z 3 + α 3 z + α 4 z + α 5, by this the vector alpha contains the coecients in a descent order. coecient Matrix as α α 4 A = α α 3 α 5 α α 4. α 3 α 5 Then the determinants easily calculate in MATLAB notation as: Thus we initialize the Delta)=alpha_; Delta)=detA:,:)); Delta3)=detA:3,:3)); Delta4)=detA); And the sign change can be checked by a simple if condition. If the polynomial has a lower degree, then α takes the place of the highest order coecient, e.g. for a polynomial of degree we have fz) = α z + α z + α 3 and α 4 = α 5 =. By this the input for the algorithm does not change and we can use it for any degree smaller or equal 4. Now we are able to test the obtained algorithm for the polynomials from 3.. a) We notice that our results from 3. coincide with the results obtained by the algorithm, as we see in Figure -3. The number of roots with positive real part are precisely derived Figure : Roots of the polynomial from 3. a.) left) and 3. b.) right).

4 Figure : Roots of the polynomial from 3. c.) left) and 3. d.) right) Figure 3: Roots of the polynomial from 3. e.). b) Since the dierential equation is linear and homogeneous) we simply obtain the characteristic polynomial as fz) = z + cdz + d Applying our algorithm we obtain that there are no roots with real part greater than. In fact we have x = i, x = i. c) The idea is to nd a suitable function, that changes signs with the stability. Hence it should be negative, if there are any roots of the characteristic polynomial with positive real part. We take a look at the Hurwitz determinants, which are in this case = cd, = cd 3 and hence for the function of sign changes we have k = V, cd, d ). We easily recognize, that the number of sign changes k is either or and depends only on the second argument cd. Thus we dene the stability indicating function as hc, d) = cd. This function is positive if the zero solution is asymptotically stable and negative if not. For

5 c = we have a stable solution, but if d = the solution is already unstable, since the two roots are both exactly and the dierential equation reduces to ẍ =. In order to satisfy the condition that hc, d) is only if the zero solution is stable we need to make a minor adjustment to { cd, for c, d) R \{d = } hc, d) =. ), if d = See Figure 4 for the contour plot Figure 4: Contour plot of the stability indicating function hc, d) as given in ). The jump at d = can be seen if one looks closely. 3.3 [ ] Application of the Lozinskii-Measure) In an article by Rupp and Scheurle [3]) a reduced model for sh-jellysh interactions is proposed, where sh being assumed to represent the dominant predatory species feeding on jellysh. This model is given by the following set of coupled non-linear ordinary dierential equations ẋ = c + y + y ) x x, and ẏ = β d x + y where c R and β, d > are parameters, and x denotes the sh population whereas y stands for the jellysh population, respectively. a) Show that the origin is an equilibrium and give the linearization of the equations at this point. ) y, b) Apply the method of Lozinskii-Measures to determine linearized) stability of the origin. Solution: ) ) a) We have that c + y +y x x = for x = and β d x +y y = for y =. Thus, the origin x, y) =, ) is an equilibrium. At any evaluation point x, y) = ξ, η ) the right

6 hand side's matrix Jξ, η ) of linearization evaluated at this point reads as Jξ, η ) = c + η +η ξ ξ +η ). βd η ξ +η β dβ +η ) In particular, the matrix of linearizion evaluated at the origin reads as J, ) = diagc, β). Its eigenvalues are thus given by λ = c corresponding to the eigenvector e =, ) T and λ = β corresponding to the eigenvector e =, ) T. I.e., from the principle of linearized stability we immediately have asymptotic stability if both c and β are negative. Due to our restriction β > the origin can hence be at best of saddle-type. b) To apply the Lozinskii-measure method, we require the second compound matrix A [] of our matrix Jξ, η ) = a i,j ) i,j=,, and ) detjξ, η )). Here, A [] is just a scalar and reads as and A [] = a + a = trjξ, η )) = c + η + η ξ + β dβ + η ) = c + β =: K for ξ, η ) =, ) ) detj, )) = cβ =: K. In the lecture, we had the following theorem: Let A R d d. For sa) < it is sucient and necessary that sa [] ) < and ) d deta) >. Here, K > if and only if c, β > or c, β <. Moreover, K = sa [] ) < holds, together with K > only in the case c, β <. Thus, for c, β < we would have asymptotic stability. 3.4 [ ] RDE Properties) In order to describe in some qualitative manner the nature of an earthquake disturbance, Bogdano et al. [], [], considered the following model for ground accelerations yt) = n ta j exp α j t) cosω j t + Θ j ), for t, and yt) = for t <, ) j= where a j, α j and ω j are given real positive numbers and the parameters Θ j are independent random variables uniformly distributed over an interval of length π. Let us assume a one-story building that is at rest at t = and let Xt), t, denote the relative horizontal displacement of its roof with respect to the ground. Then, based upon an idealized linear model, the relative displacement Xt) subject to ground accelerations is governed by a) Show that 3) has a path-wise solution. b) Compute this solution analytically. Solution: ẍt) + ζω ẋt) + ω xt) = yt), for t. 3) a) We apply the following theorem: Theorem Existence & Uniqueness of Path-Wise Solutions): Let Ω, A, P) be a probability space and the following three prerequisites be satised: a) The functions fx, t, ω) are A-measurable for all x, t) R d I. b) fx, t, ω) is continuous on R d I for almost all ω Ω. c) For almost all ω Ω there is a real continuous function Lt, ω) on I such that where t I and x, x R d. fx, t, ω) fx, t, ω) Lt, ω) x x, ξ

7 Then for any initial condition X, t ) S d there exists an unique path-wise solution on I of the random dierential equation dx t dt = fx t ), t, ω), X t ) R d. The required conditions hold in our example: a) With z := x, x ) T we have fz, t, ϖ) = ) } ω ζω {{ } =: A + yt, ϖ) with a constant matrix A. The process yt, ) : Ω R is measurable, as the pre-image of every measurable set in R is measurable w.r.t. A. Thus, f is measurable, too, for all x, t) R R. b) For any xed ϖ Ω the stochastic process y, ϖ) is continuous as a composition products, nite sum) of continuous functions. Hence, f,, ϖ) is continuous on R R. c) Finally, ), fz, t, ϖ) fz, t, ϖ) = Az z ) A z z. b) As shown in the lecture, we can compute the general solution X t of 3) explicitly analogous to the deterministic case. I.e., let Qt) be the fundamental matrix of the homogeneous system ż = Az, then for all initial conditions X S it holds that X t t = Qt)X + Qt) Q s)z s ds, t Z t =, yt, ϖ)) T, is the unique path-wise solution of 3). Compare with exercise. to obtain the fundamental solutions of ż = Az the techniques are essentially the same). 3.5 [ ] RDE Simulation) For equation 3) let the parameters be given according to [], p.67, as ω = [rad/ sec] and ζ =.5. a) Let yt) be the stochastic process dened by ) the coecients of which are given according to [], p.67, as ω = 6 [rad/ sec], ω = 8 [rad/ sec], ω 3 = [rad/ sec], ω 4 =.5 [rad/ sec], ω 5 =, 75 [rad/ sec], ω 6 =..., ω = [rad/ sec], ω =.5 [rad/ sec], ω 3 = 3.5 [rad/ sec], ω 4 = 5 [rad/ sec], ω 5 = 7 [rad/ sec], ω 6 = 9 [rad/ sec], ω 7 = 3.5 [rad/ sec], ω 8 = 3 [rad/ sec], ω 9 = 34 [rad/ sec], ω = 36 [rad/ sec], as well as α = = α = /3, a = = a =.5. Plot yt) against the time t [, ]. b) Apply the usual deterministic) Euler scheme to solve 3) for the given parameter values. c) Apply the usual deterministic) Heun scheme to solve 3) for the given parameter values. d) Compare the solution from b) and c) with the analytical solution obtained in 3.4 b). Solution: a) For the uniformly distributed random variables Θ j we are using the MATLAB expression theta=*pi*unifrnd,*pi,,); by this the resulting function yt) is plotted in Figure 5. We note that yt) is highly oscillating, as we would suspect for a suitable model for the ground acceleration of an earthquake.

8 4 3 yt) time t Figure 5: The ground acceleration yt) plotted in the interval [, ]. b+c) At rst we take a look at the solution in the x ẋ-phase plane in Figure 6. We used the initial condition x) = and ẋ =, i.e. the building is at rest at t =. We see that the acceleration ẋ increases quite fast and alternates between positive and negative acceleration. Linked to that the dislocation xt) alternates as well. The solutions produced by the Euler and Heun scheme behave similar, in Figure 7 the convergence of the known methods is illustrated. Like in problem.4 the convergence rate of the implicit and explicit Euler is O h), but the implicit Euler produces an useful solution even for small step sizes. The Heun scheme has a convergence rate of O h ), which is clearly illustrated in the convergence plot. Like the explicit Euler, the Heun scheme needs a minimal step size to produce an accurate solution. d) Classication: easy, easy with longer calculations, a little bit dicult, challenging. ferences [] J.L. Bogdanoff, J.E. Goldberg and M.C. Bernard 96): sponse of a Simple Structure to a Random Earthquake-Type Disturbance, Bull. Seism. Soc. Amer., 5, pp [] J.E. Goldberg, J.L. Bogdanoff, and D.R. Sharpe 964): The sponse of Simple Nonlinear Systems to Random Disturbance of the Earthquake Type, Bull. Seism. Soc. Amer., 54, pp

9 .5.4 plicit Euler Starting point Endpoint Heun Figure 6: Solution in the x ẋ-phase plane. Explicit Euler plicit Euler Heun Accuracy Number of steps Figure 7: Convergence of the dierent methods compared to a high order solution computed with MATLAB. [3] F. Rupp and J. Scheurle ): On the Jellysh Joyride: Mathematical Analysis of Catastrophes in Maritime Ecosystems, to appear at the proceedings of the 9th AIMS Conference on Dynamical Systems.

MAT 22B - Lecture Notes

MAT 22B - Lecture Notes MAT 22B - Lecture Notes 4 September 205 Solving Systems of ODE Last time we talked a bit about how systems of ODE arise and why they are nice for visualization. Now we'll talk about the basics of how to

More information

Stability of Feedback Solutions for Infinite Horizon Noncooperative Differential Games

Stability of Feedback Solutions for Infinite Horizon Noncooperative Differential Games Stability of Feedback Solutions for Infinite Horizon Noncooperative Differential Games Alberto Bressan ) and Khai T. Nguyen ) *) Department of Mathematics, Penn State University **) Department of Mathematics,

More information

Modeling and Analysis of Dynamic Systems

Modeling and Analysis of Dynamic Systems Modeling and Analysis of Dynamic Systems Dr. Guillaume Ducard Fall 2017 Institute for Dynamic Systems and Control ETH Zurich, Switzerland G. Ducard c 1 / 57 Outline 1 Lecture 13: Linear System - Stability

More information

Chapter 4: First-order differential equations. Similarity and Transport Phenomena in Fluid Dynamics Christophe Ancey

Chapter 4: First-order differential equations. Similarity and Transport Phenomena in Fluid Dynamics Christophe Ancey Chapter 4: First-order differential equations Similarity and Transport Phenomena in Fluid Dynamics Christophe Ancey Chapter 4: First-order differential equations Phase portrait Singular point Separatrix

More information

Dynamical Systems. August 13, 2013

Dynamical Systems. August 13, 2013 Dynamical Systems Joshua Wilde, revised by Isabel Tecu, Takeshi Suzuki and María José Boccardi August 13, 2013 Dynamical Systems are systems, described by one or more equations, that evolve over time.

More information

Controls Problems for Qualifying Exam - Spring 2014

Controls Problems for Qualifying Exam - Spring 2014 Controls Problems for Qualifying Exam - Spring 2014 Problem 1 Consider the system block diagram given in Figure 1. Find the overall transfer function T(s) = C(s)/R(s). Note that this transfer function

More information

Math Ordinary Differential Equations

Math Ordinary Differential Equations Math 411 - Ordinary Differential Equations Review Notes - 1 1 - Basic Theory A first order ordinary differential equation has the form x = f(t, x) (11) Here x = dx/dt Given an initial data x(t 0 ) = x

More information

7 Planar systems of linear ODE

7 Planar systems of linear ODE 7 Planar systems of linear ODE Here I restrict my attention to a very special class of autonomous ODE: linear ODE with constant coefficients This is arguably the only class of ODE for which explicit solution

More information

Worksheet 8 Sample Solutions

Worksheet 8 Sample Solutions Technische Universität München WS 2016/17 Lehrstuhl für Informatik V Scientific Computing Univ.-Prof. Dr. M. Bader 19.12.2016/21.12.2016 M.Sc. S. Seckler, M.Sc. D. Jarema Worksheet 8 Sample Solutions Ordinary

More information

+ i. cos(t) + 2 sin(t) + c 2.

+ i. cos(t) + 2 sin(t) + c 2. MATH HOMEWORK #7 PART A SOLUTIONS Problem 7.6.. Consider the system x = 5 x. a Express the general solution of the given system of equations in terms of realvalued functions. b Draw a direction field,

More information

1. Find the solution of the following uncontrolled linear system. 2 α 1 1

1. Find the solution of the following uncontrolled linear system. 2 α 1 1 Appendix B Revision Problems 1. Find the solution of the following uncontrolled linear system 0 1 1 ẋ = x, x(0) =. 2 3 1 Class test, August 1998 2. Given the linear system described by 2 α 1 1 ẋ = x +

More information

Practical Course Scientific Computing and Visualization

Practical Course Scientific Computing and Visualization Technische Universität München WT 007/00 Institut für Informatik Dr. Miriam Mehl Tobias Weinzierl Csaba Vigh Practical Course Scientific Computing and Visualization Worksheet distributed: 07..007 due to:

More information

ENGI 9420 Lecture Notes 4 - Stability Analysis Page Stability Analysis for Non-linear Ordinary Differential Equations

ENGI 9420 Lecture Notes 4 - Stability Analysis Page Stability Analysis for Non-linear Ordinary Differential Equations ENGI 940 Lecture Notes 4 - Stability Analysis Page 4.01 4. Stability Analysis for Non-linear Ordinary Differential Equations A pair of simultaneous first order homogeneous linear ordinary differential

More information

MATH 215/255 Solutions to Additional Practice Problems April dy dt

MATH 215/255 Solutions to Additional Practice Problems April dy dt . For the nonlinear system MATH 5/55 Solutions to Additional Practice Problems April 08 dx dt = x( x y, dy dt = y(.5 y x, x 0, y 0, (a Show that if x(0 > 0 and y(0 = 0, then the solution (x(t, y(t of the

More information

ACM/CMS 107 Linear Analysis & Applications Fall 2016 Assignment 4: Linear ODEs and Control Theory Due: 5th December 2016

ACM/CMS 107 Linear Analysis & Applications Fall 2016 Assignment 4: Linear ODEs and Control Theory Due: 5th December 2016 ACM/CMS 17 Linear Analysis & Applications Fall 216 Assignment 4: Linear ODEs and Control Theory Due: 5th December 216 Introduction Systems of ordinary differential equations (ODEs) can be used to describe

More information

ẋ = f(x, y), ẏ = g(x, y), (x, y) D, can only have periodic solutions if (f,g) changes sign in D or if (f,g)=0in D.

ẋ = f(x, y), ẏ = g(x, y), (x, y) D, can only have periodic solutions if (f,g) changes sign in D or if (f,g)=0in D. 4 Periodic Solutions We have shown that in the case of an autonomous equation the periodic solutions correspond with closed orbits in phase-space. Autonomous two-dimensional systems with phase-space R

More information

4.1 Eigenvalues, Eigenvectors, and The Characteristic Polynomial

4.1 Eigenvalues, Eigenvectors, and The Characteristic Polynomial Linear Algebra (part 4): Eigenvalues, Diagonalization, and the Jordan Form (by Evan Dummit, 27, v ) Contents 4 Eigenvalues, Diagonalization, and the Jordan Canonical Form 4 Eigenvalues, Eigenvectors, and

More information

LECTURE 15 + C+F. = A 11 x 1x1 +2A 12 x 1x2 + A 22 x 2x2 + B 1 x 1 + B 2 x 2. xi y 2 = ~y 2 (x 1 ;x 2 ) x 2 = ~x 2 (y 1 ;y 2 1

LECTURE 15 + C+F. = A 11 x 1x1 +2A 12 x 1x2 + A 22 x 2x2 + B 1 x 1 + B 2 x 2. xi y 2 = ~y 2 (x 1 ;x 2 ) x 2 = ~x 2 (y 1 ;y 2  1 LECTURE 5 Characteristics and the Classication of Second Order Linear PDEs Let us now consider the case of a general second order linear PDE in two variables; (5.) where (5.) 0 P i;j A ij xix j + P i,

More information

pendulum is moving together with disc until returned point in which he will returned back. In this paper we will investigate the existence and stabili

pendulum is moving together with disc until returned point in which he will returned back. In this paper we will investigate the existence and stabili PERIODIC MOTIONS IN VSS AND SINGULAR PERTURBATIONS LEONID FRIDMAN Division of Postgraduate and Investigation, Chihuahua Institute of Technology, Av. Tecnologico 2909, Chihuahua, Chih., 31310, Mexico e-mail:lfridman@itch.edu.mx

More information

1.7. Stability and attractors. Consider the autonomous differential equation. (7.1) ẋ = f(x),

1.7. Stability and attractors. Consider the autonomous differential equation. (7.1) ẋ = f(x), 1.7. Stability and attractors. Consider the autonomous differential equation (7.1) ẋ = f(x), where f C r (lr d, lr d ), r 1. For notation, for any x lr d, c lr, we let B(x, c) = { ξ lr d : ξ x < c }. Suppose

More information

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems.

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems. Review Outline To review for the final, look over the following outline and look at problems from the book and on the old exam s and exam reviews to find problems about each of the following topics.. Basics

More information

3.3. SYSTEMS OF ODES 1. y 0 " 2y" y 0 + 2y = x1. x2 x3. x = y(t) = c 1 e t + c 2 e t + c 3 e 2t. _x = A x + f; x(0) = x 0.

3.3. SYSTEMS OF ODES 1. y 0  2y y 0 + 2y = x1. x2 x3. x = y(t) = c 1 e t + c 2 e t + c 3 e 2t. _x = A x + f; x(0) = x 0. .. SYSTEMS OF ODES. Systems of ODEs MATH 94 FALL 98 PRELIM # 94FA8PQ.tex.. a) Convert the third order dierential equation into a rst oder system _x = A x, with y " y" y + y = x = @ x x x b) The equation

More information

Nonlinear Autonomous Systems of Differential

Nonlinear Autonomous Systems of Differential Chapter 4 Nonlinear Autonomous Systems of Differential Equations 4.0 The Phase Plane: Linear Systems 4.0.1 Introduction Consider a system of the form x = A(x), (4.0.1) where A is independent of t. Such

More information

State will have dimension 5. One possible choice is given by y and its derivatives up to y (4)

State will have dimension 5. One possible choice is given by y and its derivatives up to y (4) A Exercise State will have dimension 5. One possible choice is given by y and its derivatives up to y (4 x T (t [ y(t y ( (t y (2 (t y (3 (t y (4 (t ] T With this choice we obtain A B C [ ] D 2 3 4 To

More information

3 Stability and Lyapunov Functions

3 Stability and Lyapunov Functions CDS140a Nonlinear Systems: Local Theory 02/01/2011 3 Stability and Lyapunov Functions 3.1 Lyapunov Stability Denition: An equilibrium point x 0 of (1) is stable if for all ɛ > 0, there exists a δ > 0 such

More information

Constrained Leja points and the numerical solution of the constrained energy problem

Constrained Leja points and the numerical solution of the constrained energy problem Journal of Computational and Applied Mathematics 131 (2001) 427 444 www.elsevier.nl/locate/cam Constrained Leja points and the numerical solution of the constrained energy problem Dan I. Coroian, Peter

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

Periodic solutions of the perturbed symmetric Euler top

Periodic solutions of the perturbed symmetric Euler top Periodic solutions of the perturbed symmetric Euler top Universitatea Babeş-Bolyai (Cluj-Napoca, Romania) abuica@math.ubbcluj.ro and Universitat de Lleida (Lleida, Spain) Plan of the talk 1 Our problem

More information

MAT 22B - Lecture Notes

MAT 22B - Lecture Notes MAT 22B - Lecture Notes 2 September 2015 Systems of ODEs This is some really cool stu. Systems of ODEs are a natural and powerful way to model how multiple dierent interrelated quantities change through

More information

Math 273 (51) - Final

Math 273 (51) - Final Name: Id #: Math 273 (5) - Final Autumn Quarter 26 Thursday, December 8, 26-6: to 8: Instructions: Prob. Points Score possible 25 2 25 3 25 TOTAL 75 Read each problem carefully. Write legibly. Show all

More information

ME 132, Fall 2015, Quiz # 2

ME 132, Fall 2015, Quiz # 2 ME 132, Fall 2015, Quiz # 2 # 1 # 2 # 3 # 4 # 5 # 6 Total NAME 14 10 8 6 14 8 60 Rules: 1. 2 sheets of notes allowed, 8.5 11 inches. Both sides can be used. 2. Calculator is allowed. Keep it in plain view

More information

Solutions to Final Exam Sample Problems, Math 246, Spring 2011

Solutions to Final Exam Sample Problems, Math 246, Spring 2011 Solutions to Final Exam Sample Problems, Math 246, Spring 2 () Consider the differential equation dy dt = (9 y2 )y 2 (a) Identify its equilibrium (stationary) points and classify their stability (b) Sketch

More information

Modeling and Simulation with ODE for MSE

Modeling and Simulation with ODE for MSE Zentrum Mathematik Technische Universität München Prof. Dr. Massimo Fornasier WS 6/7 Dr. Markus Hansen Sheet 7 Modeling and Simulation with ODE for MSE The exercises can be handed in until Wed, 4..6,.

More information

Complex Dynamic Systems: Qualitative vs Quantitative analysis

Complex Dynamic Systems: Qualitative vs Quantitative analysis Complex Dynamic Systems: Qualitative vs Quantitative analysis Complex Dynamic Systems Chiara Mocenni Department of Information Engineering and Mathematics University of Siena (mocenni@diism.unisi.it) Dynamic

More information

Interdisciplinary Guided Research. Dynamical Systems & Scientific Computing

Interdisciplinary Guided Research. Dynamical Systems & Scientific Computing Interdisciplinary Guided Research at tthe Edge of Dynamical Systems & Scientific Computing Ernst Otto Fischer-Lehrpreis 2011 der TU München Dr. Tobias Neckel Dr. (Fakultät für Informatik) (Fakultät für

More information

MATH 294???? FINAL # 4 294UFQ4.tex Find the general solution y(x) of each of the following ODE's a) y 0 = cosecy

MATH 294???? FINAL # 4 294UFQ4.tex Find the general solution y(x) of each of the following ODE's a) y 0 = cosecy 3.1. 1 ST ORDER ODES 1 3.1 1 st Order ODEs MATH 294???? FINAL # 4 294UFQ4.tex 3.1.1 Find the general solution y(x) of each of the following ODE's a) y 0 = cosecy MATH 294 FALL 1990 PRELIM 2 # 4 294FA90P2Q4.tex

More information

CDS 101/110a: Lecture 2.1 Dynamic Behavior

CDS 101/110a: Lecture 2.1 Dynamic Behavior CDS 11/11a: Lecture 2.1 Dynamic Behavior Richard M. Murray 6 October 28 Goals: Learn to use phase portraits to visualize behavior of dynamical systems Understand different types of stability for an equilibrium

More information

Even-Numbered Homework Solutions

Even-Numbered Homework Solutions -6 Even-Numbered Homework Solutions Suppose that the matric B has λ = + 5i as an eigenvalue with eigenvector Y 0 = solution to dy = BY Using Euler s formula, we can write the complex-valued solution Y

More information

460 HOLGER DETTE AND WILLIAM J STUDDEN order to examine how a given design behaves in the model g` with respect to the D-optimality criterion one uses

460 HOLGER DETTE AND WILLIAM J STUDDEN order to examine how a given design behaves in the model g` with respect to the D-optimality criterion one uses Statistica Sinica 5(1995), 459-473 OPTIMAL DESIGNS FOR POLYNOMIAL REGRESSION WHEN THE DEGREE IS NOT KNOWN Holger Dette and William J Studden Technische Universitat Dresden and Purdue University Abstract:

More information

ECON : diff.eq. (systems).

ECON : diff.eq. (systems). ECON4140 018: diff.eq. (systems). FMEA 6.1 6.3 (Norw.: MA.1.3) You must know that if you are given two nonproportional solutions u 1 and u of a homogeneous linear nd order di.eq., you obtain the general

More information

Solutions to Dynamical Systems 2010 exam. Each question is worth 25 marks.

Solutions to Dynamical Systems 2010 exam. Each question is worth 25 marks. Solutions to Dynamical Systems exam Each question is worth marks [Unseen] Consider the following st order differential equation: dy dt Xy yy 4 a Find and classify all the fixed points of Hence draw the

More information

Math 308 Exam I Practice Problems

Math 308 Exam I Practice Problems Math 308 Exam I Practice Problems This review should not be used as your sole source of preparation for the exam. You should also re-work all examples given in lecture and all suggested homework problems..

More information

APPM 2360: Final Exam 10:30am 1:00pm, May 6, 2015.

APPM 2360: Final Exam 10:30am 1:00pm, May 6, 2015. APPM 23: Final Exam :3am :pm, May, 25. ON THE FRONT OF YOUR BLUEBOOK write: ) your name, 2) your student ID number, 3) lecture section, 4) your instructor s name, and 5) a grading table for eight questions.

More information

PH.D. PRELIMINARY EXAMINATION MATHEMATICS

PH.D. PRELIMINARY EXAMINATION MATHEMATICS UNIVERSITY OF CALIFORNIA, BERKELEY Dept. of Civil and Environmental Engineering FALL SEMESTER 2014 Structural Engineering, Mechanics and Materials NAME PH.D. PRELIMINARY EXAMINATION MATHEMATICS Problem

More information

Intelligent Control. Module I- Neural Networks Lecture 7 Adaptive Learning Rate. Laxmidhar Behera

Intelligent Control. Module I- Neural Networks Lecture 7 Adaptive Learning Rate. Laxmidhar Behera Intelligent Control Module I- Neural Networks Lecture 7 Adaptive Learning Rate Laxmidhar Behera Department of Electrical Engineering Indian Institute of Technology, Kanpur Recurrent Networks p.1/40 Subjects

More information

Math 312 Lecture Notes Linear Two-dimensional Systems of Differential Equations

Math 312 Lecture Notes Linear Two-dimensional Systems of Differential Equations Math 2 Lecture Notes Linear Two-dimensional Systems of Differential Equations Warren Weckesser Department of Mathematics Colgate University February 2005 In these notes, we consider the linear system of

More information

A plane autonomous system is a pair of simultaneous first-order differential equations,

A plane autonomous system is a pair of simultaneous first-order differential equations, Chapter 11 Phase-Plane Techniques 11.1 Plane Autonomous Systems A plane autonomous system is a pair of simultaneous first-order differential equations, ẋ = f(x, y), ẏ = g(x, y). This system has an equilibrium

More information

Chapter III. Stability of Linear Systems

Chapter III. Stability of Linear Systems 1 Chapter III Stability of Linear Systems 1. Stability and state transition matrix 2. Time-varying (non-autonomous) systems 3. Time-invariant systems 1 STABILITY AND STATE TRANSITION MATRIX 2 In this chapter,

More information

Electric and Magnetic Forces in Lagrangian and Hamiltonian Formalism

Electric and Magnetic Forces in Lagrangian and Hamiltonian Formalism Electric and Magnetic Forces in Lagrangian and Hamiltonian Formalism Benjamin Hornberger 1/26/1 Phy 55, Classical Electrodynamics, Prof. Goldhaber Lecture notes from Oct. 26, 21 Lecture held by Prof. Weisberger

More information

Prof. Krstic Nonlinear Systems MAE281A Homework set 1 Linearization & phase portrait

Prof. Krstic Nonlinear Systems MAE281A Homework set 1 Linearization & phase portrait Prof. Krstic Nonlinear Systems MAE28A Homework set Linearization & phase portrait. For each of the following systems, find all equilibrium points and determine the type of each isolated equilibrium. Use

More information

ZERO-HOPF BIFURCATION FOR A CLASS OF LORENZ-TYPE SYSTEMS

ZERO-HOPF BIFURCATION FOR A CLASS OF LORENZ-TYPE SYSTEMS This is a preprint of: Zero-Hopf bifurcation for a class of Lorenz-type systems, Jaume Llibre, Ernesto Pérez-Chavela, Discrete Contin. Dyn. Syst. Ser. B, vol. 19(6), 1731 1736, 214. DOI: [doi:1.3934/dcdsb.214.19.1731]

More information

STABILITY. Phase portraits and local stability

STABILITY. Phase portraits and local stability MAS271 Methods for differential equations Dr. R. Jain STABILITY Phase portraits and local stability We are interested in system of ordinary differential equations of the form ẋ = f(x, y), ẏ = g(x, y),

More information

Nonlinear Control Systems

Nonlinear Control Systems Nonlinear Control Systems António Pedro Aguiar pedro@isr.ist.utl.pt 7. Feedback Linearization IST-DEEC PhD Course http://users.isr.ist.utl.pt/%7epedro/ncs1/ 1 1 Feedback Linearization Given a nonlinear

More information

Imaginary. Axis. Real. Axis

Imaginary. Axis. Real. Axis Name ME6 Final. I certify that I upheld the Stanford Honor code during this exam Monday December 2, 25 3:3-6:3 p.m. ffl Print your name and sign the honor code statement ffl You may use your course notes,

More information

Linearization problem. The simplest example

Linearization problem. The simplest example Linear Systems Lecture 3 1 problem Consider a non-linear time-invariant system of the form ( ẋ(t f x(t u(t y(t g ( x(t u(t (1 such that x R n u R m y R p and Slide 1 A: f(xu f(xu g(xu and g(xu exist and

More information

Math 266: Phase Plane Portrait

Math 266: Phase Plane Portrait Math 266: Phase Plane Portrait Long Jin Purdue, Spring 2018 Review: Phase line for an autonomous equation For a single autonomous equation y = f (y) we used a phase line to illustrate the equilibrium solutions

More information

Second-Order Linear ODEs

Second-Order Linear ODEs Second-Order Linear ODEs A second order ODE is called linear if it can be written as y + p(t)y + q(t)y = r(t). (0.1) It is called homogeneous if r(t) = 0, and nonhomogeneous otherwise. We shall assume

More information

MathQuest: Differential Equations

MathQuest: Differential Equations MathQuest: Differential Equations Geometry of Systems 1. The differential equation d Y dt = A Y has two straight line solutions corresponding to [ ] [ ] 1 1 eigenvectors v 1 = and v 2 2 = that are shown

More information

EEE 184: Introduction to feedback systems

EEE 184: Introduction to feedback systems EEE 84: Introduction to feedback systems Summary 6 8 8 x 7 7 6 Level() 6 5 4 4 5 5 time(s) 4 6 8 Time (seconds) Fig.. Illustration of BIBO stability: stable system (the input is a unit step) Fig.. step)

More information

Numerical Methods for the Solution of Differential Equations

Numerical Methods for the Solution of Differential Equations Numerical Methods for the Solution of Differential Equations Markus Grasmair Vienna, winter term 2011 2012 Analytical Solutions of Ordinary Differential Equations 1. Find the general solution of the differential

More information

Jordan normal form notes (version date: 11/21/07)

Jordan normal form notes (version date: 11/21/07) Jordan normal form notes (version date: /2/7) If A has an eigenbasis {u,, u n }, ie a basis made up of eigenvectors, so that Au j = λ j u j, then A is diagonal with respect to that basis To see this, let

More information

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

More information

Modelling and Mathematical Methods in Process and Chemical Engineering

Modelling and Mathematical Methods in Process and Chemical Engineering Modelling and Mathematical Methods in Process and Chemical Engineering Solution Series 3 1. Population dynamics: Gendercide The system admits two steady states The Jacobi matrix is ẋ = (1 p)xy k 1 x ẏ

More information

5 Eigenvalues and Diagonalization

5 Eigenvalues and Diagonalization Linear Algebra (part 5): Eigenvalues and Diagonalization (by Evan Dummit, 27, v 5) Contents 5 Eigenvalues and Diagonalization 5 Eigenvalues, Eigenvectors, and The Characteristic Polynomial 5 Eigenvalues

More information

Mathematical Economics. Lecture Notes (in extracts)

Mathematical Economics. Lecture Notes (in extracts) Prof. Dr. Frank Werner Faculty of Mathematics Institute of Mathematical Optimization (IMO) http://math.uni-magdeburg.de/ werner/math-ec-new.html Mathematical Economics Lecture Notes (in extracts) Winter

More information

ODE Homework 1. Due Wed. 19 August 2009; At the beginning of the class

ODE Homework 1. Due Wed. 19 August 2009; At the beginning of the class ODE Homework Due Wed. 9 August 2009; At the beginning of the class. (a) Solve Lẏ + Ry = E sin(ωt) with y(0) = k () L, R, E, ω are positive constants. (b) What is the limit of the solution as ω 0? (c) Is

More information

L = 1 2 a(q) q2 V (q).

L = 1 2 a(q) q2 V (q). Physics 3550, Fall 2011 Motion near equilibrium - Small Oscillations Relevant Sections in Text: 5.1 5.6 Motion near equilibrium 1 degree of freedom One of the most important situations in physics is motion

More information

Imaginary. Axis. Real. Axis

Imaginary. Axis. Real. Axis Name ME6 Final. I certify that I upheld the Stanford Honor code during this exam Monday December 2, 2005 3:30-6:30 p.m. ffl Print your name and sign the honor code statement ffl You may use your course

More information

Nonlinear Observers. Jaime A. Moreno. Eléctrica y Computación Instituto de Ingeniería Universidad Nacional Autónoma de México

Nonlinear Observers. Jaime A. Moreno. Eléctrica y Computación Instituto de Ingeniería Universidad Nacional Autónoma de México Nonlinear Observers Jaime A. Moreno JMorenoP@ii.unam.mx Eléctrica y Computación Instituto de Ingeniería Universidad Nacional Autónoma de México XVI Congreso Latinoamericano de Control Automático October

More information

PROOF OF TWO MATRIX THEOREMS VIA TRIANGULAR FACTORIZATIONS ROY MATHIAS

PROOF OF TWO MATRIX THEOREMS VIA TRIANGULAR FACTORIZATIONS ROY MATHIAS PROOF OF TWO MATRIX THEOREMS VIA TRIANGULAR FACTORIZATIONS ROY MATHIAS Abstract. We present elementary proofs of the Cauchy-Binet Theorem on determinants and of the fact that the eigenvalues of a matrix

More information

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) Contents 1 Vector Spaces 1 1.1 The Formal Denition of a Vector Space.................................. 1 1.2 Subspaces...................................................

More information

2015 School Year. Graduate School Entrance Examination Problem Booklet. Mathematics

2015 School Year. Graduate School Entrance Examination Problem Booklet. Mathematics 2015 School Year Graduate School Entrance Examination Problem Booklet Mathematics Examination Time: 10:00 to 12:30 Instructions 1. Do not open this problem booklet until the start of the examination is

More information

CDS 101/110a: Lecture 2.1 Dynamic Behavior

CDS 101/110a: Lecture 2.1 Dynamic Behavior CDS 11/11a: Lecture.1 Dynamic Behavior Richard M. Murray 6 October 8 Goals: Learn to use phase portraits to visualize behavior of dynamical systems Understand different types of stability for an equilibrium

More information

Differential equations

Differential equations Differential equations Math 7 Spring Practice problems for April Exam Problem Use the method of elimination to find the x-component of the general solution of x y = 6x 9x + y = x 6y 9y Soln: The system

More information

Contents. 2.1 Vectors in R n. Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v. 2.50) 2 Vector Spaces

Contents. 2.1 Vectors in R n. Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v. 2.50) 2 Vector Spaces Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v 250) Contents 2 Vector Spaces 1 21 Vectors in R n 1 22 The Formal Denition of a Vector Space 4 23 Subspaces 6 24 Linear Combinations and

More information

Math 215/255 Final Exam (Dec 2005)

Math 215/255 Final Exam (Dec 2005) Exam (Dec 2005) Last Student #: First name: Signature: Circle your section #: Burggraf=0, Peterson=02, Khadra=03, Burghelea=04, Li=05 I have read and understood the instructions below: Please sign: Instructions:.

More information

Contents. 6 Systems of First-Order Linear Dierential Equations. 6.1 General Theory of (First-Order) Linear Systems

Contents. 6 Systems of First-Order Linear Dierential Equations. 6.1 General Theory of (First-Order) Linear Systems Dierential Equations (part 3): Systems of First-Order Dierential Equations (by Evan Dummit, 26, v 2) Contents 6 Systems of First-Order Linear Dierential Equations 6 General Theory of (First-Order) Linear

More information

2 Lyapunov Stability. x(0) x 0 < δ x(t) x 0 < ɛ

2 Lyapunov Stability. x(0) x 0 < δ x(t) x 0 < ɛ 1 2 Lyapunov Stability Whereas I/O stability is concerned with the effect of inputs on outputs, Lyapunov stability deals with unforced systems: ẋ = f(x, t) (1) where x R n, t R +, and f : R n R + R n.

More information

Math 1060 Linear Algebra Homework Exercises 1 1. Find the complete solutions (if any!) to each of the following systems of simultaneous equations:

Math 1060 Linear Algebra Homework Exercises 1 1. Find the complete solutions (if any!) to each of the following systems of simultaneous equations: Homework Exercises 1 1 Find the complete solutions (if any!) to each of the following systems of simultaneous equations: (i) x 4y + 3z = 2 3x 11y + 13z = 3 2x 9y + 2z = 7 x 2y + 6z = 2 (ii) x 4y + 3z =

More information

Lecture 7. Please note. Additional tutorial. Please note that there is no lecture on Tuesday, 15 November 2011.

Lecture 7. Please note. Additional tutorial. Please note that there is no lecture on Tuesday, 15 November 2011. Lecture 7 3 Ordinary differential equations (ODEs) (continued) 6 Linear equations of second order 7 Systems of differential equations Please note Please note that there is no lecture on Tuesday, 15 November

More information

1 Lyapunov theory of stability

1 Lyapunov theory of stability M.Kawski, APM 581 Diff Equns Intro to Lyapunov theory. November 15, 29 1 1 Lyapunov theory of stability Introduction. Lyapunov s second (or direct) method provides tools for studying (asymptotic) stability

More information

Statistical Learning Theory

Statistical Learning Theory Statistical Learning Theory Fundamentals Miguel A. Veganzones Grupo Inteligencia Computacional Universidad del País Vasco (Grupo Inteligencia Vapnik Computacional Universidad del País Vasco) UPV/EHU 1

More information

for all subintervals I J. If the same is true for the dyadic subintervals I D J only, we will write ϕ BMO d (J). In fact, the following is true

for all subintervals I J. If the same is true for the dyadic subintervals I D J only, we will write ϕ BMO d (J). In fact, the following is true 3 ohn Nirenberg inequality, Part I A function ϕ L () belongs to the space BMO() if sup ϕ(s) ϕ I I I < for all subintervals I If the same is true for the dyadic subintervals I D only, we will write ϕ BMO

More information

Canards at Folded Nodes

Canards at Folded Nodes Canards at Folded Nodes John Guckenheimer and Radu Haiduc Mathematics Department, Ithaca, NY 14853 For Yulij Il yashenko with admiration and affection on the occasion of his 60th birthday March 18, 2003

More information

Problem Set 9 Due: In class Tuesday, Nov. 27 Late papers will be accepted until 12:00 on Thursday (at the beginning of class).

Problem Set 9 Due: In class Tuesday, Nov. 27 Late papers will be accepted until 12:00 on Thursday (at the beginning of class). Math 3, Fall Jerry L. Kazdan Problem Set 9 Due In class Tuesday, Nov. 7 Late papers will be accepted until on Thursday (at the beginning of class).. Suppose that is an eigenvalue of an n n matrix A and

More information

Module 3F2: Systems and Control EXAMPLES PAPER 2 ROOT-LOCUS. Solutions

Module 3F2: Systems and Control EXAMPLES PAPER 2 ROOT-LOCUS. Solutions Cambridge University Engineering Dept. Third Year Module 3F: Systems and Control EXAMPLES PAPER ROOT-LOCUS Solutions. (a) For the system L(s) = (s + a)(s + b) (a, b both real) show that the root-locus

More information

Lecture 10: Singular Perturbations and Averaging 1

Lecture 10: Singular Perturbations and Averaging 1 Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.243j (Fall 2003): DYNAMICS OF NONLINEAR SYSTEMS by A. Megretski Lecture 10: Singular Perturbations and

More information

Lecture 2: Review of Prerequisites. Table of contents

Lecture 2: Review of Prerequisites. Table of contents Math 348 Fall 217 Lecture 2: Review of Prerequisites Disclaimer. As we have a textbook, this lecture note is for guidance and supplement only. It should not be relied on when preparing for exams. In this

More information

Nonlinear Control Lecture 5: Stability Analysis II

Nonlinear Control Lecture 5: Stability Analysis II Nonlinear Control Lecture 5: Stability Analysis II Farzaneh Abdollahi Department of Electrical Engineering Amirkabir University of Technology Fall 2010 Farzaneh Abdollahi Nonlinear Control Lecture 5 1/41

More information

Poincaré Map, Floquet Theory, and Stability of Periodic Orbits

Poincaré Map, Floquet Theory, and Stability of Periodic Orbits Poincaré Map, Floquet Theory, and Stability of Periodic Orbits CDS140A Lecturer: W.S. Koon Fall, 2006 1 Poincaré Maps Definition (Poincaré Map): Consider ẋ = f(x) with periodic solution x(t). Construct

More information

Introduction to Modern Control MT 2016

Introduction to Modern Control MT 2016 CDT Autonomous and Intelligent Machines & Systems Introduction to Modern Control MT 2016 Alessandro Abate Lecture 2 First-order ordinary differential equations (ODE) Solution of a linear ODE Hints to nonlinear

More information

CDS 101 Precourse Phase Plane Analysis and Stability

CDS 101 Precourse Phase Plane Analysis and Stability CDS 101 Precourse Phase Plane Analysis and Stability Melvin Leok Control and Dynamical Systems California Institute of Technology Pasadena, CA, 26 September, 2002. mleok@cds.caltech.edu http://www.cds.caltech.edu/

More information

Solution via Laplace transform and matrix exponential

Solution via Laplace transform and matrix exponential EE263 Autumn 2015 S. Boyd and S. Lall Solution via Laplace transform and matrix exponential Laplace transform solving ẋ = Ax via Laplace transform state transition matrix matrix exponential qualitative

More information

Entrance Exam, Differential Equations April, (Solve exactly 6 out of the 8 problems) y + 2y + y cos(x 2 y) = 0, y(0) = 2, y (0) = 4.

Entrance Exam, Differential Equations April, (Solve exactly 6 out of the 8 problems) y + 2y + y cos(x 2 y) = 0, y(0) = 2, y (0) = 4. Entrance Exam, Differential Equations April, 7 (Solve exactly 6 out of the 8 problems). Consider the following initial value problem: { y + y + y cos(x y) =, y() = y. Find all the values y such that the

More information

Comments on integral variants of ISS 1

Comments on integral variants of ISS 1 Systems & Control Letters 34 (1998) 93 1 Comments on integral variants of ISS 1 Eduardo D. Sontag Department of Mathematics, Rutgers University, Piscataway, NJ 8854-819, USA Received 2 June 1997; received

More information

/00 $ $.25 per page

/00 $ $.25 per page Contemporary Mathematics Volume 00, 0000 Domain Decomposition For Linear And Nonlinear Elliptic Problems Via Function Or Space Decomposition UE-CHENG TAI Abstract. In this article, we use a function decomposition

More information

EE222 - Spring 16 - Lecture 2 Notes 1

EE222 - Spring 16 - Lecture 2 Notes 1 EE222 - Spring 16 - Lecture 2 Notes 1 Murat Arcak January 21 2016 1 Licensed under a Creative Commons Attribution-NonCommercial-ShareAlike 4.0 International License. Essentially Nonlinear Phenomena Continued

More information

MIDTERM REVIEW AND SAMPLE EXAM. Contents

MIDTERM REVIEW AND SAMPLE EXAM. Contents MIDTERM REVIEW AND SAMPLE EXAM Abstract These notes outline the material for the upcoming exam Note that the review is divided into the two main topics we have covered thus far, namely, ordinary differential

More information

MODELLING OF FLEXIBLE MECHANICAL SYSTEMS THROUGH APPROXIMATED EIGENFUNCTIONS L. Menini A. Tornambe L. Zaccarian Dip. Informatica, Sistemi e Produzione

MODELLING OF FLEXIBLE MECHANICAL SYSTEMS THROUGH APPROXIMATED EIGENFUNCTIONS L. Menini A. Tornambe L. Zaccarian Dip. Informatica, Sistemi e Produzione MODELLING OF FLEXIBLE MECHANICAL SYSTEMS THROUGH APPROXIMATED EIGENFUNCTIONS L. Menini A. Tornambe L. Zaccarian Dip. Informatica, Sistemi e Produzione, Univ. di Roma Tor Vergata, via di Tor Vergata 11,

More information

Calculus for the Life Sciences II Assignment 6 solutions. f(x, y) = 3π 3 cos 2x + 2 sin 3y

Calculus for the Life Sciences II Assignment 6 solutions. f(x, y) = 3π 3 cos 2x + 2 sin 3y Calculus for the Life Sciences II Assignment 6 solutions Find the tangent plane to the graph of the function at the point (0, π f(x, y = 3π 3 cos 2x + 2 sin 3y Solution: The tangent plane of f at a point

More information