University of Sydney MATH3063 LECTURE NOTES

Size: px
Start display at page:

Download "University of Sydney MATH3063 LECTURE NOTES"

Transcription

1 University of Sydney MATH3063 LECTURE NOTES Shane Leviton

2 Contents Introduction:... 6 Order of ODE:... 6 Explicit ODEs... 6 Notation:... 7 Example:... 7 Systems of ODEs... 7 Example 0: fx = Eg 2: fx = c (or fx = f(t)... 8 But what when f(x) is a standard function... 8 Matrix ODEs (lecture 2)... 9 Linear equation of x:... 9 Solveing: FINDING THE EIGENVALUES/EIGENVECTORS!!!... 9 Why do we care about eigenvectors/values?... 0 Matrix exponentials... 2 When does ea exist?... 2 exp (A) first class: full set of linearly independent eigenvectors... 2 Diagonalizable or semi-simple matrix... 3 How big of a restriction is a full set of LI eigenvectors?... 3 Matrix and other term exponentials:... 6 Complex numbers and matricies:... 6 Real normal form of matricies... 8 Repeated eigenvalues Generalized eigenspace: Primary decomposition theorym Theorems:... 2 General algorithm for finding ea... 2 Derivative of eat Phase Plots Example: Phase Plot/Phase line Remarks:... 3 Constant solution:... 3 Spectrum: Definition of spectrum: Spectrally stable definition... 32

3 Stable/unstable/centre sub spaces: Primary decomposition theorem: Generally: Hyperbolic: Bounded for forward time: Definition Linearly stable definition: Asymptotically linearly stable Definition Restricted dynamics: Generally: The theory: Classification of 2D linear systems:... 4 Our approach: Discriminant: Overall picture: Linear ODEs with non constant coeffiencts Principle fundamental solution matric Liouville s/ Abel s Formula: (Theorem) PART 2: METRIC SPACES Start of thinking: Key idea: Formal definition of metric spaces: Metric (distance function): Metric space Topology of metric spaces: Open ball Examples: Open subset of metric space Closed subset of metric space Interior: Closure: Boundary: Limit point/accumulation point Sequences and Completeness... 7 Definition: complete sequence Contraction Mapping Principle: A contraction is a map:... 73

4 Definition: Lipshitz function Defintion: Locally Liphschitz Existence and Uniqueness of solutions of ODEs: Equation * Solution Dependence on initial conditions and parameters... 8 Theorem (P-L again) Theorem : Families of solutions Maximal intervals of existence Definition: Maximal interval of existence PART 3: NON LINEAR PLANAR AUTONOMOUS ODES Terminology: Function vector: Talking about what solutions are: Eg: pendulum equation Phase portraits:... 9 Isoclines Linearisation: Generally for linearlisation: Hyperbolic good, non-hyperbolic = bad More Qualitative results Theorem: uniqun phase curves Closed phase curves/periodic solutoins Hamiltonian Systems: Lotka-Volterra/ Predator-Prey system Definition of predator prey: Analysis of system: Modifications to equations: Epidemics: SIR model... 0 Abstraction, Global existsnece and Reparametrisation... 6 Definition: parameter family... 7 Definition: Orbit/trajectory... 7 Existence of complete flow:... 7 Flows on R... 8 Thereom: types of flows in R... 20

5 α alpha and ω omega limit sets: Asymptotic limit point Non- Linear stability (of critical points) Lyapunov stable definition: Asymptotically stable: defininition Lyapunov functions... 3 LaSalle s Invariance principle: Hilbert s 6 th problem and Poincare- Bendixon theorem Questino: hilbert s 6 th problem Poincare Bendixson theorem Proof: Proof: Definitions of sets: disconnected Proof of Poincare Bendixson theorem: Bendixsons Negative Criterion INDEX THEORY (Bonus) Set up: Theta: Index: definition Theorem: on Index Poincare Index: Index at infinity: Computing the index at infinity Theorem: Poincare Hopf Index theorem Part 4 Bifurcation theory... 5 Lets start with an example in D: Bifurcations: Bifurcation diagram: Bifurcation: Example 2 (in 2D) (Saddle node) bifurcation Transcritical bifurcation D example: Supercritical Pitchfork bifurcation Example Logistic growth with harvesting Hopf Bifurcation... 6 Definition of Hopf:... 6

6 Some more examples of bifurcations FIREFLIES AND FLOWS ON A CIRCLE Non uniform oscillator Glycolysis Model: Sel kov Catastrophe: Eg : fold bifurcation:... 8 Eg 2: swallowtail catastrophe Hysteresis and van der pol oscillator Van der poll oscillator example:... 88

7 MATH3963 NON LINEAR DIFFERENTIAL EQUATIONS WITH APPLICATIONS (biomaths) NOTES - Robert Marangell Robert.marangell@sydney.edu.au Assessment: - Midterm (Thursday April 2) 25% - 2 assignments 0% each (due 4/4 and 30/5) - 55% exam Assignments are typed (eg LaTex) PART : LINEAR SYSTEMS Introduction: - What is an ODE; how to understand them a DE is a function relationship between a function and its derivatives An ODE is when the function has only variable independent variable. Eg; t independant (x(t); y(t) dependant Not just scalar, but also vector valued functions (Systems of ODES) x (t) R d x (t) = (x (t), x 2 (t), x d (t)) x j : R R Order of ODE: - Highest derivative appearing in equation If you can isolate the highest derivative (eg F (t, y (t), dy(t), d(n) y (t) ) = 0 dt dt (n) Explicit ODEs If you can isolate highet derivative: it is an explicit ODE

8 d (n) y (t) dt (n) (explicit is easier; implicit is very hard) Notation: Use dot = G (t, y (t), dy(t), d(n ) y (t) dt dt (n ) ) Example: d dt = y + 2y y + 3(y ) 2 + y = 0 You can reduce the order of an ODE (to ), in exchange for making it a system of ODEs - Introduce new variables into system y 0 = y y = y 0 = y y 2 = y = y y 0 = y y = y 2 y 2 = 2y 2 y 0 3y 2 y 0 Which is a first order system in 3 variables, equivalent to the original 3 rd order ODE Systems of ODEs - We can play the same game for systems of ODEs y + Ay = 0 (with y R 2 ; A = ( a c ( y a b ) + ( y 2 c d ) (y y ) = 0 2 b d ) ) introduce: y = y 3 y 2 = y 4 y 3 = y = ay by 2 y 4 = y 2 = cy dy 2 y y ( ) = ( y 3 a b 0 0 y 4 c d 0 0 let x = (y, y 2, y 3, y 4 ) ) ( y y 2 y ) 3 y 4 The system of equations is now: Where x = f (x ) x = Bx

9 Example 0: f(x) = 0 x = 0 x i = 0 i x = c for x, c R n This is all the solutions to x = 0; and the solutions form an n dimensional vector space Eg 2: f(x) = c (or f (x) = f(t) x = c x (t) = c t + d But what when f(x) is a standard function - If f(x) is linear in x Remember: linear if: f(cx + y) = cf(x) + f(y) Recall any linear map can be represented by a matrix, by choosing a basis x = A(t)x If A(t) = A (independent of t), it is called a constant coefficient system x = Ax Eg: A = ( ) x x ( x ) = ( ) ( x x = x 2 x 2 = x + x 3 x 3 = x 2 + x 4 x 4 = x 3 Is the system of ODEs which we now have to solve x x 2 x ) 3 x 4

10 Matrix ODEs (lecture 2) x = f(x) Linear equation of x: x = Ax (x R n ; and A M n (R)) Eg: 0 0 eg: A = x = Ax; x = (x, x 2, x 3 ) x 0 0 x! ( x 2 ) = ( 0 ) ( x 2 ) x x 3 x = x 2 ; x 2 = x + x 3 x 3 = x 2 So a solution is a triple vector which solves this equation Solveing: FINDING THE EIGENVALUES/EIGENVECTORS!!! Recall: A value λ C Is an eigenvalue of an n n matrix A if a non zero vector v R n such that v is the corresponding eigenvector Av = λv (A λi)v = 0 v ker (A λi) A λi is not invertible det(a λi) = 0 det (A λi) is a polynomial in λ of degree n called the characteristic polynomial of A Eigenvalues are roots of ρ A (λ) = 0 ρ A (λ) Fundamental theorem of algebra: ρ A (λ) has exactly n (possibly complex) roots counted according to algebraic multiplicity.

11 Algebraic multiplicity: The algebraic multiplicity of a root r of ρ A (λ) = 0 is the largest k such that ρ A (λ) = (λ r) k q(λ) and q(r) 0 The algebraic multiplicity of an eigenvalue λ of A is its algebraic multiplicity as a root of ρ A (λ) Geometric multiplicity: The geometric multiplicity of an eigenvalue is the maximum number of linearly independent eigenvectors Alg multiplicity and geometric algebraic multiplicity geometric multiplicity Returning to example: x ( x 2 x 3 x! 0 0 ) = ( 0 ) ( x 2 ) 0 0 x A = ( 0 ) 0 0 λ 0 det(a λi) = λ = λ(λ 2 2) = 0 0 λ λ = 0; ± 2 Eigenvectors are found by finding the kernel of ker (A λi) for an eigenvalue: Giving eigenvectors: λ = 0 v = ( 0 ) λ 2 = 2 v 2 = ( 2) λ 3 = 2 v 3 = ( 2) Why do we care about eigenvectors/values? x = Ax Suppose that v is an eigenvector of A M n (C), with eigenvalues of λ. Consider the vector of functions:

12 x (t) = c(t)v c is some unkown function c: C C If x solves x = Ax, then As v 0, Which is a differential equation of one variable SO: is a solution vector to c (t)v = Ac(t)v = c(t)av = λc(t)v (as eigenvector) c (t) = λc(t) c(t) = e λt x(t) = e λt v x = Ax So- we have a D subspace of solutions x(t) = c 0 e λt v Notes:. Solutions to x = Ax are of the form x = c 0 e λt v where λ is a constant eigenvalue of A of v is the corresponding eigenvectors are called EIGENSOLUTIONS 2. What we just did has a name ansatz (guess what the solution could be, and see if it is correct) Back to example: x(t) = e 0t ( 0 ) ; y(t) = e 2t ( 2) ; z(t) = e 2 ( 2) So, as linear- any linear combination of these is the solution: So: IS OUR SOLUTION!!!!! X(t) = c e 0t ( 0 ) + c 2 e 2t ( 2) + c 3 e 2 ( 2) X(t) is actually a 3D vector space.

13 Matrix exponentials A M n n ; what is: e A (exp(a)) For a matrix: DEFINE e A = exp (A) = k! Ak (k=0) = I + A + 2 A2 + 3! A3 + If the entries converge, then: e A IS an n n matrix When does e A exist? exp (A) first class: full set of linearly independent eigenvectors - Hypothesis: Suppose A has a full set of linearly independent eigenvectors - Assume that hypothesis for the rest of today(we ll look at if it s not later) Let v, v n be the eigenvectors; with λ,, λ n eigenvalues Form the following matrix: (whose columes are the eigenvectors) LHS: Lemma: So: P = (v, v 2, v n ) AP = (Av, A v 2, Av n ) = (λ v, λ n v n ) (by multiplication) = P diag(λ,, λ n ) PΛ P AP = Λ (= diag(λ, λ n )) e Λ = I + Λ + 2 Λ2 + = diag(e λ,., e λ n) e P AP (P AP) n = P A n P e A = Pe Λ P (e Λ = diag(e λ,, e λ n)) AND: the eigenvectors of e A = e λ j, where λ j is eigenvalues of A,

14 Example: 0 0 A = ( 0 ) ; 0 0 x ( 0 ) ; ( 2) ; ( 2) P = ( 0 2 2) 0 0 Λ = ( ) e A = Pe ΛP 0 0 = ( 0 2 2) ( = (ugly answer) e ) ( e ) Diagonalizable or semi-simple matrix A matrix A for which there exists an invertible matrix P such that P AP = Λ (where Λ is diagonal is called diagonalizable or semisimple This says, if A is semisimple, then e A exists, and we can compute it How big of a restriction is a full set of LI eigenvectors? Defective matricies If A does not have a full set of linearly independent eigenvectors, it is called defective - How big of a restriction is being semisimple? - Are there many semi simple matrices? Proposition: Suppose λ λ 2 are eigenvalues of a matrix A with eigenvectors v and v 2. Then v and v 2 are linearly independent

15 Proof: If a dependence relation, then k and k 2 scalars such that Applying A: k v + k 2 v 2 = 0 (k, k 2 0) A(k v + k 2 v 2 ) = 0 Ak v + Ak 2 v 2 = 0 k λv + k 2 λ 2 v 2 = 0 (as eigenvectors) take λ k v λ k 2 v 2 = 0 \ (λ 2 λ )k 2 v 2 = 0 k 2 = 0 ( contradiction) Example: A = ( a b c d ) ρ A (λ) = λ 2 (a + d)λ + ad bc = λ 2 τλ + δ (taking τ = a + d; δ = ad bc) n (τ = Trace(A) = a jj (sum of the diagonals)) j= λ = τ ± τ2 4δ are roots 2 λ + λ if τ 2 4δ = 0 τ 2 4δ = 0 δ = τ2 4 Therefore: any matrix which does not lie on this parabola in τ, δ space will be diagonalizable τ 2 4δ = (a d) 2 + 4bc The set of matricies with repeated eigenvalues, is the locus of points with (a d) 2 + 4bc = 0 A 3D hypersurface, in 4D space So what if A is defective? Can we compute e A - Yes Two n n matricies A, B are commutative, if AB = BA

16 Commutator A commutator we will define as: Proposition If A and B commute, then Proof [A, B] AB BA = 0 (iff AB commute) e A+B = e A + e B - Aside: if e A+B = e A e B, and A and B satisfy symmetric AB = BA e A+B = I + (A + B) + (A + B)2 2 = I + A + B + 2 (A2 + AB + BA + B 2 ) + = I + A + B + 2 A2 + AB + 2 B2 (as commutative) And: e A e B = (I + A + 2 A2 ) (I + B + 2 B2 ) = I + (A + B) + 2 A2 + AB + 2 B2 + Example: If x = a b A = ( a 0 ) (a b); B = (0 0 b 0 0 ) e A = ( ea 0 0 e b) ; eb = ( 0 ) e A+B = ( ea e a e b a b ) 0 e b e A e B = e A+B (a b)e a = e a e b x = e x One example of a solution: is x i Nilpotent matrix: Definition: A matrix N is nilpotent if some power of it is = 0 (N T = 0 for some T) Eg; N = N 3 = 0 (calculate) This means that the power series terminates for e N :

17 So- how do we compute the exponential? e N = I + N + 2 N Jordan Canonical Form: Let A be an n n matrix, with complex entries a basis of C n and an invertible matrix B (of basis vectors) such that B AB = S + N Where S is diagonal (semisimple); and N is nilpotent; and S and N commute (SN NS = 0) So; this means that e A exists for all matricies: B AB = S + N B e A B = e S e N This is cool. Matrix and other term exponentials: e A = Be S e N B So now: consider the follow At; where A M n (R) and t R So: e At = ( tk k! ) Ak For a fixed A; the exponential is a function map between real numbers and matricies e At is invertible! Inverse is e At k=0 e At : R M n (R) exp A (t) : t e At exp A (t + s) = e A(t+s) = e At e As = exp A (t) exp A (s) So- what is the derivative between the map of the real numbers to the matricies? Complex numbers and matricies: Let J = ( 0 0 ) J 2 = I; J 2 = J; J 4 = I e Jt = I + Jt + 2 J2 t 2 +

18 = I + Jt 2 t2 I 3! t3 J Which is the rotation matrix; = I t2 t4 t3 I J (t 2 4! 3! + ) = cos t I + sin t J cos t sin t = ( sin t cos t ) So: the matrix J is the complex number i; and we wrote Euler s formula e it = cos t + i sin t - We can actually take any complex number z = x + iy; and find its corresponding matrix M z xi + yj = ( x y y x ) (the technical term is a field isomorphism) Complex number algebra: M z +z 2 = M z + M z2 M z z 2 = M z M z2 = M z2 M z = M z2 z Complex exponentials: M e z = e Mt z = x + iy: e z = e x cos y + ie x sin y = e x cos y sin y ( sin y cos y ) = e x I + e y J Complex number things: det(m z ) = x 2 + y 2 = z 2 M z = ( x y y x ) = M z T M r = ri (if r R) M z M Z = M z 2 = z 2 I if z 0; M z is invertible; and M z = z 2 M z T = det(m z ) M Z T So lets compute e Jt cos t sin t = ( sin t cos t ): Eigenvalues of Jt are ±it e vectors are ( ±i )

19 So we got what we started with! (which is good) P = ( i i ) ; P = 2i ( i i ) Λ = ( it 0 0 it ) e Jt = 2i (i i ) (eit 0 i 0 e it) ( i ) cos t sin t = ( sin t cos t ) Real normal form of matricies Moving towards a real normal form for matricesl with real entries but complex eigenvalues Fact: if A M n (R) then if λ is an eigenvalue; so λ is an e-value. (complex conjugate theorem). Alsoeigenvectors come in conjugate pairs as well Av = λv Av = λ v - If λ is an eigenvalue λ = a + ib; then λ = a ib is also an e-value - If v = u + iw ; (u, w R n ) v = u iw So: Similarly; So; if P is the n 2 matrix 2u = v + v A(2u) = λv + λv = 2(au bw ) Au = (au bw ) Aw = (au + bw ) P = (u w) AP = P ( a b b a ) (we are close to finding the algorithm for computing the matrix exponential of any matrix) Eg: Characteristic polynomial is: A = x 4 + 3x 2 + e-values of A are ±iφ and ± i φ + 5 (with φ = the golden ratio) 2

20 so eigenvectors: i 0 φ φ v = ( ) = ( ) + i ( iφ 0 iφ ; v 2 = ( ) i φ 0 φ ) = u + iw i So AP = P ( 0 φ φ 0 ) 0 φ 0 0 φ P = (u w u 2 w 2 )P AP = φ ( φ ) this is called a block diagonal matrix (has blocks of diagonal matricies; and 0s everywhere else) = φj φ J Direct sum: A and B don t need to be the same size A B = ( A 0 0 B ) Lemma: if A = B C Then e A = e B e C Proof: (A = ( B ) + (0 0 )) which commute 0 C e A = e (B ) e (0 0 0 C ) = ( eb 0 0 I ) (I 0 0 e C) = (eb 0 0 e C) = eb e C

21 Repeated eigenvalues So what do we do if we have repeated eigenvalues? How do we calculate the matrix exponential? Generalized eigenspace: Definition Suppose λ j is an eigenvalue of a matrix A with algebraic multiplicity n j. We define the generalized eigenspace of λ j as: E j ker[(a λ j I) nj ] There are basically two reasons why this definition is important. The first is that these generalized eigenspaces are INVARIANT UNDER MULTIPLICATION BY A (does not change). That is: if v E j, then Av is as well Proposition: of generalized eigenspace Suppose that E j is a generalized eigenspace of the matrix A, then if v E j ; so is Av Proof of proposition: - If v E j for some generalized eigenspace, for some eigenvector λ; then v ker((a λi) k ) say for some k. Then we have that (A λi) k v = (A λi) k (A λi + λi)v = (A λi) k+ + (A λi) k λv = 0 The second reason we care about this is that it will give us our set of linearly independent generalized eigenvectors; which we can use to find e A Primary decomposition theorym Let T: V V be a linear transformation of an n dimensional vector space over the complex numbers. If λ, λ k are the distinct eigenvalues (not necessarily = n ) ; if E j is the eigenspace for λ j, then dim(e j ) = the algebraic multiplicity of λ j and the generalized eigenvectors span V. In terms of vector spaces, we have: V = E E 2 E k Combining this with the previous proposition: T will decompose the vector space into the direct sum of the invariant subspaces. The next thing to do is explicitly determine the ssemisimple nilpotent decomposition. Before: we had the diagonal matrix Λ which was - Block diagonal - In normal form for complex eigenvalues

22 - Diagonal for real eigenvalues Suppose we have a real matrix A with n eigenvalues λ, λ n with repeated multiplicity, suppose we break them up into complex ones and real ones, so we have λ, λ,, λ k, λ k complex and λ 2k+, λ n real. Let λ j = a j + ib + j then: Λ ( a b b a ) ( a k b k b k a k ) diag(λ 2k+, λ n ) Let v, v, v 2k+,, v n be a basis of R n of generalsed eigenvectors, then for complex ones: write v j = u j + iw j Let P (u w u 2 w 2 u k w k v 2k+ v n ) Returning to our construction, the matrix P is invertiable (because of the primary decomposition theorem); so we can write the new matrix as And a matrix We have the following: Theorems: Let A, N S Λ and P be the matricies defined: then S = PΛP N = A S. A = S + N 2. S is semisimple 3. S, N and A commute 4. N is nilpotent Proofs of theorems:. From definition of N 2. From construction of S 3. [S, A] = 0 suppose that v is a generalized eigenvector of A associated to eigenvalue λ. By construction: v is a genuine eigenvector of S. Note that eigenspace is invariant, [S, A]v = SAv ASv = λ(av Av) = 0 so N and S commute. A and N commute from the definition of N and that A commutes with S 4. suppose maximum algebraic multiplicity of an eigenvalue of A is m. Then for any v E j a generalized eigenspace corresponding to the eigenvalue λ j. We have N m v = (A S) m v = (A S) m v(a λ j )v = (A λ j ) m v = 0 General algorithm for finding e A. find eigenvalues

23 2. find generalized eigenspace for each eigenvalue.; eigenvalues Λ 3. Turn these vectors into P 4. S = PΛP 5. N = A S 6. e At = e St e Nt = Pe ΛP e (A S)t Example: Eigenvalues: ( 4 3 ) λ det (( 4 3 λ )) = 0 λ =, Λ = diag(,) = I Generalized eigenspace: ker((a λi) n j) = ker((a I) 2 ) = ker ( )2 = ker (( 0 0 )) = R2 0 0 So our vectors must span R n ; choose ( 0 ) ; (0 ) P = ( 0 0 ) = I S = I II = I N = A S = A I = ( ) So then: e A = e ST e Nt

24 Last time: Algorithm for computing e A and e At Eg: let Evals ar λ = 2,2,, A = ( ) Generalized eigenspace for λ = 2 E 2 = ker((a 2I) 2 ) E 2 is spanned by: E = ker((a I) 2 ) spanned by ( ) ; ( ) ( ) ; ( ) Λ = diag(2,2,,); S = PΛP P = ( ) P = S = PΛP N = AS Note: if not using a computer: Check that N is nilpotent (N a = 0 for some a at most the size of the matrix, ) check NS SN = 0 (that they commute) At = (S + N)t = St + Nt e At = e St e Nt = Pe Λt P e Nt = Pe Λt P ( + Nt)

25 e At : R GL(n, R) = (Space of invertible n n matricies with real entries) Derivative of e At Proposition: what is d dt (eat ) = Ae At = e At A (Ae At = e At A from that e At exists and = power series representation) Proof : d dt (eat ) = d dt (I + ta + 2 t2 A 2 + t3 3! A3 + ) = A + ta 2 + t2 2 A3 + t3 3! A4 + = A ( + t + t2 2 + t3 3! + ) (we will show it converges uniformly, and so we can differentiate it term by term) = Ae At Proof 2: d dt (eat ) = lim ( ea(t+h) e At ) h 0 h = lim ( eat (e Ah I) ) h 0 h (Ah + A2 h 2 = e At 2 + ) lim ( ) h 0 h = e At lim h 0 (A + A2 2 h + ) = e At A This proposition implies that e At is a solution to the matrix differential equation: Φ (t) = AΦ(t) (note: A is constant coefficient) A cannot be functions of t, as the functions may not commute with the integral Comparing this to the x differential equation: y = ay y = Ce at

MATH 2921 VECTOR CALCULUS AND DIFFERENTIAL EQUATIONS LINEAR SYSTEMS NOTES

MATH 2921 VECTOR CALCULUS AND DIFFERENTIAL EQUATIONS LINEAR SYSTEMS NOTES MATH 9 VECTOR CALCULUS AND DIFFERENTIAL EQUATIONS LINEAR SYSTEMS NOTES R MARANGELL Contents. Higher Order ODEs and First Order Systems: One and the Same. Some First Examples 5 3. Matrix ODEs 6 4. Diagonalization

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

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

Chapter 7. Canonical Forms. 7.1 Eigenvalues and Eigenvectors

Chapter 7. Canonical Forms. 7.1 Eigenvalues and Eigenvectors Chapter 7 Canonical Forms 7.1 Eigenvalues and Eigenvectors Definition 7.1.1. Let V be a vector space over the field F and let T be a linear operator on V. An eigenvalue of T is a scalar λ F such that there

More information

Linear ODEs. Existence of solutions to linear IVPs. Resolvent matrix. Autonomous linear systems

Linear ODEs. Existence of solutions to linear IVPs. Resolvent matrix. Autonomous linear systems Linear ODEs p. 1 Linear ODEs Existence of solutions to linear IVPs Resolvent matrix Autonomous linear systems Linear ODEs Definition (Linear ODE) A linear ODE is a differential equation taking the form

More information

Examples include: (a) the Lorenz system for climate and weather modeling (b) the Hodgkin-Huxley system for neuron modeling

Examples include: (a) the Lorenz system for climate and weather modeling (b) the Hodgkin-Huxley system for neuron modeling 1 Introduction Many natural processes can be viewed as dynamical systems, where the system is represented by a set of state variables and its evolution governed by a set of differential equations. Examples

More information

235 Final exam review questions

235 Final exam review questions 5 Final exam review questions Paul Hacking December 4, 0 () Let A be an n n matrix and T : R n R n, T (x) = Ax the linear transformation with matrix A. What does it mean to say that a vector v R n is an

More information

Generalized Eigenvectors and Jordan Form

Generalized Eigenvectors and Jordan Form Generalized Eigenvectors and Jordan Form We have seen that an n n matrix A is diagonalizable precisely when the dimensions of its eigenspaces sum to n. So if A is not diagonalizable, there is at least

More information

Linear Systems Notes for CDS-140a

Linear Systems Notes for CDS-140a Linear Systems Notes for CDS-140a October 27, 2008 1 Linear Systems Before beginning our study of linear dynamical systems, it only seems fair to ask the question why study linear systems? One might hope

More information

The goal of this chapter is to study linear systems of ordinary differential equations: dt,..., dx ) T

The goal of this chapter is to study linear systems of ordinary differential equations: dt,..., dx ) T 1 1 Linear Systems The goal of this chapter is to study linear systems of ordinary differential equations: ẋ = Ax, x(0) = x 0, (1) where x R n, A is an n n matrix and ẋ = dx ( dt = dx1 dt,..., dx ) T n.

More information

4. Linear transformations as a vector space 17

4. Linear transformations as a vector space 17 4 Linear transformations as a vector space 17 d) 1 2 0 0 1 2 0 0 1 0 0 0 1 2 3 4 32 Let a linear transformation in R 2 be the reflection in the line = x 2 Find its matrix 33 For each linear transformation

More information

= A(λ, t)x. In this chapter we will focus on the case that the matrix A does not depend on time (so that the ODE is autonomous):

= A(λ, t)x. In this chapter we will focus on the case that the matrix A does not depend on time (so that the ODE is autonomous): Chapter 2 Linear autonomous ODEs 2 Linearity Linear ODEs form an important class of ODEs They are characterized by the fact that the vector field f : R m R p R R m is linear at constant value of the parameters

More information

Calculating determinants for larger matrices

Calculating determinants for larger matrices Day 26 Calculating determinants for larger matrices We now proceed to define det A for n n matrices A As before, we are looking for a function of A that satisfies the product formula det(ab) = det A det

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors Sec. 6.1 Eigenvalues and Eigenvectors Linear transformations L : V V that go from a vector space to itself are often called linear operators. Many linear operators can be understood geometrically by identifying

More information

DIAGONALIZATION. In order to see the implications of this definition, let us consider the following example Example 1. Consider the matrix

DIAGONALIZATION. In order to see the implications of this definition, let us consider the following example Example 1. Consider the matrix DIAGONALIZATION Definition We say that a matrix A of size n n is diagonalizable if there is a basis of R n consisting of eigenvectors of A ie if there are n linearly independent vectors v v n such that

More information

j=1 x j p, if 1 p <, x i ξ : x i < ξ} 0 as p.

j=1 x j p, if 1 p <, x i ξ : x i < ξ} 0 as p. LINEAR ALGEBRA Fall 203 The final exam Almost all of the problems solved Exercise Let (V, ) be a normed vector space. Prove x y x y for all x, y V. Everybody knows how to do this! Exercise 2 If V is a

More information

Diagonalization of Matrices

Diagonalization of Matrices LECTURE 4 Diagonalization of Matrices Recall that a diagonal matrix is a square n n matrix with non-zero entries only along the diagonal from the upper left to the lower right (the main diagonal) Diagonal

More information

MATH 304 Linear Algebra Lecture 23: Diagonalization. Review for Test 2.

MATH 304 Linear Algebra Lecture 23: Diagonalization. Review for Test 2. MATH 304 Linear Algebra Lecture 23: Diagonalization. Review for Test 2. Diagonalization Let L be a linear operator on a finite-dimensional vector space V. Then the following conditions are equivalent:

More information

MAT 1302B Mathematical Methods II

MAT 1302B Mathematical Methods II MAT 1302B Mathematical Methods II Alistair Savage Mathematics and Statistics University of Ottawa Winter 2015 Lecture 19 Alistair Savage (uottawa) MAT 1302B Mathematical Methods II Winter 2015 Lecture

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

Diagonalization. P. Danziger. u B = A 1. B u S.

Diagonalization. P. Danziger. u B = A 1. B u S. 7., 8., 8.2 Diagonalization P. Danziger Change of Basis Given a basis of R n, B {v,..., v n }, we have seen that the matrix whose columns consist of these vectors can be thought of as a change of basis

More information

Lecture Notes for Math 524

Lecture Notes for Math 524 Lecture Notes for Math 524 Dr Michael Y Li October 19, 2009 These notes are based on the lecture notes of Professor James S Muldowney, the books of Hale, Copple, Coddington and Levinson, and Perko They

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors Eigenvalues and Eigenvectors week -2 Fall 26 Eigenvalues and eigenvectors The most simple linear transformation from R n to R n may be the transformation of the form: T (x,,, x n ) (λ x, λ 2,, λ n x n

More information

1. In this problem, if the statement is always true, circle T; otherwise, circle F.

1. In this problem, if the statement is always true, circle T; otherwise, circle F. Math 1553, Extra Practice for Midterm 3 (sections 45-65) Solutions 1 In this problem, if the statement is always true, circle T; otherwise, circle F a) T F If A is a square matrix and the homogeneous equation

More information

MATH 1553-C MIDTERM EXAMINATION 3

MATH 1553-C MIDTERM EXAMINATION 3 MATH 553-C MIDTERM EXAMINATION 3 Name GT Email @gatech.edu Please read all instructions carefully before beginning. Please leave your GT ID card on your desk until your TA scans your exam. Each problem

More information

B5.6 Nonlinear Systems

B5.6 Nonlinear Systems B5.6 Nonlinear Systems 1. Linear systems Alain Goriely 2018 Mathematical Institute, University of Oxford Table of contents 1. Linear systems 1.1 Differential Equations 1.2 Linear flows 1.3 Linear maps

More information

Review problems for MA 54, Fall 2004.

Review problems for MA 54, Fall 2004. Review problems for MA 54, Fall 2004. Below are the review problems for the final. They are mostly homework problems, or very similar. If you are comfortable doing these problems, you should be fine on

More information

Linear ODEs. Types of systems. Linear ODEs. Definition (Linear ODE) Linear ODEs. Existence of solutions to linear IVPs.

Linear ODEs. Types of systems. Linear ODEs. Definition (Linear ODE) Linear ODEs. Existence of solutions to linear IVPs. Linear ODEs Linear ODEs Existence of solutions to linear IVPs Resolvent matrix Autonomous linear systems p. 1 Linear ODEs Types of systems Definition (Linear ODE) A linear ODE is a ifferential equation

More information

MTH 464: Computational Linear Algebra

MTH 464: Computational Linear Algebra MTH 464: Computational Linear Algebra Lecture Outlines Exam 4 Material Prof. M. Beauregard Department of Mathematics & Statistics Stephen F. Austin State University April 15, 2018 Linear Algebra (MTH 464)

More information

MATH 583A REVIEW SESSION #1

MATH 583A REVIEW SESSION #1 MATH 583A REVIEW SESSION #1 BOJAN DURICKOVIC 1. Vector Spaces Very quick review of the basic linear algebra concepts (see any linear algebra textbook): (finite dimensional) vector space (or linear space),

More information

Linear Algebra (MATH ) Spring 2011 Final Exam Practice Problem Solutions

Linear Algebra (MATH ) Spring 2011 Final Exam Practice Problem Solutions Linear Algebra (MATH 4) Spring 2 Final Exam Practice Problem Solutions Instructions: Try the following on your own, then use the book and notes where you need help. Afterwards, check your solutions with

More information

Definition (T -invariant subspace) Example. Example

Definition (T -invariant subspace) Example. Example Eigenvalues, Eigenvectors, Similarity, and Diagonalization We now turn our attention to linear transformations of the form T : V V. To better understand the effect of T on the vector space V, we begin

More information

Linear Algebra Practice Problems

Linear Algebra Practice Problems Linear Algebra Practice Problems Math 24 Calculus III Summer 25, Session II. Determine whether the given set is a vector space. If not, give at least one axiom that is not satisfied. Unless otherwise stated,

More information

PRACTICE FINAL EXAM. why. If they are dependent, exhibit a linear dependence relation among them.

PRACTICE FINAL EXAM. why. If they are dependent, exhibit a linear dependence relation among them. Prof A Suciu MTH U37 LINEAR ALGEBRA Spring 2005 PRACTICE FINAL EXAM Are the following vectors independent or dependent? If they are independent, say why If they are dependent, exhibit a linear dependence

More information

Eigenspaces and Diagonalizable Transformations

Eigenspaces and Diagonalizable Transformations Chapter 2 Eigenspaces and Diagonalizable Transformations As we explored how heat states evolve under the action of a diffusion transformation E, we found that some heat states will only change in amplitude.

More information

Math Matrix Algebra

Math Matrix Algebra Math 44 - Matrix Algebra Review notes - 4 (Alberto Bressan, Spring 27) Review of complex numbers In this chapter we shall need to work with complex numbers z C These can be written in the form z = a+ib,

More information

Announcements Wednesday, November 01

Announcements Wednesday, November 01 Announcements Wednesday, November 01 WeBWorK 3.1, 3.2 are due today at 11:59pm. The quiz on Friday covers 3.1, 3.2. My office is Skiles 244. Rabinoffice hours are Monday, 1 3pm and Tuesday, 9 11am. Section

More information

MATH 115A: SAMPLE FINAL SOLUTIONS

MATH 115A: SAMPLE FINAL SOLUTIONS MATH A: SAMPLE FINAL SOLUTIONS JOE HUGHES. Let V be the set of all functions f : R R such that f( x) = f(x) for all x R. Show that V is a vector space over R under the usual addition and scalar multiplication

More information

LINEAR ALGEBRA REVIEW

LINEAR ALGEBRA REVIEW LINEAR ALGEBRA REVIEW SPENCER BECKER-KAHN Basic Definitions Domain and Codomain. Let f : X Y be any function. This notation means that X is the domain of f and Y is the codomain of f. This means that for

More information

In these chapter 2A notes write vectors in boldface to reduce the ambiguity of the notation.

In these chapter 2A notes write vectors in boldface to reduce the ambiguity of the notation. 1 2 Linear Systems In these chapter 2A notes write vectors in boldface to reduce the ambiguity of the notation 21 Matrix ODEs Let and is a scalar A linear function satisfies Linear superposition ) Linear

More information

Announcements Monday, November 06

Announcements Monday, November 06 Announcements Monday, November 06 This week s quiz: covers Sections 5 and 52 Midterm 3, on November 7th (next Friday) Exam covers: Sections 3,32,5,52,53 and 55 Section 53 Diagonalization Motivation: Difference

More information

Module 09 From s-domain to time-domain From ODEs, TFs to State-Space Modern Control

Module 09 From s-domain to time-domain From ODEs, TFs to State-Space Modern Control Module 09 From s-domain to time-domain From ODEs, TFs to State-Space Modern Control Ahmad F. Taha EE 3413: Analysis and Desgin of Control Systems Email: ahmad.taha@utsa.edu Webpage: http://engineering.utsa.edu/

More information

Chapter 5. Eigenvalues and Eigenvectors

Chapter 5. Eigenvalues and Eigenvectors Chapter 5 Eigenvalues and Eigenvectors Section 5. Eigenvectors and Eigenvalues Motivation: Difference equations A Biology Question How to predict a population of rabbits with given dynamics:. half of the

More information

Old Math 330 Exams. David M. McClendon. Department of Mathematics Ferris State University

Old Math 330 Exams. David M. McClendon. Department of Mathematics Ferris State University Old Math 330 Exams David M. McClendon Department of Mathematics Ferris State University Last updated to include exams from Fall 07 Contents Contents General information about these exams 3 Exams from Fall

More information

LINEAR ALGEBRA BOOT CAMP WEEK 2: LINEAR OPERATORS

LINEAR ALGEBRA BOOT CAMP WEEK 2: LINEAR OPERATORS LINEAR ALGEBRA BOOT CAMP WEEK 2: LINEAR OPERATORS Unless otherwise stated, all vector spaces in this worksheet are finite dimensional and the scalar field F has characteristic zero. The following are facts

More information

October 4, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS

October 4, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS October 4, 207 EIGENVALUES AND EIGENVECTORS. APPLICATIONS RODICA D. COSTIN Contents 4. Eigenvalues and Eigenvectors 3 4.. Motivation 3 4.2. Diagonal matrices 3 4.3. Example: solving linear differential

More information

NONCOMMUTATIVE POLYNOMIAL EQUATIONS. Edward S. Letzter. Introduction

NONCOMMUTATIVE POLYNOMIAL EQUATIONS. Edward S. Letzter. Introduction NONCOMMUTATIVE POLYNOMIAL EQUATIONS Edward S Letzter Introduction My aim in these notes is twofold: First, to briefly review some linear algebra Second, to provide you with some new tools and techniques

More information

Remark By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero.

Remark By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero. Sec 6 Eigenvalues and Eigenvectors Definition An eigenvector of an n n matrix A is a nonzero vector x such that A x λ x for some scalar λ A scalar λ is called an eigenvalue of A if there is a nontrivial

More information

Differential Equations and Modeling

Differential Equations and Modeling Differential Equations and Modeling Preliminary Lecture Notes Adolfo J. Rumbos c Draft date: March 22, 2018 March 22, 2018 2 Contents 1 Preface 5 2 Introduction to Modeling 7 2.1 Constructing Models.........................

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors /88 Chia-Ping Chen Department of Computer Science and Engineering National Sun Yat-sen University Linear Algebra Eigenvalue Problem /88 Eigenvalue Equation By definition, the eigenvalue equation for matrix

More information

Math 205, Summer I, Week 4b:

Math 205, Summer I, Week 4b: Math 205, Summer I, 2016 Week 4b: Chapter 5, Sections 6, 7 and 8 (5.5 is NOT on the syllabus) 5.6 Eigenvalues and Eigenvectors 5.7 Eigenspaces, nondefective matrices 5.8 Diagonalization [*** See next slide

More information

LECTURE VII: THE JORDAN CANONICAL FORM MAT FALL 2006 PRINCETON UNIVERSITY. [See also Appendix B in the book]

LECTURE VII: THE JORDAN CANONICAL FORM MAT FALL 2006 PRINCETON UNIVERSITY. [See also Appendix B in the book] LECTURE VII: THE JORDAN CANONICAL FORM MAT 204 - FALL 2006 PRINCETON UNIVERSITY ALFONSO SORRENTINO [See also Appendix B in the book] 1 Introduction In Lecture IV we have introduced the concept of eigenvalue

More information

Summary of topics relevant for the final. p. 1

Summary of topics relevant for the final. p. 1 Summary of topics relevant for the final p. 1 Outline Scalar difference equations General theory of ODEs Linear ODEs Linear maps Analysis near fixed points (linearization) Bifurcations How to analyze a

More information

Matrix Solutions to Linear Systems of ODEs

Matrix Solutions to Linear Systems of ODEs Matrix Solutions to Linear Systems of ODEs James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University November 3, 216 Outline 1 Symmetric Systems of

More information

MATH 221, Spring Homework 10 Solutions

MATH 221, Spring Homework 10 Solutions MATH 22, Spring 28 - Homework Solutions Due Tuesday, May Section 52 Page 279, Problem 2: 4 λ A λi = and the characteristic polynomial is det(a λi) = ( 4 λ)( λ) ( )(6) = λ 6 λ 2 +λ+2 The solutions to the

More information

A Brief Outline of Math 355

A Brief Outline of Math 355 A Brief Outline of Math 355 Lecture 1 The geometry of linear equations; elimination with matrices A system of m linear equations with n unknowns can be thought of geometrically as m hyperplanes intersecting

More information

Math 205, Summer I, Week 4b: Continued. Chapter 5, Section 8

Math 205, Summer I, Week 4b: Continued. Chapter 5, Section 8 Math 205, Summer I, 2016 Week 4b: Continued Chapter 5, Section 8 2 5.8 Diagonalization [reprint, week04: Eigenvalues and Eigenvectors] + diagonaliization 1. 5.8 Eigenspaces, Diagonalization A vector v

More information

21 Linear State-Space Representations

21 Linear State-Space Representations ME 132, Spring 25, UC Berkeley, A Packard 187 21 Linear State-Space Representations First, let s describe the most general type of dynamic system that we will consider/encounter in this class Systems may

More information

September 26, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS

September 26, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS September 26, 207 EIGENVALUES AND EIGENVECTORS. APPLICATIONS RODICA D. COSTIN Contents 4. Eigenvalues and Eigenvectors 3 4.. Motivation 3 4.2. Diagonal matrices 3 4.3. Example: solving linear differential

More information

Math 110 Linear Algebra Midterm 2 Review October 28, 2017

Math 110 Linear Algebra Midterm 2 Review October 28, 2017 Math 11 Linear Algebra Midterm Review October 8, 17 Material Material covered on the midterm includes: All lectures from Thursday, Sept. 1st to Tuesday, Oct. 4th Homeworks 9 to 17 Quizzes 5 to 9 Sections

More information

LINEAR ALGEBRA MICHAEL PENKAVA

LINEAR ALGEBRA MICHAEL PENKAVA LINEAR ALGEBRA MICHAEL PENKAVA 1. Linear Maps Definition 1.1. If V and W are vector spaces over the same field K, then a map λ : V W is called a linear map if it satisfies the two conditions below: (1)

More information

Announcements Wednesday, November 01

Announcements Wednesday, November 01 Announcements Wednesday, November 01 WeBWorK 3.1, 3.2 are due today at 11:59pm. The quiz on Friday covers 3.1, 3.2. My office is Skiles 244. Rabinoffice hours are Monday, 1 3pm and Tuesday, 9 11am. Section

More information

Linear Algebra- Final Exam Review

Linear Algebra- Final Exam Review Linear Algebra- Final Exam Review. Let A be invertible. Show that, if v, v, v 3 are linearly independent vectors, so are Av, Av, Av 3. NOTE: It should be clear from your answer that you know the definition.

More information

Lecture 7: Positive Semidefinite Matrices

Lecture 7: Positive Semidefinite Matrices Lecture 7: Positive Semidefinite Matrices Rajat Mittal IIT Kanpur The main aim of this lecture note is to prepare your background for semidefinite programming. We have already seen some linear algebra.

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

Control Systems. Dynamic response in the time domain. L. Lanari

Control Systems. Dynamic response in the time domain. L. Lanari Control Systems Dynamic response in the time domain L. Lanari outline A diagonalizable - real eigenvalues (aperiodic natural modes) - complex conjugate eigenvalues (pseudoperiodic natural modes) - phase

More information

Half of Final Exam Name: Practice Problems October 28, 2014

Half of Final Exam Name: Practice Problems October 28, 2014 Math 54. Treibergs Half of Final Exam Name: Practice Problems October 28, 24 Half of the final will be over material since the last midterm exam, such as the practice problems given here. The other half

More information

JORDAN NORMAL FORM NOTES

JORDAN NORMAL FORM NOTES 18.700 JORDAN NORMAL FORM NOTES These are some supplementary notes on how to find the Jordan normal form of a small matrix. First we recall some of the facts from lecture, next we give the general algorithm

More information

2 Eigenvectors and Eigenvalues in abstract spaces.

2 Eigenvectors and Eigenvalues in abstract spaces. MA322 Sathaye Notes on Eigenvalues Spring 27 Introduction In these notes, we start with the definition of eigenvectors in abstract vector spaces and follow with the more common definition of eigenvectors

More information

MATHEMATICS 217 NOTES

MATHEMATICS 217 NOTES MATHEMATICS 27 NOTES PART I THE JORDAN CANONICAL FORM The characteristic polynomial of an n n matrix A is the polynomial χ A (λ) = det(λi A), a monic polynomial of degree n; a monic polynomial in the variable

More information

Lotka Volterra Predator-Prey Model with a Predating Scavenger

Lotka Volterra Predator-Prey Model with a Predating Scavenger Lotka Volterra Predator-Prey Model with a Predating Scavenger Monica Pescitelli Georgia College December 13, 2013 Abstract The classic Lotka Volterra equations are used to model the population dynamics

More information

Linear Algebra 1. M.T.Nair Department of Mathematics, IIT Madras. and in that case x is called an eigenvector of T corresponding to the eigenvalue λ.

Linear Algebra 1. M.T.Nair Department of Mathematics, IIT Madras. and in that case x is called an eigenvector of T corresponding to the eigenvalue λ. Linear Algebra 1 M.T.Nair Department of Mathematics, IIT Madras 1 Eigenvalues and Eigenvectors 1.1 Definition and Examples Definition 1.1. Let V be a vector space (over a field F) and T : V V be a linear

More information

1 Invariant subspaces

1 Invariant subspaces MATH 2040 Linear Algebra II Lecture Notes by Martin Li Lecture 8 Eigenvalues, eigenvectors and invariant subspaces 1 In previous lectures we have studied linear maps T : V W from a vector space V to another

More information

Eigenvalues, Eigenvectors, and Diagonalization

Eigenvalues, Eigenvectors, and Diagonalization Math 240 TA: Shuyi Weng Winter 207 February 23, 207 Eigenvalues, Eigenvectors, and Diagonalization The concepts of eigenvalues, eigenvectors, and diagonalization are best studied with examples. We will

More information

33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM

33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM 33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM (UPDATED MARCH 17, 2018) The final exam will be cumulative, with a bit more weight on more recent material. This outline covers the what we ve done since the

More information

Find the general solution of the system y = Ay, where

Find the general solution of the system y = Ay, where Math Homework # March, 9..3. Find the general solution of the system y = Ay, where 5 Answer: The matrix A has characteristic polynomial p(λ = λ + 7λ + = λ + 3(λ +. Hence the eigenvalues are λ = 3and λ

More information

Ir O D = D = ( ) Section 2.6 Example 1. (Bottom of page 119) dim(v ) = dim(l(v, W )) = dim(v ) dim(f ) = dim(v )

Ir O D = D = ( ) Section 2.6 Example 1. (Bottom of page 119) dim(v ) = dim(l(v, W )) = dim(v ) dim(f ) = dim(v ) Section 3.2 Theorem 3.6. Let A be an m n matrix of rank r. Then r m, r n, and, by means of a finite number of elementary row and column operations, A can be transformed into the matrix ( ) Ir O D = 1 O

More information

1.1 Limits and Continuity. Precise definition of a limit and limit laws. Squeeze Theorem. Intermediate Value Theorem. Extreme Value Theorem.

1.1 Limits and Continuity. Precise definition of a limit and limit laws. Squeeze Theorem. Intermediate Value Theorem. Extreme Value Theorem. STATE EXAM MATHEMATICS Variant A ANSWERS AND SOLUTIONS 1 1.1 Limits and Continuity. Precise definition of a limit and limit laws. Squeeze Theorem. Intermediate Value Theorem. Extreme Value Theorem. Definition

More information

MATH 1553 PRACTICE MIDTERM 3 (VERSION B)

MATH 1553 PRACTICE MIDTERM 3 (VERSION B) MATH 1553 PRACTICE MIDTERM 3 (VERSION B) Name Section 1 2 3 4 5 Total Please read all instructions carefully before beginning. Each problem is worth 10 points. The maximum score on this exam is 50 points.

More information

MATH 304 Linear Algebra Lecture 33: Bases of eigenvectors. Diagonalization.

MATH 304 Linear Algebra Lecture 33: Bases of eigenvectors. Diagonalization. MATH 304 Linear Algebra Lecture 33: Bases of eigenvectors. Diagonalization. Eigenvalues and eigenvectors of an operator Definition. Let V be a vector space and L : V V be a linear operator. A number λ

More information

Symmetric and anti symmetric matrices

Symmetric and anti symmetric matrices Symmetric and anti symmetric matrices In linear algebra, a symmetric matrix is a square matrix that is equal to its transpose. Formally, matrix A is symmetric if. A = A Because equal matrices have equal

More information

Course 216: Ordinary Differential Equations

Course 216: Ordinary Differential Equations Course 16: Ordinary Differential Equations Notes by Chris Blair These notes cover the ODEs course given in 7-8 by Dr. John Stalker. Contents I Solving Linear ODEs 1 Reduction of Order Computing Matrix

More information

ft-uiowa-math2550 Assignment NOTRequiredJustHWformatOfQuizReviewForExam3part2 due 12/31/2014 at 07:10pm CST

ft-uiowa-math2550 Assignment NOTRequiredJustHWformatOfQuizReviewForExam3part2 due 12/31/2014 at 07:10pm CST me me ft-uiowa-math2550 Assignment NOTRequiredJustHWformatOfQuizReviewForExam3part2 due 12/31/2014 at 07:10pm CST 1. (1 pt) local/library/ui/eigentf.pg A is n n an matrices.. There are an infinite number

More information

IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET

IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET This is a (not quite comprehensive) list of definitions and theorems given in Math 1553. Pay particular attention to the ones in red. Study Tip For each

More information

Supplement til SDL, Blok

Supplement til SDL, Blok Supplement til SDL, Blok 1 2007 NOTES TO THE COURSE ON ORDINARY DIFFERENTIAL EQUATIONS Inst. f. Matematiske Fag Gerd Grubb August 2007 This is a supplement to the text in [BN], short for F. Brauer and

More information

MATH 431: FIRST MIDTERM. Thursday, October 3, 2013.

MATH 431: FIRST MIDTERM. Thursday, October 3, 2013. MATH 431: FIRST MIDTERM Thursday, October 3, 213. (1) An inner product on the space of matrices. Let V be the vector space of 2 2 real matrices (that is, the algebra Mat 2 (R), but without the mulitiplicative

More information

Mathematical Modeling I

Mathematical Modeling I Mathematical Modeling I Dr. Zachariah Sinkala Department of Mathematical Sciences Middle Tennessee State University Murfreesboro Tennessee 37132, USA November 5, 2011 1d systems To understand more complex

More information

Lecture Note 12: The Eigenvalue Problem

Lecture Note 12: The Eigenvalue Problem MATH 5330: Computational Methods of Linear Algebra Lecture Note 12: The Eigenvalue Problem 1 Theoretical Background Xianyi Zeng Department of Mathematical Sciences, UTEP The eigenvalue problem is a classical

More information

DM554 Linear and Integer Programming. Lecture 9. Diagonalization. Marco Chiarandini

DM554 Linear and Integer Programming. Lecture 9. Diagonalization. Marco Chiarandini DM554 Linear and Integer Programming Lecture 9 Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark Outline 1. More on 2. 3. 2 Resume Linear transformations and

More information

Spring 2019 Exam 2 3/27/19 Time Limit: / Problem Points Score. Total: 280

Spring 2019 Exam 2 3/27/19 Time Limit: / Problem Points Score. Total: 280 Math 307 Spring 2019 Exam 2 3/27/19 Time Limit: / Name (Print): Problem Points Score 1 15 2 20 3 35 4 30 5 10 6 20 7 20 8 20 9 20 10 20 11 10 12 10 13 10 14 10 15 10 16 10 17 10 Total: 280 Math 307 Exam

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

0.1 Rational Canonical Forms

0.1 Rational Canonical Forms We have already seen that it is useful and simpler to study linear systems using matrices. But matrices are themselves cumbersome, as they are stuffed with many entries, and it turns out that it s best

More information

Eigenspaces. (c) Find the algebraic multiplicity and the geometric multiplicity for the eigenvaules of A.

Eigenspaces. (c) Find the algebraic multiplicity and the geometric multiplicity for the eigenvaules of A. Eigenspaces 1. (a) Find all eigenvalues and eigenvectors of A = (b) Find the corresponding eigenspaces. [ ] 1 1 1 Definition. If A is an n n matrix and λ is a scalar, the λ-eigenspace of A (usually denoted

More information

Remark 1 By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero.

Remark 1 By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero. Sec 5 Eigenvectors and Eigenvalues In this chapter, vector means column vector Definition An eigenvector of an n n matrix A is a nonzero vector x such that A x λ x for some scalar λ A scalar λ is called

More information

av 1 x 2 + 4y 2 + xy + 4z 2 = 16.

av 1 x 2 + 4y 2 + xy + 4z 2 = 16. 74 85 Eigenanalysis The subject of eigenanalysis seeks to find a coordinate system, in which the solution to an applied problem has a simple expression Therefore, eigenanalysis might be called the method

More information

Math 21b. Review for Final Exam

Math 21b. Review for Final Exam Math 21b. Review for Final Exam Thomas W. Judson Spring 2003 General Information The exam is on Thursday, May 15 from 2:15 am to 5:15 pm in Jefferson 250. Please check with the registrar if you have a

More information

w T 1 w T 2. w T n 0 if i j 1 if i = j

w T 1 w T 2. w T n 0 if i j 1 if i = j Lyapunov Operator Let A F n n be given, and define a linear operator L A : C n n C n n as L A (X) := A X + XA Suppose A is diagonalizable (what follows can be generalized even if this is not possible -

More information

Notes on the matrix exponential

Notes on the matrix exponential Notes on the matrix exponential Erik Wahlén erik.wahlen@math.lu.se February 14, 212 1 Introduction The purpose of these notes is to describe how one can compute the matrix exponential e A when A is not

More information

Lecture 10 - Eigenvalues problem

Lecture 10 - Eigenvalues problem Lecture 10 - Eigenvalues problem Department of Computer Science University of Houston February 28, 2008 1 Lecture 10 - Eigenvalues problem Introduction Eigenvalue problems form an important class of problems

More information

ALGEBRA QUALIFYING EXAM PROBLEMS LINEAR ALGEBRA

ALGEBRA QUALIFYING EXAM PROBLEMS LINEAR ALGEBRA ALGEBRA QUALIFYING EXAM PROBLEMS LINEAR ALGEBRA Kent State University Department of Mathematical Sciences Compiled and Maintained by Donald L. White Version: August 29, 2017 CONTENTS LINEAR ALGEBRA AND

More information