Solving the Polynomial Eigenvalue Problem by Linearization

Size: px
Start display at page:

Download "Solving the Polynomial Eigenvalue Problem by Linearization"

Transcription

1 Solving the Polynomial Eigenvalue Problem by Linearization Nick Higham School of Mathematics The University of Manchester Joint work with Ren-Cang Li, Steve Mackey and Françoise Tisseur. IWASEP 6, May

2 Outline PEP and Linearization Background B err and Conditioning of Linearizations Algorithm based on Linearization MIMS Nick Higham Polynomial eigenproblem 2 / 39

3 Polynomial Eigenproblem (PEP) P(λ) = m λ i A i, A i C n n, A m 0. i=0 P assumed regular (det P(λ) 0). Find scalars λ and nonzero vectors x and y satisfying P(λ)x = 0 and y P(λ) = 0. Special case quadratic eigenvalue problem (QEP): (λ 2 M + λd + K)x = 0. MIMS Nick Higham Polynomial eigenproblem 3 / 39

4 Applications classical structural mechanics molecular dynamics gyroscopic systems optical waveguide design MIMO systems in control theory constrained least squares problems. MIMS Nick Higham Polynomial eigenproblem 4 / 39

5 Applications classical structural mechanics molecular dynamics gyroscopic systems optical waveguide design MIMO systems in control theory constrained least squares problems. More specifically: Excitation of rail tracks by high speed trains (SIAM News, Nov. 2004). Extreme designs lead to problems with poor conditioning; physics of system leads to structure. MIMS Nick Higham Polynomial eigenproblem 4 / 39

6 Polyeig (Companion Pencil) 4 x

7 Polyeig on Scaled Quadratic 4 x

8 Methods Interested in methods for solving dense problems (possibly a projection of a sparse problem). Solvent: m i=0 A ix i = 0. Bandwidth reduction. Structure-preserving transformations. Linearization. MIMS Nick Higham Polynomial eigenproblem 8 / 39

9 Current Software MATLAB spolyeig. Solvers in commercial engineering packages (Nastran, etc.). Aim to design and implement LAPACK solvers for general and structured QEPs/PEPs (Manchester and TU Berlin). MIMS Nick Higham Polynomial eigenproblem 9 / 39

10 Linearizations L(λ) = λx + Y, X, Y C mn mn is a linearization of P(λ) = m i=0 λi A i if [ ] P(λ) 0 E(λ)L(λ)F(λ) = 0 I (m 1)n for some unimodular E(λ) and F(λ). Example Companion form linearization ( [ ] [ A2 0 A1 A E(λ) λ I I 0 ]) F(λ) = [ ] λ 2 A 2 + λa 1 + A I MIMS Nick Higham Polynomial eigenproblem 10 / 39

11 Solution Process for PEP Linearize P(λ) into L(λ) = λx + Y. Solve generalized eigenproblem L(λ)z = 0. Recover eigenvectors of P from those of L. Usual choice of L: companion linearization, for which λ m 1 x z =. λx. x Left e vec: more complicated formula. MIMS Nick Higham Polynomial eigenproblem 11 / 39

12 Desiderata for a Linearization Good conditioning. Backward stability. Suitable eigenvector recovery formulae. Preservation of structure, e.g. symmetry. Numerical preservation of key qualitative properties, including location and symmetries of spectrum. Preserve partial multiplicities of e vals (strong linearization). MIMS Nick Higham Polynomial eigenproblem 12 / 39

13 Outline PEP and Linearization Background B err and Conditioning of Linearizations Algorithm based on Linearization MIMS Nick Higham Polynomial eigenproblem 13 / 39

14 Backward Error P(α,β) = m α i β m i A i i=0 (x,α,β) approx eigenpair of P: (λ α/β). { η P (x,α,β) = min ǫ : Extending Tisseur (2000): m α i β m i (A i + A i )x = 0, i=0 A i 2 ǫ A i 2, i = 0: m }. η P (x,α,β) = P(α,β)x 2 ( m i=0 α i β m i A i 2 ) x 2. MIMS Nick Higham Polynomial eigenproblem 14 / 39

15 Key Question How good an approx eigenpair of P will be produced from an approx eigenpair of L? Here good" refers to relative error (see H, D. S. Mackey & Tisseur, 2005), backward error. A small perturbation to C 1 (λ) = [ ] A I [ ] A1 A 0 I 0 may not correspond to a small perturbation to Q(λ) = λ 2 A 2 + λa 1 + A 0. MIMS Nick Higham Polynomial eigenproblem 15 / 39

16 Want to compare η P (x,α,β) = P(α,β)x 2 ( m i=0 α i β m i A i 2 ) x 2, with η L (z,α,β) = L(α,β)z 2 ( α X 2 + β Y 2 ) z 2. (z, α, β): approx e pair of linearization L(λ) = λx + Y of P(λ). (x,α,β): approx e pair of P with x recovered from z. MIMS Nick Higham Polynomial eigenproblem 16 / 39

17 One Sided Factorization Suppose there exists n nm G(α, β) s.t. G(α,β)L(α,β) = g T P(α,β), g C m. With z i := z((i 1)n + 1: in), G(α,β)L(α,β)z = (g T P(α,β))z z 1 = [g 1 P(α,β)... g m P(α,β)]. z m m = P(α,β) g i z i =: P(α,β)x. i=1 P(α,β)x 2 G(α,β) 2 L(α,β)z 2. MIMS Nick Higham Polynomial eigenproblem 17 / 39

18 Bounding η P /η L Suppose G(α,β)L(α,β) = g T P(α,β), g C m. Let z be approx e vec of L with e val (α,β) and take x = g i z i as approx e vec of P. η P (x,α,β) η L (z,α,β) = α X 2 + β Y 2 m i=0 α i β m i A i 2 P(α,β)x 2 L(α,β)z 2 z 2 x 2. MIMS Nick Higham Polynomial eigenproblem 18 / 39

19 Bounding η P /η L Suppose G(α,β)L(α,β) = g T P(α,β), g C m. Let z be approx e vec of L with e val (α,β) and take x = g i z i as approx e vec of P. η P (x,α,β) η L (z,α,β) α X 2 + β Y 2 m i=0 α i β m i A i 2 G(α,β) 2 z 2 x 2. Separates the dependence on L, P and (α,β) from dependence on G and z. η P is finite if η L is. MIMS Nick Higham Polynomial eigenproblem 18 / 39

20 Bounding η P /η L Suppose G(α,β)L(α,β) = g T P(α,β), g C m. Let z be approx e vec of L with e val (α,β) and take x = g i z i as approx e vec of P. η P (x,α,β) η L (z,α,β) α X 2 + β Y 2 m i=0 α i β m i A i 2 G(α,β) 2 z 2 x 2. Separates the dependence on L, P and (α,β) from dependence on G and z. η P is finite if η L is. Sim. for left e vecs: assume L(α,β)H(α,β) = h P(α,β), h C m. MIMS Nick Higham Polynomial eigenproblem 18 / 39

21 Vector Spaces L 1, L 2, and DL(P) Λ := [λ m 1,λ m 2,...,1] T. Mackey, Mackey, Mehl & Mehrmann (2005) define L 1 (P) = { L(λ) : L(λ)(Λ I n ) = v P(λ), v C } m, L 2 (P) = { L(λ) : (Λ T I n )L(λ) = ṽ T P(λ), ṽ C } m, DL(P) = L 1 (P) L 2 (P). MIMS Nick Higham Polynomial eigenproblem 19 / 39

22 Vector Spaces L 1, L 2, and DL(P) Λ := [λ m 1,λ m 2,...,1] T. Mackey, Mackey, Mehl & Mehrmann (2005) define L 1 (P) = { L(λ) : L(λ)(Λ I n ) = v P(λ), v C } m, L 2 (P) = { L(λ) : (Λ T I n )L(λ) = ṽ T P(λ), ṽ C } m, DL(P) = L 1 (P) L 2 (P). Dimensions: L 1, L 2 : m(m 1)n 2 + m, DL: m. Pencils in DL(P) are block symmetric. Almost all L in the above are linearizations. MIMS Nick Higham Polynomial eigenproblem 19 / 39

23 Vector Spaces L 1, L 2, and DL(P) Λ := [λ m 1,λ m 2,...,1] T. Mackey, Mackey, Mehl & Mehrmann (2005) define L 1 (P) = { L(λ) : L(λ)(Λ I n ) = v P(λ), v C } m, L 2 (P) = { L(λ) : (Λ T I n )L(λ) = ṽ T P(λ), ṽ C } m, DL(P) = L 1 (P) L 2 (P). Dimensions: L 1, L 2 : m(m 1)n 2 + m, DL: m. Pencils in DL(P) are block symmetric. Almost all L in the above are linearizations. Recall G(α,β)L(α,β) = g T P(α,β), g C m. MIMS Nick Higham Polynomial eigenproblem 19 / 39

24 Companion Linearizations C i (λ) = λx + Y i with X = diag(a m, I n,...,i n ), Y 1 = A m 1 A m 2... A 0 I n I n 0, Y 2 = A m 1 I n A m In A C 1 L 1 (P) (v = e 1 ) and C 2 L 2 (P) (ṽ = e 1 ). C 1 and C 2 always (strong) linearizations. C 2 (P) = C 1 (P T ) T concentrate on C 1 only.. MIMS Nick Higham Polynomial eigenproblem 20 / 39

25 Companion Linearizations C i (λ) = λx + Y i with X = diag(a m, I n,...,i n ), Y 1 = A m 1 A m 2... A 0 I n I n 0, Y 2 = A m 1 I n A m In A C 1 L 1 (P) (v = e 1 ) and C 2 L 2 (P) (ṽ = e 1 ). C 1 and C 2 always (strong) linearizations. C 2 (P) = C 1 (P T ) T concentrate on C 1 only. Are the factorizations G(α,β)C 1 (α,β) = g T P(α,β), possible for C 1? C 1 (α,β)h(α,β) = h P(α,β). MIMS Nick Higham Polynomial eigenproblem 20 / 39

26 First Companion For m = 2, [ αi βa0 βi βa 1 + αa 2 yields two choices: ] [ ] P(α,β) 0 C 1 (α,β) = 0 P(α, β) G(α,β) = [αi βa 0 ], g = e 1 x = z 1, G(α,β) = [βi βa 1 + αa 2 ], g = e 2 x = z 2. Generalizes to arbitrary degrees m. C 1 L 1 (v = e 1 ) C 1 (α,β)(λ α,β I n ) = e 1 P(α,β). Can take H(α,β) = Λ α,β I n and h = e 1 y = w 1. MIMS Nick Higham Polynomial eigenproblem 21 / 39

27 First Companion: Right Eigenvector Theorem Let z be approx right e vec of C 1 with approx e val (α,β). For z k = z((k 1)n + 1: kn), k = 1: m, ( ) 2 η P (z k,α,β) max 1, maxi A i 2 m5/2 η C1 (z,α,β) min ( ) z 2. A 0 2, A m 2 z k 2 MIMS Nick Higham Polynomial eigenproblem 22 / 39

28 First Companion: Right Eigenvector Theorem Let z be approx right e vec of C 1 with approx e val (α,β). For z k = z((k 1)n + 1: kn), k = 1: m, ( ) 2 η P (z k,α,β) max 1, maxi A i 2 m5/2 η C1 (z,α,β) min ( ) z 2. A 0 2, A m 2 z k 2 η P η C1 if min( A 0 2, A m 2 ) max i A i 2 1. z 2 / z k 2 1. Exact z = Λ α,β x z 2 z k 2 m, k = { 1 if α β, m if α β. MIMS Nick Higham Polynomial eigenproblem 22 / 39

29 First Companion: Left Eigenvector Theorem Let w be approx left e vec of C 1 with approx e val (α,β). Then for w 1 = w(1: n), ( ) η P (w 1,α,β) max 1, maxi A i 2 η C1 (w m3/2,α,β) min( A m 2, A 0 2 ) η P (w 1,α,β) η C1 (w,α,β) if min( A 0 2, A m 2 ) max i A i 2 1 w 2 / w w 2 w 1 2. MIMS Nick Higham Polynomial eigenproblem 23 / 39

30 Left Eigenvector recovery for C 1 Lemma y C n is a left e vec of P with simple e val (α,β) iff w = [α m 1 I] [α m 2 βa m αβ m 2 A 1 + β m 1 A 0 ] [α m 2 βa m α 2 β m 3 A 1 + αβ m 2 A 0 ]. [α m 2 βa 0 ] y, α 0, is a left e vec of C 1 corr. to (α,β). Every left e vec of C 1 with e val (α,β) has this form for some left e vec y of P. MIMS Nick Higham Polynomial eigenproblem 24 / 39

31 Left Eigenvector recovery for C 1 Lemma y C n is a left e vec of P with simple e val (α,β) iff w = [β m 1 I] [αβ m 2 A m + β m 1 A m 1 ]. [α m 1 A m + + αβ m 2 A 2 + β m 1 A 1 ] y, β 0 is a left e vec of C 1 corr. to (α,β). Every left e vec of C 1 with e val (α,β) has this form for some left e vec y of P. MIMS Nick Higham Polynomial eigenproblem 24 / 39

32 Left Eigenvector recovery for C 1 Lemma y C n is a left e vec of P with simple e val (α,β) iff w = [β m 1 I] [αβ m 2 A m + β m 1 A m 1 ]. [α m 1 A m + + αβ m 2 A 2 + β m 1 A 1 ] y, β 0 is a left e vec of C 1 corr. to (α,β). Every left e vec of C 1 with e val (α,β) has this form for some left e vec y of P. If A i 2 1 i then exact left e vec w satisfies w 2 / w 1 2 (m 2 /3) 1/2. MIMS Nick Higham Polynomial eigenproblem 24 / 39

33 UnScaled Companion Form C 1 (λ) = λx + Y i with X = diag(a m, I n,...,i n ), A m 1 A m 2... A 0 I Y 1 = n I n 0 MIMS Nick Higham Polynomial eigenproblem 25 / 39

34 Scaled Companion Form C 1 (λ) = λx + Y i with X = diag(a m,µi n,...,µi n ), A m 1 A m 2... A 0 µi Y 1 = n µi n 0 Let D µ = diag(1,µ,...,µ) I n, where µ = max i A i 2. Then D µ C 1 (λ) L 1 (P) with v = e 1. MIMS Nick Higham Polynomial eigenproblem 26 / 39

35 Scaled Companion: Right and Left E vecs ρ = max i A i 2 min( A 0 2, A m 2 ). Theorem Let z and w be approx right and left e vecs of D µ C 1 corr. to the approx e val (α,β). Then η P (z k,α,β) η DµC 1 (z,α,β) m5/2 ρ z 2 z k 2, k = 1: m, η P (w 1,α,β) η DµC 1 (w,α,β) m3/2 ρ w 2 w 1 2. MIMS Nick Higham Polynomial eigenproblem 27 / 39

36 Scaling Q(λ) Write a = A 2, b = B 2, c = C 2. Fan, Lin & Van Dooren (2004): let λ = µγ, Q(λ) = λ 2 A + λb + C Q(µ) = µ 2 (δγ 2 A) + µ(δγb) + δc, where γ = c/a, δ = 2/(c + bγ). For Q(µ) = µ 2Ã + µ B + C we have max( Ã 2, B 2, C 2 ) 2. MIMS Nick Higham Polynomial eigenproblem 28 / 39

37 Growth Factor Bound η eq (z i,α,β) η C1 (z,α,β) 27/2 ω z 2 z i 2, i = 1, 2, where, with α 2 + β 2 = 1, { } 1 1 ω min 1 + τ, 1 + τ, τ = b. αβ ac MIMS Nick Higham Polynomial eigenproblem 29 / 39

38 Growth Factor Bound η eq (z i,α,β) η C1 (z,α,β) 27/2 ω z 2 z i 2, i = 1, 2, where, with α 2 + β 2 = 1, { } 1 1 ω min 1 + τ, 1 + τ, τ = b. αβ ac F, L & VD identify max(1 + τ, 1 + τ 1 ) as growth factor. Our bounds for ω sharper: τ 1 is harmless. if τ 1, min{ } = O(1) if α β = O(1). ω = O(1) if B 2 < A 2 C 2. Hence η C1 η Q for systems not heavily damped. MIMS Nick Higham Polynomial eigenproblem 29 / 39

39 Comparison with Conditioning Results Analysis of H, D. S. Mackey & Tisseur (2005) bounds the ratio κ C1 (α,β)/κ P (α,β). Conditions for those κ C1 (α,β) κ P (α,β) are essentially the same as those for η C1 η P. Backward error results entirely harmonious with e val conditioning results. MIMS Nick Higham Polynomial eigenproblem 30 / 39

40 Polyeig (Companion Pencil) 4 x

41 Polyeig on Scaled Quadratic 4 x

42 Details Before scaling After scaling A B C ρ = ρ = 1, ω = 1 MIMS Nick Higham Polynomial eigenproblem 33 / 39

43 Outline PEP and Linearization Background B err and Conditioning of Linearizations Algorithm based on Linearization MIMS Nick Higham Polynomial eigenproblem 34 / 39

44 Meta-Algorithm for PEP 1 Preprocess P 2 for one or more (scaled) linearizations L 3 Balance (scale) L 4 Apply QZ to L (maybe HZ if structured) 5 Obtain relevant e vals 6 Recover left and right e vecs 7 Iteratively refine e vecs 8 Compute/estimate b errs and condition numbers 9 Detect nonregular problem 10 end MIMS Nick Higham Polynomial eigenproblem 35 / 39

45 Balancing Balancing GEP: Ward (1981) Lemonnier & Van Dooren (2006) To investigate: To what extent can balancing make the results worse? Cf. Watkins (2006): A Case where Balancing is Harmful. Exploit structure of pencils arising via linearization of a matrix poly. Can we balance a QEP? MIMS Nick Higham Polynomial eigenproblem 36 / 39

46 Iterative Refinement Underlying theory for fixed and extended precision residuals in Tisseur (2001). Done for definite GEPs in Davies, H & Tisseur (2001). Details for QEPs in Berhanu (2005), incl. complex conj. pairs in real arith. Issues: Convergence to wrong eigenpair or non-convergence. Exploiting structure of pencil from a linearization. MIMS Nick Higham Polynomial eigenproblem 37 / 39

47 Tentative Outline of Algorithm for QEP 1 Preprocess Q: Fan, Lin & Van Dooren (2004) scaling 2 Let L = D µ C 1 : scaled companion linearization 3 Apply QZ to L 4 Obtain relevant e vals 5 Recover left (w 1 ) and right (max i z i 2 ) e vecs 6 Compute/estimate b errs and condition numbers 7 Detect nonregular problem MIMS Nick Higham Polynomial eigenproblem 38 / 39

48 Tentative Outline of Algorithm for QEP 1 Preprocess Q: Fan, Lin & Van Dooren (2004) scaling 2 Let L = D µ C 1 : scaled companion linearization 3 Apply QZ to L 4 Obtain relevant e vals 5 Recover left (w 1 ) and right (max i z i 2 ) e vecs 6 Compute/estimate b errs and condition numbers 7 Detect nonregular problem Mainpolyeig differences: Doesn t scale. Doesn t return left e vecs. Doesn t detect nonregular Q. MIMS Nick Higham Polynomial eigenproblem 38 / 39

49 Concluding Remarks Analysis of cond. & b err for wide variety of lineariz ns. E vector recovery formulae crucial. Scaling crucial. Favour L = (scaled) companion form for general PEPs. L L 1 (P), L 2 (P) or DL(P) for structured problems. Implications for pseudospectra. Further work needed on algorithmics scaling & balancing (pencils & general m) structured problems (symm, odd even, definite)... MIMS Nick Higham Polynomial eigenproblem 39 / 39

50 Bibliography I M. Berhanu. The Polynomial Eigenvalue Problem. PhD thesis, University of Manchester, Manchester, England, P. I. Davies, N. J. Higham, and F. Tisseur. Analysis of the Cholesky method with iterative refinement for solving the symmetric definite generalized eigenproblem. SIAM J. Matrix Anal. Appl., 23(2): , H.-Y. Fan, W.-W. Lin, and P. Van Dooren. Normwise scaling of second order polynomial matrices. SIAM J. Matrix Anal. Appl., 26(1): , MIMS Nick Higham Polynomial eigenproblem 35 / 39

51 Bibliography II N. J. Higham, R.-C. Li, and F. Tisseur. Backward error of polynomial eigenproblems solved by linearization. MIMS EPrint 2006.xx, Manchester Institute for Mathematical Sciences, The University of Manchester, UK, In preparation. N. J. Higham, D. S. Mackey, N. Mackey, and F. Tisseur. Symmetric linearizations for matrix polynomials. MIMS EPrint , Manchester Institute for Mathematical Sciences, The University of Manchester, UK, Submitted to SIAM J. Matrix Anal. Appl. MIMS Nick Higham Polynomial eigenproblem 36 / 39

52 Bibliography III N. J. Higham, D. S. Mackey, and F. Tisseur. The conditioning of linearizations of matrix polynomials. Numerical Analysis Report No. 465, Manchester Centre for Computational Mathematics, Manchester, England, To appear in SIAM J. Matrix Anal. Appl. D. Lemonnier and P. M. Van Dooren. Balancing regular matrix pencils. SIAM J. Matrix Anal. Appl., 28(1): , MIMS Nick Higham Polynomial eigenproblem 37 / 39

53 Bibliography IV D. S. Mackey, N. Mackey, C. Mehl, and V. Mehrmann. Vector spaces of linearizations for matrix polynomials. Numerical Analysis Report No. 464, Manchester Centre for Computational Mathematics, Manchester, England, To appear in SIAM J. Matrix Anal. Appl. D. S. Mackey, N. Mackey, C. Mehl, and V. Mehrmann. Structured polynomial eigenvalue problems: Good vibrations from good linearizations. MIMS EPrint , Manchester Institute for Mathematical Sciences, The University of Manchester, UK, To appear in SIAM J. Matrix Anal. Appl. MIMS Nick Higham Polynomial eigenproblem 38 / 39

54 Bibliography V F. Tisseur. Newton s method in floating point arithmetic and iterative refinement of generalized eigenvalue problems. SIAM J. Matrix Anal. Appl., 22(4): , R. C. Ward. Balancing the generalized eigenvalue problem. SIAM J. Sci. Statist. Comput., 2(2): , D. S. Watkins. A case where balancing is harmful. Electron. Trans. Numer. Anal., 23:1 4, MIMS Nick Higham Polynomial eigenproblem 39 / 39

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

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

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

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

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

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

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

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

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

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

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

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 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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J MATRIX ANAL APPL Vol 28, No 4, pp 971 1004 c 2006 Society for Industrial and Applied Mathematics VECTOR SPACES OF LINEARIZATIONS FOR MATRIX POLYNOMIALS D STEVEN MACKEY, NILOUFER MACKEY, CHRISTIAN

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

Resonant MEMS, Eigenvalues, and Numerical Pondering

Resonant MEMS, Eigenvalues, and Numerical Pondering Resonant MEMS, Eigenvalues, and Numerical Pondering David Bindel UC Berkeley, CS Division Resonant MEMS, Eigenvalues,and Numerical Pondering p.1/27 Introduction I always pass on good advice. It is the

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

Pseudospectra of Matrix Pencils and some Distance Problems

Pseudospectra of Matrix Pencils and some Distance Problems Pseudospectra of Matrix Pencils and some Distance Problems Rafikul Alam Department of Mathematics Indian Institute of Technology Guwahati Guwahati - 781 039, INDIA Many thanks to Safique Ahmad and Ralph

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

Linearizing Symmetric Matrix Polynomials via Fiedler pencils with Repetition

Linearizing Symmetric Matrix Polynomials via Fiedler pencils with Repetition Linearizing Symmetric Matrix Polynomials via Fiedler pencils with Repetition Kyle Curlett Maribel Bueno Cachadina, Advisor March, 2012 Department of Mathematics Abstract Strong linearizations of a matrix

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

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

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

Taylor s Theorem for Matrix Functions with Applications to Condition Number Estimation. Deadman, Edvin and Relton, Samuel. MIMS EPrint: 2015.

Taylor s Theorem for Matrix Functions with Applications to Condition Number Estimation. Deadman, Edvin and Relton, Samuel. MIMS EPrint: 2015. Taylor s Theorem for Matrix Functions with Applications to Condition Number Estimation Deadman, Edvin and Relton, Samuel 215 MIMS EPrint: 215.27 Manchester Institute for Mathematical Sciences School of

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

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

A block-symmetric linearization of odd degree matrix polynomials with optimal eigenvalue condition number and backward error

A block-symmetric linearization of odd degree matrix polynomials with optimal eigenvalue condition number and backward error Calcolo manuscript No. (will be inserted by the editor) A block-symmetric linearization of odd degree matrix polynomials with optimal eigenvalue condition number and backward error M. I Bueno F. M. Dopico

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

Some Useful Results in the Theory of Matrix Functions

Some Useful Results in the Theory of Matrix Functions Some Useful Results in the Theory of Matrix Functions Nick Higham School of Mathematics The University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/ Matrix Analysis and Applications,

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

Structured eigenvalue condition numbers and linearizations for matrix polynomials

Structured eigenvalue condition numbers and linearizations for matrix polynomials Eidgenössische Technische Hochschule Zürich Ecole polytechnique fédérale de Zurich Politecnico federale di Zurigo Swiss Federal Institute of Technology Zurich Structured eigenvalue condition numbers and

More information

Structured Polynomial Eigenvalue Problems: Good Vibrations from Good Linearizations

Structured Polynomial Eigenvalue Problems: Good Vibrations from Good Linearizations Structured Polynomial Eigenvalue Problems: Good Vibrations from Good Linearizations Mackey, D. Steven and Mackey, Niloufer and Mehl, Christian and Mehrmann, Volker 006 MIMS EPrint: 006.8 Manchester Institute

More information

Linearizations of singular matrix polynomials and the recovery of minimal indices

Linearizations of singular matrix polynomials and the recovery of minimal indices Electronic Journal of Linear Algebra Volume 18 Volume 18 (2009) Article 32 2009 Linearizations of singular matrix polynomials and the recovery of minimal indices Fernando de Teran fteran@math.uc3m.es Froilan

More information

Computing Matrix Functions by Iteration: Convergence, Stability and the Role of Padé Approximants

Computing Matrix Functions by Iteration: Convergence, Stability and the Role of Padé Approximants Computing Matrix Functions by Iteration: Convergence, Stability and the Role of Padé Approximants Nick Higham School of Mathematics The University of Manchester higham@ma.man.ac.uk http://www.ma.man.ac.uk/~higham/

More information

Nonlinear eigenvalue problems: Analysis and numerical solution

Nonlinear eigenvalue problems: Analysis and numerical solution Nonlinear eigenvalue problems: Analysis and numerical solution Volker Mehrmann TU Berlin, Institut für Mathematik DFG Research Center MATHEON Mathematics for key technologies MATTRIAD 2011 July 2011 Outline

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

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

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 POLYNOMIAL EIGENVALUE PROBLEMS: GOOD VIBRATIONS FROM GOOD LINEARIZATIONS

PALINDROMIC POLYNOMIAL EIGENVALUE PROBLEMS: GOOD VIBRATIONS FROM GOOD LINEARIZATIONS PALINDROMIC POLYNOMIAL EIGENVALUE PROBLEMS: GOOD VIBRATIONS FROM GOOD LINEARIZATIONS D STEVEN MACKEY, NILOUFER MACKEY, CHRISTIAN MEHL, AND VOLKER MEHRMANN Abstract Palindromic polynomial eigenvalue problems

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

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

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

Total least squares. Gérard MEURANT. October, 2008

Total least squares. Gérard MEURANT. October, 2008 Total least squares Gérard MEURANT October, 2008 1 Introduction to total least squares 2 Approximation of the TLS secular equation 3 Numerical experiments Introduction to total least squares In least squares

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

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

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

HARMONIC RAYLEIGH RITZ EXTRACTION FOR THE MULTIPARAMETER EIGENVALUE PROBLEM

HARMONIC RAYLEIGH RITZ EXTRACTION FOR THE MULTIPARAMETER EIGENVALUE PROBLEM HARMONIC RAYLEIGH RITZ EXTRACTION FOR THE MULTIPARAMETER EIGENVALUE PROBLEM MICHIEL E. HOCHSTENBACH AND BOR PLESTENJAK Abstract. We study harmonic and refined extraction methods for the multiparameter

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

of dimension n 1 n 2, one defines the matrix determinants

of dimension n 1 n 2, one defines the matrix determinants HARMONIC RAYLEIGH RITZ FOR THE MULTIPARAMETER EIGENVALUE PROBLEM MICHIEL E. HOCHSTENBACH AND BOR PLESTENJAK Abstract. We study harmonic and refined extraction methods for the multiparameter eigenvalue

More information

A Note on Inverse Iteration

A Note on Inverse Iteration A Note on Inverse Iteration Klaus Neymeyr Universität Rostock, Fachbereich Mathematik, Universitätsplatz 1, 18051 Rostock, Germany; SUMMARY Inverse iteration, if applied to a symmetric positive definite

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

Suppose that the approximate solutions of Eq. (1) satisfy the condition (3). Then (1) if η = 0 in the algorithm Trust Region, then lim inf.

Suppose that the approximate solutions of Eq. (1) satisfy the condition (3). Then (1) if η = 0 in the algorithm Trust Region, then lim inf. Maria Cameron 1. Trust Region Methods At every iteration the trust region methods generate a model m k (p), choose a trust region, and solve the constraint optimization problem of finding the minimum of

More information

The Lanczos and conjugate gradient algorithms

The Lanczos and conjugate gradient algorithms The Lanczos and conjugate gradient algorithms Gérard MEURANT October, 2008 1 The Lanczos algorithm 2 The Lanczos algorithm in finite precision 3 The nonsymmetric Lanczos algorithm 4 The Golub Kahan bidiagonalization

More information

1 Sylvester equations

1 Sylvester equations 1 Sylvester equations Notes for 2016-11-02 The Sylvester equation (or the special case of the Lyapunov equation) is a matrix equation of the form AX + XB = C where A R m m, B R n n, B R m n, are known,

More information

Inverse Eigenvalue Problems and Their Associated Approximation Problems for Matrices with J-(Skew) Centrosymmetry

Inverse Eigenvalue Problems and Their Associated Approximation Problems for Matrices with J-(Skew) Centrosymmetry Inverse Eigenvalue Problems and Their Associated Approximation Problems for Matrices with -(Skew) Centrosymmetry Zhong-Yun Liu 1 You-Cai Duan 1 Yun-Feng Lai 1 Yu-Lin Zhang 1 School of Math., Changsha University

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

Direct methods for symmetric eigenvalue problems

Direct methods for symmetric eigenvalue problems Direct methods for symmetric eigenvalue problems, PhD McMaster University School of Computational Engineering and Science February 4, 2008 1 Theoretical background Posing the question Perturbation theory

More information

Rational Krylov Decompositions: Theory and Applications. Berljafa, Mario. MIMS EPrint:

Rational Krylov Decompositions: Theory and Applications. Berljafa, Mario. MIMS EPrint: Rational Krylov Decompositions: Theory and Applications Berljafa, Mario 2017 MIMS EPrint: 2017.6 Manchester Institute for Mathematical Sciences School of Mathematics The University of Manchester Reports

More information

U AUc = θc. n u = γ i x i,

U AUc = θc. n u = γ i x i, HARMONIC AND REFINED RAYLEIGH RITZ FOR THE POLYNOMIAL EIGENVALUE PROBLEM MICHIEL E. HOCHSTENBACH AND GERARD L. G. SLEIJPEN Abstract. After reviewing the harmonic Rayleigh Ritz approach for the standard

More information

Structured eigenvalue/eigenvector backward errors of matrix pencils arising in optimal control

Structured eigenvalue/eigenvector backward errors of matrix pencils arising in optimal control Electronic Journal of Linear Algebra Volume 34 Volume 34 08) Article 39 08 Structured eigenvalue/eigenvector backward errors of matrix pencils arising in optimal control Christian Mehl Technische Universitaet

More information

Lecture 2: Numerical linear algebra

Lecture 2: Numerical linear algebra Lecture 2: Numerical linear algebra QR factorization Eigenvalue decomposition Singular value decomposition Conditioning of a problem Floating point arithmetic and stability of an algorithm Linear algebra

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

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