Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems Minghao Wu AMSC Program Advisor: Dr. Howard.

Slides:



Advertisements
Similar presentations
Copyright 2011, Data Mining Research Laboratory Fast Sparse Matrix-Vector Multiplication on GPUs: Implications for Graph Mining Xintian Yang, Srinivasan.
Advertisements

Solving Large-scale Eigenvalue Problems in SciDAC Applications
Partial Differential Equations
A NOVEL APPROACH TO SOLVING LARGE-SCALE LINEAR SYSTEMS Ken Habgood, Itamar Arel Department of Electrical Engineering & Computer Science GABRIEL CRAMER.
A Discrete Adjoint-Based Approach for Optimization Problems on 3D Unstructured Meshes Dimitri J. Mavriplis Department of Mechanical Engineering University.
Point-wise Discretization Errors in Boundary Element Method for Elasticity Problem Bart F. Zalewski Case Western Reserve University Robert L. Mullen Case.
Applied Linear Algebra - in honor of Hans SchneiderMay 25, 2010 A Look-Back Technique of Restart for the GMRES(m) Method Akira IMAKURA † Tomohiro SOGABE.
Kalman Filtering, Theory and Practice Using Matlab Wang Hongmei
MATH 685/ CSI 700/ OR 682 Lecture Notes
Solving Linear Systems (Numerical Recipes, Chap 2)
Lecture 13 - Eigen-analysis CVEN 302 July 1, 2002.
Lecture 17 Introduction to Eigenvalue Problems
Modern iterative methods For basic iterative methods, converge linearly Modern iterative methods, converge faster –Krylov subspace method Steepest descent.
1cs542g-term High Dimensional Data  So far we’ve considered scalar data values f i (or interpolated/approximated each component of vector values.
CS 584. Review n Systems of equations and finite element methods are related.
Mar Numerical approach for large-scale Eigenvalue problems 1 Definition Why do we study it ? Is the Behavior system based or nodal based? What are.
CSE245: Computer-Aided Circuit Simulation and Verification Lecture Note 3 Model Order Reduction (1) Spring 2008 Prof. Chung-Kuan Cheng.
MA5233: Computational Mathematics
Some useful linear algebra. Linearly independent vectors span(V): span of vector space V is all linear combinations of vectors v i, i.e.
Shawn Sickel A Comparison of some Iterative Methods in Scientific Computing.
Ch 7.3: Systems of Linear Equations, Linear Independence, Eigenvalues
The Terms that You Have to Know! Basis, Linear independent, Orthogonal Column space, Row space, Rank Linear combination Linear transformation Inner product.
An introduction to iterative projection methods Eigenvalue problems Luiza Bondar the 23 rd of November th Seminar.
CS240A: Conjugate Gradients and the Model Problem.
1cs542g-term Notes  Extra class next week (Oct 12, not this Friday)  To submit your assignment: me the URL of a page containing (links to)
MATH 685/ CSI 700/ OR 682 Lecture Notes Lecture 6. Eigenvalue problems.
Chapter 12 Fast Fourier Transform. 1.Metropolis algorithm for Monte Carlo 2.Simplex method for linear programming 3.Krylov subspace iteration (CG) 4.Decomposition.
Dominant Eigenvalues & The Power Method
5.1 Orthogonality.
Introduction The central problems of Linear Algebra are to study the properties of matrices and to investigate the solutions of systems of linear equations.
Autumn 2008 EEE8013 Revision lecture 1 Ordinary Differential Equations.
Eigenvalue Problems Solving linear systems Ax = b is one part of numerical linear algebra, and involves manipulating the rows of a matrix. The second main.
Advanced Computer Graphics Spring 2014 K. H. Ko School of Mechatronics Gwangju Institute of Science and Technology.
+ Review of Linear Algebra Optimization 1/14/10 Recitation Sivaraman Balakrishnan.
Algorithms for a large sparse nonlinear eigenvalue problem Yusaku Yamamoto Dept. of Computational Science & Engineering Nagoya University.
4.6 Matrix Equations and Systems of Linear Equations In this section, you will study matrix equations and how to use them to solve systems of linear equations.
Boundary Value Problems and Least Squares Minimization
CFD Lab - Department of Engineering - University of Liverpool Ken Badcock & Mark Woodgate Department of Engineering University of Liverpool Liverpool L69.
Scientific Computing Partial Differential Equations Implicit Solution of Heat Equation.
Orthogonalization via Deflation By Achiya Dax Hydrological Service Jerusalem, Israel
MECH593 Introduction to Finite Element Methods Eigenvalue Problems and Time-dependent Problems.
Professor Walter W. Olson Department of Mechanical, Industrial and Manufacturing Engineering University of Toledo System Solutions y(t) t +++++… 11 22.
1 Marijn Bartel Schreuders Supervisor: Dr. Ir. M.B. Van Gijzen Date:Monday, 24 February 2014.
Lesson 3 CSPP58001.
CS240A: Conjugate Gradients and the Model Problem.
Elementary Linear Algebra Anton & Rorres, 9 th Edition Lecture Set – 07 Chapter 7: Eigenvalues, Eigenvectors.
Numerical Analysis – Eigenvalue and Eigenvector Hanyang University Jong-Il Park.
Eigenvalues The eigenvalue problem is to determine the nontrivial solutions of the equation Ax= x where A is an n-by-n matrix, x is a length n column.
*Man-Cheol Kim, Hyung-Jo Jung and In-Won Lee *Man-Cheol Kim, Hyung-Jo Jung and In-Won Lee Structural Dynamics & Vibration Control Lab. Structural Dynamics.
Al Parker July 19, 2011 Polynomial Accelerated Iterative Sampling of Normal Distributions.
Lecture 21 MA471 Fall 03. Recall Jacobi Smoothing We recall that the relaxed Jacobi scheme: Smooths out the highest frequency modes fastest.
23/5/20051 ICCS congres, Atlanta, USA May 23, 2005 The Deflation Accelerated Schwarz Method for CFD C. Vuik Delft University of Technology
Advanced Computer Graphics Spring 2014 K. H. Ko School of Mechatronics Gwangju Institute of Science and Technology.
MA5233 Lecture 6 Krylov Subspaces and Conjugate Gradients Wayne M. Lawton Department of Mathematics National University of Singapore 2 Science Drive 2.
MA237: Linear Algebra I Chapters 1 and 2: What have we learned?
Solving linear systems in fluid dynamics P. Aaron Lott Applied Mathematics and Scientific Computation Program University of Maryland.
ALGEBRAIC EIGEN VALUE PROBLEMS
Introduction The central problems of Linear Algebra are to study the properties of matrices and to investigate the solutions of systems of linear equations.
Introduction The central problems of Linear Algebra are to study the properties of matrices and to investigate the solutions of systems of linear equations.
Chapter 12 Fast Fourier Transform
Eigenspectrum calculation of the non-Hermitian O(a)-improved Wilson-Dirac operator using the Sakurai-Sugiura method H. Sunoa, Y. Nakamuraa,b, K.-I. Ishikawac,
Meros: Software for Block Preconditioning the Navier-Stokes Equations
Singular Value Decomposition
Eigenvalues and Eigenvectors
Scientific Computing Partial Differential Equations Implicit Solution of Heat Equation.
Eigenvalues and Eigenvectors
Eigenvalues and Eigenvectors
RKPACK A numerical package for solving large eigenproblems
Linear Algebra Lecture 28.
Presentation transcript:

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems Minghao Wu AMSC Program Advisor: Dr. Howard Elman Department of Computer Science

2 Motivation To determine the stability of the linearized system of the form: The steady state solution x* is - stable, if all the eigenvalues of Ax = λBx have negative real parts; - unstable, otherwise.

3 Problem Statement To find the rightmost eigenvalues of: where matrices A and B are Real N-by-N Large Sparse Nonsymmetric Depend on one or several parameters

4 Method Eigensolver: Arnoldi Algorithm - Iterative method - Based on Krylov subspace: - Computes Arnoldi decomposition: where: [U k u k+1 ]: an orthonormal basis of H k : k-by-k upper Hessenberg matrix, k « N β k: scalar, e k : k-by-1 vector [0 0 … 0 1]’

5 Arnoldi Algorithm (continue) Eigenvalues of H k approximate eigenvalues of A Premultiply previous equation by transpose(Uk): Let (λ,z) be an eigenpair of H k, then: As k increases, ||Residual|| will decrease. When k = N, Residual = 0. Residual

6 Matrix Transformation Motivation - Arnoldi Algorithm cannot solve generalized eigenvalue problem - It converges to well – separated extremal eigenvalues, not rightmost eigenvalues Shift – Invert Transformation

7 Matlab Code of Arnoldi Method Arnoldi Algorithm (with Shift – Invert matrix transformation) routine: [v,X,U,H]=SI_Arnoldi(A,B,k,sigma) Input: A, B: matrix A and B in Ax = λBx k: number of eigenpairs wanted sigma: the shift σ in shift – invert matrix transformation Output: v: a vector of k computed eigenvalues X: k eigenvectors associated with the eigenvalues U: the Krylov basis U k+1 H: the upper Hessenberg matrix H k

8 Test Problem Olmstead Model (see Olmstead et al (1986)): with boundary conditions: This model represents the flow of a layer of viscoelastic fluid heated from below. u: the speed of the fluid S: related to viscoelastic forces b,c: scalars, R: scalar, Rayleigh number

9 Test Problem (continue) Discretize the model with finite differences - grid – size: h = 1/(N/2) - (4) can be written as dy/dt = f(y) with Evaluate the Jacobian matrix A = df/dy at steady state solution y* - N = 1000, b = 2, c = 0.1, R = y* = 0 - A = df/dy(y*) is a nonsymmetric sparse matrix with bandwidth 6

10 Test Problem (continue) Computational Result: Rightmost eigenvalues: λ 1,2 = 0 ± i Residual: ||Ax i - λ i x i || = e-012, i=1,2 The result agrees with the literature.

11 Implicitly Restarted Arnoldi (IRA) Motivation - Large k is not practical Example: Size of A:10,000 Value of k:100 Memory required to store U 100 in double precision: 10 MB - When B is singular, Arnoldi algorithm may give rise to spurious eigenvalues

12 IRA (continue) Basic idea of Implicitly Restarted Arnoldi Filter out the unwanted eigendirections from the starting vector by using the most recent spectrum information and a clever filtering technique IRA steps 1. Compute m eigenpairs (k<m«N) by Arnoldi method with starting vector u 1 2. Filter out the m-k unwanted eigendirections from u 1 (Key Technique: shifted QR algorithm) 3. Restart the process with filtered starting vector till the k eigenvalues of interest converge

13 Test Problem K: 200-by-200 matrix, full rank; C: 200-by-100 matrix, full rank; M: 200-by-200 matrix, full rank. Eigenvalue problem with this kind of block structure appears in the stability analysis of steady state solution of Navier – Stokes equations for incompressible flow.

14 Test Problem (continue) Use Matlab function “rand” to generate K, C, M ≤ Re(λ) ≤ Find out 10 rightmost eigenvalues Use the IRA code written by Fei Xue

15 Test Problem (continue) Exact Eigenavalues i i i i i i i i i i Computed Eigenavalues (Arnoldi) i i i i i i i i i i Computed Eigenavalues (IRA) i i i i i i i i i i Computational Result: (shift σ = 60)

16 Future Work (AMSC 664) Solve the third test problem Implement iterative solvers for linear systems