Quadratic Matrix Polynomials

Size: px
Start display at page:

Download "Quadratic Matrix Polynomials"

Transcription

1 Research Triangularization Matters of Quadratic Matrix Polynomials February 25, 2009 Nick Françoise Higham Tisseur Director School of of Research Mathematics The University of Manchester School of Mathematics Joint work with Yuji Nakatsukasa (M/cr), Leo Taslaman (M/cr) and Ion Zaballa (Universidad del País Vasco) SIAM Conference on Applied Linear Algebra, June / 6

2 Reduction to Triangular Forms Let A, B C n n and let T A, T B denote triangular matrices. Single matrices: there exists U C n n such that U AU = T A, U U = I, (Schur decomp.). Pair of matrices: there exist unitary U, V C n n s.t. U AV = T A, U BV = T B, (generalized Schur decomp.). These reductions have many applications (eigenvalue computation, matrix function computation,... ). Can we extend these reductions to matrix triples? MIMS Françoise Tisseur Triangularization 2 / 21

3 Extension to Matrix Triples Let Q(λ) = λ 2 M + λd + K be regular (det Q(λ) 0). Suppose there exist U, V nonsingular s.t. UQ(λ)V = λ 2 T M + λt D + T K = T (λ) is triangular. Roots λ (1) j, λ (2) j of λ 2 (T M ) jj + λ(t D ) jj + (T K ) jj are e vals of Q(λ). Q(λ (k) 1 )v 1 = U 1 T (λ (k) 1 )e 1 = 0, k = 1, 2. So λ (1) 1 and λ (2) 1 must have the same e vec a strong condition! We can forget about simultaneous triangularization... " Charlie Van Loan, CP3, Monday Use U(λ), V (λ) unimodular instead! MIMS Françoise Tisseur Triangularization 3 / 21

4 Equivalences Definition Two matrix polynomials Q(λ), T (λ) are equivalent if there are unimodular U(λ), V (λ) s.t. T (λ) = U(λ)Q(λ)V (λ). Q(λ) and T (λ) have the same finite elementary divisors. Need equivalence transformations preserving the degree (want Q(λ), T (λ) to be quadratic), the elementary divisors at infinity (i.e., the elementary divisors at 0 of revq(λ) = λ 2 Q(1/λ) = λ 2 K + λd + M). MIMS Françoise Tisseur Triangularization 4 / 21

5 Elementary Divisors at Infinity L(λ) = λ has one linear elementary divisors at 0 and two linear elementary at. Now 1 λ L(λ) = λ , }{{} unimodular has one linear elementary divisor at 0 and one elementary divisor at with partial multiplicity 2. Equivalences can modify the partial multiplicities at. MIMS Françoise Tisseur Triangularization 5 / 21

6 Triangularization by Strong Equivalences Theorem (Zaballa & T, 2012) Any regular Q(λ) = λ 2 M + λd + K is strongly equivalent over C[λ] to triangular T (λ) = λ 2 T M + λt D + T K, i.e., there are unimodular U(λ), V (λ) s.t. T (λ) = U(λ)Q(λ)V (λ) has same finite and infinite elementary divisors as Q(λ). Byproduct of solution to quadratic realizability problem, D.S. Mackey (MS68). Proved by Gohberg, Lancaster & Rodman (1982) for monic polynomials of arbitrary degree. Extended to regular/singular polynomials of arbitrary degree by Taslaman, Nakatsukasa, Zaballa & T. (2012). How to numerically compute T (λ)? MIMS Françoise Tisseur Triangularization 6 / 21

7 Structure Preserving Transformation (SPT) Q(λ) = λ 2 M + λd + K, [ ] I 0 C Q (λ) = λ + 0 M [ 0 K I D ]. Q(λ) C Q (λ) (strong) equivalence U(λ)Q(λ)V (λ) SPT S L C Q (λ)s R T (λ) linearization quadratization C T (λ) MIMS Françoise Tisseur Triangularization 7 / 21

8 A Simple MATLAB Code Let Q(λ) = λ 2 I + λd + K be n n. A = [zeros(n) -K; eye(n) -D]; [U,T] = schur(a, complex ); X =(U(:,1:2:2*n-1)+U(:,2:2:2*n))/sqrt(2); S = [X A*X]; At = S\A*S; MIMS Françoise Tisseur Triangularization 8 / 21

9 A Simple MATLAB Code Let Q(λ) = λ 2 I + λd + K be n n. A = [zeros(n) -K; eye(n) -D]; [U,T] = schur(a, complex ); X =(U(:,1:2:2*n-1)+U(:,2:2:2*n))/sqrt(2); S = [X A*X]; At = S\A*S; [ ] 0 TK A T = is in companion form. I T D T (λ) = λ 2 I + λt D + T K : upper triang., Λ(Q) = Λ(T ). S is an SPT. Cols of X C 2n n are orthonormal. MIMS Françoise Tisseur Triangularization 8 / 21

10 Schur s Theorem for Complex Matrices Matrix version: if A C n n then there exists a unitary U such that U AU = T is a triangular matrix. Subspaces version: Theorem Let A C n n. There are subspaces V 1,..., V n of C n satisfying (i) C n = V 1 V 2 V n, (ii) for k = 1: n, V 1 V k, is A-invariant, (iii) for k = 1: n, V k = u k, where u 1,... u n form an orthonormal system of vectors of C n. MIMS Françoise Tisseur Triangularization 9 / 21

11 Schur-like Theorem for Q(λ) Let Q(λ) = λ 2 M + λd + K, det M 0. Theorem (Zaballa, T., 2012) Let λi A C[λ] 2n 2n be a linearization of n n Q(λ). There are subspaces V 1,..., V n of C 2n satisfying (i) C 2n = V 1 V 2 V n, (ii) for k = 1: n, V 1 V k is A-invariant, (iii) for k = 1: n, dim V k = 2 and V k = x k, Ax k, where x 1,... x n form an orthogonal system of vectors of C 2n. V k = x k, Ax k is a Krylov subspace of dimension 2. The x j are generating vectors. If X = [x 1... x n ] then S = [X AX] is nonsingular. MIMS Françoise Tisseur Triangularization 10 / 21

12 Triangularizing SPT for Q(λ) = λ 2 M + λd + K Let S = [X AX], where X contains generating vectors for linearization λi A of Q(λ). [ ] S 1 B11 B AS =: B A[X AX] = [X AX] 12. B 21 B 22 [ ] [ ] B11 0 = and hence B has companion form. I B 21 x 1, Ax 1, x k, Ax k A-invariant B 12 and B 22 are upper triangular. S = [X AX] is a triangularizing SPT. MIMS Françoise Tisseur Triangularization 11 / 21

13 Schur-like Theorem: Matrix Form Let Q(λ) = λ 2 M + λd + K C[λ] n n with det(m) 0. Theorem (Zaballa, T., 2012) For any linearization λi A of Q(λ), there exists U C 2n n with orthonormal columns s.t. [U AU] is nonsingular and [ ] 0 [U AU] 1 T0 A[U AU] =, I n T 1 where I n λ 2 + T 1 λ + T 0 is triangular and equivalent to Q(λ). The columns of U are generating vectors for A. Extends to arbitrary degree matrix polynomials. MIMS Françoise Tisseur Triangularization 12 / 21

14 Generating Vectors from Schur Vectors Theorem (Nakatsukasa, Taslaman, Zaballa & T, 2012) Let A C 2n 2n have Schur decomposition T 11 T 1n U AU =...., T ij C 2 2. T nn [ ] νj1 If there is v j = s.t. T jj v j α j v j, j = 1: n then cols of ν j2 X = Udiag(v 1,..., v n ) = [ν 11 u 1 + ν 12 u 2,... ν n1 u 2n 1 + ν n2 u 2n ] are generating vectors. Hence [ 0 [X AX] 1 TK A[X AX] = I T D where T D, T K are upper triangular. MIMS Françoise Tisseur Triangularization 13 / 21 ],

15 Schur form with Nonderogatory Blocks If T jj αi 2, i.e., T jj is nonderogatory then there exists 0 v j C 2 s.t. v j is not an e vec of T jj. Theorem (Nakatsukasa, Taslaman, Zaballa, T., 2012) Any Schur form T of a linearization A C 2n 2n of Q(λ) C[λ] n n is unitarily similar to a Schur form T with nonderogatory 2 2 diagonal blocks. Proof is constructive and nontrivial. Relies on the property that λ Λ(A) = Λ(Q) has geometric multiplicity less or equal to n. MIMS Françoise Tisseur Triangularization 14 / 21

16 Triangular Matrix Coefficients Q(λ) is equivalent to triangular T (λ) = λ 2 T M + λt D + T K. Have explicit expressions for T M, T D, T K in terms of either the n orthonormal generating vectors for A, or the Schur form T of A, (or Jordan form of A, see Taslaman MS 35) where λi A is a linearization of Q(λ) C[λ] n n with nonsingular leading coeff. MIMS Françoise Tisseur Triangularization 15 / 21

17 Triangular Coefficients from Schur Form Let λi A be a linearization of Q(λ) = λ 2 M + λd + K with T 11 T 1n Schur form T =....,T jj C 2 2 nonderogatory. T nn Take v i, w i C 2 s.t. v i 2 = w i 2 = 1, T ii v i αv i, w i v i = 0, V = diag(v 1,..., v n ) C 2n n, W = diag(w 1,..., w n ) C 2n n. Q(λ) is equivalent to T (λ) = λ 2 T M + λt D + T K, where are triangular. T M = W TV, T D = W T 2 V, T K = T M ((V TV )T D (V T 2 V )) MIMS Françoise Tisseur Triangularization 16 / 21

18 Triangularizing SPT S Let S [ = [X AX], where ] X contains generating [ vectors ] for 0 KM 1 0 A = I DM 1 so that S 1 TK AS = =: A I T T. D S 1 = [ Y A T Y ], Y C 2n n [Garvey et al., 2011]. Can construct Y from generating vectors X and M, D, K. No need to factorize (invert) S. MIMS Françoise Tisseur Triangularization 17 / 21

19 Linear Systems Let S = [X AX] = [Y A T Y ] 1 and X = For every λ / Λ(Q), [ X1 X 2 ], Y = [ Y1 Q(λ) 1 = ( X 1 + λx 2 )T (λ) 1 (Y 1 + λy 2 ) X 2 Y 2, where X 1 = X 1 DX 2 + X 2 T D. Y 2 ]. MIMS Françoise Tisseur Triangularization 18 / 21

20 Linear Systems Let S = [X AX] = [Y A T Y ] 1 and X = For every λ / Λ(Q), [ X1 X 2 ], Y = [ Y1 Q(λ) 1 = ( X 1 + λx 2 )T (λ) 1 (Y 1 + λy 2 ) X 2 Y 2, where X 1 = X 1 DX 2 + X 2 T D. Applications Solving for x, Q(ω)x = b for many values of ω [ω l, ω h ], ω l ω h. Evaluation of transfer function: G(s) = c T Q(s) 1 b. Y 2 ]. MIMS Françoise Tisseur Triangularization 18 / 21

21 Triangularization over R Theorem (Zaballa & T, 2012) Q(λ) R[λ] n n is triangularizable over R[λ] if and only if where p n n c, 2n c is the number of nonreal e vals and p is the largest geometric multiplicity of the real e vals and e vals at infinity. Q(λ) R[λ] 3 3 with elementary divisors in R: (λ 1), (λ 1), (λ 2 + 1) 2 is not triangularizable over R[λ] since p = 2 > n n c = 3 2 = 1. MIMS Françoise Tisseur Triangularization 19 / 21

22 Quasi-triangular Quadratics [Zaballa & T, 2012] Any quadratic Q(λ) R[λ] n n is strongly equivalent to a quadratic of the form T (λ) = 2r 2n 2r [ ] 2r T 1 (λ) T 3 (λ), 2n 2r 0 T 2 (λ) where r = max{0, p + n c n} and T 1 (λ) is quasi-triangular with r 2 2 diag. blocks with elementary divisors (λ λ 1 ), (λ λ 1 ), (λ 2 + d i λ + k i ). Here, λ 1 R has largest geometric multiplicity p. T 2 (λ) is triangular. (Q(λ) has 2n c nonreal e vals.) MIMS Françoise Tisseur Triangularization 20 / 21

23 Summary and Concluding Remarks Any regular quadratic is strongly equivalent to a triangular quadratic. There is a Schur-like theorem for quadratic matrix polynomials. Triangularizing SPTs are defined by n orthonormal (generating) vectors. Can competitive algorithms be designed that compute sets of n orthonormal generating vectors? Subspace iteration, Krylov subspace methods are worth exploring. MIMS Françoise Tisseur Triangularization 21 / 21

24 References I S. D. Garvey, P. Lancaster, A. A. Popov, U. Prells, and I. Zaballa. Filters connecting isospectral quadratic systems. To appear in Linear Algebra Appl., Y. Nakatsukasa, L. Taslaman, and F. Tisseur. Reduction of matrix polynomials to simpler forms. Technical report, Manchester Institute for Mathematical Sciences, The University of Manchester, UK, In preparation. MIMS Françoise Tisseur Triangularization 20 / 21

25 References II L. Taslaman and F. Tisseur. Triangularization of matrix polynomials. Technical report, Manchester Institute for Mathematical Sciences, The University of Manchester, UK, In preparation. F. Tisseur and I. Zaballa. Triangularizing quadratic matrix polynomials. MIMS EPrint , Manchester Institute for Mathematical Sciences, The University of Manchester, UK, MIMS Françoise Tisseur Triangularization 21 / 21

Reduction of matrix polynomials to simpler forms. Nakatsukasa, Yuji and Taslaman, Leo and Tisseur, Francoise and Zaballa, Ion. MIMS EPrint: 2017.

Reduction of matrix polynomials to simpler forms. Nakatsukasa, Yuji and Taslaman, Leo and Tisseur, Francoise and Zaballa, Ion. MIMS EPrint: 2017. Reduction of matrix polynomials to simpler forms Nakatsukasa, Yuji and Taslaman, Leo and Tisseur, Francoise and Zaballa, Ion 217 MIMS EPrint: 217.13 Manchester Institute for Mathematical Sciences School

More information

Recent Advances in the Numerical Solution of Quadratic Eigenvalue Problems

Recent Advances in the Numerical Solution of Quadratic Eigenvalue Problems Recent Advances in the Numerical Solution of Quadratic Eigenvalue Problems Françoise Tisseur School of Mathematics The University of Manchester ftisseur@ma.man.ac.uk http://www.ma.man.ac.uk/~ftisseur/

More information

Algorithms for Solving the Polynomial Eigenvalue Problem

Algorithms for Solving the Polynomial Eigenvalue Problem Algorithms for Solving the Polynomial Eigenvalue Problem Nick Higham School of Mathematics The University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/ Joint work with D. Steven Mackey

More information

Triangularizing matrix polynomials. Taslaman, Leo and Tisseur, Francoise and Zaballa, Ion. MIMS EPrint:

Triangularizing matrix polynomials. Taslaman, Leo and Tisseur, Francoise and Zaballa, Ion. MIMS EPrint: Triangularizing matrix polynomials Taslaman, Leo and Tisseur, Francoise and Zaballa, Ion 2012 MIMS EPrint: 2012.77 Manchester Institute for Mathematical Sciences School of Mathematics The University of

More information

Scaling, Sensitivity and Stability in Numerical Solution of the Quadratic Eigenvalue Problem

Scaling, Sensitivity and Stability in Numerical Solution of the Quadratic Eigenvalue Problem Scaling, Sensitivity and Stability in Numerical Solution of the Quadratic Eigenvalue Problem Nick Higham School of Mathematics The University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/

More information

Research Matters. February 25, The Nonlinear Eigenvalue Problem. Nick Higham. Part III. Director of Research School of Mathematics

Research Matters. February 25, The Nonlinear Eigenvalue Problem. Nick Higham. Part III. Director of Research School of Mathematics Research Matters February 25, 2009 The Nonlinear Eigenvalue Problem Nick Higham Part III Director of Research School of Mathematics Françoise Tisseur School of Mathematics The University of Manchester

More information

The quadratic eigenvalue problem (QEP) is to find scalars λ and nonzero vectors u satisfying

The quadratic eigenvalue problem (QEP) is to find scalars λ and nonzero vectors u satisfying I.2 Quadratic Eigenvalue Problems 1 Introduction The quadratic eigenvalue problem QEP is to find scalars λ and nonzero vectors u satisfying where Qλx = 0, 1.1 Qλ = λ 2 M + λd + K, M, D and K are given

More information

Finite and Infinite Elementary Divisors of Matrix Polynomials: A Global Approach. Zaballa, Ion and Tisseur, Francoise. MIMS EPrint: 2012.

Finite and Infinite Elementary Divisors of Matrix Polynomials: A Global Approach. Zaballa, Ion and Tisseur, Francoise. MIMS EPrint: 2012. Finite and Infinite Elementary Divisors of Matrix Polynomials: A Global Approach Zaballa, Ion and Tisseur, Francoise 2012 MIMS EPrint: 201278 Manchester Institute for Mathematical Sciences School of Mathematics

More information

An Algorithm for. Nick Higham. Françoise Tisseur. Director of Research School of Mathematics.

An Algorithm for. Nick Higham. Françoise Tisseur. Director of Research School of Mathematics. An Algorithm for the Research Complete Matters Solution of Quadratic February Eigenvalue 25, 2009 Problems Nick Higham Françoise Tisseur Director of Research School of Mathematics The School University

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 16: Eigenvalue Problems; Similarity Transformations Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical Analysis I 1 / 18 Eigenvalue

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

Solving Polynomial Eigenproblems by Linearization

Solving Polynomial Eigenproblems by Linearization Solving Polynomial Eigenproblems by Linearization Nick Higham School of Mathematics University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/ Joint work with D. Steven Mackey and Françoise

More information

ELA

ELA SHARP LOWER BOUNDS FOR THE DIMENSION OF LINEARIZATIONS OF MATRIX POLYNOMIALS FERNANDO DE TERÁN AND FROILÁN M. DOPICO Abstract. A standard way of dealing with matrixpolynomial eigenvalue problems is to

More information

Numerical Methods for Solving Large Scale Eigenvalue Problems

Numerical Methods for Solving Large Scale Eigenvalue Problems Peter Arbenz Computer Science Department, ETH Zürich E-mail: arbenz@inf.ethz.ch arge scale eigenvalue problems, Lecture 2, February 28, 2018 1/46 Numerical Methods for Solving Large Scale Eigenvalue Problems

More information

Eigenvalue and Eigenvector Problems

Eigenvalue and Eigenvector Problems Eigenvalue and Eigenvector Problems An attempt to introduce eigenproblems Radu Trîmbiţaş Babeş-Bolyai University April 8, 2009 Radu Trîmbiţaş ( Babeş-Bolyai University) Eigenvalue and Eigenvector Problems

More information

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 Instructions Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 The exam consists of four problems, each having multiple parts. You should attempt to solve all four problems. 1.

More information

Hermitian Matrix Polynomials with Real Eigenvalues of Definite Type. Part I: Classification. Al-Ammari, Maha and Tisseur, Francoise

Hermitian Matrix Polynomials with Real Eigenvalues of Definite Type. Part I: Classification. Al-Ammari, Maha and Tisseur, Francoise Hermitian Matrix Polynomials with Real Eigenvalues of Definite Type. Part I: Classification Al-Ammari, Maha and Tisseur, Francoise 2010 MIMS EPrint: 2010.9 Manchester Institute for Mathematical Sciences

More information

Definite versus Indefinite Linear Algebra. Christian Mehl Institut für Mathematik TU Berlin Germany. 10th SIAM Conference on Applied Linear Algebra

Definite versus Indefinite Linear Algebra. Christian Mehl Institut für Mathematik TU Berlin Germany. 10th SIAM Conference on Applied Linear Algebra Definite versus Indefinite Linear Algebra Christian Mehl Institut für Mathematik TU Berlin Germany 10th SIAM Conference on Applied Linear Algebra Monterey Bay Seaside, October 26-29, 2009 Indefinite Linear

More information

On the reduction of matrix polynomials to Hessenberg form

On the reduction of matrix polynomials to Hessenberg form Electronic Journal of Linear Algebra Volume 3 Volume 3: (26) Article 24 26 On the reduction of matrix polynomials to Hessenberg form Thomas R. Cameron Washington State University, tcameron@math.wsu.edu

More information

Solving the Polynomial Eigenvalue Problem by Linearization

Solving the Polynomial Eigenvalue Problem by Linearization Solving the Polynomial Eigenvalue Problem by Linearization Nick Higham School of Mathematics The University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/ Joint work with Ren-Cang Li,

More information

Eigenvector error bound and perturbation for nonlinear eigenvalue problems

Eigenvector error bound and perturbation for nonlinear eigenvalue problems Eigenvector error bound and perturbation for nonlinear eigenvalue problems Yuji Nakatsukasa School of Mathematics University of Tokyo Joint work with Françoise Tisseur Workshop on Nonlinear Eigenvalue

More information

Inverse Eigenvalue Problem with Non-simple Eigenvalues for Damped Vibration Systems

Inverse Eigenvalue Problem with Non-simple Eigenvalues for Damped Vibration Systems Journal of Informatics Mathematical Sciences Volume 1 (2009), Numbers 2 & 3, pp. 91 97 RGN Publications (Invited paper) Inverse Eigenvalue Problem with Non-simple Eigenvalues for Damped Vibration Systems

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors Chapter 1 Eigenvalues and Eigenvectors Among problems in numerical linear algebra, the determination of the eigenvalues and eigenvectors of matrices is second in importance only to the solution of linear

More information

On the Definition of Two Natural Classes of Scalar Product

On the Definition of Two Natural Classes of Scalar Product On the Definition of Two Natural Classes of Scalar Product D. Steven Mackey, Niloufer Mackey and Françoise Tisseur Abstract. We identify two natural classes of scalar product, termed unitary and orthosymmetric,

More information

that determines x up to a complex scalar of modulus 1, in the real case ±1. Another condition to normalize x is by requesting that

that determines x up to a complex scalar of modulus 1, in the real case ±1. Another condition to normalize x is by requesting that Chapter 3 Newton methods 3. Linear and nonlinear eigenvalue problems When solving linear eigenvalue problems we want to find values λ C such that λi A is singular. Here A F n n is a given real or complex

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis (Numerical Linear Algebra for Computational and Data Sciences) Lecture 14: Eigenvalue Problems; Eigenvalue Revealing Factorizations Xiangmin Jiao Stony Brook University Xiangmin

More information

Diagonalization of Matrix

Diagonalization of Matrix of Matrix King Saud University August 29, 2018 of Matrix Table of contents 1 2 of Matrix Definition If A M n (R) and λ R. We say that λ is an eigenvalue of the matrix A if there is X R n \ {0} such that

More information

Linear Algebra and its Applications

Linear Algebra and its Applications Linear Algebra and its Applications 436 (2012) 3954 3973 Contents lists available at ScienceDirect Linear Algebra and its Applications journal homepage: www.elsevier.com/locate/laa Hermitian matrix polynomials

More information

Applied Mathematics 205. Unit V: Eigenvalue Problems. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit V: Eigenvalue Problems. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit V: Eigenvalue Problems Lecturer: Dr. David Knezevic Unit V: Eigenvalue Problems Chapter V.2: Fundamentals 2 / 31 Eigenvalues and Eigenvectors Eigenvalues and eigenvectors of

More information

Trimmed linearizations for structured matrix polynomials

Trimmed linearizations for structured matrix polynomials Trimmed linearizations for structured matrix polynomials Ralph Byers Volker Mehrmann Hongguo Xu January 5 28 Dedicated to Richard S Varga on the occasion of his 8th birthday Abstract We discuss the eigenvalue

More information

Math 108b: Notes on the Spectral Theorem

Math 108b: Notes on the Spectral Theorem Math 108b: Notes on the Spectral Theorem From section 6.3, we know that every linear operator T on a finite dimensional inner product space V has an adjoint. (T is defined as the unique linear operator

More information

Numerical Methods I Eigenvalue Problems

Numerical Methods I Eigenvalue Problems Numerical Methods I Eigenvalue Problems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 2nd, 2014 A. Donev (Courant Institute) Lecture

More information

Nonlinear palindromic eigenvalue problems and their numerical solution

Nonlinear palindromic eigenvalue problems and their numerical solution Nonlinear palindromic eigenvalue problems and their numerical solution TU Berlin DFG Research Center Institut für Mathematik MATHEON IN MEMORIAM RALPH BYERS Polynomial eigenvalue problems k P(λ) x = (

More information

Question: Given an n x n matrix A, how do we find its eigenvalues? Idea: Suppose c is an eigenvalue of A, then what is the determinant of A-cI?

Question: Given an n x n matrix A, how do we find its eigenvalues? Idea: Suppose c is an eigenvalue of A, then what is the determinant of A-cI? Section 5. The Characteristic Polynomial Question: Given an n x n matrix A, how do we find its eigenvalues? Idea: Suppose c is an eigenvalue of A, then what is the determinant of A-cI? Property The eigenvalues

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

Off-diagonal perturbation, first-order approximation and quadratic residual bounds for matrix eigenvalue problems

Off-diagonal perturbation, first-order approximation and quadratic residual bounds for matrix eigenvalue problems Off-diagonal perturbation, first-order approximation and quadratic residual bounds for matrix eigenvalue problems Yuji Nakatsukasa Abstract When a symmetric block diagonal matrix [ A 1 A2 ] undergoes an

More information

EIGENVALUE PROBLEMS. Background on eigenvalues/ eigenvectors / decompositions. Perturbation analysis, condition numbers..

EIGENVALUE PROBLEMS. Background on eigenvalues/ eigenvectors / decompositions. Perturbation analysis, condition numbers.. EIGENVALUE PROBLEMS Background on eigenvalues/ eigenvectors / decompositions Perturbation analysis, condition numbers.. Power method The QR algorithm Practical QR algorithms: use of Hessenberg form and

More information

MATHEMATICAL ENGINEERING TECHNICAL REPORTS. Eigenvector Error Bound and Perturbation for Polynomial and Rational Eigenvalue Problems

MATHEMATICAL ENGINEERING TECHNICAL REPORTS. Eigenvector Error Bound and Perturbation for Polynomial and Rational Eigenvalue Problems MATHEMATICAL ENGINEERING TECHNICAL REPORTS Eigenvector Error Bound and Perturbation for Polynomial and Rational Eigenvalue Problems Yuji NAKATSUKASA and Françoise TISSEUR METR 2016 04 April 2016 DEPARTMENT

More information

Matrix Theory, Math6304 Lecture Notes from September 27, 2012 taken by Tasadduk Chowdhury

Matrix Theory, Math6304 Lecture Notes from September 27, 2012 taken by Tasadduk Chowdhury Matrix Theory, Math634 Lecture Notes from September 27, 212 taken by Tasadduk Chowdhury Last Time (9/25/12): QR factorization: any matrix A M n has a QR factorization: A = QR, whereq is unitary and R is

More information

Linear Algebra: Matrix Eigenvalue Problems

Linear Algebra: Matrix Eigenvalue Problems CHAPTER8 Linear Algebra: Matrix Eigenvalue Problems Chapter 8 p1 A matrix eigenvalue problem considers the vector equation (1) Ax = λx. 8.0 Linear Algebra: Matrix Eigenvalue Problems Here A is a given

More information

2 Computing complex square roots of a real matrix

2 Computing complex square roots of a real matrix On computing complex square roots of real matrices Zhongyun Liu a,, Yulin Zhang b, Jorge Santos c and Rui Ralha b a School of Math., Changsha University of Science & Technology, Hunan, 410076, China b

More information

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination Math 0, Winter 07 Final Exam Review Chapter. Matrices and Gaussian Elimination { x + x =,. Different forms of a system of linear equations. Example: The x + 4x = 4. [ ] [ ] [ ] vector form (or the column

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

CSL361 Problem set 4: Basic linear algebra

CSL361 Problem set 4: Basic linear algebra CSL361 Problem set 4: Basic linear algebra February 21, 2017 [Note:] If the numerical matrix computations turn out to be tedious, you may use the function rref in Matlab. 1 Row-reduced echelon matrices

More information

Study Guide for Linear Algebra Exam 2

Study Guide for Linear Algebra Exam 2 Study Guide for Linear Algebra Exam 2 Term Vector Space Definition A Vector Space is a nonempty set V of objects, on which are defined two operations, called addition and multiplication by scalars (real

More information

Notes on Eigenvalues, Singular Values and QR

Notes on Eigenvalues, Singular Values and QR Notes on Eigenvalues, Singular Values and QR Michael Overton, Numerical Computing, Spring 2017 March 30, 2017 1 Eigenvalues Everyone who has studied linear algebra knows the definition: given a square

More information

BASIC ALGORITHMS IN LINEAR ALGEBRA. Matrices and Applications of Gaussian Elimination. A 2 x. A T m x. A 1 x A T 1. A m x

BASIC ALGORITHMS IN LINEAR ALGEBRA. Matrices and Applications of Gaussian Elimination. A 2 x. A T m x. A 1 x A T 1. A m x BASIC ALGORITHMS IN LINEAR ALGEBRA STEVEN DALE CUTKOSKY Matrices and Applications of Gaussian Elimination Systems of Equations Suppose that A is an n n matrix with coefficents in a field F, and x = (x,,

More information

Draft. Lecture 14 Eigenvalue Problems. MATH 562 Numerical Analysis II. Songting Luo. Department of Mathematics Iowa State University

Draft. Lecture 14 Eigenvalue Problems. MATH 562 Numerical Analysis II. Songting Luo. Department of Mathematics Iowa State University Lecture 14 Eigenvalue Problems Songting Luo Department of Mathematics Iowa State University MATH 562 Numerical Analysis II Songting Luo ( Department of Mathematics Iowa State University[0.5in] MATH562

More information

Jordan Structures of Alternating Matrix Polynomials

Jordan Structures of Alternating Matrix Polynomials Jordan Structures of Alternating Matrix Polynomials D. Steven Mackey Niloufer Mackey Christian Mehl Volker Mehrmann August 17, 2009 Abstract Alternating matrix polynomials, that is, polynomials whose coefficients

More information

Eigenvalues, Eigenvectors. Eigenvalues and eigenvector will be fundamentally related to the nature of the solutions of state space systems.

Eigenvalues, Eigenvectors. Eigenvalues and eigenvector will be fundamentally related to the nature of the solutions of state space systems. Chapter 3 Linear Algebra In this Chapter we provide a review of some basic concepts from Linear Algebra which will be required in order to compute solutions of LTI systems in state space form, discuss

More information

Online Exercises for Linear Algebra XM511

Online Exercises for Linear Algebra XM511 This document lists the online exercises for XM511. The section ( ) numbers refer to the textbook. TYPE I are True/False. Lecture 02 ( 1.1) Online Exercises for Linear Algebra XM511 1) The matrix [3 2

More information

EIGENVALUE PROBLEMS. EIGENVALUE PROBLEMS p. 1/4

EIGENVALUE PROBLEMS. EIGENVALUE PROBLEMS p. 1/4 EIGENVALUE PROBLEMS EIGENVALUE PROBLEMS p. 1/4 EIGENVALUE PROBLEMS p. 2/4 Eigenvalues and eigenvectors Let A C n n. Suppose Ax = λx, x 0, then x is a (right) eigenvector of A, corresponding to the eigenvalue

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

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

Last Time. Social Network Graphs Betweenness. Graph Laplacian. Girvan-Newman Algorithm. Spectral Bisection

Last Time. Social Network Graphs Betweenness. Graph Laplacian. Girvan-Newman Algorithm. Spectral Bisection Eigenvalue Problems Last Time Social Network Graphs Betweenness Girvan-Newman Algorithm Graph Laplacian Spectral Bisection λ 2, w 2 Today Small deviation into eigenvalue problems Formulation Standard eigenvalue

More information

Improved Newton s method with exact line searches to solve quadratic matrix equation

Improved Newton s method with exact line searches to solve quadratic matrix equation Journal of Computational and Applied Mathematics 222 (2008) 645 654 wwwelseviercom/locate/cam Improved Newton s method with exact line searches to solve quadratic matrix equation Jian-hui Long, Xi-yan

More information

MATH 423 Linear Algebra II Lecture 20: Geometry of linear transformations. Eigenvalues and eigenvectors. Characteristic polynomial.

MATH 423 Linear Algebra II Lecture 20: Geometry of linear transformations. Eigenvalues and eigenvectors. Characteristic polynomial. MATH 423 Linear Algebra II Lecture 20: Geometry of linear transformations. Eigenvalues and eigenvectors. Characteristic polynomial. Geometric properties of determinants 2 2 determinants and plane geometry

More information

Numerical Methods - Numerical Linear Algebra

Numerical Methods - Numerical Linear Algebra Numerical Methods - Numerical Linear Algebra Y. K. Goh Universiti Tunku Abdul Rahman 2013 Y. K. Goh (UTAR) Numerical Methods - Numerical Linear Algebra I 2013 1 / 62 Outline 1 Motivation 2 Solving Linear

More information

Linear Algebra and its Applications

Linear Algebra and its Applications Linear Algebra and its Applications 430 (2009) 579 586 Contents lists available at ScienceDirect Linear Algebra and its Applications journal homepage: www.elsevier.com/locate/laa Low rank perturbation

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

Skew-Symmetric Matrix Polynomials and their Smith Forms

Skew-Symmetric Matrix Polynomials and their Smith Forms Skew-Symmetric Matrix Polynomials and their Smith Forms D. Steven Mackey Niloufer Mackey Christian Mehl Volker Mehrmann March 23, 2013 Abstract Two canonical forms for skew-symmetric matrix polynomials

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

ANALYSIS OF STRUCTURED POLYNOMIAL EIGENVALUE PROBLEMS

ANALYSIS OF STRUCTURED POLYNOMIAL EIGENVALUE PROBLEMS ANALYSIS OF STRUCTURED POLYNOMIAL EIGENVALUE PROBLEMS A thesis submitted to the University of Manchester for the degree of Doctor of Philosophy in the Faculty of Engineering and Physical Sciences 2011

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 4 Eigenvalue Problems Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction

More information

I. Multiple Choice Questions (Answer any eight)

I. Multiple Choice Questions (Answer any eight) Name of the student : Roll No : CS65: Linear Algebra and Random Processes Exam - Course Instructor : Prashanth L.A. Date : Sep-24, 27 Duration : 5 minutes INSTRUCTIONS: The test will be evaluated ONLY

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

Isospectral Families of High-order Systems

Isospectral Families of High-order Systems Isospectral Families of High-order Systems Peter Lancaster Department of Mathematics and Statistics University of Calgary Calgary T2N 1N4, Alberta, Canada and Uwe Prells School of Mechanical, Materials,

More information

Cheat Sheet for MATH461

Cheat Sheet for MATH461 Cheat Sheet for MATH46 Here is the stuff you really need to remember for the exams Linear systems Ax = b Problem: We consider a linear system of m equations for n unknowns x,,x n : For a given matrix A

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

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

Characteristic Polynomial

Characteristic Polynomial Linear Algebra Massoud Malek Characteristic Polynomial Preleminary Results Let A = (a ij ) be an n n matrix If Au = λu, then λ and u are called the eigenvalue and eigenvector of A, respectively The eigenvalues

More information

The Eigenvalue Problem: Perturbation Theory

The Eigenvalue Problem: Perturbation Theory Jim Lambers MAT 610 Summer Session 2009-10 Lecture 13 Notes These notes correspond to Sections 7.2 and 8.1 in the text. The Eigenvalue Problem: Perturbation Theory The Unsymmetric Eigenvalue Problem Just

More information

ECS231 Handout Subspace projection methods for Solving Large-Scale Eigenvalue Problems. Part I: Review of basic theory of eigenvalue problems

ECS231 Handout Subspace projection methods for Solving Large-Scale Eigenvalue Problems. Part I: Review of basic theory of eigenvalue problems ECS231 Handout Subspace projection methods for Solving Large-Scale Eigenvalue Problems Part I: Review of basic theory of eigenvalue problems 1. Let A C n n. (a) A scalar λ is an eigenvalue of an n n A

More information

Matrix Theory. A.Holst, V.Ufnarovski

Matrix Theory. A.Holst, V.Ufnarovski Matrix Theory AHolst, VUfnarovski 55 HINTS AND ANSWERS 9 55 Hints and answers There are two different approaches In the first one write A as a block of rows and note that in B = E ij A all rows different

More information

Synopsis of Numerical Linear Algebra

Synopsis of Numerical Linear Algebra Synopsis of Numerical Linear Algebra Eric de Sturler Department of Mathematics, Virginia Tech sturler@vt.edu http://www.math.vt.edu/people/sturler Iterative Methods for Linear Systems: Basics to Research

More information

Numerical Linear Algebra Homework Assignment - Week 2

Numerical Linear Algebra Homework Assignment - Week 2 Numerical Linear Algebra Homework Assignment - Week 2 Đoàn Trần Nguyên Tùng Student ID: 1411352 8th October 2016 Exercise 2.1: Show that if a matrix A is both triangular and unitary, then it is diagonal.

More information

Orthogonal iteration revisited

Orthogonal iteration revisited Week 10 11: Friday, Oct 30 and Monday, Nov 2 Orthogonal iteration revisited Last time, we described a generalization of the power methods to compute invariant subspaces. That is, starting from some initial

More information

Matrices, Moments and Quadrature, cont d

Matrices, Moments and Quadrature, cont d Jim Lambers CME 335 Spring Quarter 2010-11 Lecture 4 Notes Matrices, Moments and Quadrature, cont d Estimation of the Regularization Parameter Consider the least squares problem of finding x such that

More information

Jordan Normal Form. Chapter Minimal Polynomials

Jordan Normal Form. Chapter Minimal Polynomials Chapter 8 Jordan Normal Form 81 Minimal Polynomials Recall p A (x) =det(xi A) is called the characteristic polynomial of the matrix A Theorem 811 Let A M n Then there exists a unique monic polynomial q

More information

Research Matters. February 25, The Nonlinear Eigenvalue. Director of Research School of Mathematics

Research Matters. February 25, The Nonlinear Eigenvalue. Director of Research School of Mathematics Research Matters February 25, 2009 The Nonlinear Eigenvalue Nick Problem: HighamPart I Director of Research School of Mathematics Françoise Tisseur School of Mathematics The University of Manchester Woudschoten

More information

MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators.

MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators. MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators. Adjoint operator and adjoint matrix Given a linear operator L on an inner product space V, the adjoint of L is a transformation

More information

Linear Algebra Review. Vectors

Linear Algebra Review. Vectors Linear Algebra Review 9/4/7 Linear Algebra Review By Tim K. Marks UCSD Borrows heavily from: Jana Kosecka http://cs.gmu.edu/~kosecka/cs682.html Virginia de Sa (UCSD) Cogsci 8F Linear Algebra review Vectors

More information

Perturbation theory for eigenvalues of Hermitian pencils. Christian Mehl Institut für Mathematik TU Berlin, Germany. 9th Elgersburg Workshop

Perturbation theory for eigenvalues of Hermitian pencils. Christian Mehl Institut für Mathematik TU Berlin, Germany. 9th Elgersburg Workshop Perturbation theory for eigenvalues of Hermitian pencils Christian Mehl Institut für Mathematik TU Berlin, Germany 9th Elgersburg Workshop Elgersburg, March 3, 2014 joint work with Shreemayee Bora, Michael

More information

Eigenvalue Problems. Eigenvalue problems occur in many areas of science and engineering, such as structural analysis

Eigenvalue Problems. Eigenvalue problems occur in many areas of science and engineering, such as structural analysis Eigenvalue Problems Eigenvalue problems occur in many areas of science and engineering, such as structural analysis Eigenvalues also important in analyzing numerical methods Theory and algorithms apply

More information

EE5120 Linear Algebra: Tutorial 6, July-Dec Covers sec 4.2, 5.1, 5.2 of GS

EE5120 Linear Algebra: Tutorial 6, July-Dec Covers sec 4.2, 5.1, 5.2 of GS EE0 Linear Algebra: Tutorial 6, July-Dec 07-8 Covers sec 4.,.,. of GS. State True or False with proper explanation: (a) All vectors are eigenvectors of the Identity matrix. (b) Any matrix can be diagonalized.

More information

Research CharlieMatters

Research CharlieMatters Research CharlieMatters Van Loan and the Matrix Exponential February 25, 2009 Nick Nick Higham Director Schoolof ofresearch Mathematics The School University of Mathematics of Manchester http://www.maths.manchester.ac.uk/~higham

More information

An Algorithm for the Complete Solution of Quadratic Eigenvalue Problems. Hammarling, Sven and Munro, Christopher J. and Tisseur, Francoise

An Algorithm for the Complete Solution of Quadratic Eigenvalue Problems. Hammarling, Sven and Munro, Christopher J. and Tisseur, Francoise An Algorithm for the Complete Solution of Quadratic Eigenvalue Problems Hammarling, Sven and Munro, Christopher J. and Tisseur, Francoise 2011 MIMS EPrint: 2011.86 Manchester Institute for Mathematical

More information

Linear Algebra. Workbook

Linear Algebra. Workbook Linear Algebra Workbook Paul Yiu Department of Mathematics Florida Atlantic University Last Update: November 21 Student: Fall 2011 Checklist Name: A B C D E F F G H I J 1 2 3 4 5 6 7 8 9 10 xxx xxx xxx

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

Mathematical foundations - linear algebra

Mathematical foundations - linear algebra Mathematical foundations - linear algebra Andrea Passerini passerini@disi.unitn.it Machine Learning Vector space Definition (over reals) A set X is called a vector space over IR if addition and scalar

More information

Foundations of Matrix Analysis

Foundations of Matrix Analysis 1 Foundations of Matrix Analysis In this chapter we recall the basic elements of linear algebra which will be employed in the remainder of the text For most of the proofs as well as for the details, the

More information

Spectral Theorem for Self-adjoint Linear Operators

Spectral Theorem for Self-adjoint Linear Operators Notes for the undergraduate lecture by David Adams. (These are the notes I would write if I was teaching a course on this topic. I have included more material than I will cover in the 45 minute lecture;

More information

1. Introduction. Throughout this work we consider n n matrix polynomials with degree k of the form

1. Introduction. Throughout this work we consider n n matrix polynomials with degree k of the form LINEARIZATIONS OF SINGULAR MATRIX POLYNOMIALS AND THE RECOVERY OF MINIMAL INDICES FERNANDO DE TERÁN, FROILÁN M. DOPICO, AND D. STEVEN MACKEY Abstract. A standard way of dealing with a regular matrix polynomial

More information

LINEAR ALGEBRA SUMMARY SHEET.

LINEAR ALGEBRA SUMMARY SHEET. LINEAR ALGEBRA SUMMARY SHEET RADON ROSBOROUGH https://intuitiveexplanationscom/linear-algebra-summary-sheet/ This document is a concise collection of many of the important theorems of linear algebra, organized

More information

Review of some mathematical tools

Review of some mathematical tools MATHEMATICAL FOUNDATIONS OF SIGNAL PROCESSING Fall 2016 Benjamín Béjar Haro, Mihailo Kolundžija, Reza Parhizkar, Adam Scholefield Teaching assistants: Golnoosh Elhami, Hanjie Pan Review of some mathematical

More information

MATH 20F: LINEAR ALGEBRA LECTURE B00 (T. KEMP)

MATH 20F: LINEAR ALGEBRA LECTURE B00 (T. KEMP) MATH 20F: LINEAR ALGEBRA LECTURE B00 (T KEMP) Definition 01 If T (x) = Ax is a linear transformation from R n to R m then Nul (T ) = {x R n : T (x) = 0} = Nul (A) Ran (T ) = {Ax R m : x R n } = {b R m

More information

Eigenvectors. Prop-Defn

Eigenvectors. Prop-Defn Eigenvectors Aim lecture: The simplest T -invariant subspaces are 1-dim & these give rise to the theory of eigenvectors. To compute these we introduce the similarity invariant, the characteristic polynomial.

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

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

Orthogonal iteration to QR

Orthogonal iteration to QR Week 10: Wednesday and Friday, Oct 24 and 26 Orthogonal iteration to QR On Monday, we went through a somewhat roundabout algbraic path from orthogonal subspace iteration to the QR iteration. Let me start

More information