in Numerical Linear Algebra

Size: px
Start display at page:

Download "in Numerical Linear Algebra"

Transcription

1 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 Joint work with J. Hook (Bath), J. Pestana (Strathclyde), M. Van Barel (Leuven), L. Grammont, J. Hogg, V. Noferini, J. Scott, M. Sharify. 27th Biennial Conference on NA, / 6

2 What Is Tropical Algebra? By tropical" we refer to a semiring in which the addition operation is min or max. In this talk, we consider the max-plus semiring R max = (R,, ), where R = R { }, a b = max(a, b), a b = a + b, a, b R, and additive and multiplicative identities and 0: a = a, a 0 = a. (James Hook used the min-plus semiring in his talk.) Françoise Tisseur Tropical algebra 2 / 30

3 What Is Tropical Algebra? By tropical" we refer to a semiring in which the addition operation is min or max. In this talk, we consider the max-plus semiring R max = (R,, ), where R = R { }, a b = max(a, b), a b = a + b, a, b R, and additive and multiplicative identities and 0: a = a, a 0 = a. (James Hook used the min-plus semiring in his talk.) Tropical algebra is the tropical analogue of linear algebra, working with matrices with entries in R. If A, B R n n, n (A B) ij = a ij b ij, (A B) ij = a ik b kj. k=1 Françoise Tisseur Tropical algebra 2 / 30

4 Valuation A valuation is a map from a field F R (provide a measure of of the size or multiplicity of elements of F). x C V c (x) = log x R max (log 0 = ). For A C n n, V c (A) = (log a ij ). For x, y C, V c (xy) = V c (x) + V c (y), and when x y or x y then V c (x + y) max{v c (x), V c (y)}. Françoise Tisseur Tropical algebra 3 / 30

5 How Can Tropical Algebra Help NLA? Some NLA problems are easier to study/solve when expressed in the tropical algebra setting, e.g., characterization of all Hungarian scalings of a matrix A. Tropical analogues of NLA problems offer order of magnitude approximation, e.g., for entries in the LU factors or Cholesky factors of a matrix A, roots of scalar polynomials and eigenvalues of matrices/matrix polynomials. These approximations are often cheap to compute and useful for the design of preprocessing steps. Françoise Tisseur Tropical algebra 4 / 30

6 Hungarian Scaling A two-sided diagonal scaling of A C n n applied along with permutation P to Ax = b: H = PD 1 AD 2, Hy = PD 1 b, x = D 2 y, with D 1, D 2 diagonal and H = (h ij ) s.t. h ij 1, h ii = 1. Françoise Tisseur Tropical algebra 5 / 30

7 Hungarian Scaling A two-sided diagonal scaling of A C n n applied along with permutation P to Ax = b: H = PD 1 AD 2, Hy = PD 1 b, x = D 2 y, with D 1, D 2 diagonal and H = (h ij ) s.t. h ij 1, h ii = 1. Improves stability of LU fact. with no pivoting [Olschowka & Neumaier 96], [Hogg & Scott 14] Effective preprocessing step for preconditioned iterative methods. [Benzi, Haws & Tůma 00] Code MC64 in HSL. [Duff & Koster 01] Worst case complexity: O(nτ + n 2 log(n)), τ = nnz(a). In practice, complexity is O(τ). Françoise Tisseur Tropical algebra 5 / 30

8 Hungarian Pairs Max-plus permanent of A R n n : perm(a) = π Π n n j=1 a π(j)j = max π Π n n a π(j)j, (1) j=1 Π n : set of permutations of {1,..., n}. Permutation π attaining max in (1) is an optimal assignment. Françoise Tisseur Tropical algebra 6 / 30

9 Hungarian Pairs Max-plus permanent of A R n n : perm(a) = n a π(j)j = max π Π n π Π n j=1 n a π(j)j, (1) Π n : set of permutations of {1,..., n}. Permutation π attaining max in (1) is an optimal assignment. Express (1) as a linear programming problem (LPP) perm(a) = max { n n n a ij d ij : d ij > 0, d ij = d ji = 1 i } i,j=1 with dual problem { n } perm(a) = min u i +v i : u, v R n, a ij u i v j 0. (2) i=1 j=1 A Hungarian pair is a solution (u, v) to (2). j=1 j=1 Françoise Tisseur Tropical algebra 6 / 30

10 Set of All Hungarian Pairs Let π and (u, v) be an opt assignment and a Hungarian pair of A = V c (A) with A C n n. Then H = P π diag 0 ( exp( u) ) Adiag0 ( exp( v) ) C n n is a Hungarian scaling of A. Theorem (Hook, Pestana, T., Hogg 17) The set of all Hungarian pairs of A is given by Hung(A) = { (u + s π 1, v s) : s col(h ) R n}, where H = P π diag ( u) A diag ( v) and (s π 1) i = s π 1 (i). Here H = I H H 2 H n 1 is the Kleene star and col(h) := {H x : x R n } is the column space of H. Françoise Tisseur Tropical algebra 7 / 30

11 Summary/Comments We have used max-plus algebra to characterize set of all Hungarian scalings for a given A C n n, shown that max-balancing a Hungarian scaled matrix yields the most diagonally dominant" Hungarian scaled matrix with respect to some ordering. For max-balanced Hungarian scaled matrices, numerical experiments show reduced need for row interchanges in GEPP, improved stability of LU with no pivoting, improved convergence rate of iterative methods. (See Hook, Pestana, Tisseur, Hogg, MIMS Eprint ) Françoise Tisseur Tropical algebra 8 / 30

12 Objectives Given A C n n, sparse with nonzero entries that vary widely in magnitude, approximate efficiently the order of magnitude of the entries in the LU factors of A, use large entries to define pattern matrix for an ILU preconditioner. Françoise Tisseur Tropical algebra 9 / 30

13 Objectives Given A C n n, sparse with nonzero entries that vary widely in magnitude, approximate efficiently the order of magnitude of the entries in the LU factors of A, use large entries to define pattern matrix for an ILU preconditioner. Use max-plus algebraic techniques: transform A into a max-plus matrix using valuation V c : C R := R { }, V c (x) = log x, (log 0 = ). Françoise Tisseur Tropical algebra 9 / 30

14 Basis for Approximation Entries in L and U can be expressed explicitly in terms of determinants of submatrices of A C n n, e.g., l ik = det ( A([1 : k 1, i], 1 : k) ) / det ( A(1 : k, 1 : k) ), i k, when A has large variation in the size of its entries, V c ( det(a) ) perm ( Vc (A) ), (Heuristic 1) V c : C R, V c (x) = log x, (log 0 = ), perm is the max-plus permanent, i.e., for A R n n, perm(a) = max π Π(n) n a i,π(i). i=1 Françoise Tisseur Tropical algebra 10 / 30

15 Example Let V c (x) = log 10 x and consider [ 10 0 ] 1000 A = , det(a) = Then A = V c (A) = [ 1 3 ] 0 1, 0 0 perm(a) = max{ , } = 3, which provides an approximation of log 10 det(a) Françoise Tisseur Tropical algebra 11 / 30

16 Max-Plus LU Factors of A R n n Let L = (l ij ) and U = (u ij ) R n n be such that l ik = u kj = if i, j < k, and for i, j k, l ik = perm ( A([1:k 1, i], 1: k) ) perm ( A(1: k, 1: k) ), u kj =perm ( A(1:k, [1:k 1, j]) perm ( A(1: k 1, 1: k 1) ). As a consequence of Heuristic 1 we have Heuristic 2: If A = V(A) R n n has max-plus LU factors L, U R n n then A C n n has LU fact A = LU with V c (L) L, V c (U) U. Françoise Tisseur Tropical algebra 12 / 30

17 Example (Cont.) The matrix A = and A = LU = [ ] [ A = V c (A) = has max-plus LU factors [ 0 ] L = 1 0, U = 1 0 Note that V c (L) = L and V c (U) U. has LU fact ] [ 10 0 ] [ 1 3 ] [ 1 ] Françoise Tisseur Tropical algebra 13 / 30

18 Quality of Max-plus LU Approximation 233 matrices from U. Florida sparse matrix collection. precision = (# of true positives)/(# of l ij, u ij 10 2 ), P(p) = % test matrices with precision p, SP(p) = % of test matrices with soft precision p. log 10 l ij, log 10 u ij log 10 l ij, log 10 u ij false -ve true -ve true +ve -1 soft true +ve l ij, u -2 ij l ij, u -2 ij soft false +ve true -ve -3 p P(p) 86% 83% 80% SP(p) 93% 91% 89% Françoise Tisseur Tropical algebra 14 / 30

19 Computing the Max-plus LU Factors Let A R n n have max-plus LU factors L, U given by l ik =perm ( A([1:k 1, i], 1: k) ) perm ( A(1: k, 1: k) ), u kj =perm ( A(1:k, [1:k 1, j]) perm ( A(1: k 1, 1: k 1) ). Françoise Tisseur Tropical algebra 15 / 30

20 Computing the Max-plus LU Factors Let A R n n have max-plus LU factors L, U given by l ik =perm ( A([1:k 1, i], 1: k) ) perm ( A(1: k, 1: k) ), u kj =perm ( A(1:k, [1:k 1, j]) perm ( A(1: k 1, 1: k 1) ). Proposition (Hook, T. 16) Let G = (X, Y ; E) be bipartite graph of A and M l be max weighted matching between {x(i)} l i=1 and {y(i)}l i=1. u kj is the weight of the maximally weighted path through the residual graph R G (M k 1 ) from x(k) to y(j) for j k, or if there is no such a path, l ik is the weight of the maximally weighted path through R T G (M k) from x(k) to x(i) for i > k, or if there is no such a path. Françoise Tisseur Tropical algebra 15 / 30

21 Max-plus ILU Preconditioner Compute Hungarian scaling H = PD 1 AD 2 of A C n n. Compute max-plus LU factors L and U of V c (H). For a threshold t, define pattern matrix as { 1 if lij log t or u S ij = ij log t, 0 otherwise. Compute ILU factors for H restricted to patter matrix S using, for example, the general static pattern ILU alg. Françoise Tisseur Tropical algebra 16 / 30

22 Performance Profile 233 matrices from U. of Florida sparse matrix collection. Cost measure: # iters ( (nnz(h) + nnz(l ilu ) +nnz(u ilu ) ). Tolerance for GMRES: 10 5 (no restart). 1 Cost of GMRES solve (maxit = 100, right precond) 0.8 within α of best threshold ILU (15 fails) max-plus ILU (38 fails) ILU(k) (59 fails) ILU(0) (88 fails) α Françoise Tisseur Tropical algebra 17 / 30

23 Summary/Comments We presented a new method for approximating order of magnitude of entries in LU factors of a A C n n, which uses max-plus algebra and is based solely on a ij. Cost: O ( nτ + n 2 log n ). Can be parallelized. Approximation can be used to compute an ILU preconditioner for A. Max-plus ILU preconditioner tends to outperform ILU(k) and have performance very close to threshold ILU. (see Hook, Tisseur, MIMS Eprint ) Can also define max-plus Cholesky factors and design incomplete Cholesky factorization preconditioners. (see Hogg, Hook, Scott, Tisseur, MIMS Eprint ) Françoise Tisseur Tropical algebra 18 / 30

24 Polynomial Eigenvalue Problem (PEP) Find λ C { } (eigenvalue) and nonzero x, y C n (right/left eigenvectors) s.t. where P(λ) = d j=0 λj P j. P(λ)x = 0, y P(λ) = 0. Assume P(λ) regular, i.e., det P(λ) 0. P has dn eigenvalues. Finite eigenvalues are roots of det P(λ) = 0. PEPs commonly solved by linearization: converts P into a nd nd linear pencil A λb, solve generalized eigenvalue problem (A λb)z = 0, w (A λb) = 0, recover e vecs x, y of P(λ) from those of A λb. Françoise Tisseur Tropical algebra 19 / 30

25 Tropical Scalar Polynomials (Max-Plus) p(z) := d j=0 p j z j = max 0 j d (p j + jz), p j R max. p(z) is a convex, piecewise-affine function. Max-plus roots are the points at which p(z) is non-differentiable, i.e., points at which the maximum expression for p(z) is attained by more than one term. p(z) has d max-plus roots counting multiplicities, α j, j = 1,..., d. p(z) = p d (α 1 z) (α d z). Françoise Tisseur Tropical algebra 20 / 30

26 Tropical Scalar Polynomials (Max-Plus) p(z) := d j=0 p j z j = max 0 j d (p j + jz), p j R. Max-plus roots can be obtained via Newton polygons (upper convex hull of points (j, p j ), j = 0: d). p j p kj p kj 1 Tropical roots: α j = p k j p kj 1 k j k j 1, j = 1,..., q, multiplicity: m j = k j k j 1. p k2 p k1 p k0 p k q k 0 =0 k 1 k 2 k j 1 k j k q 1 k q=d j Françoise Tisseur Tropical algebra 21 / 30

27 Scalar Polynomials: Classical/Max-Plus Tropicalize" p(x) = d i=0 a ix i, a i C, i.e., construct p(z) = d i=0 log a i z i = max 0 i d (log a i + iz). Let α 1 < < α q be roots of p with α j of multiplicity m j. Theorem (Sharify 11) If max(α j α j 1, α j+1 α j ) log for 1 j q then p(x) has exactly m j roots in the annulus A(x) = {x C : 1 3 exp(α j) x 3 exp(α j ) }. Max-plus roots of p(z) offer order of magnitude approx. to roots of p as long as the α j are well separated. Françoise Tisseur Tropical algebra 22 / 30

28 Computation and Applications Max-plus roots of max-plus polynomials can be computed in O(d) operations, where d = deg(p), provide asymptotic growth rates of roots of p(x; t) = d j=0 x j α j (t); have been used for many years in MPSolve (Multiprecision Polynomial Solver) for the selection of the starting points in the Ehrlich-Aberth method. [Bini and Fiorentino, 2000] Françoise Tisseur Tropical algebra 23 / 30

29 Extension to Matrix Polynomials Let P(λ) = d P i λ i C[λ] n n and p(x) = i=0 d log P i x i with max-plus roots α 1 < < α q, α j of multiplicity m j. k 0 < < k q : corresponding indices in Newton polygon. Theorem (Noferini, Sharify, T. 14) If α l α l 1 2 log(1 + 2κ ( P kl ) ), l = j 1, j then P(λ) has exactly nm j ei vals inside the annulus A ( (1 + 2κ(P kj 1 )) 1 exp(α j ), (1 + 2κ(P kj ))exp(α j ) ). i=0 For P kj 1, P kj well conditioned and α j 1, α j, α j+1 sufficiently well separated, P has nm j ei vals of modulus close to exp(α j ). Here κ(a) = A A 1. Françoise Tisseur Tropical algebra 24 / 30

30 Example: Random Cubic n = 10; A0 = randn(n); A1 = 1e3*randn(n); A2 = 1e2*randn(n); A3 = 1e-2*randn(n); λ j α j Eigenvalue index j Françoise Tisseur Tropical algebra 25 / 30

31 Use of Max-Plus Roots in NLA Max-plus roots used to select starting points in the Ehrlich-Aberth method for polynomial eigenproblems. [Bini, Noferini, Sharify 13] Define eigenvalue parameter scalings (λ = exp(α j )µ) for polynomial eigensolvers based on linearizations. P(µ) := δ 1 P(exp(α j )µ), δ = P kj 1 exp(k j 1 α j ). Allow computation of ei pairs with small b err for λ near exp(α j ). Linearization process does not affect ei val condition number of ei vals near exp(α j ). Available in quadratic eigensolver quadeig. [Hammarling, Munroe, Tisseur 13] Françoise Tisseur Tropical algebra 26 / 30

32 Lagrange Linearization Rewrite n n P(λ) = λ 2 M + λd + K in Lagrange basis, P(λ) = l(λ)m + β 1 l 1 (λ)p(σ 1 ) + β 2 l 1 (λ)p(σ 2 ), β j = (σ j σ i ), l j (λ) = λ σ i, i j, l(λ) = l 1 (λ)l 2 (λ). Construct 3n 3n pencil A λb, where M β 1 P(σ 1 )/σ 1 β 2 P(σ 2 )/σ A = I n I n 0, B = 0 1 σ 1 I n 0. 1 I n 0 I n 0 0 σ 2 I n L(λ) is a linearization of λ 3 0 n + P(λ). Use tropical roots for interpolation points σ j, j = 1, 2. Can show that β j P(σ j ) / σ j = O(1), i.e., A is well-balanced. Françoise Tisseur Tropical algebra 27 / 30

33 Numerical Experiments Backward error for eigenpair (λ, x) of P(λ) = d j=0 λj P j, η(λ, x) = P(λ)x 2 (. d j=0 λ j P j 2 ) x 2 Compare Alg.1: QZ alg applied to tropically scaled Lagrange linearization. [Van Barel, Tisseur 17] Alg.2: MATLAB s polyeig function. Alg.3: Gaubert & Sharify s algorithm. [Gaubert, Sharify 09] Françoise Tisseur Tropical algebra 28 / 30

34 Numerical Experiments (Cont.) Largest backward errors of eigenpairs computed by Alg.1 Alg.3. Problem d n Alg.1 Alg.2 Alg.3 cd_player e e e-13 damped_beam e e e-17 hospital e e e-15 orr_sommerfeld e e e-15 power_plant e e e-18 Problem e e e-12 Problem e e e-14 Problem e e e-10 Françoise Tisseur Tropical algebra 29 / 30

35 Conclusion Some NLA problems are easier to solve in the tropical algebra setting. Tropical analogues of NLA problems offer approximation to solutions of classical problems. These solutions are usually cheap to compute, usuful for the design of preprocessing steps and scalings. Papers and tech reports available on my web page. Françoise Tisseur Tropical algebra 30 / 30

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

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

Max-plus LU. James Hook. November Manchester Institute for Mathematical Sciences School of Mathematics. The University of Manchester

Max-plus LU. James Hook. November Manchester Institute for Mathematical Sciences School of Mathematics. The University of Manchester Max-plus LU James Hook November 25 MIMS EPrint: 25. Manchester Institute for Mathematical Sciences School of Mathematics The University of Manchester Reports available from: And by contacting: http://www.manchester.ac.uk/mims/eprints

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

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

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

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

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

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

Max-Plus Singular Values. Hook, James. MIMS EPrint: Manchester Institute for Mathematical Sciences School of Mathematics

Max-Plus Singular Values. Hook, James. MIMS EPrint: Manchester Institute for Mathematical Sciences School of Mathematics Max-Plus Singular Values Hook, James 2014 MIMS EPrint: 2014.7 Manchester Institute for Mathematical Sciences School of Mathematics The University of Manchester Reports available from: And by contacting:

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2017/18 Part 2: Direct Methods PD Dr.

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

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

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

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

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

Preconditioning Techniques for Large Linear Systems Part III: General-Purpose Algebraic Preconditioners

Preconditioning Techniques for Large Linear Systems Part III: General-Purpose Algebraic Preconditioners Preconditioning Techniques for Large Linear Systems Part III: General-Purpose Algebraic Preconditioners Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, Georgia, USA

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

1 Multiply Eq. E i by λ 0: (λe i ) (E i ) 2 Multiply Eq. E j by λ and add to Eq. E i : (E i + λe j ) (E i )

1 Multiply Eq. E i by λ 0: (λe i ) (E i ) 2 Multiply Eq. E j by λ and add to Eq. E i : (E i + λe j ) (E i ) Direct Methods for Linear Systems Chapter Direct Methods for Solving Linear Systems Per-Olof Persson persson@berkeleyedu Department of Mathematics University of California, Berkeley Math 18A Numerical

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

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

Solving linear equations with Gaussian Elimination (I)

Solving linear equations with Gaussian Elimination (I) Term Projects Solving linear equations with Gaussian Elimination The QR Algorithm for Symmetric Eigenvalue Problem The QR Algorithm for The SVD Quasi-Newton Methods Solving linear equations with Gaussian

More information

Linear Algebra. Matrices Operations. Consider, for example, a system of equations such as x + 2y z + 4w = 0, 3x 4y + 2z 6w = 0, x 3y 2z + w = 0.

Linear Algebra. Matrices Operations. Consider, for example, a system of equations such as x + 2y z + 4w = 0, 3x 4y + 2z 6w = 0, x 3y 2z + w = 0. Matrices Operations Linear Algebra Consider, for example, a system of equations such as x + 2y z + 4w = 0, 3x 4y + 2z 6w = 0, x 3y 2z + w = 0 The rectangular array 1 2 1 4 3 4 2 6 1 3 2 1 in which the

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

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

FINITE-DIMENSIONAL LINEAR ALGEBRA

FINITE-DIMENSIONAL LINEAR ALGEBRA DISCRETE MATHEMATICS AND ITS APPLICATIONS Series Editor KENNETH H ROSEN FINITE-DIMENSIONAL LINEAR ALGEBRA Mark S Gockenbach Michigan Technological University Houghton, USA CRC Press Taylor & Francis Croup

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

Direct Methods for Solving Linear Systems. Simon Fraser University Surrey Campus MACM 316 Spring 2005 Instructor: Ha Le

Direct Methods for Solving Linear Systems. Simon Fraser University Surrey Campus MACM 316 Spring 2005 Instructor: Ha Le Direct Methods for Solving Linear Systems Simon Fraser University Surrey Campus MACM 316 Spring 2005 Instructor: Ha Le 1 Overview General Linear Systems Gaussian Elimination Triangular Systems The LU Factorization

More information

Challenges for Matrix Preconditioning Methods

Challenges for Matrix Preconditioning Methods Challenges for Matrix Preconditioning Methods Matthias Bollhoefer 1 1 Dept. of Mathematics TU Berlin Preconditioning 2005, Atlanta, May 19, 2005 supported by the DFG research center MATHEON in Berlin Outline

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

Gaussian Elimination without/with Pivoting and Cholesky Decomposition

Gaussian Elimination without/with Pivoting and Cholesky Decomposition Gaussian Elimination without/with Pivoting and Cholesky Decomposition Gaussian Elimination WITHOUT pivoting Notation: For a matrix A R n n we define for k {,,n} the leading principal submatrix a a k A

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

Tropical Islands. Jan Verschelde

Tropical Islands. Jan Verschelde Tropical Islands Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu Graduate Computational Algebraic

More information

Matlab s Krylov Methods Library. For. Large Sparse. Ax = b Problems

Matlab s Krylov Methods Library. For. Large Sparse. Ax = b Problems Matlab s Krylov Methods Library For Large Sparse Ax = b Problems PCG Preconditioned Conjugate Gradients Method. X = PCG(A,B) attempts to solve the system of linear equations A*X=B for X. The N-by-N coefficient

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

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

4. Determinants.

4. Determinants. 4. Determinants 4.1. Determinants; Cofactor Expansion Determinants of 2 2 and 3 3 Matrices 2 2 determinant 4.1. Determinants; Cofactor Expansion Determinants of 2 2 and 3 3 Matrices 3 3 determinant 4.1.

More information

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit VII Sparse Matrix

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit VII Sparse Matrix Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccswebpage Lecture Notes for Unit VII Sparse Matrix Computations Part 1: Direct Methods Dianne P. O Leary c 2008

More information

Review Questions REVIEW QUESTIONS 71

Review Questions REVIEW QUESTIONS 71 REVIEW QUESTIONS 71 MATLAB, is [42]. For a comprehensive treatment of error analysis and perturbation theory for linear systems and many other problems in linear algebra, see [126, 241]. An overview of

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors 5 Eigenvalues and Eigenvectors 5.2 THE CHARACTERISTIC EQUATION DETERMINANATS n n Let A be an matrix, let U be any echelon form obtained from A by row replacements and row interchanges (without scaling),

More information

Conjugate Gradient (CG) Method

Conjugate Gradient (CG) Method Conjugate Gradient (CG) Method by K. Ozawa 1 Introduction In the series of this lecture, I will introduce the conjugate gradient method, which solves efficiently large scale sparse linear simultaneous

More information

QR-decomposition. The QR-decomposition of an n k matrix A, k n, is an n n unitary matrix Q and an n k upper triangular matrix R for which A = QR

QR-decomposition. The QR-decomposition of an n k matrix A, k n, is an n n unitary matrix Q and an n k upper triangular matrix R for which A = QR QR-decomposition The QR-decomposition of an n k matrix A, k n, is an n n unitary matrix Q and an n k upper triangular matrix R for which In Matlab A = QR [Q,R]=qr(A); Note. The QR-decomposition is unique

More information

Incomplete factorization preconditioners and their updates with applications - I 1,2

Incomplete factorization preconditioners and their updates with applications - I 1,2 Incomplete factorization preconditioners and their updates with applications - I 1,2 Daniele Bertaccini, Fabio Durastante Moscow August 24, 216 Notes of the course: Incomplete factorization preconditioners

More information

Math Matrix Algebra

Math Matrix Algebra Math 44 - Matrix Algebra Review notes - (Alberto Bressan, Spring 7) sec: Orthogonal diagonalization of symmetric matrices When we seek to diagonalize a general n n matrix A, two difficulties may arise:

More information

A Tuned Preconditioner for Inexact Inverse Iteration Applied to Hermitian Eigenvalue Problems

A Tuned Preconditioner for Inexact Inverse Iteration Applied to Hermitian Eigenvalue Problems A Tuned Preconditioner for Applied to Eigenvalue Problems Department of Mathematical Sciences University of Bath, United Kingdom IWASEP VI May 22-25, 2006 Pennsylvania State University, University Park

More information

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Prof. Tesler Math 283 Fall 2016 Also see the separate version of this with Matlab and R commands. Prof. Tesler Diagonalizing

More information

ACM106a - Homework 2 Solutions

ACM106a - Homework 2 Solutions ACM06a - Homework 2 Solutions prepared by Svitlana Vyetrenko October 7, 2006. Chapter 2, problem 2.2 (solution adapted from Golub, Van Loan, pp.52-54): For the proof we will use the fact that if A C m

More information

9. Numerical linear algebra background

9. Numerical linear algebra background Convex Optimization Boyd & Vandenberghe 9. Numerical linear algebra background matrix structure and algorithm complexity solving linear equations with factored matrices LU, Cholesky, LDL T factorization

More information

Sparsity-Preserving Difference of Positive Semidefinite Matrix Representation of Indefinite Matrices

Sparsity-Preserving Difference of Positive Semidefinite Matrix Representation of Indefinite Matrices Sparsity-Preserving Difference of Positive Semidefinite Matrix Representation of Indefinite Matrices Jaehyun Park June 1 2016 Abstract We consider the problem of writing an arbitrary symmetric matrix as

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

Towards parallel bipartite matching algorithms

Towards parallel bipartite matching algorithms Outline Towards parallel bipartite matching algorithms Bora Uçar CNRS and GRAAL, ENS Lyon, France Scheduling for large-scale systems, 13 15 May 2009, Knoxville Joint work with Patrick R. Amestoy (ENSEEIHT-IRIT,

More information

Linear algebra issues in Interior Point methods for bound-constrained least-squares problems

Linear algebra issues in Interior Point methods for bound-constrained least-squares problems Linear algebra issues in Interior Point methods for bound-constrained least-squares problems Stefania Bellavia Dipartimento di Energetica S. Stecco Università degli Studi di Firenze Joint work with Jacek

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors 5 Eigenvalues and Eigenvectors 5.2 THE CHARACTERISTIC EQUATION DETERMINANATS nn Let A be an matrix, let U be any echelon form obtained from A by row replacements and row interchanges (without scaling),

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

Computational Methods CMSC/AMSC/MAPL 460. Eigenvalues and Eigenvectors. Ramani Duraiswami, Dept. of Computer Science

Computational Methods CMSC/AMSC/MAPL 460. Eigenvalues and Eigenvectors. Ramani Duraiswami, Dept. of Computer Science Computational Methods CMSC/AMSC/MAPL 460 Eigenvalues and Eigenvectors Ramani Duraiswami, Dept. of Computer Science Eigen Values of a Matrix Recap: A N N matrix A has an eigenvector x (non-zero) with corresponding

More information

Systems of Second Order Differential Equations Cayley-Hamilton-Ziebur

Systems of Second Order Differential Equations Cayley-Hamilton-Ziebur Systems of Second Order Differential Equations Cayley-Hamilton-Ziebur Characteristic Equation Cayley-Hamilton Cayley-Hamilton Theorem An Example Euler s Substitution for u = A u The Cayley-Hamilton-Ziebur

More information

Numerical Linear Algebra

Numerical Linear Algebra Numerical Linear Algebra Direct Methods Philippe B. Laval KSU Fall 2017 Philippe B. Laval (KSU) Linear Systems: Direct Solution Methods Fall 2017 1 / 14 Introduction The solution of linear systems is one

More information

9. Numerical linear algebra background

9. Numerical linear algebra background Convex Optimization Boyd & Vandenberghe 9. Numerical linear algebra background matrix structure and algorithm complexity solving linear equations with factored matrices LU, Cholesky, LDL T factorization

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

Recent advances in sparse linear solver technology for semiconductor device simulation matrices

Recent advances in sparse linear solver technology for semiconductor device simulation matrices Recent advances in sparse linear solver technology for semiconductor device simulation matrices (Invited Paper) Olaf Schenk and Michael Hagemann Department of Computer Science University of Basel Basel,

More information

c 2000 Society for Industrial and Applied Mathematics

c 2000 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 22, No. 4, pp. 1333 1353 c 2000 Society for Industrial and Applied Mathematics PRECONDITIONING HIGHLY INDEFINITE AND NONSYMMETRIC MATRICES MICHELE BENZI, JOHN C. HAWS, AND MIROSLAV

More information

Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs

Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs Using an Auction Algorithm in AMG based on Maximum Weighted Matching in Matrix Graphs Pasqua D Ambra Institute for Applied Computing (IAC) National Research Council of Italy (CNR) pasqua.dambra@cnr.it

More information

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Prof. Tesler Math 283 Fall 2018 Also see the separate version of this with Matlab and R commands. Prof. Tesler Diagonalizing

More information

Conceptual Questions for Review

Conceptual Questions for Review Conceptual Questions for Review Chapter 1 1.1 Which vectors are linear combinations of v = (3, 1) and w = (4, 3)? 1.2 Compare the dot product of v = (3, 1) and w = (4, 3) to the product of their lengths.

More information

Recall : Eigenvalues and Eigenvectors

Recall : Eigenvalues and Eigenvectors Recall : Eigenvalues and Eigenvectors Let A be an n n matrix. If a nonzero vector x in R n satisfies Ax λx for a scalar λ, then : The scalar λ is called an eigenvalue of A. The vector x is called an eigenvector

More information

Conjugate Gradient Method

Conjugate Gradient Method Conjugate Gradient Method direct and indirect methods positive definite linear systems Krylov sequence spectral analysis of Krylov sequence preconditioning Prof. S. Boyd, EE364b, Stanford University Three

More information

Numerical Methods I Solving Square Linear Systems: GEM and LU factorization

Numerical Methods I Solving Square Linear Systems: GEM and LU factorization Numerical Methods I Solving Square Linear Systems: GEM and LU factorization Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 18th,

More information

Numerical Methods - Numerical Linear Algebra

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

More information

Iterative Solution methods

Iterative Solution methods p. 1/28 TDB NLA Parallel Algorithms for Scientific Computing Iterative Solution methods p. 2/28 TDB NLA Parallel Algorithms for Scientific Computing Basic Iterative Solution methods The ideas to use iterative

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

Applied Mathematics 205. Unit II: Numerical Linear Algebra. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit II: Numerical Linear Algebra. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit II: Numerical Linear Algebra Lecturer: Dr. David Knezevic Unit II: Numerical Linear Algebra Chapter II.2: LU and Cholesky Factorizations 2 / 82 Preliminaries 3 / 82 Preliminaries

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

Matrix Theory. A.Holst, V.Ufnarovski

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

More information

Structured Matrix Methods for Polynomial Root-Finding

Structured Matrix Methods for Polynomial Root-Finding Structured Matrix Methods for Polynomial Root-Finding Luca Gemignani Department of Mathematics University of Pisa Largo B. Pontecorvo 5, 5617 Pisa, Italy gemignan@dm.unipi.it ABSTRACT In this paper we

More information

Scientific Computing: Solving Linear Systems

Scientific Computing: Solving Linear Systems Scientific Computing: Solving Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 September 17th and 24th, 2015 A. Donev (Courant

More information

CS 246 Review of Linear Algebra 01/17/19

CS 246 Review of Linear Algebra 01/17/19 1 Linear algebra In this section we will discuss vectors and matrices. We denote the (i, j)th entry of a matrix A as A ij, and the ith entry of a vector as v i. 1.1 Vectors and vector operations A vector

More information

A Cholesky LR algorithm for the positive definite symmetric diagonal-plus-semiseparable eigenproblem

A Cholesky LR algorithm for the positive definite symmetric diagonal-plus-semiseparable eigenproblem A Cholesky LR algorithm for the positive definite symmetric diagonal-plus-semiseparable eigenproblem Bor Plestenjak Department of Mathematics University of Ljubljana Slovenia Ellen Van Camp and Marc Van

More information

Chapter 1: Systems of linear equations and matrices. Section 1.1: Introduction to systems of linear equations

Chapter 1: Systems of linear equations and matrices. Section 1.1: Introduction to systems of linear equations Chapter 1: Systems of linear equations and matrices Section 1.1: Introduction to systems of linear equations Definition: A linear equation in n variables can be expressed in the form a 1 x 1 + a 2 x 2

More information

Notes on Linear Algebra and Matrix Theory

Notes on Linear Algebra and Matrix Theory Massimo Franceschet featuring Enrico Bozzo Scalar product The scalar product (a.k.a. dot product or inner product) of two real vectors x = (x 1,..., x n ) and y = (y 1,..., y n ) is not a vector but a

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Numerical Linear Algebra And Its Applications

Numerical Linear Algebra And Its Applications Numerical Linear Algebra And Its Applications Xiao-Qing JIN 1 Yi-Min WEI 2 August 29, 2008 1 Department of Mathematics, University of Macau, Macau, P. R. China. 2 Department of Mathematics, Fudan University,

More information

CHAPTER 6. Direct Methods for Solving Linear Systems

CHAPTER 6. Direct Methods for Solving Linear Systems CHAPTER 6 Direct Methods for Solving Linear Systems. Introduction A direct method for approximating the solution of a system of n linear equations in n unknowns is one that gives the exact solution to

More information

A Generalized Eigenmode Algorithm for Reducible Regular Matrices over the Max-Plus Algebra

A Generalized Eigenmode Algorithm for Reducible Regular Matrices over the Max-Plus Algebra International Mathematical Forum, 4, 2009, no. 24, 1157-1171 A Generalized Eigenmode Algorithm for Reducible Regular Matrices over the Max-Plus Algebra Zvi Retchkiman Königsberg Instituto Politécnico Nacional,

More information

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

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

Preconditioning techniques to accelerate the convergence of the iterative solution methods

Preconditioning techniques to accelerate the convergence of the iterative solution methods Note Preconditioning techniques to accelerate the convergence of the iterative solution methods Many issues related to iterative solution of linear systems of equations are contradictory: numerical efficiency

More information

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 Introduction Almost all numerical methods for solving PDEs will at some point be reduced to solving A

More information

MTH5112 Linear Algebra I MTH5212 Applied Linear Algebra (2017/2018)

MTH5112 Linear Algebra I MTH5212 Applied Linear Algebra (2017/2018) MTH5112 Linear Algebra I MTH5212 Applied Linear Algebra (2017/2018) COURSEWORK 3 SOLUTIONS Exercise ( ) 1. (a) Write A = (a ij ) n n and B = (b ij ) n n. Since A and B are diagonal, we have a ij = 0 and

More information

LU Factorization. Marco Chiarandini. DM559 Linear and Integer Programming. Department of Mathematics & Computer Science University of Southern Denmark

LU Factorization. Marco Chiarandini. DM559 Linear and Integer Programming. Department of Mathematics & Computer Science University of Southern Denmark DM559 Linear and Integer Programming LU Factorization Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark [Based on slides by Lieven Vandenberghe, UCLA] Outline

More information

An Introduction to Correlation Stress Testing

An Introduction to Correlation Stress Testing An Introduction to Correlation Stress Testing Defeng Sun Department of Mathematics and Risk Management Institute National University of Singapore This is based on a joint work with GAO Yan at NUS March

More information

Verified Solutions of Sparse Linear Systems by LU factorization

Verified Solutions of Sparse Linear Systems by LU factorization Verified Solutions of Sparse Linear Systems by LU factorization TAKESHI OGITA CREST, Japan Science and Technology Agency JST), and Faculty of Science and Engineering, Waseda University, Robert J. Shillman

More information

7. LU factorization. factor-solve method. LU factorization. solving Ax = b with A nonsingular. the inverse of a nonsingular matrix

7. LU factorization. factor-solve method. LU factorization. solving Ax = b with A nonsingular. the inverse of a nonsingular matrix EE507 - Computational Techniques for EE 7. LU factorization Jitkomut Songsiri factor-solve method LU factorization solving Ax = b with A nonsingular the inverse of a nonsingular matrix LU factorization

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Aggregation-based algebraic multigrid

Aggregation-based algebraic multigrid Aggregation-based algebraic multigrid from theory to fast solvers Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire CEMRACS, Marseille, July 18, 2012 Supported by the Belgian FNRS

More information

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

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

More information

The flexible incomplete LU preconditioner for large nonsymmetric linear systems. Takatoshi Nakamura Takashi Nodera

The flexible incomplete LU preconditioner for large nonsymmetric linear systems. Takatoshi Nakamura Takashi Nodera Research Report KSTS/RR-15/006 The flexible incomplete LU preconditioner for large nonsymmetric linear systems by Takatoshi Nakamura Takashi Nodera Takatoshi Nakamura School of Fundamental Science and

More information

MA 265 FINAL EXAM Fall 2012

MA 265 FINAL EXAM Fall 2012 MA 265 FINAL EXAM Fall 22 NAME: INSTRUCTOR S NAME:. There are a total of 25 problems. You should show work on the exam sheet, and pencil in the correct answer on the scantron. 2. No books, notes, or calculators

More information

Error Bounds for Iterative Refinement in Three Precisions

Error Bounds for Iterative Refinement in Three Precisions Error Bounds for Iterative Refinement in Three Precisions Erin C. Carson, New York University Nicholas J. Higham, University of Manchester SIAM Annual Meeting Portland, Oregon July 13, 018 Hardware Support

More information