Parameterized Partial Differential Equations and the Proper Orthogonal D

Size: px
Start display at page:

Download "Parameterized Partial Differential Equations and the Proper Orthogonal D"

Transcription

1 Parameterized Partial Differential Equations and the Proper Orthogonal Decomposition Stanford University February 04, 2014

2 Outline Parameterized PDEs The steady case Dimensionality reduction Proper orthogonal decomposition Projection-based model reduction Snapshot selection The unsteady case

3 Parameterized PDE Parametrized partial differential equation (PDE) L(W, x, t; µ) = 0 Associated boundary conditions B(W, x BC, t; µ) = 0 Initial condition W 0 (x) = W IC (x, µ) W = W(x, t) R q : state variable x Ω R d, d 3: space variable t 0: time variable µ D R p : parameter vector

4 Model parameterized PDE Advection-diffusion-reaction equation: W = W(x, t; µ) solution of W t + U W κ W = f R(W, t, µ R ) for x Ω with appropriate boundary and initial conditions Parameters of interest W(x, t; µ) = W D (x, t; µ D ) for x Γ D W(x, t; µ) n(x) = 0 for x Γ N W(x, 0; µ) = W 0 (x; µ IC ) for x Ω µ = [U 1,, U d, κ, µ R, µ D, µ IC ]

5 Semi-discretized problem The PDE is then discretized in space by one of the following methods Finite Differences approximation Finite Element method Finite Volumes method Discontinuous Galerkin method Spectral method... This leads to a system of N w = q N space ordinary differential equations (ODEs) dw = f(w, t; µ) dt in terms of the discretized state variable with initial condition w(0; µ) = w(µ) w = w(t; µ) R Nw This is the high-dimensional model (HDM)

6 Parameterized solutions Example: two dimensional advection-diffusion equation W + U W κ W = 0 for x Ω t with boundary and initial conditions W(x, t; µ) = W D (x, t; µ D ) for x Γ D W(x, t; µ) n(x) = 0 for x Γ N W(x, 0; µ) = W 0 (x) for x Ω Γ N Γ D U Ω Γ N Γ N

7 Parameterized solutions Example: two dimensional advection-diffusion equation W t with boundary and initial conditions 4 parameters of interest w R Nw with N w = 2, U W κ W = 0 for x Ω W(x, t; µ) = W D (x, t; µ D ) for x Γ D W(x, t; µ) n(x) = 0 for x Γ N W(x, 0; µ) = W 0 (x) for x Ω µ = [U 1, U 2, κ, µ D ] R 4

8 Parameterized solutions

9 Steady parameterized PDE Steady parameterized HDM f(w; µ) = 0 Linear case A(µ)w = b(µ) Example: steady advection-diffusion equation

10 Dimensionality reduction Consider the manifold of solutions M = {w(µ) s.t. µ D} R Nw Often dim(m) N w Therefore, M could be described in terms of a much smaller set of variables, rather than {e 1,, e Nw } Hence dimensionality reduction

11 Dimensionality reduction First idea: use solutions of the equation to describe M Consider pre-computed solution {w(µ 1 ),, w(µ m )} where {µ 1,, µ m } D Let µ D. Then approximate w(µ) as w(µ) α 1 (µ)w(µ 1 ) + + α m (µ)w(µ m ) where {α 1 (µ),, α m (µ)} are coefficients to be determined

12 Reduced-order basis There may be redundancies in the solutions {w(µ 1 ),, w(µ m )}. Better approach: remove the redundancies by considering an equivalent independent set {v 1,, v k } with k m such that span {v 1,, v k } = span {w(µ 1 ),, w(µ m )} V = [v 1,, v k ] R Nw k is a reduced-order basis with k N w

13 Basis construction Lagrange basis Hermite basis span {v 1,, v k } = span {w(µ 1 ),, w(µ m )} span (v 1,, v k )} = span { w(µ 1 ), w (µ 1 ),, w } (µ 1 ), w(µ 2 ), µ 1 µ p

14 Data compression It is possible to remove more information from the snapshots {w(µ 1 ),, w(µ m )} Consider the snapshot matrix W = [w(µ 1 ),, w(µ m )] Can we quantify the main information contained in W and discard the rest (noise)? This amount to data compression Here orthogonal projection will be used to compress the data

15 Orthogonal projection Let V R Nw k be an orthogonal matrix (V T V = I k ) which columns span S, a subspace of dimension k Let x R Nw. The orthogonal projection of x onto the subspace S is VV T x Projection matrix Π V,V = V(V T V) 1 V T = VV T special case 1: if x belongs to S Π V,V x = VV T x = x special case 2: if x is orthogonal to S Π V,V x = VV T x = 0

16

17 Proper Orthogonal Decomposition POD seeks the subspace S of a given dimension k minimizing the projection error of the snapshots {w(µ 1 ),, w(µ m )} Mathematical formulation S = range(v) where V = argmin Y m w(µ i ) Π Y,Y w(µ i ) 2 2 i=1 s.t. Y T Y = I k

18 POD by eigenvalue decomposition Minimization problem V = argmin Y T Y=I k m w(µ i ) Π Y,Y w(µ i ) 2 2 i=1 Equivalent maximization problem V = argmax Y T Y=I k m YY T w(µ i ) 2 2 i=1 = argmax Y T Y=I k Y T W 2 F = argmax Y T Y=I k trace ( Y T WW T Y ) Solution: V is the matrix of eigenvectors {φ 1,, φ k } associated with the k largest eigenvalues of K = WW T

19 The method of snapshots POD: V is the matrix of eigenvectors {φ 1,, φ k } associated with the k largest eigenvalues of K = WW T K R Nw Nw is a large, dense matrix Its rank is at most m N w In 1987, Sirovich developed the method of snapshots by noticing that R = W T W R m m has the same non-zero eigenvalues {λ i } r i=1 as K r = rank(r) m N w and Rψ i = λψ i, i = 1,, r Exercise: relationship between {φ 1,, φ r } and {ψ 1,, ψ r }?

20 The method of snapshots Step 1: compute the eigenpairs {λ i, ψ i } r i=1 associated with R Rψ i = λψ i, i = 1,, r Step 2: compute φ i = 1 λi Wψ i, i = 1,, r In matrix form Φ = WΨΛ 1 2 POD reduced basis of dimension k r: V = [φ 1,, φ k ]

21 POD by singular value decomposition The POD basis V can also be computed by singular value decomposition (SVD) SVD of W: W = U r Σ r Z T r U r = [u 1,, u r] R Nw r : left singular vectors (U T r U r = I r) Σ r = diag(σ 1,, σ r) R r r : singular values Z r = [z 1,, z r] R m r : right singular vectors (Z T r Z r = I r) POD reduced basis of dimension k r V = [u 1,, u k ]

22 POD basis size selection The POD basis V can also be computed by singular value decomposition (SVD) SVD of W: W = U r Σ r Z T r POD reduced basis of dimension k r Relative projection error V k = [u 1,, u k ] e(k) = W V kv T k W F W F = Typically k is chosen so that e(k) < 0.1 r i=k+1 σ2 i r i=1 σ2 i

23 Projection-based model reduction High-dimensional model (HDM) A(µ)w = b(µ) Reduced-order modeling assumption using a reduced basis V w(µ) Vq(µ) q(µ): reduced (generalized) coordinates Inserting in the HDM equation AVq b N w equations in terms of k unknowns q Associated residual r(q) = A(µ)Vq b(µ)

24 Galerkin projection Residual equation r(q) = A(µ)Vq b(µ) N w equations with k unknowns Galerkin projection enforces the orthogonality of r(q) to range(v): V T r(q) = 0 Reduced equations: V T A(µ)Vq = V T b(µ) k equations in terms of k unknowns A k (µ)q = b k (µ)

25 Application to the steady advection diffusion equation m = 5 snapshots {µ i } 5 i=1

26 Application to the steady advection diffusion equation m = 5 snapshots {µ i } 5 i=1 POD basis of dimension k = 5

27 Application to the steady advection diffusion equation Projection error e(k) k

28 Application to the steady advection diffusion equation µ 5 = (U 1, U 2, κ, µ D ) = (1, 10, , 850)

29 Exercise: Petrov-Galerkin projection Other approach to get a unique solution to Least-squares approach A(µ)Vq b(µ) q = argmin A(µ)Vy b(µ) 2 y Exercise: give the equivalent set of equations satisfied by y Solution: V T A(µ) T A(µ)Vq = V T A(µ) T b(µ)

30 Offline/online decomposition for parametric systems Offline phase: computation of V from snapshots {w(µ 1 ),, w(µ m )} Online phase: construction and solution of V T A(µ)Vq = V T b(µ) Issue: constructing A k (µ) = V T A(µ)V and b k (µ) = V T b(µ) is expensive Exception in the case of affine parameter dependence: q A N w and q b N w Then A k (µ) = A(µ) = q A i=1 q A i=1 f (i) A (µ)a(i), b(µ) = f (i) A (µ)vt A (i) V, b(µ) = q b i=1 q b i=1 f (i) b (µ)b (i) f (i) b (µ)v T b (i) The following small dimensional matrices can be computed offline A (i) k b (i) k = VT A (i) V R k k, i = 1,, q A = VT b (i) R k, i = 1,, q b

31 Snapshot selection For a given number of snapshots m, what are the best snapshot parameter locations µ 1,, µ m D? The snapshots {w(µ 1 ),, w(µ m )} should be optimally placed so that they capture the physics over the parameter space D Difficult problem use a heuristic approach (Greedy algorithm)

32 Greedy approach Start by randomly selecting a parameter value µ 1 and compute w(µ 1 ) For i = 1, m, find the parameter µ i which presents the highest error between the ROM solution Vq(µ) and the HDM solution w(µ) This however requires knowing the HDM solution (unknown) Instead, for i = 1, m, find the parameter µ i for which the residual r(q(µ)) = AVq(µ) b(µ) is the highest where V T A(µ)Vq(µ) = V T b(µ) µ i = argmin A(µ)Vq(µ) b(µ) 2 µ D The parameter domain µ D can be in practice replaced by a search over a finite set µ {µ (1),, µ (N) } D

33 Application to the steady advection diffusion equation Parameter domain (U 1, U 2 ) [0, 10] [0, 10] U 2 6 initial U 1

34 Application to the steady advection diffusion equation

35 Application to the steady advection diffusion equation Maximum Residual Maximum Error Normalized quantity Iteration 6 7 8

36 Application to the steady advection diffusion equation Normalized quantity Maximum Residual Maximum Error Iteration

37 POD in time Consider an unsteady linear parametric problem dw (t) = A(µ)w(t) b(µ)u(t) dt where u(t) is given for a time interval t [t 0, t Nt ] For a given parameter µ, POD can also provide an optimal reduced basis associated with the minimization problem min V T V=I k tnt t 0 w(t, µ) VV T w(t, µ) 2 2 dt Solution by the method of snapshots: consider the solutions in time w(t 0, µ),, w(t Nt, µ). An approximation of the minimization problem is min V T V=I k N t i=0 δ i w(ti, µ) VV T w(t i, µ) 2 2 where δ 0,, δ Nt are appropriate quadrature weights

38 POD in time (continued) Equivalent maximization problem max V T V=I k N t i=0 δ i V T w(t i, µ) 2 2 Solution by POD by the method of snapshots with the associated snapshot matrix W = [ δ 0 w(t 0, µ),, δ Nt w(t Nt, µ)]

39 POD: Application to linearized aeroelasticity M = 0.99 N w = 2, 188, 394, m = 99 snapshots, k = 60 retained POD vectors Lift (lb)! 6000! 5000! 4000! 3000! 2000! 1000! 0! -1000! -2000! 0.00! 0.10! 0.20! 0.30! 0.40! 0.50! Time (s)! HDM (2,188,394)! ROM (69)!

40 Global vs. local strategies Global strategy build a ROB V that captures the behavior of unsteady systems for all µ D POD based on snapshots {w(t 0, µ 1),, w(t Nt, µ 1), w(t 0, µ 2),, w(t Nt, µ m)} not optimal for a given µ i Local strategy build a separate ROB V(µ) for every value of µ D database approach: build offline a set of ROBs {V(µ i)} m i=1 and use them online to build V(µ) for µ D each ROB V(µ i) is optimal at µ = µ i requires an adaptation approach online (see Lecture 3)

41 References Lecture notes on projection-based model reduction: amsallem/ca-cme345-ch3.pdf Lecture notes on POD: amsallem/ca-cme345-ch4.pdf Holmes, P., Lumley, J., and Berkooz, G., Turbulence, Coherent Structures, Dynamical Systems and Symmetry, Cambridge Univ. Press, Cambridge, England, U.K., Sirovich, L.: Turbulence and the dynamics of coherent structures. Part I: coherent structures. Quarterly of applied mathematics 45(3), (1987). Patera A. and Rozza G., Reduced Basis Approximation and a Posteriori Error Estimation for Parametrized Partial Differential Equations, Version 1.0, Copyright MIT 2006, to appear in (tentative rubric) MIT Pappalardo Graduate Monographs in Mechanical Engineering. Haasdonk, B., Ohlberger, M.: Efficient reduced models and a-posteriori error estimation for parametrized dynamical systems by offline/online decomposition. Stuttgart Research Centre for Simulation Technology (SRC SimTech) Preprint Series 23 (2009)

CME 345: MODEL REDUCTION

CME 345: MODEL REDUCTION CME 345: MODEL REDUCTION Proper Orthogonal Decomposition (POD) Charbel Farhat & David Amsallem Stanford University cfarhat@stanford.edu 1 / 43 Outline 1 Time-continuous Formulation 2 Method of Snapshots

More information

Reduced Basis Method for Parametric

Reduced Basis Method for Parametric 1/24 Reduced Basis Method for Parametric H 2 -Optimal Control Problems NUMOC2017 Andreas Schmidt, Bernard Haasdonk Institute for Applied Analysis and Numerical Simulation, University of Stuttgart andreas.schmidt@mathematik.uni-stuttgart.de

More information

CME 345: MODEL REDUCTION

CME 345: MODEL REDUCTION CME 345: MODEL REDUCTION Methods for Nonlinear Systems Charbel Farhat & David Amsallem Stanford University cfarhat@stanford.edu 1 / 65 Outline 1 Nested Approximations 2 Trajectory PieceWise Linear (TPWL)

More information

CME 345: MODEL REDUCTION - Projection-Based Model Order Reduction

CME 345: MODEL REDUCTION - Projection-Based Model Order Reduction CME 345: MODEL REDUCTION - Projection-Based Model Order Reduction Projection-Based Model Order Reduction Charbel Farhat and David Amsallem Stanford University cfarhat@stanford.edu 1 / 38 Outline 1 Solution

More information

Empirical Interpolation of Nonlinear Parametrized Evolution Operators

Empirical Interpolation of Nonlinear Parametrized Evolution Operators MÜNSTER Empirical Interpolation of Nonlinear Parametrized Evolution Operators Martin Drohmann, Bernard Haasdonk, Mario Ohlberger 03/12/2010 MÜNSTER 2/20 > Motivation: Reduced Basis Method RB Scenario:

More information

Proper Orthogonal Decomposition (POD)

Proper Orthogonal Decomposition (POD) Intro Results Problem etras Proper Orthogonal Decomposition () Advisor: Dr. Sorensen CAAM699 Department of Computational and Applied Mathematics Rice University September 5, 28 Outline Intro Results Problem

More information

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems Institute for Mathematics and Scientific Computing, Austria DISC Summerschool 5 Outline of the talk POD and singular value decomposition

More information

Proper Orthogonal Decomposition

Proper Orthogonal Decomposition Proper Orthogonal Decomposition Kameswararao Anupindi School of Mechanical Engineering Purdue University October 15, 2010 Kameswararao Anupindi (Purdue University) ME611, Principles of Turbulence October

More information

A-Posteriori Error Estimation for Parameterized Kernel-Based Systems

A-Posteriori Error Estimation for Parameterized Kernel-Based Systems A-Posteriori Error Estimation for Parameterized Kernel-Based Systems Daniel Wirtz Bernard Haasdonk Institute for Applied Analysis and Numerical Simulation University of Stuttgart 70569 Stuttgart, Pfaffenwaldring

More information

Proper Orthogonal Decomposition. POD for PDE Constrained Optimization. Stefan Volkwein

Proper Orthogonal Decomposition. POD for PDE Constrained Optimization. Stefan Volkwein Proper Orthogonal Decomposition for PDE Constrained Optimization Institute of Mathematics and Statistics, University of Constance Joined work with F. Diwoky, M. Hinze, D. Hömberg, M. Kahlbacher, E. Kammann,

More information

Towards parametric model order reduction for nonlinear PDE systems in networks

Towards parametric model order reduction for nonlinear PDE systems in networks Towards parametric model order reduction for nonlinear PDE systems in networks MoRePas II 2012 Michael Hinze Martin Kunkel Ulrich Matthes Morten Vierling Andreas Steinbrecher Tatjana Stykel Fachbereich

More information

CME 345: MODEL REDUCTION

CME 345: MODEL REDUCTION CME 345: MODEL REDUCTION Balanced Truncation Charbel Farhat & David Amsallem Stanford University cfarhat@stanford.edu These slides are based on the recommended textbook: A.C. Antoulas, Approximation of

More information

Machine Learning Applied to 3-D Reservoir Simulation

Machine Learning Applied to 3-D Reservoir Simulation Machine Learning Applied to 3-D Reservoir Simulation Marco A. Cardoso 1 Introduction The optimization of subsurface flow processes is important for many applications including oil field operations and

More information

Dimensionality reduction of parameter-dependent problems through proper orthogonal decomposition

Dimensionality reduction of parameter-dependent problems through proper orthogonal decomposition MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 01.2016 January 2016 (New 25.05.2016) Dimensionality

More information

UNITEXT La Matematica per il 3+2

UNITEXT La Matematica per il 3+2 UNITEXT La Matematica per il 3+2 Volume 92 Editor-in-chief A. Quarteroni Series editors L. Ambrosio P. Biscari C. Ciliberto M. Ledoux W.J. Runggaldier More information about this series at http://www.springer.com/series/5418

More information

Efficient model reduction of parametrized systems by matrix discrete empirical interpolation

Efficient model reduction of parametrized systems by matrix discrete empirical interpolation MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 02.2015 February 2015 Efficient model reduction of

More information

Towards Reduced Order Modeling (ROM) for Gust Simulations

Towards Reduced Order Modeling (ROM) for Gust Simulations Towards Reduced Order Modeling (ROM) for Gust Simulations S. Görtz, M. Ripepi DLR, Institute of Aerodynamics and Flow Technology, Braunschweig, Germany Deutscher Luft und Raumfahrtkongress 2017 5. 7. September

More information

Proper Orthogonal Decomposition for Optimal Control Problems with Mixed Control-State Constraints

Proper Orthogonal Decomposition for Optimal Control Problems with Mixed Control-State Constraints Proper Orthogonal Decomposition for Optimal Control Problems with Mixed Control-State Constraints Technische Universität Berlin Martin Gubisch, Stefan Volkwein University of Konstanz March, 3 Martin Gubisch,

More information

Hessian-based model reduction for large-scale systems with initial condition inputs

Hessian-based model reduction for large-scale systems with initial condition inputs Hessian-based model reduction for large-scale systems with initial condition inputs O. Bashir 1, K. Willcox 1,, O. Ghattas 2, B. van Bloemen Waanders 3, J. Hill 3 1 Massachusetts Institute of Technology,

More information

On a Data Assimilation Method coupling Kalman Filtering, MCRE Concept and PGD Model Reduction for Real-Time Updating of Structural Mechanics Model

On a Data Assimilation Method coupling Kalman Filtering, MCRE Concept and PGD Model Reduction for Real-Time Updating of Structural Mechanics Model On a Data Assimilation Method coupling, MCRE Concept and PGD Model Reduction for Real-Time Updating of Structural Mechanics Model 2016 SIAM Conference on Uncertainty Quantification Basile Marchand 1, Ludovic

More information

arxiv: v1 [math.na] 23 Jun 2015

arxiv: v1 [math.na] 23 Jun 2015 Real-time solution of computational problems using databases of parametric linear reduced-order models with arbitrary underlying meshes David Amsallem a,, Radek ezaur a, Charbel Farhat b a Department of

More information

POD/DEIM 4DVAR Data Assimilation of the Shallow Water Equation Model

POD/DEIM 4DVAR Data Assimilation of the Shallow Water Equation Model nonlinear 4DVAR 4DVAR Data Assimilation of the Shallow Water Equation Model R. Ştefănescu and Ionel M. Department of Scientific Computing Florida State University Tallahassee, Florida May 23, 2013 (Florida

More information

REDUCED ORDER METHODS

REDUCED ORDER METHODS REDUCED ORDER METHODS Elisa SCHENONE Legato Team Computational Mechanics Elisa SCHENONE RUES Seminar April, 6th 5 team at and of Numerical simulation of biological flows Respiration modelling Blood flow

More information

Model Reduction, Centering, and the Karhunen-Loeve Expansion

Model Reduction, Centering, and the Karhunen-Loeve Expansion Model Reduction, Centering, and the Karhunen-Loeve Expansion Sonja Glavaški, Jerrold E. Marsden, and Richard M. Murray 1 Control and Dynamical Systems, 17-81 California Institute of Technology Pasadena,

More information

Highly-efficient Reduced Order Modelling Techniques for Shallow Water Problems

Highly-efficient Reduced Order Modelling Techniques for Shallow Water Problems Highly-efficient Reduced Order Modelling Techniques for Shallow Water Problems D.A. Bistrian and I.M. Navon Department of Electrical Engineering and Industrial Informatics, University Politehnica of Timisoara,

More information

INTERPRETATION OF PROPER ORTHOGONAL DECOMPOSITION AS SINGULAR VALUE DECOMPOSITION AND HJB-BASED FEEDBACK DESIGN PAPER MSC-506

INTERPRETATION OF PROPER ORTHOGONAL DECOMPOSITION AS SINGULAR VALUE DECOMPOSITION AND HJB-BASED FEEDBACK DESIGN PAPER MSC-506 INTERPRETATION OF PROPER ORTHOGONAL DECOMPOSITION AS SINGULAR VALUE DECOMPOSITION AND HJB-BASED FEEDBACK DESIGN PAPER MSC-506 SIXTEENTH INTERNATIONAL SYMPOSIUM ON MATHEMATICAL THEORY OF NETWORKS AND SYSTEMS

More information

Reduced-Order Greedy Controllability of Finite Dimensional Linear Systems. Giulia Fabrini Laura Iapichino Stefan Volkwein

Reduced-Order Greedy Controllability of Finite Dimensional Linear Systems. Giulia Fabrini Laura Iapichino Stefan Volkwein Universität Konstanz Reduced-Order Greedy Controllability of Finite Dimensional Linear Systems Giulia Fabrini Laura Iapichino Stefan Volkwein Konstanzer Schriften in Mathematik Nr. 364, Oktober 2017 ISSN

More information

RICE UNIVERSITY. Nonlinear Model Reduction via Discrete Empirical Interpolation by Saifon Chaturantabut

RICE UNIVERSITY. Nonlinear Model Reduction via Discrete Empirical Interpolation by Saifon Chaturantabut RICE UNIVERSITY Nonlinear Model Reduction via Discrete Empirical Interpolation by Saifon Chaturantabut A Thesis Submitted in Partial Fulfillment of the Requirements for the Degree Doctor of Philosophy

More information

POD-DEIM APPROACH ON DIMENSION REDUCTION OF A MULTI-SPECIES HOST-PARASITOID SYSTEM

POD-DEIM APPROACH ON DIMENSION REDUCTION OF A MULTI-SPECIES HOST-PARASITOID SYSTEM POD-DEIM APPROACH ON DIMENSION REDUCTION OF A MULTI-SPECIES HOST-PARASITOID SYSTEM G. Dimitriu Razvan Stefanescu Ionel M. Navon Abstract In this study, we implement the DEIM algorithm (Discrete Empirical

More information

Proper Orthogonal Decomposition in PDE-Constrained Optimization

Proper Orthogonal Decomposition in PDE-Constrained Optimization Proper Orthogonal Decomposition in PDE-Constrained Optimization K. Kunisch Department of Mathematics and Computational Science University of Graz, Austria jointly with S. Volkwein Dynamic Programming Principle

More information

Krylov Subspace Methods for Nonlinear Model Reduction

Krylov Subspace Methods for Nonlinear Model Reduction MAX PLANCK INSTITUT Conference in honour of Nancy Nichols 70th birthday Reading, 2 3 July 2012 Krylov Subspace Methods for Nonlinear Model Reduction Peter Benner and Tobias Breiten Max Planck Institute

More information

Schmidt, Andreas 1 and Haasdonk, Bernard 1

Schmidt, Andreas 1 and Haasdonk, Bernard 1 ESAIM: Control, Optimisation and Calculus of Variations URL: http://www.emath.fr/cocv/ Will be set by the publisher REDUCED BASIS APPROXIMATION OF LARGE SCALE PARAMETRIC ALGEBRAIC RICCATI EQUATIONS Schmidt,

More information

Complexity Reduction for Parametrized Catalytic Reaction Model

Complexity Reduction for Parametrized Catalytic Reaction Model Proceedings of the World Congress on Engineering 5 Vol I WCE 5, July - 3, 5, London, UK Complexity Reduction for Parametrized Catalytic Reaction Model Saifon Chaturantabut, Member, IAENG Abstract This

More information

December 20, MAA704, Multivariate analysis. Christopher Engström. Multivariate. analysis. Principal component analysis

December 20, MAA704, Multivariate analysis. Christopher Engström. Multivariate. analysis. Principal component analysis .. December 20, 2013 Todays lecture. (PCA) (PLS-R) (LDA) . (PCA) is a method often used to reduce the dimension of a large dataset to one of a more manageble size. The new dataset can then be used to make

More information

ROBUST MODEL REDUCTION OF HYPERBOLIC PROBLEMS BY L 1 -NORM MINIMIZATION AND DICTIONARY APPROXIMATION

ROBUST MODEL REDUCTION OF HYPERBOLIC PROBLEMS BY L 1 -NORM MINIMIZATION AND DICTIONARY APPROXIMATION ROBUST MODEL REDUCTION OF HYPERBOLIC PROBLEMS BY L 1 -NORM MINIMIZATION AND DICTIONARY APPROXIMATION R. Abgrall, R Crisovan To cite this version: R. Abgrall, R Crisovan. ROBUST MODEL REDUCTION OF HYPERBOLIC

More information

Changing coordinates to adapt to a map of constant rank

Changing coordinates to adapt to a map of constant rank Introduction to Submanifolds Most manifolds of interest appear as submanifolds of others e.g. of R n. For instance S 2 is a submanifold of R 3. It can be obtained in two ways: 1 as the image of a map into

More information

A model order reduction technique for speeding up computational homogenisation

A model order reduction technique for speeding up computational homogenisation A model order reduction technique for speeding up computational homogenisation Olivier Goury, Pierre Kerfriden, Wing Kam Liu, Stéphane Bordas Cardiff University Outline Introduction Heterogeneous materials

More information

1 Singular Value Decomposition and Principal Component

1 Singular Value Decomposition and Principal Component Singular Value Decomposition and Principal Component Analysis In these lectures we discuss the SVD and the PCA, two of the most widely used tools in machine learning. Principal Component Analysis (PCA)

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 10 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Pseudo-Time Integration 1 / 10 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 10 Outline 1

More information

A reduced basis method and ROM-based optimization for batch chromatography

A reduced basis method and ROM-based optimization for batch chromatography MAX PLANCK INSTITUTE MedRed, 2013 Magdeburg, Dec 11-13 A reduced basis method and ROM-based optimization for batch chromatography Yongjin Zhang joint work with Peter Benner, Lihong Feng and Suzhou Li Max

More information

1. Diagonalize the matrix A if possible, that is, find an invertible matrix P and a diagonal

1. Diagonalize the matrix A if possible, that is, find an invertible matrix P and a diagonal . Diagonalize the matrix A if possible, that is, find an invertible matrix P and a diagonal 3 9 matrix D such that A = P DP, for A =. 3 4 3 (a) P = 4, D =. 3 (b) P = 4, D =. (c) P = 4 8 4, D =. 3 (d) P

More information

Principal Component Analysis

Principal Component Analysis B: Chapter 1 HTF: Chapter 1.5 Principal Component Analysis Barnabás Póczos University of Alberta Nov, 009 Contents Motivation PCA algorithms Applications Face recognition Facial expression recognition

More information

Improvement of Reduced Order Modeling based on Proper Orthogonal Decomposition

Improvement of Reduced Order Modeling based on Proper Orthogonal Decomposition ICCFD5, Seoul, Korea, July 7-11, 28 p. 1 Improvement of Reduced Order Modeling based on Proper Orthogonal Decomposition Michel Bergmann, Charles-Henri Bruneau & Angelo Iollo Michel.Bergmann@inria.fr http://www.math.u-bordeaux.fr/

More information

L26: Advanced dimensionality reduction

L26: Advanced dimensionality reduction L26: Advanced dimensionality reduction The snapshot CA approach Oriented rincipal Components Analysis Non-linear dimensionality reduction (manifold learning) ISOMA Locally Linear Embedding CSCE 666 attern

More information

Reduced order model of three-dimensional Euler equations using proper orthogonal decomposition basis

Reduced order model of three-dimensional Euler equations using proper orthogonal decomposition basis Journal of Mechanical Science and Technology 24 (2) (2010) 601~608 www.springerlink.com/content/1738-494x DOI 10.1007/s12206-010-0106-0 Reduced order model of three-dimensional Euler equations using proper

More information

arxiv: v1 [math.na] 16 Feb 2016

arxiv: v1 [math.na] 16 Feb 2016 NONLINEAR MODEL ORDER REDUCTION VIA DYNAMIC MODE DECOMPOSITION ALESSANDRO ALLA, J. NATHAN KUTZ arxiv:62.58v [math.na] 6 Feb 26 Abstract. We propose a new technique for obtaining reduced order models for

More information

Reduced Basis Methods for Parametrized PDEs A Tutorial Introduction for Stationary and Instationary Problems

Reduced Basis Methods for Parametrized PDEs A Tutorial Introduction for Stationary and Instationary Problems B. Haasdonk Reduced Basis Methods for Parametrized PDEs A Tutorial Introduction for Stationary and Instationary Problems Stuttgart, March 2014, revised version March 2016 Institute of Applied Analysis

More information

MLCC 2015 Dimensionality Reduction and PCA

MLCC 2015 Dimensionality Reduction and PCA MLCC 2015 Dimensionality Reduction and PCA Lorenzo Rosasco UNIGE-MIT-IIT June 25, 2015 Outline PCA & Reconstruction PCA and Maximum Variance PCA and Associated Eigenproblem Beyond the First Principal Component

More information

Approximation of the Linearized Boussinesq Equations

Approximation of the Linearized Boussinesq Equations Approximation of the Linearized Boussinesq Equations Alan Lattimer Advisors Jeffrey Borggaard Serkan Gugercin Department of Mathematics Virginia Tech SIAM Talk Series, Virginia Tech, April 22, 2014 Alan

More information

arxiv: v1 [math.na] 8 Mar 2016

arxiv: v1 [math.na] 8 Mar 2016 arxiv:1603.02652v1 [math.na] 8 Mar 2016 ROBUST MODEL REDUCTION OF HYPERBOLIC PROBLEMS BY L 1 -NORM MINIMIZATION AND DICTIONARY APPROXIMATION R. ABGRALL (1), D. AMSALLEM (2) AND R. CRISOVAN (1) (1): INSTITUT

More information

Reduced-Order Modeling of Channel Flow Using Traveling POD and Balanced POD

Reduced-Order Modeling of Channel Flow Using Traveling POD and Balanced POD 3rd AIAA Flow Control Conference, 5 8 June 26, San Francisco Reduced-Order Modeling of Channel Flow Using Traveling POD and Balanced POD M. Ilak and C. W. Rowley Dept. of Mechanical and Aerospace Engineering,

More information

POD for Parametric PDEs and for Optimality Systems

POD for Parametric PDEs and for Optimality Systems POD for Parametric PDEs and for Optimality Systems M. Kahlbacher, K. Kunisch, H. Müller and S. Volkwein Institute for Mathematics and Scientific Computing University of Graz, Austria DMV-Jahrestagung 26,

More information

10-725/36-725: Convex Optimization Prerequisite Topics

10-725/36-725: Convex Optimization Prerequisite Topics 10-725/36-725: Convex Optimization Prerequisite Topics February 3, 2015 This is meant to be a brief, informal refresher of some topics that will form building blocks in this course. The content of the

More information

(a) If A is a 3 by 4 matrix, what does this tell us about its nullspace? Solution: dim N(A) 1, since rank(a) 3. Ax =

(a) If A is a 3 by 4 matrix, what does this tell us about its nullspace? Solution: dim N(A) 1, since rank(a) 3. Ax = . (5 points) (a) If A is a 3 by 4 matrix, what does this tell us about its nullspace? dim N(A), since rank(a) 3. (b) If we also know that Ax = has no solution, what do we know about the rank of A? C(A)

More information

A review of stability and dynamical behaviors of differential equations:

A review of stability and dynamical behaviors of differential equations: A review of stability and dynamical behaviors of differential equations: scalar ODE: u t = f(u), system of ODEs: u t = f(u, v), v t = g(u, v), reaction-diffusion equation: u t = D u + f(u), x Ω, with boundary

More information

Reduced Basis Method for Explicit Finite Volume Approximations of Nonlinear Conservation Laws

Reduced Basis Method for Explicit Finite Volume Approximations of Nonlinear Conservation Laws Proceedings of Symposia in Applied Mathematics Reduced Basis Method for Explicit Finite Volume Approximations of Nonlinear Conservation Laws Bernard Haasdonk and Mario Ohlberger Abstract. The numerical

More information

Fourier Model Reduction for Large-Scale Applications in Computational Fluid Dynamics

Fourier Model Reduction for Large-Scale Applications in Computational Fluid Dynamics Fourier Model Reduction for Large-Scale Applications in Computational Fluid Dynamics K. Willcox and A. Megretski A new method, Fourier model reduction (FMR), for obtaining stable, accurate, low-order models

More information

CS168: The Modern Algorithmic Toolbox Lecture #8: How PCA Works

CS168: The Modern Algorithmic Toolbox Lecture #8: How PCA Works CS68: The Modern Algorithmic Toolbox Lecture #8: How PCA Works Tim Roughgarden & Gregory Valiant April 20, 206 Introduction Last lecture introduced the idea of principal components analysis (PCA). The

More information

Tutorial on Principal Component Analysis

Tutorial on Principal Component Analysis Tutorial on Principal Component Analysis Copyright c 1997, 2003 Javier R. Movellan. This is an open source document. Permission is granted to copy, distribute and/or modify this document under the terms

More information

Reduced Basis Methods for inverse problems

Reduced Basis Methods for inverse problems Reduced Basis Methods for inverse problems Dominik Garmatter dominik.garmatter@mathematik.uni-stuttgart.de Chair of Optimization and Inverse Problems, University of Stuttgart, Germany Joint work with Bastian

More information

Model Reduction of Inhomogeneous Initial Conditions

Model Reduction of Inhomogeneous Initial Conditions Model Reduction of Inhomogeneous Initial Conditions Caleb Magruder Abstract Our goal is to develop model reduction processes for linear dynamical systems with non-zero initial conditions. Standard model

More information

Model Reduction via Proper Orthogonal Decomposition

Model Reduction via Proper Orthogonal Decomposition Model Reduction via Proper Orthogonal Decomposition René Pinnau Fachbereich Mathematik, Technische Universität Kaiserslautern, D-67663 Kaiserslautern, Germany pinnau@mathematik.uni-kl.de 1 Introduction

More information

POD/DEIM 4D-Var for a Finite-Difference Shallow Water Equations Model

POD/DEIM 4D-Var for a Finite-Difference Shallow Water Equations Model .. POD/DEIM 4D-Var for a Finite-Difference Shallow Water Equations Model North Carolina State University rstefan@ncsu.edu POD/DEIM 4D-Var for a Finite-Difference Shallow Water Equations Model 1/64 Part1

More information

STA141C: Big Data & High Performance Statistical Computing

STA141C: Big Data & High Performance Statistical Computing STA141C: Big Data & High Performance Statistical Computing Numerical Linear Algebra Background Cho-Jui Hsieh UC Davis May 15, 2018 Linear Algebra Background Vectors A vector has a direction and a magnitude

More information

Lecture 13. Principal Component Analysis. Brett Bernstein. April 25, CDS at NYU. Brett Bernstein (CDS at NYU) Lecture 13 April 25, / 26

Lecture 13. Principal Component Analysis. Brett Bernstein. April 25, CDS at NYU. Brett Bernstein (CDS at NYU) Lecture 13 April 25, / 26 Principal Component Analysis Brett Bernstein CDS at NYU April 25, 2017 Brett Bernstein (CDS at NYU) Lecture 13 April 25, 2017 1 / 26 Initial Question Intro Question Question Let S R n n be symmetric. 1

More information

Nonlinear Model Reduction for Uncertainty Quantification in Large-Scale Inverse Problems

Nonlinear Model Reduction for Uncertainty Quantification in Large-Scale Inverse Problems Nonlinear Model Reduction for Uncertainty Quantification in Large-Scale Inverse Problems Krzysztof Fidkowski, David Galbally*, Karen Willcox* (*MIT) Computational Aerospace Sciences Seminar Aerospace Engineering

More information

Solution of Linear Equations

Solution of Linear Equations Solution of Linear Equations (Com S 477/577 Notes) Yan-Bin Jia Sep 7, 07 We have discussed general methods for solving arbitrary equations, and looked at the special class of polynomial equations A subclass

More information

Computational Methods. Eigenvalues and Singular Values

Computational Methods. Eigenvalues and Singular Values Computational Methods Eigenvalues and Singular Values Manfred Huber 2010 1 Eigenvalues and Singular Values Eigenvalues and singular values describe important aspects of transformations and of data relations

More information

DYNAMICAL MODELS FOR CONTROL OF CAVITY OSCILLATIONS

DYNAMICAL MODELS FOR CONTROL OF CAVITY OSCILLATIONS AIAA 21-2126 DYNAMICAL MODELS FOR CONTROL OF CAVITY OSCILLATIONS Clarence W. Rowley Tim Colonius Richard M. Murray Division of Engineering and Applied Science California Institute of Technology Pasadena,

More information

Singular Value Decomposition and Principal Component Analysis (PCA) I

Singular Value Decomposition and Principal Component Analysis (PCA) I Singular Value Decomposition and Principal Component Analysis (PCA) I Prof Ned Wingreen MOL 40/50 Microarray review Data per array: 0000 genes, I (green) i,i (red) i 000 000+ data points! The expression

More information

STA141C: Big Data & High Performance Statistical Computing

STA141C: Big Data & High Performance Statistical Computing STA141C: Big Data & High Performance Statistical Computing Lecture 5: Numerical Linear Algebra Cho-Jui Hsieh UC Davis April 20, 2017 Linear Algebra Background Vectors A vector has a direction and a magnitude

More information

MATH 304 Linear Algebra Lecture 20: The Gram-Schmidt process (continued). Eigenvalues and eigenvectors.

MATH 304 Linear Algebra Lecture 20: The Gram-Schmidt process (continued). Eigenvalues and eigenvectors. MATH 304 Linear Algebra Lecture 20: The Gram-Schmidt process (continued). Eigenvalues and eigenvectors. Orthogonal sets Let V be a vector space with an inner product. Definition. Nonzero vectors v 1,v

More information

Unsupervised Learning: Dimensionality Reduction

Unsupervised Learning: Dimensionality Reduction Unsupervised Learning: Dimensionality Reduction CMPSCI 689 Fall 2015 Sridhar Mahadevan Lecture 3 Outline In this lecture, we set about to solve the problem posed in the previous lecture Given a dataset,

More information

Lecture 24: Principal Component Analysis. Aykut Erdem May 2016 Hacettepe University

Lecture 24: Principal Component Analysis. Aykut Erdem May 2016 Hacettepe University Lecture 4: Principal Component Analysis Aykut Erdem May 016 Hacettepe University This week Motivation PCA algorithms Applications PCA shortcomings Autoencoders Kernel PCA PCA Applications Data Visualization

More information

Principal components analysis COMS 4771

Principal components analysis COMS 4771 Principal components analysis COMS 4771 1. Representation learning Useful representations of data Representation learning: Given: raw feature vectors x 1, x 2,..., x n R d. Goal: learn a useful feature

More information

POD-based Reduced Order Models for Parameterized PDEs

POD-based Reduced Order Models for Parameterized PDEs POD-based Reduced Order Models for Parameterized PDEs Florian De Vuyst florian.de-vuyst@ecp.fr Ecole Centrale Paris Laboratoire Mathématiques Appliquées aux Systèmes July 2008 the 1st Outline 1. Setting

More information

Model reduction of parametrized aerodynamic flows: stability, error control, and empirical quadrature. Masayuki Yano

Model reduction of parametrized aerodynamic flows: stability, error control, and empirical quadrature. Masayuki Yano Model reduction of parametrized aerodynamic flows: stability, error control, and empirical quadrature Masayuki Yano University of Toronto Institute for Aerospace Studies Acknowledgments: Anthony Patera;

More information

Reduced Modeling in Data Assimilation

Reduced Modeling in Data Assimilation Reduced Modeling in Data Assimilation Peter Binev Department of Mathematics and Interdisciplinary Mathematics Institute University of South Carolina Challenges in high dimensional analysis and computation

More information

Principal Component Analysis and Linear Discriminant Analysis

Principal Component Analysis and Linear Discriminant Analysis Principal Component Analysis and Linear Discriminant Analysis Ying Wu Electrical Engineering and Computer Science Northwestern University Evanston, IL 60208 http://www.eecs.northwestern.edu/~yingwu 1/29

More information

AN ITERATIVE PROPER ORTHOGONAL DECOMPOSITION (I-POD) TECHNIQUE WITH APPLICATION TO THE FILTERING OF PARTIAL DIFFERENTIAL EQUATIONS

AN ITERATIVE PROPER ORTHOGONAL DECOMPOSITION (I-POD) TECHNIQUE WITH APPLICATION TO THE FILTERING OF PARTIAL DIFFERENTIAL EQUATIONS AAS 2-622 AN ITERATIVE PROPER ORTHOGONAL DECOMPOSITION (I-POD) TECHNIQUE WITH APPLICATION TO THE FILTERING OF PARTIAL DIFFERENTIAL EQUATIONS Dan Yu, Suman Chakravorty INTRODUCTION In this paper, we consider

More information

LECTURE 3: DISCRETE GRADIENT FLOWS

LECTURE 3: DISCRETE GRADIENT FLOWS LECTURE 3: DISCRETE GRADIENT FLOWS Department of Mathematics and Institute for Physical Science and Technology University of Maryland, USA Tutorial: Numerical Methods for FBPs Free Boundary Problems and

More information

Problem # Max points possible Actual score Total 120

Problem # Max points possible Actual score Total 120 FINAL EXAMINATION - MATH 2121, FALL 2017. Name: ID#: Email: Lecture & Tutorial: Problem # Max points possible Actual score 1 15 2 15 3 10 4 15 5 15 6 15 7 10 8 10 9 15 Total 120 You have 180 minutes to

More information

Linear Systems. Class 27. c 2008 Ron Buckmire. TITLE Projection Matrices and Orthogonal Diagonalization CURRENT READING Poole 5.4

Linear Systems. Class 27. c 2008 Ron Buckmire. TITLE Projection Matrices and Orthogonal Diagonalization CURRENT READING Poole 5.4 Linear Systems Math Spring 8 c 8 Ron Buckmire Fowler 9 MWF 9: am - :5 am http://faculty.oxy.edu/ron/math//8/ Class 7 TITLE Projection Matrices and Orthogonal Diagonalization CURRENT READING Poole 5. Summary

More information

Advanced Introduction to Machine Learning CMU-10715

Advanced Introduction to Machine Learning CMU-10715 Advanced Introduction to Machine Learning CMU-10715 Principal Component Analysis Barnabás Póczos Contents Motivation PCA algorithms Applications Some of these slides are taken from Karl Booksh Research

More information

Matrix Vector Products

Matrix Vector Products We covered these notes in the tutorial sessions I strongly recommend that you further read the presented materials in classical books on linear algebra Please make sure that you understand the proofs and

More information

Discrete Empirical Interpolation for Nonlinear Model Reduction

Discrete Empirical Interpolation for Nonlinear Model Reduction Discrete Empirical Interpolation for Nonlinear Model Reduction Saifon Chaturantabut and Danny C. Sorensen Department of Computational and Applied Mathematics, MS-34, Rice University, 6 Main Street, Houston,

More information

Numerical approximation for optimal control problems via MPC and HJB. Giulia Fabrini

Numerical approximation for optimal control problems via MPC and HJB. Giulia Fabrini Numerical approximation for optimal control problems via MPC and HJB Giulia Fabrini Konstanz Women In Mathematics 15 May, 2018 G. Fabrini (University of Konstanz) Numerical approximation for OCP 1 / 33

More information

Model reduction for multiscale problems

Model reduction for multiscale problems Model reduction for multiscale problems Mario Ohlberger Dec. 12-16, 2011 RICAM, Linz , > Outline Motivation: Multi-Scale and Multi-Physics Problems Model Reduction: The Reduced Basis Approach A new Reduced

More information

Maximum variance formulation

Maximum variance formulation 12.1. Principal Component Analysis 561 Figure 12.2 Principal component analysis seeks a space of lower dimensionality, known as the principal subspace and denoted by the magenta line, such that the orthogonal

More information

1 Principal Components Analysis

1 Principal Components Analysis Lecture 3 and 4 Sept. 18 and Sept.20-2006 Data Visualization STAT 442 / 890, CM 462 Lecture: Ali Ghodsi 1 Principal Components Analysis Principal components analysis (PCA) is a very popular technique for

More information

Linear Algebra Methods for Data Mining

Linear Algebra Methods for Data Mining Linear Algebra Methods for Data Mining Saara Hyvönen, Saara.Hyvonen@cs.helsinki.fi Spring 2007 The Singular Value Decomposition (SVD) continued Linear Algebra Methods for Data Mining, Spring 2007, University

More information

Priority Programme The Combination of POD Model Reduction with Adaptive Finite Element Methods in the Context of Phase Field Models

Priority Programme The Combination of POD Model Reduction with Adaptive Finite Element Methods in the Context of Phase Field Models Priority Programme 1962 The Combination of POD Model Reduction with Adaptive Finite Element Methods in the Context of Phase Field Models Carmen Gräßle, Michael Hinze Non-smooth and Complementarity-based

More information

Model order reduction & PDE constrained optimization

Model order reduction & PDE constrained optimization 1 Model order reduction & PDE constrained optimization Fachbereich Mathematik Optimierung und Approximation, Universität Hamburg Leuven, January 8, 01 Names Afanasiev, Attwell, Burns, Cordier,Fahl, Farrell,

More information

Reduced basis method for H 2 optimal feedback control problems

Reduced basis method for H 2 optimal feedback control problems A. Schmidt a B. Haasdonk b Reduced basis method for H 2 optimal feedback control problems Stuttgart, November 215 a Institute for Applied Analysis and Numerical Simulation, University of Stuttgart, Pfaffenwaldring

More information

Overview of sparse system identification

Overview of sparse system identification Overview of sparse system identification J.-Ch. Loiseau 1 & Others 2, 3 1 Laboratoire DynFluid, Arts et Métiers ParisTech, France 2 LIMSI, Université d Orsay CNRS, France 3 University of Washington, Seattle,

More information

Reduced-Order Multiobjective Optimal Control of Semilinear Parabolic Problems. Laura Iapichino Stefan Trenz Stefan Volkwein

Reduced-Order Multiobjective Optimal Control of Semilinear Parabolic Problems. Laura Iapichino Stefan Trenz Stefan Volkwein Universität Konstanz Reduced-Order Multiobjective Optimal Control of Semilinear Parabolic Problems Laura Iapichino Stefan Trenz Stefan Volkwein Konstanzer Schriften in Mathematik Nr. 347, Dezember 2015

More information

Principal Component Analysis (PCA)

Principal Component Analysis (PCA) Principal Component Analysis (PCA) Salvador Dalí, Galatea of the Spheres CSC411/2515: Machine Learning and Data Mining, Winter 2018 Michael Guerzhoy and Lisa Zhang Some slides from Derek Hoiem and Alysha

More information

Numerical Methods for Solving Large Scale Eigenvalue Problems

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

More information

Lecture 27: Structural Dynamics - Beams.

Lecture 27: Structural Dynamics - Beams. Chapter #16: Structural Dynamics and Time Dependent Heat Transfer. Lectures #1-6 have discussed only steady systems. There has been no time dependence in any problems. We will investigate beam dynamics

More information

MATH 5640: Functions of Diagonalizable Matrices

MATH 5640: Functions of Diagonalizable Matrices MATH 5640: Functions of Diagonalizable Matrices Hung Phan, UMass Lowell November 27, 208 Spectral theorem for diagonalizable matrices Definition Let V = X Y Every v V is uniquely decomposed as u = x +

More information