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

Size: px
Start display at page:

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

Transcription

1 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 of Mathematics of Manchester Joint work with Sven Hammarling and Christopher Munro. 1 / 6

2 Quadratic Eigenvalue Problem (QEP) Consider Q(λ) = λ 2 M + λd + K C[λ] n n. Assume Q(λ) regular (det(q(λ)) 0). QEP: find nonzero vectors x, y and scalars λ C s.t. Q(λ)x = 0, y Q(λ) = 0. Q(λ) has 2n e vals. Finite e vals are roots of det(q(λ)) = 0. E val at 0 when K is singular and e val at when M is singular. MIMS Françoise Tisseur Quadratic eigenproblem 2 / 28

3 Example 1 Q(λ) = λ λ Regular: det Q(λ) = 6λ λ 4 12λ λ 2 6λ Six eigenpairs (λ k, x k ), k = 1: 6, given by k λ k 1/3 1/2 1 i i x k MIMS Françoise Tisseur Quadratic eigenproblem 3 / 28

4 NLEVP Toolbox Collection of Nonlinear Eigenvalue Problems : T. Betcke, N. J. Higham, V. Mehrmann, C. Schröder, F. T., Quadratic, polynomial, rational and other nonlinear eigenproblems. Provided in the form of a MATLAB Toolbox. Compatible with GNU Octave. Problems from real-life applications + specifically constructed problems. numerical-analysis/nlevp.html MIMS Françoise Tisseur Quadratic eigenproblem 4 / 28

5 Sample of Quadratic Problems n m quadratic Q(λ) = λ 2 M + λd + K. Speaker box (pep,qep,real,symmetric). n = m = 107. Finite element model of a speaker box. M 2 = 1, D 2 = , K 2 = Railtrack (pep,qep,t-palindromic,sparse). n = m = Model of vibration of rail tracks under the excitation of high speed trains. M = K T, D = D T. Surveillance (pep,qep,real,nonsquare, nonregular). n = 21, m = 16. From calibration of surveillance camera using human body as calibration target. MIMS Françoise Tisseur Quadratic eigenproblem 5 / 28

6 Standard Solution Process Find all λ and x satisfying Q(λ)x = (λ 2 M + λd + K )x = 0. Commonly solved by linearization: Convert Q(λ)x = 0 into (A λb)ξ = 0, e.g., [ ] [ ] K 0 D M A λb = λ, ξ = 0 I I 0 [ x λx Solve (A λb)ξ = 0 with an eigensolver for generalized eigenproblem (e.g., QZ algorithm). Recover eigenvectors of Q(λ) from those of A λb. Eigensolver often absent from numerical libraries. MIMS Françoise Tisseur Quadratic eigenproblem 6 / 28 ].

7 Beam Problem /////// L /////// //////////// Transverse displacement u(x, t) governed by ρa 2 u t 2 + c(x) u t + EI 4 u x 4 = 0. u(0, t) = u (0, t) = u(l, t) = u (L, t) = 0. Separation of variables u(x, t) = e λt v(x, λ) yields the eigenvalue problem for the free vibrations: λ 2 ρav(x, λ) + λc(x)v(x, λ) + EI 4 v(x, λ) = 0. x4 MIMS Françoise Tisseur Quadratic eigenproblem 7 / 28

8 Discretized Beam Problem Finite element method leads to Q(λ) = λ 2 M + λd + K with symmetric M, D, K R n n. M > 0, K > 0, D 0. Roots of x Q(λ)x = 0, x C n \ {0}, λ = (x Dx) ± (x Dx) 2 4(x Mx)(x Kx). 2(x Mx) M > 0, K > 0, D 0 all e vals have Re(λ) 0. D is rank 1. Can show n pure imaginary e vals. MIMS Françoise Tisseur Quadratic eigenproblem 8 / 28

9 Eigenvalues of Q(λ) = λ 2 M + λd + K When M, K are nonsingular then theoretically [ ] [ ] M 0 D K C 1 (λ) = λ +, 0 I I 0 [ ] [ ] [ ] [ ] M 0 D K 0 M M 0 L 1 (λ) = λ +, L 0 K K 0 2 (λ) = λ + M D 0 K have the same eigenvalues as Q(λ). MIMS Françoise Tisseur Quadratic eigenproblem 9 / 28

10 Eigenvalues of Q(λ) = λ 2 M + λd + K When M, K are nonsingular then theoretically [ ] [ ] M 0 D K C 1 (λ) = λ +, 0 I I 0 [ D K [ ] M 0 L 1 (λ) = λ + 0 K K 0 ], L 2 (λ) = λ have the same eigenvalues as Q(λ). [ 0 M M D ] [ ] M K coeffs = nlevp( damped beam,100); K = coeffs{1}; D = coeffs{2}; M = coeffs{3}; I = eye(2*nele); O = zeros(2*nele); eval = eig([d K; -I O],-[M O; O I]; % C 1 %eval = eig([d K; K O],-[M O; O -K]; % L 1 %eval = eig([-m O; O K],-[O M; M D]; % L 2 plot(eval,.r ); MIMS Françoise Tisseur Quadratic eigenproblem 9 / 28

11 Computed Spectra of C 1, L 1 and L x x x MIMS Françoise Tisseur Quadratic eigenproblem 10 / 28

12 Sensitivity and Stability of Linearizations Condition number measures sensitivity of the solution of a problem to perturbations in the data. Backward error measures how well the problem has been solved. error in solution < condition number backward error. MIMS Françoise Tisseur Quadratic eigenproblem 11 / 28

13 Sensitivity and Stability of Linearizations Condition number measures sensitivity of the solution of a problem to perturbations in the data. Backward error measures how well the problem has been solved. error in solution < condition number backward error. For a given Q(λ), infinitely many linearizations exist: can have widely varying eigenvalue condition numbers, computed eigenpairs can have widely varying backward errors. MIMS Françoise Tisseur Quadratic eigenproblem 11 / 28

14 Objectives To design a general purpose eigensolver for dense QEPs quadeig. Incorporate: Appropriate choice of linearization. Deflation of 0 and eigenvalues. Eigenvalue parameter scaling. Advantageous use of block structure. Careful recovery of the eigenvectors. A MATLAB and Fortran implementation. MIMS Françoise Tisseur Quadratic eigenproblem 12 / 28

15 Linearization for Q(λ) = λ 2 M + λd + K Opt for C(λ) = [ D I K 0 Simple block structure. ] [ ] M 0 (companion form, + λ 0 I Fiedler pencil) Always a linearization, i.e., there exist E(λ) and F(λ) with constant, nonzero determinants s.t. [ ] Q(λ) 0 = E(λ)C(λ)F(λ). 0 I Left/right e vecs of Q(λ) are easily recovered from those of companion linearizations. Deflation of 0 and e vals easy to implement. "Good" backward error and conditioning properties. MIMS Françoise Tisseur Quadratic eigenproblem 13 / 28

16 Eigenvalue Condition Numbers κ Q (λ) Q(λ)x = 0, y Q(λ) = 0, Q(λ) = λ 2 M + λ D + K. For λ simple, nonzero and finite, { λ κ Q (λ) = lim sup ɛ 0 ɛ λ : [ (Q + Q)(λ + λ) ] (x + x) = 0, M 2 ɛ M 2, D 2 ɛ D 2, K 2 ɛ K 2 }. MIMS Françoise Tisseur Quadratic eigenproblem 14 / 28

17 Eigenvalue Condition Numbers κ Q (λ) Q(λ)x = 0, y Q(λ) = 0, Q(λ) = λ 2 M + λ D + K. For λ simple, nonzero and finite, { λ κ Q (λ) = lim sup ɛ 0 ɛ λ : [ (Q + Q)(λ + λ) ] (x + x) = 0, M 2 ɛ M 2, D 2 ɛ D 2, K 2 ɛ K 2 }. Can show that [T. 01] κ Q (λ) = ( ) λ 2 M 2 + λ D 2 + K 2 y 2 x 2. λ y (2λM + D)x When λ = 0 or, use homogeneous form of Q. MIMS Françoise Tisseur Quadratic eigenproblem 14 / 28

18 Eigenvalue Condition Numbers κ Q (α, β) Homogeneous form: Q(α, β) = α 2 M + αβd + β 2 K. E vals are pairs (α, β) (0, 0) s.t. det Q(α, β) = 0, λ = α/β. MIMS Françoise Tisseur Quadratic eigenproblem 15 / 28

19 Eigenvalue Condition Numbers κ Q (α, β) Homogeneous form: Q(α, β) = α 2 M + αβd + β 2 K. E vals are pairs (α, β) (0, 0) s.t. det Q(α, β) = 0, λ = α/β. For (α, β) simple with right/left e vecs x, y, [Dedieu, T., 03] κ Q (α, β) = ( α 4 M α 2 β 2 D ) β 4 K 2 1/2 y 2 2 x 2 y ( β D α Q ᾱd β Q) (α,β) x. Angle between original and perturbed eigenvalues satisfies θ ( (α, β), ( α, β) ) κq (α, β) Q + o( Q ). Here Q = ( M, D, K ). Similar expression for κ C (α, β), C(λ) = [ D K ] [ I 0 + λ M ] 0 0 I. MIMS Françoise Tisseur Quadratic eigenproblem 15 / 28

20 Eigenvalue Condition Numbers κ Q (α, β) Homogeneous form: Q(α, β) = α 2 M + αβd + β 2 K. E vals are pairs (α, β) (0, 0) s.t. det Q(α, β) = 0, λ = α/β. For (α, β) simple with right/left e vecs x, y, [Dedieu, T., 03] κ Q (α, β) = ( α 4 M α 2 β 2 D ) β 4 K 2 1/2 y 2 2 x 2 y ( β D α Q ᾱd β Q) (α,β) x. Angle between original and perturbed eigenvalues satisfies θ ( (α, β), ( α, β) ) κq (α, β) Q + o( Q ). Here Q = ( M, D, K ). Similar expression for κ C (α, β), C(λ) = [ ] [ D I K 0 + λ M ] 0 0 I. Want κ Q (α, β) κ C (α, β) for all (α, β). MIMS Françoise Tisseur Quadratic eigenproblem 15 / 28

21 Backward Error η Q (x, α, β) For an approximate (right) eigenpair (x, α, β) of Q(α, β), η Q (x, α, β) = min{ ɛ : (Q(α, β) + Q(α, β))x = 0, M 2 ɛ M 2, D 2 ɛ D 2, K 2 ɛ K 2 }, where Q(α, β) = α 2 M + αβ D + β 2 K. Can show that [T.01] η Q (x, α, β) = Q(α, β)x 2 ( α 2 M 2 + α β D 2 + β 2 K 2 ) x 2. Similar expression for η C (z, α, β), C(λ) = [ D K ] [ I 0 + λ M ] 0 0 I. MIMS Françoise Tisseur Quadratic eigenproblem 16 / 28

22 Backward Error η Q (x, α, β) For an approximate (right) eigenpair (x, α, β) of Q(α, β), η Q (x, α, β) = min{ ɛ : (Q(α, β) + Q(α, β))x = 0, M 2 ɛ M 2, D 2 ɛ D 2, K 2 ɛ K 2 }, where Q(α, β) = α 2 M + αβ D + β 2 K. Can show that [T.01] η Q (x, α, β) = Q(α, β)x 2 ( α 2 M 2 + α β D 2 + β 2 K 2 ) x 2. Similar expression for η C (z, α, β), C(λ) = [ D K Want η Q (z 1, α, β) η C (z, α, β), z = [ z 1 z 2 ]. ] [ I 0 + λ M ] 0 0 I. MIMS Françoise Tisseur Quadratic eigenproblem 16 / 28

23 Eigenvalue Parameter Scaling Let λ = µγ, γ 0 and convert Q(λ) = λ 2 M + λd + K to δq(µγ) = µ 2 (γ 2 δm) + µ(γδd) + δk = µ 2 M + µ D + K =: Q(µ). Choose γ such that the linearization process does not affect the eigenvalue condition numbers, i.e., κ Q (α, β) κ C (α, β) for all e vals (α, β). the standard solution process in numerically stable, i.e., η Q (z[ 1, α, ] β) η C (z, α, β) for all e vals (α, β), where z1 z =. z 2 MIMS Françoise Tisseur Quadratic eigenproblem 17 / 28

24 Try γ = exp(r), where r is a tropical root of a tropical scalar quadratic (proposed by Gaubert & Sharify, 09). MIMS Françoise Tisseur Quadratic eigenproblem 17 / 28 Eigenvalue Parameter Scaling Let λ = µγ, γ 0 and convert Q(λ) = λ 2 M + λd + K to δq(µγ) = µ 2 (γ 2 δm) + µ(γδd) + δk = µ 2 M + µ D + K =: Q(µ). Choose γ such that the linearization process does not affect the eigenvalue condition numbers, i.e., κ Q (α, β) κ C (α, β) for all e vals (α, β). the standard solution process in numerically stable, i.e., η Q (z[ 1, α, ] β) η C (z, α, β) for all e vals (α, β), where z1 z =. z 2

25 Tropical Scalar Polynomials Let (R { },, ) be the tropical semiring with a b = max(a, b), a b = a+b for all a, b R { }. The piecewise affine function p(x) = d k=0 p k x k = max 0 k d (p k + kx), p k R { } is a tropical polynomial of degree d. The tropical roots of p(x) are the points of nondifferentiability of p(x). MIMS Françoise Tisseur Quadratic eigenproblem 18 / 28

26 Computation of Tropical Roots Let p(x) = d k=0 p k x k = max(p 0, p 1 + x,..., p d + dx). Upper boundary of convex hull of (k, p k ), k = 0: d. Tropical roots are minus the slopes of the segments (Legendre-Fenchel duality). Horizontal width of segment gives multiplicity. p(x) = max(2, 1+x, 3+2x, 3+3x, 1+4x, x, 2+6x, 1+7x) has roots 1 2, 1 2, 0, 1 3, 1 3, 1 3, 3. p k k MIMS Françoise Tisseur Quadratic eigenproblem 19 / 28

27 Tropical Roots (cont.) Tropical roots can be computed in linear time. Classical roots of p(x) = a 0 + a 1 x + + a n x n can be bounded in terms of tropical roots of p trop (x) = d k=0 p k x k ( Sharify, 11). Let r 1, r 2 be the tropical roots of p trop (r) = max(log( K ), log( D ) + r, log( M ) + 2r). When r 1 r 2 and M, D, K are well conditioned, e r 1 λmax (Q) and e r 2 λmin (Q), where Q(λ) = λ 2 M + λd + K (Gaubert & Sharify, 09). MIMS Françoise Tisseur Quadratic eigenproblem 20 / 28

28 Tropical Scaling Let p trop (r) = max(log( K ), log( D ) + r, log( M ) + 2r). Convert Q(λ) to δq(µγ), where γ = e r, r is a tropical root of p trop, δ = e ptrop(r). If D 2 2 M 2 K 2 then r 1 = r 2 (one double root). Can show that, for all e vals. η Q η C κ Q κ C Otherwise, two distinct tropical roots r 1 > r 2. Can show { r = r1 and λ γ, that, if η Q η C κ Q κ C r = r 2 and λ γ. MIMS Françoise Tisseur Quadratic eigenproblem 21 / 28

29 Beam Pb: Λ(C), Λ(L 2 ) before/after Scaling x x x x MIMS Françoise Tisseur Quadratic eigenproblem 22 / 28

30 Modified Hospital Problem Damping added s.t. D 2 2 M 2 K 2. γ FLV = ( K 2 M 2 ) 1/2 56. Two tropical roots: γ and γ 0.8. Backward error no scaling FLV λ Backward error tropical γ tropical γ λ MIMS Françoise Tisseur Quadratic eigenproblem 23 / 28

31 Deflation of 0 and eigenvalues Transform C(λ) = [ γδd δk S 11 S 12 S 13 0 S 22 S n rk ] [ I 0 λ γ 2 δm 0 λ where r M = rank(m) and r K = rank(k ). 0 I ] into T 11 T 12 T n rm T I n rk 2 QR fact with col piv and 1 COD if r M < n and r K < n. Make use of block structure of C(λ). Call QZ on S 11 λt 11, with T 11 usually upper triang. Q(λ) nonregular if S 22 singular. Cost of deflation negligible compared with overall cost. MIMS Françoise Tisseur Quadratic eigenproblem 24 / 28,

32 Some QEPs from NLEVP Collection η Q (x, λ): backward error of computed eigenpair (x, λ). polyeig quadeig Problem n τ Q η Q (x, λ) η Q (x, λ) η Q (y, λ) power plant 8 7e-1 1e-8 4e-16 5e-17 cd player 60 9e+3 2e-10 7e-16 2e-15 speaker box 107 2e-5 2e-11 2e-16 4e-16 damped beam 200 2e-4 3e-9 1e-15 1e-15 shaft 400 1e-6 9e-8 9e-16 6e-16 railtrack e1 2e-8 2e-15 8e-15 quadeig is backward stable for τ Q < 1, where τ Q = A 1 / A 2 A 0. MIMS Françoise Tisseur Quadratic eigenproblem 25 / 28

33 Some Timings polyeig quadeig Problem n Λ (Λ, X) Λ (Λ, X) acoustic wave 2D s 202s 114s 191s damped beam s 156s 97s 163s spring s 272s 94s 170s railtrack s 306s 79s 113s railtrack2: QEPs with singular M, K. MIMS Françoise Tisseur Quadratic eigenproblem 26 / 28

34 Extension to Higher Degree Polynomials P(λ)x = (λ l A l + + λa 1 + A 0 )x = 0. Use Fiedler linearization: F(λ) = λ A l I I A l 1 A l 2 A 1 I I... I Stability/conditioning similar to companion forms. Deflation of 0 and e vals easy to implement. A 0 Work in progress: scaling strategy (Betcke s scaling, tropical roots, tropical eigenvalues,... ).. MIMS Françoise Tisseur Quadratic eigenproblem 27 / 28

35 Summary quadeig is backward stable for not too heavily damped problems. Tropical mathematics useful for e val scaling. Deflation strategy can produce significant speedups. Returns e vals, right & left e vecs, e val condition numbers, b errs of right/left approx. eigenpairs. MATLAB function available. Fortran implementation available soon. Extension to polynomial eigenproblem of degree l > 2. For papers, eprints and codes, MIMS Françoise Tisseur Quadratic eigenproblem 28 / 28

36 References I T. Betcke, N. J. Higham, V. Mehrmann, C. Schröder, and F. Tisseur. NLEVP: A collection of nonlinear eigenvalue problems. MIMS EPrint , Manchester Institute for Mathematical Sciences, The University of Manchester, UK, Dec pp. To appear in ACM Trans. Math. Software. J.-P. Dedieu and F. Tisseur. Perturbation theory for polynomial eigenvalue problems in homogeneous form. Linear Algebra Appl., 358(1-3):71 94, MIMS Françoise Tisseur Quadratic eigenproblem 24 / 28

37 References II H.-Y. Fan, W.-W. Lin, and P. Van Dooren. Normwise scaling of second order polynomial matrices. SIAM J. Matrix Anal. Appl., 26(1): , S. Gaubert and M. Sharify. Tropical scaling of polynomial matrices. volume 389 of Lecture Notes in Control and Information Sciences, pages Springer-Verlag, Berlin, S. Hammarling, C. J. Munro, and F. Tisseur. An algorithm for the complete solution of quadratic eigenvalue problems. To appear in ACM Trans. Math. Software, MIMS Françoise Tisseur Quadratic eigenproblem 25 / 28

38 References III N. J. Higham, R.-C. Li, and F. Tisseur. Backward error of polynomial eigenproblems solved by linearization. SIAM J. Matrix Anal. Appl., 29(4): , N. J. Higham, D. S. Mackey, and F. Tisseur. The conditioning of linearizations of matrix polynomials. SIAM J. Matrix Anal. Appl., 28(4): , N. J. Higham, D. S. Mackey, F. Tisseur, and S. D. Garvey. Scaling, sensitivity and stability in the numerical solution of quadratic eigenvalue problems. Internat. J. Numer. Methods Eng., 73(3): , MIMS Françoise Tisseur Quadratic eigenproblem 26 / 28

39 References IV M. Sharify. Scaling Algorithms and Tropical Methods in Numerical Matrix Analysis: Application to the Optimal Assignment Problem and to the Accurate Computation of Eigenvalues. PhD thesis, Ecole Polytechnique, pp. F. Tisseur. Backward error and condition of polynomial eigenvalue problems. Linear Algebra Appl., 309: , MIMS Françoise Tisseur Quadratic eigenproblem 27 / 28

40 References V F. Tisseur and K. Meerbergen. The quadratic eigenvalue problem. SIAM Rev., 43(2): , MIMS Françoise Tisseur Quadratic eigenproblem 28 / 28

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

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

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

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

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

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

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

An Algorithm for the Complete Solution of Quadratic Eigenvalue Problems

An Algorithm for the Complete Solution of Quadratic Eigenvalue Problems An Algorithm for the Complete Solution of Quadratic Eigenvalue Problems SVEN HAMMARLING, Numerical Algorithms Group Ltd. and The University of Manchester CHRISTOPHER J. MUNRO, Rutherford Appleton Laboratory

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

in Numerical Linear Algebra

in Numerical Linear Algebra Exploiting ResearchTropical MattersAlgebra in Numerical Linear Algebra February 25, 2009 Nick Françoise Higham Tisseur Director Schoolof ofresearch Mathematics The School University of Mathematics of Manchester

More information

Polynomial eigenvalue solver based on tropically scaled Lagrange linearization. Van Barel, Marc and Tisseur, Francoise. MIMS EPrint: 2016.

Polynomial eigenvalue solver based on tropically scaled Lagrange linearization. Van Barel, Marc and Tisseur, Francoise. MIMS EPrint: 2016. Polynomial eigenvalue solver based on tropically scaled Lagrange linearization Van Barel, Marc and Tisseur, Francoise 2016 MIMS EPrint: 201661 Manchester Institute for Mathematical Sciences School of Mathematics

More information

Nick Higham. Director of Research School of Mathematics

Nick Higham. Director of Research School of Mathematics Exploiting Research Tropical Matters Algebra in Numerical February 25, Linear 2009 Algebra Nick Higham Françoise Tisseur Director of Research School of Mathematics The School University of Mathematics

More information

Tropical roots as approximations to eigenvalues of matrix polynomials. Noferini, Vanni and Sharify, Meisam and Tisseur, Francoise

Tropical roots as approximations to eigenvalues of matrix polynomials. Noferini, Vanni and Sharify, Meisam and Tisseur, Francoise Tropical roots as approximations to eigenvalues of matrix polynomials Noferini, Vanni and Sharify, Meisam and Tisseur, Francoise 2014 MIMS EPrint: 2014.16 Manchester Institute for Mathematical Sciences

More information

KU Leuven Department of Computer Science

KU Leuven Department of Computer Science Backward error of polynomial eigenvalue problems solved by linearization of Lagrange interpolants Piers W. Lawrence Robert M. Corless Report TW 655, September 214 KU Leuven Department of Computer Science

More information

Quadratic Matrix Polynomials

Quadratic Matrix Polynomials 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

More information

Nonlinear eigenvalue problems - A Review

Nonlinear eigenvalue problems - A Review Nonlinear eigenvalue problems - A Review Namita Behera Department of Electrical Engineering Indian Institute of Technology Bombay Mumbai 8 th March, 2016 Outline 1 Nonlinear Eigenvalue Problems 2 Polynomial

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

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

SOLVING RATIONAL EIGENVALUE PROBLEMS VIA LINEARIZATION

SOLVING RATIONAL EIGENVALUE PROBLEMS VIA LINEARIZATION SOLVNG RATONAL EGENVALUE PROBLEMS VA LNEARZATON YANGFENG SU AND ZHAOJUN BA Abstract Rational eigenvalue problem is an emerging class of nonlinear eigenvalue problems arising from a variety of physical

More information

On a root-finding approach to the polynomial eigenvalue problem

On a root-finding approach to the polynomial eigenvalue problem On a root-finding approach to the polynomial eigenvalue problem Dipartimento di Matematica, Università di Pisa www.dm.unipi.it/ bini Joint work with Vanni Noferini and Meisam Sharify Limoges, May, 10,

More information

Backward Error of Polynomial Eigenproblems Solved by Linearization. Higham, Nicholas J. and Li, Ren-Cang and Tisseur, Françoise. MIMS EPrint: 2006.

Backward Error of Polynomial Eigenproblems Solved by Linearization. Higham, Nicholas J. and Li, Ren-Cang and Tisseur, Françoise. MIMS EPrint: 2006. Backward Error of Polynomial Eigenproblems Solved by Linearization Higham, Nicholas J and Li, Ren-Cang and Tisseur, Françoise 2007 MIMS EPrint: 2006137 Manchester Institute for Mathematical Sciences School

More information

ACCURATE SOLUTIONS OF POLYNOMIAL EIGENVALUE PROBLEMS

ACCURATE SOLUTIONS OF POLYNOMIAL EIGENVALUE PROBLEMS ACCURATE SOLUTIONS OF POLYNOMIAL EIGENVALUE PROBLEMS YILING YOU, JOSE ISRAEL RODRIGUEZ, AND LEK-HENG LIM Abstract. Quadratic eigenvalue problems (QEP) and more generally polynomial eigenvalue problems

More information

How to Detect Definite Hermitian Pairs

How to Detect Definite Hermitian Pairs How to Detect Definite Hermitian Pairs Françoise Tisseur School of Mathematics The University of Manchester ftisseur@ma.man.ac.uk http://www.ma.man.ac.uk/~ftisseur/ Joint work with Chun-Hua Guo and Nick

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 II Director of Research School of Mathematics Françoise Tisseur School of Mathematics The University of Manchester Woudschoten

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

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

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

A numerical method for polynomial eigenvalue problems using contour integral

A numerical method for polynomial eigenvalue problems using contour integral A numerical method for polynomial eigenvalue problems using contour integral Junko Asakura a Tetsuya Sakurai b Hiroto Tadano b Tsutomu Ikegami c Kinji Kimura d a Graduate School of Systems and Information

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

NLEVP: A Collection of Nonlinear Eigenvalue Problems. Users Guide

NLEVP: A Collection of Nonlinear Eigenvalue Problems. Users Guide NLEVP: A Collection of Nonlinear Eigenvalue Problems. Users Guide Betcke, Timo and Higham, Nicholas J. and Mehrmann, Volker and Schröder, Christian and Tisseur, Françoise 2010 MIMS EPrint: 2010.99 Manchester

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

Polynomial Jacobi Davidson Method for Large/Sparse Eigenvalue Problems

Polynomial Jacobi Davidson Method for Large/Sparse Eigenvalue Problems Polynomial Jacobi Davidson Method for Large/Sparse Eigenvalue Problems Tsung-Ming Huang Department of Mathematics National Taiwan Normal University, Taiwan April 28, 2011 T.M. Huang (Taiwan Normal Univ.)

More information

Tropical aspects of eigenvalue computation problems

Tropical aspects of eigenvalue computation problems Tropical aspects of eigenvalue computation problems Stephane.Gaubert@inria.fr INRIA and CMAP, École Polytechnique Séminaire Algo Lundi 11 Janvier 2010 Synthesis of: Akian, Bapat, SG CRAS 2004, arxiv:0402090;

More information

Structured Backward Error for Palindromic Polynomial Eigenvalue Problems

Structured Backward Error for Palindromic Polynomial Eigenvalue Problems Structured Backward Error for Palindromic Polynomial Eigenvalue Problems Ren-Cang Li Wen-Wei Lin Chern-Shuh Wang Technical Report 2008-06 http://www.uta.edu/math/preprint/ Structured Backward Error for

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis Volume 38, pp 75-30, 011 Copyright 011, ISSN 1068-9613 ETNA PERTURBATION ANALYSIS FOR COMPLEX SYMMETRIC, SKEW SYMMETRIC, EVEN AND ODD MATRIX POLYNOMIALS SK

More information

Available online at ScienceDirect. Procedia Engineering 100 (2015 ) 56 63

Available online at   ScienceDirect. Procedia Engineering 100 (2015 ) 56 63 Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 100 (2015 ) 56 63 25th DAAAM International Symposium on Intelligent Manufacturing and Automation, DAAAM 2014 Definite Quadratic

More information

ON SYLVESTER S LAW OF INERTIA FOR NONLINEAR EIGENVALUE PROBLEMS

ON SYLVESTER S LAW OF INERTIA FOR NONLINEAR EIGENVALUE PROBLEMS ON SYLVESTER S LAW OF INERTIA FOR NONLINEAR EIGENVALUE PROBLEMS ALEKSANDRA KOSTIĆ AND HEINRICH VOSS Key words. eigenvalue, variational characterization, principle, Sylvester s law of inertia AMS subject

More information

KU Leuven Department of Computer Science

KU Leuven Department of Computer Science Compact rational Krylov methods for nonlinear eigenvalue problems Roel Van Beeumen Karl Meerbergen Wim Michiels Report TW 651, July 214 KU Leuven Department of Computer Science Celestinenlaan 2A B-31 Heverlee

More information

A Framework for Structured Linearizations of Matrix Polynomials in Various Bases

A Framework for Structured Linearizations of Matrix Polynomials in Various Bases A Framework for Structured Linearizations of Matrix Polynomials in Various Bases Leonardo Robol Joint work with Raf Vandebril and Paul Van Dooren, KU Leuven and Université

More information

Multiparameter eigenvalue problem as a structured eigenproblem

Multiparameter eigenvalue problem as a structured eigenproblem Multiparameter eigenvalue problem as a structured eigenproblem Bor Plestenjak Department of Mathematics University of Ljubljana This is joint work with M Hochstenbach Będlewo, 2932007 1/28 Overview Introduction

More information

Structured Condition Numbers and Backward Errors in Scalar Product Spaces

Structured Condition Numbers and Backward Errors in Scalar Product Spaces Structured Condition Numbers and Backward Errors in Scalar Product Spaces Françoise Tisseur Department of Mathematics University of Manchester ftisseur@ma.man.ac.uk http://www.ma.man.ac.uk/~ftisseur/ Joint

More information

STRUCTURE PRESERVING DEFLATION OF INFINITE EIGENVALUES IN STRUCTURED PENCILS

STRUCTURE PRESERVING DEFLATION OF INFINITE EIGENVALUES IN STRUCTURED PENCILS Electronic Transactions on Numerical Analysis Volume 44 pp 1 24 215 Copyright c 215 ISSN 168 9613 ETNA STRUCTURE PRESERVING DEFLATION OF INFINITE EIGENVALUES IN STRUCTURED PENCILS VOLKER MEHRMANN AND HONGGUO

More information

Definite Matrix Polynomials and their Linearization by Definite Pencils. Higham, Nicholas J. and Mackey, D. Steven and Tisseur, Françoise

Definite Matrix Polynomials and their Linearization by Definite Pencils. Higham, Nicholas J. and Mackey, D. Steven and Tisseur, Françoise Definite Matrix Polynomials and their Linearization by Definite Pencils Higham Nicholas J and Mackey D Steven and Tisseur Françoise 2007 MIMS EPrint: 200797 Manchester Institute for Mathematical Sciences

More information

Structure preserving stratification of skew-symmetric matrix polynomials. Andrii Dmytryshyn

Structure preserving stratification of skew-symmetric matrix polynomials. Andrii Dmytryshyn Structure preserving stratification of skew-symmetric matrix polynomials by Andrii Dmytryshyn UMINF 15.16 UMEÅ UNIVERSITY DEPARTMENT OF COMPUTING SCIENCE SE- 901 87 UMEÅ SWEDEN Structure preserving stratification

More information

Nonlinear Eigenvalue Problems: An Introduction

Nonlinear Eigenvalue Problems: An Introduction Nonlinear Eigenvalue Problems: An Introduction Cedric Effenberger Seminar for Applied Mathematics ETH Zurich Pro*Doc Workshop Disentis, August 18 21, 2010 Cedric Effenberger (SAM, ETHZ) NLEVPs: An Introduction

More information

NLEVP: A Collection of Nonlinear Eigenvalue Problems

NLEVP: A Collection of Nonlinear Eigenvalue Problems NLEVP: A Collection of Nonlinear Eigenvalue Problems Betcke, Timo and Higham, Nicholas J. and Mehrmann, Volker and Schröder, Christian and Tisseur, Françoise 2 MIMS EPrint: 2.6 Manchester Institute for

More information

HOMOGENEOUS JACOBI DAVIDSON. 1. Introduction. We study a homogeneous Jacobi Davidson variant for the polynomial eigenproblem

HOMOGENEOUS JACOBI DAVIDSON. 1. Introduction. We study a homogeneous Jacobi Davidson variant for the polynomial eigenproblem HOMOGENEOUS JACOBI DAVIDSON MICHIEL E. HOCHSTENBACH AND YVAN NOTAY Abstract. We study a homogeneous variant of the Jacobi Davidson method for the generalized and polynomial eigenvalue problem. Special

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

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

7 NLEVP: A Collection of Nonlinear Eigenvalue Problems

7 NLEVP: A Collection of Nonlinear Eigenvalue Problems 7 NLEVP: A Collection of Nonlinear Eigenvalue Problems TIMO BETCKE, University College London NICHOLAS J. HIGHAM, The University of Manchester VOLKER MEHRMANN and CHRISTIAN SCHRÖDER, Technische Universität

More information

Detecting a definite Hermitian pair and a hyperbolic or elliptic quadratic eigenvalue problem, and associated nearness problems

Detecting a definite Hermitian pair and a hyperbolic or elliptic quadratic eigenvalue problem, and associated nearness problems Linear Algebra and its Applications 351 352 (2002) 455 474 www.elsevier.com/locate/laa Detecting a definite Hermitian pair and a hyperbolic or elliptic quadratic eigenvalue problem, and associated nearness

More information

Polynomial Eigenvalue Problems: Theory, Computation, and Structure. Mackey, D. S. and Mackey, N. and Tisseur, F. MIMS EPrint: 2015.

Polynomial Eigenvalue Problems: Theory, Computation, and Structure. Mackey, D. S. and Mackey, N. and Tisseur, F. MIMS EPrint: 2015. Polynomial Eigenvalue Problems: Theory, Computation, and Structure Mackey, D. S. and Mackey, N. and Tisseur, F. 2015 MIMS EPrint: 2015.29 Manchester Institute for Mathematical Sciences School of Mathematics

More information

A Structure-Preserving Doubling Algorithm for Quadratic Eigenvalue Problems Arising from Time-Delay Systems

A Structure-Preserving Doubling Algorithm for Quadratic Eigenvalue Problems Arising from Time-Delay Systems A Structure-Preserving Doubling Algorithm for Quadratic Eigenvalue Problems Arising from Time-Delay Systems Tie-xiang Li Eric King-wah Chu Wen-Wei Lin Abstract We propose a structure-preserving doubling

More information

Computing Unstructured and Structured Polynomial Pseudospectrum Approximations

Computing Unstructured and Structured Polynomial Pseudospectrum Approximations Computing Unstructured and Structured Polynomial Pseudospectrum Approximations Silvia Noschese 1 and Lothar Reichel 2 1 Dipartimento di Matematica, SAPIENZA Università di Roma, P.le Aldo Moro 5, 185 Roma,

More information

Structured Condition Numbers and Backward Errors in Scalar Product Spaces. February MIMS EPrint:

Structured Condition Numbers and Backward Errors in Scalar Product Spaces. February MIMS EPrint: Structured Condition Numbers and Backward Errors in Scalar Product Spaces Françoise Tisseur and Stef Graillat February 2006 MIMS EPrint: 2006.16 Manchester Institute for Mathematical Sciences School of

More information

NLEVP: A Collection of Nonlinear Eigenvalue Problems

NLEVP: A Collection of Nonlinear Eigenvalue Problems School of Mathematical and Physical Sciences Department of Mathematics and Statistics Preprint MPS_2-33 5 November 2 NLEVP: A Collection of Nonlinear Eigenvalue Problems by Timo Betcke, Nicholas J. Higham,

More information

More on pseudospectra for polynomial eigenvalue problems and applications in control theory

More on pseudospectra for polynomial eigenvalue problems and applications in control theory Linear Algebra and its Applications 351 352 (2002) 435 453 www.elsevier.com/locate/laa More on pseudospectra for polynomial eigenvalue problems and applications in control theory Nicholas J. Higham,1,

More information

SOLVING A STRUCTURED QUADRATIC EIGENVALUE PROBLEM BY A STRUCTURE-PRESERVING DOUBLING ALGORITHM

SOLVING A STRUCTURED QUADRATIC EIGENVALUE PROBLEM BY A STRUCTURE-PRESERVING DOUBLING ALGORITHM SOLVING A STRUCTURED QUADRATIC EIGENVALUE PROBLEM BY A STRUCTURE-PRESERVING DOUBLING ALGORITHM CHUN-HUA GUO AND WEN-WEI LIN Abstract In studying the vibration of fast trains, we encounter a palindromic

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

Stability of Feedback Solutions for Infinite Horizon Noncooperative Differential Games

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

More information

arxiv: v2 [math.na] 8 Aug 2018

arxiv: v2 [math.na] 8 Aug 2018 THE CONDITIONING OF BLOCK KRONECKER l-ifications OF MATRIX POLYNOMIALS JAVIER PÉREZ arxiv:1808.01078v2 math.na] 8 Aug 2018 Abstract. A strong l-ification of a matrix polynomial P(λ) = A i λ i of degree

More information

A UNIFIED APPROACH TO FIEDLER-LIKE PENCILS VIA STRONG BLOCK MINIMAL BASES PENCILS.

A UNIFIED APPROACH TO FIEDLER-LIKE PENCILS VIA STRONG BLOCK MINIMAL BASES PENCILS. A UNIFIED APPROACH TO FIEDLER-LIKE PENCILS VIA STRONG BLOCK MINIMAL BASES PENCILS M I BUENO, F M DOPICO, J PÉREZ, R SAAVEDRA, AND B ZYKOSKI Abstract The standard way of solving the polynomial eigenvalue

More information

PALINDROMIC LINEARIZATIONS OF A MATRIX POLYNOMIAL OF ODD DEGREE OBTAINED FROM FIEDLER PENCILS WITH REPETITION.

PALINDROMIC LINEARIZATIONS OF A MATRIX POLYNOMIAL OF ODD DEGREE OBTAINED FROM FIEDLER PENCILS WITH REPETITION. PALINDROMIC LINEARIZATIONS OF A MATRIX POLYNOMIAL OF ODD DEGREE OBTAINED FROM FIEDLER PENCILS WITH REPETITION. M.I. BUENO AND S. FURTADO Abstract. Many applications give rise to structured, in particular

More information

Perturbation of Palindromic Eigenvalue Problems

Perturbation of Palindromic Eigenvalue Problems Numerische Mathematik manuscript No. (will be inserted by the editor) Eric King-wah Chu Wen-Wei Lin Chern-Shuh Wang Perturbation of Palindromic Eigenvalue Problems Received: date / Revised version: date

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

Computing the Action of the Matrix Exponential

Computing the Action of the Matrix Exponential Computing the Action of the Matrix Exponential Nick Higham School of Mathematics The University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/ Joint work with Awad H. Al-Mohy 16th ILAS

More information

A Structure-Preserving Method for Large Scale Eigenproblems. of Skew-Hamiltonian/Hamiltonian (SHH) Pencils

A Structure-Preserving Method for Large Scale Eigenproblems. of Skew-Hamiltonian/Hamiltonian (SHH) Pencils A Structure-Preserving Method for Large Scale Eigenproblems of Skew-Hamiltonian/Hamiltonian (SHH) Pencils Yangfeng Su Department of Mathematics, Fudan University Zhaojun Bai Department of Computer Science,

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

Computable error bounds for nonlinear eigenvalue problems allowing for a minmax characterization

Computable error bounds for nonlinear eigenvalue problems allowing for a minmax characterization Computable error bounds for nonlinear eigenvalue problems allowing for a minmax characterization Heinrich Voss voss@tuhh.de Joint work with Kemal Yildiztekin Hamburg University of Technology Institute

More information

Reduction of nonlinear eigenproblems with JD

Reduction of nonlinear eigenproblems with JD Reduction of nonlinear eigenproblems with JD Henk van der Vorst H.A.vanderVorst@math.uu.nl Mathematical Institute Utrecht University July 13, 2005, SIAM Annual New Orleans p.1/16 Outline Polynomial Eigenproblems

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

On the computation of the Jordan canonical form of regular matrix polynomials

On the computation of the Jordan canonical form of regular matrix polynomials On the computation of the Jordan canonical form of regular matrix polynomials G Kalogeropoulos, P Psarrakos 2 and N Karcanias 3 Dedicated to Professor Peter Lancaster on the occasion of his 75th birthday

More information

A Jacobi Davidson Method for Nonlinear Eigenproblems

A Jacobi Davidson Method for Nonlinear Eigenproblems A Jacobi Davidson Method for Nonlinear Eigenproblems Heinrich Voss Section of Mathematics, Hamburg University of Technology, D 21071 Hamburg voss @ tu-harburg.de http://www.tu-harburg.de/mat/hp/voss Abstract.

More information

MATH 3321 Sample Questions for Exam 3. 3y y, C = Perform the indicated operations, if possible: (a) AC (b) AB (c) B + AC (d) CBA

MATH 3321 Sample Questions for Exam 3. 3y y, C = Perform the indicated operations, if possible: (a) AC (b) AB (c) B + AC (d) CBA MATH 33 Sample Questions for Exam 3. Find x and y so that x 4 3 5x 3y + y = 5 5. x = 3/7, y = 49/7. Let A = 3 4, B = 3 5, C = 3 Perform the indicated operations, if possible: a AC b AB c B + AC d CBA AB

More information

Analysis of the Cholesky Method with Iterative Refinement for Solving the Symmetric Definite Generalized Eigenproblem

Analysis of the Cholesky Method with Iterative Refinement for Solving the Symmetric Definite Generalized Eigenproblem Analysis of the Cholesky Method with Iterative Refinement for Solving the Symmetric Definite Generalized Eigenproblem Davies, Philip I. and Higham, Nicholas J. and Tisseur, Françoise 2001 MIMS EPrint:

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

A SIMPLIFIED APPROACH TO FIEDLER-LIKE PENCILS VIA STRONG BLOCK MINIMAL BASES PENCILS.

A SIMPLIFIED APPROACH TO FIEDLER-LIKE PENCILS VIA STRONG BLOCK MINIMAL BASES PENCILS. A SIMPLIFIED APPROACH TO FIEDLER-LIKE PENCILS VIA STRONG BLOCK MINIMAL BASES PENCILS. M. I. BUENO, F. M. DOPICO, J. PÉREZ, R. SAAVEDRA, AND B. ZYKOSKI Abstract. The standard way of solving the polynomial

More information

Perturbation theory for homogeneous polynomial eigenvalue problems

Perturbation theory for homogeneous polynomial eigenvalue problems Linear Algebra and its Applications 358 (23) 71 94 www.elsevier.com/locate/laa Perturbation theory for homogeneous polynomial eigenvalue problems Jean-Pierre Dedieu a, Françoise Tisseur b,,1 a MIP, Département

More information

Combinatorial Types of Tropical Eigenvector

Combinatorial Types of Tropical Eigenvector Combinatorial Types of Tropical Eigenvector arxiv:1105.55504 Ngoc Mai Tran Department of Statistics, UC Berkeley Joint work with Bernd Sturmfels 2 / 13 Tropical eigenvalues and eigenvectors Max-plus: (R,,

More information

Iyad T. Abu-Jeib and Thomas S. Shores

Iyad T. Abu-Jeib and Thomas S. Shores NEW ZEALAND JOURNAL OF MATHEMATICS Volume 3 (003, 9 ON PROPERTIES OF MATRIX I ( OF SINC METHODS Iyad T. Abu-Jeib and Thomas S. Shores (Received February 00 Abstract. In this paper, we study the determinant

More information

Polynomial two-parameter eigenvalue problems and matrix pencil methods for stability of delay-differential equations

Polynomial two-parameter eigenvalue problems and matrix pencil methods for stability of delay-differential equations Polynomial two-parameter eigenvalue problems and matrix pencil methods for stability of delay-differential equations Elias Jarlebring a, Michiel E. Hochstenbach b,1, a Technische Universität Braunschweig,

More information

A Nonlinear QR Algorithm for Banded Nonlinear Eigenvalue Problems

A Nonlinear QR Algorithm for Banded Nonlinear Eigenvalue Problems A Nonlinear QR Algorithm for Banded Nonlinear Eigenvalue Problems C. KRISTOPHER GARRETT, Computational Physics and Methods, Los Alamos National Laboratory ZHAOJUN BAI, Department of Computer Science and

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

Maths for Signals and Systems Linear Algebra in Engineering

Maths for Signals and Systems Linear Algebra in Engineering Maths for Signals and Systems Linear Algebra in Engineering Lectures 13 15, Tuesday 8 th and Friday 11 th November 016 DR TANIA STATHAKI READER (ASSOCIATE PROFFESOR) IN SIGNAL PROCESSING IMPERIAL COLLEGE

More information

EXPLICIT BLOCK-STRUCTURES FOR BLOCK-SYMMETRIC FIEDLER-LIKE PENCILS

EXPLICIT BLOCK-STRUCTURES FOR BLOCK-SYMMETRIC FIEDLER-LIKE PENCILS EXPLICIT BLOCK-STRUCTURES FOR BLOCK-SYMMETRIC FIEDLER-LIKE PENCILS M I BUENO, M MARTIN, J PÉREZ, A SONG, AND I VIVIANO Abstract In the last decade, there has been a continued effort to produce families

More information

An algorithm for computing the eigenvalues of a max-plus matrix polynomial. James, Hook. MIMS EPrint:

An algorithm for computing the eigenvalues of a max-plus matrix polynomial. James, Hook. MIMS EPrint: An algorithm for computing the eigenvalues of a ma-plus matri polynomial James, Hook 16 MIMS EPrint: 16.44 Manchester Institute for Mathematical Sciences School of Mathematics The University of Manchester

More information

On an Inverse Problem for a Quadratic Eigenvalue Problem

On an Inverse Problem for a Quadratic Eigenvalue Problem International Journal of Difference Equations ISSN 0973-6069, Volume 12, Number 1, pp. 13 26 (2017) http://campus.mst.edu/ijde On an Inverse Problem for a Quadratic Eigenvalue Problem Ebru Ergun and Adil

More information

Nonlinear Eigenvalue Problems and Contour Integrals

Nonlinear Eigenvalue Problems and Contour Integrals Nonlinear Eigenvalue Problems and Contour Integrals Marc Van Barel a,,, Peter Kravanja a a KU Leuven, Department of Computer Science, Celestijnenlaan 200A, B-300 Leuven (Heverlee), Belgium Abstract In

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

A Continuation Approach to a Quadratic Matrix Equation

A Continuation Approach to a Quadratic Matrix Equation A Continuation Approach to a Quadratic Matrix Equation Nils Wagner nwagner@mecha.uni-stuttgart.de Institut A für Mechanik, Universität Stuttgart GAMM Workshop Applied and Numerical Linear Algebra September

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

The Solvability Conditions for the Inverse Eigenvalue Problem of Hermitian and Generalized Skew-Hamiltonian Matrices and Its Approximation

The Solvability Conditions for the Inverse Eigenvalue Problem of Hermitian and Generalized Skew-Hamiltonian Matrices and Its Approximation The Solvability Conditions for the Inverse Eigenvalue Problem of Hermitian and Generalized Skew-Hamiltonian Matrices and Its Approximation Zheng-jian Bai Abstract In this paper, we first consider the inverse

More information

Polynomial two-parameter eigenvalue problems and matrix pencil methods for stability of delay-differential equations

Polynomial two-parameter eigenvalue problems and matrix pencil methods for stability of delay-differential equations Polynomial two-parameter eigenvalue problems and matrix pencil methods for stability of delay-differential equations Elias Jarlebring a, Michiel E. Hochstenbach b,1, a Technische Universität Braunschweig,

More information

Bounds for eigenvalues of matrix polynomials

Bounds for eigenvalues of matrix polynomials Linear Algebra and its Applications 358 003 5 wwwelseviercom/locate/laa Bounds for eigenvalues of matrix polynomials Nicholas J Higham,1, Françoise Tisseur Department of Mathematics, University of Manchester,

More information

Fiedler Companion Linearizations and the Recovery of Minimal Indices. De Teran, Fernando and Dopico, Froilan M. and Mackey, D.

Fiedler Companion Linearizations and the Recovery of Minimal Indices. De Teran, Fernando and Dopico, Froilan M. and Mackey, D. Fiedler Companion Linearizations and the Recovery of Minimal Indices De Teran, Fernando and Dopico, Froilan M and Mackey, D Steven 2009 MIMS EPrint: 200977 Manchester Institute for Mathematical Sciences

More information

Structured condition numbers and backward errors in scalar product spaces

Structured condition numbers and backward errors in scalar product spaces Electronic Journal of Linear Algebra Volume 15 Volume 15 (006) Article 1 006 Structured condition numbers and backward errors in scalar product spaces Francoise Tisseur ftisseur@ma.man.ac.uk Stef Graillat

More information

Improved Inverse Scaling and Squaring Algorithms for the Matrix Logarithm. Al-Mohy, Awad H. and Higham, Nicholas J. MIMS EPrint: 2011.

Improved Inverse Scaling and Squaring Algorithms for the Matrix Logarithm. Al-Mohy, Awad H. and Higham, Nicholas J. MIMS EPrint: 2011. Improved Inverse Scaling and Squaring Algorithms for the Matrix Logarithm Al-Mohy, Awad H. and Higham, Nicholas J. 2011 MIMS EPrint: 2011.83 Manchester Institute for Mathematical Sciences School of Mathematics

More information

Computational Methods for Feedback Control in Damped Gyroscopic Second-order Systems 1

Computational Methods for Feedback Control in Damped Gyroscopic Second-order Systems 1 Computational Methods for Feedback Control in Damped Gyroscopic Second-order Systems 1 B. N. Datta, IEEE Fellow 2 D. R. Sarkissian 3 Abstract Two new computationally viable algorithms are proposed for

More information

1. Select the unique answer (choice) for each problem. Write only the answer.

1. Select the unique answer (choice) for each problem. Write only the answer. MATH 5 Practice Problem Set Spring 7. Select the unique answer (choice) for each problem. Write only the answer. () Determine all the values of a for which the system has infinitely many solutions: x +

More information

Lecture Note 5: Semidefinite Programming for Stability Analysis

Lecture Note 5: Semidefinite Programming for Stability Analysis ECE7850: Hybrid Systems:Theory and Applications Lecture Note 5: Semidefinite Programming for Stability Analysis Wei Zhang Assistant Professor Department of Electrical and Computer Engineering Ohio State

More information