Introduction to Multigrid Method

Size: px
Start display at page:

Download "Introduction to Multigrid Method"

Transcription

1 Introduction to Multigrid Metod Presented by: Bogojeska Jasmina /08/005 JASS, 005, St. Petersburg 1

2 Te ultimate upsot of MLAT Te amount of computational work sould be proportional to te amount of real pysical canges in te computed system! In fully developped Multigrid processes te amount of computations sould be determined only by te amount of real pysical information /08/005 JASS, 005, St. Petersburg

3 Content Model Problems Basic Iterative Scemes Te Multigrid Metod Is everyting really tat simple??? /08/005 JASS, 005, St. Petersburg 3

4 Testing Ground One-dimensional boundary value problem describing te steady-state temperature distribution in a long uniform rod Grid: ''( x) + u( x) = f ( x) 0 < x < 1 u(0) = u(1) = 0 σ 0 1 = n x j j = 0,1 x x 1 = j,..., n 0 n /08/005 JASS, 005, St. Petersburg 4 x

5 Approximation wit te finite difference metod v + v v v 0 j 1 j j+ 1 = v = 0 n + σ v = f j = 1,,..., n 1 j j Were v is te approximation to te exact solution u( x ) j and f is f( x ) for j = 1,,..., n 1 j j j /08/005 JASS, 005, St. Petersburg 5

6 Matrix Form f T T Defining = (f 1,..., fn 1) and = ( v1,..., vn 1) we get te v matrix form of te system of linear equations A v= f: + σ 1 v1 f1 1 1 v + σ f = σ vn 1 fn 1 were A is ( n 1) ( n 1) symmetric, positive, definite matrix /08/005 JASS, 005, St. Petersburg 6

7 Testing Ground II Two-dimensional boundary value problem u u + σ u = f( x, y), 0 < x< 1, 0 < y< 1, σ > 0 xx yy were u = 0 on te boundary of te unit square. Te grid is defined wit te points: ( x, y ) = ( i, j ), i j x y 1 1 were i = 1,..., m 1, j = 1,..., m 1, x = and y = m n /08/005 JASS, 005, St. Petersburg 7

8 Approximation wit te finite difference metod Replacing te derivatives by te second-order finite differences leads to te system of linear equations v + v v v + v v + + σ v = i0 i 1, j ij i+ 1, j i, j 1 ij i, j+ 1 x y v = v = 0, i= 1,,..., m 1, j = 1,,..., n 1 in were v is an approximation of te exact solution u( x, y ) ij i j and f = f( x, y ) ij i j ij f ij /08/005 JASS, 005, St. Petersburg 8

9 Matrix Form Considering te lexicograpic ordering by lines we get T T i = ( i1,..., in, 1) and i=( i1,..., in, 1) for = 1,..., 1 v v v f f f i m Te block-tridiagonal matrix form of te system is A v= f A1 a I v1 f1 a I A a I v f..... =..... a I An a I v n f n a I An 1 vn 1 fn 1 /08/005 JASS, 005, St. Petersburg 9

10 y Matrix Form II 1 were a =, I is an ( n 1) ( n 1) identity matrix and Ai is an ( n 1) ( n 1) tridiagonal matrix A i σ x + y x σ x x + y x = σ x x + y /08/005 JASS, 005, St. Petersburg 10

11 Content Model Problems Basic Iterative Scemes Te Multigrid Metod Is everyting really tat simple??? /08/005 JASS, 005, St. Petersburg 11

12 Some Notations and Definitions Notation for model problems is Au = f, uis te exact solution and v is te approxiamtion Te error is given by e= u v and measured wit vector norms Te residual is given by r = f A v Te residual equation Ae = r Te residual correction u= v+ e /08/005 JASS, 005, St. Petersburg 1

13 Stationary Linear Iterations 1 Using u v= A r, v v and u v ( old ) ( new) ( new) ( old ) ( old ) an iteration is formed by v = v + B r were B is an approximation to A 1 ( new) ( old ) ( old ) = + = + Anoter form of te iteration v R v B f R v were R = I B A Te exact solution u is a fixed point i.e. u= R u+ g ( new) ( old ) Te error is or after relaxation e = R e sweeps e = R e ( m) m (0) ( m) m (0) e R e if R < 1 te error is forced towards zero wit te repeated iterations m g /08/005 JASS, 005, St. Petersburg 13

14 Assymptotic Convergence Factor ( R) = { } convergence factor ( R) 1 ( ) m R 0 as m ( R is convergent) ρ R < 1, were ρ max λ,..., λ is te spectral radius or n (0) ( m) For any given initial vector v, e 0 as asymptotic ρ < 1, so tis condition ensures te convergence of te iteration m /08/005 JASS, 005, St. Petersburg 14

15 Jacobi Relaxation Te one-dimensional model problem wit σ =0 is u + u u = f, j = 1,,..., n 1, u = u = 0 j 1 j j+ 1 j 0 1 ( new) 1 ( ( old ) ( old ) Jacobi relaxation v ) j = vj 1 + vj+ 1 + f j, j = 1,..., n 1 1 Matrix form, were R = D L+ U v R v D f ( ) ( new) ( old ) 1 = J + and A= D L U Weigted Jacobi relaxation ( new) ( old ) ω ( old ) ( old ) vj = vj + vj + vj + f j = + ( 1 ω) ( ) ( new) ( old ) 1 Matrix form v Rω v ω D f, ( ω) were R = 1 I+ ωr ω J /08/005 JASS, 005, St. Petersburg 15 J

16 Gauss-Seidel Relaxation Components of te new approximation are used as soon as tey are calculated reduced storage requirements ( new) 1 ( ( new) ( old ) Gaus-Seidl relaxation v ) j = vj 1 + vj+ 1 + f j, j = 1,..., n 1 v R v D L f R D L U ( ), were ( ) ( new) ( old ) 1 1 Matrix form = G + G = and A= D L U /08/005 JASS, 005, St. Petersburg 16

17 Fourier Modes We work wit te omogeneous linear system Au = 0 exact solution is u= 0, error is v j k p Fourier modes vj = sin, 0 j n, 1 k n 1 n were k is frequency or wavenumber indicating te number of alf sine waves tat constitute v on te domain Low frequency( smoot) modes wavenumbers in n range 1 k Hig frequency( oscillatory) modes wavenumbers in n range k n 1 /08/005 JASS, 005, St. Petersburg 17

18 Fourier Modes I /08/005 JASS, 005, St. Petersburg 18

19 Numerical Example Te error in weigted Jacobi iteration ω= for 100 iterations 3 wit Fourier modes k = 1, 3 and 6 as initial iteration /08/005 JASS, 005, St. Petersburg 19

20 Numerical Example I Te error in weigted Jacobi iteration ω= for 100 iterations 3 1 j π 6 j π 3 j π and initial guess v j = sin sin sin n n n /08/005 JASS, 005, St. Petersburg 0

21 Observation Standard iterations converge quickly as long as te error as ig-frequency components BUT te slow elimination of te low frequency components of te error degrades te performance /08/005 JASS, 005, St. Petersburg 1

22 Wy? ω ω Rω = I A λ( Rω) = 1 λ( A) k π λ ( A) = k n n Eigenvalues of A: k 4 sin, 1 1 j k π Eigenvectors of A and Rω : w k,j = sin, 1 k n 1 n k π λ ( R ) = ω k n n Error in an initial guess: Eigenvalues of Rω: k ω 1 sin, 1 1 n 1 n 1 n 1 (0) m = m c ( ) k = m ck = m e wk e Rω wk ck λk Rω wk k= 1 k= 1 k= 1 /08/005 JASS, 005, St. Petersburg

23 k ( ) Wy? If 0 < ω 1 ten λ < 1 convergent Jacobi relaxation For all ω, 0 < ω 1: R ω π π ω π λ1 = 1 ω sin = 1 ω sin 1 n /08/005 JASS, 005, St. Petersburg 3

24 Conclusion Te eigenvalue associated wit te smootest mode will always be close to 1 (esspecially for smaller grid spacing) No value of ω can reduce te smoot components of te error effectively Wat value of ω damps best te oscillatory components of te error? n/ ( R ) λ ( R ) Solving λ = for weigted Jacobi leads to ω 1 n ω= and λk, for k n n ω /08/005 JASS, 005, St. Petersburg 4

25 Smooting Factor Smooting factor - te largest absolute value among te eigenvalues in te upper alf of te spectrum (te oscillatory modes) of te iteration matrix: λ max k n k n Smooting property for weigted Jacobi after 35 iteration sweeps: ( ) R ω /08/005 JASS, 005, St. Petersburg 5

26 Content Model Problems Basic Iterative Scemes Te Multigrid Metod Is everyting really tat simple??? /08/005 JASS, 005, St. Petersburg 6

27 Elements of Multigrid Coarse Grids Nested Iteration Correction Sceme Interpolation Operator Restriction Operator Two-Grid Correction Sceme V-Cycle Sceme Full Multigrid V-Cycle - FMG /08/005 JASS, 005, St. Petersburg 7

28 Coarse Grids Te smooting property becomes an advantage Relaxation on a coarse grid is less expensive ( ) Because of te convergence factor 1 Ο te coarse grid as a marginally improved convergence rate A smoot wave on a fine grid Ω looks more oscillatory on a coarse grid Ω /08/005 JASS, 005, St. Petersburg 8

29 Coarse Grids /08/005 JASS, 005, St. Petersburg 9

30 Coarse Grids Te kt mode on Ω becomes te kt mode on Ω n for 1 k < : j k π j k π wk, j = sin = sin = wk, j n n/ n For k >, te kt mode on Ω becomes te ( n k)t Ω ing- so te oscilatory modes mode on - because of alias are misinterpreted as relatively smoot: w k, j ( ) ( ) j k π j π n k = sin = sin = n n j n k π = sin = w n / /08/005 JASS, 005, St. Petersburgn k, j 30

31 Nested Iteration Compute an improved initial guess for te fine-grid relaxation Relax on Au = fon a very coarse grid to obtain an initial guess for te next finer grid... Au = f Ω for 4 Relax on on to obtain an initial guess Ω Relax on A u= f on Ω to obtain an initial guess for Ω = Ω to te solution Relax on Au fon to obtain a final approximation /08/005 JASS, 005, St. Petersburg 31

32 Correction Sceme We can relax directly on te error using te residual equation Ae = rwit a specific initial guess e= 0 Relax on Au = fon Ω to obtain an approximation v Compute te residual r = f A v Ae = r Ω Relax on te residual equation on to obtain an approximation to te error Correct te approximation obtained on Ω wit te error e estimate obtained on Ω : v v + e /08/005 JASS, 005, St. Petersburg 3

33 Interpolation Operator (1D) Mapping I : Ω Ω I v = v, were 1 ( ) n v j = vj, v j+ 1 = vj + vj+ 1, 0 j 1 /08/005 JASS, 005, St. Petersburg 33

34 Interpolation Operator (1D) If te error on Ω is smoot, an interpolant of te coarse-grid error gives a good representation of te error - te interpolant is smoot /08/005 JASS, 005, St. Petersburg 34

35 Interpolation Operator (1D) If te error on Ω is oscillatory, an interpolant of te coarse-grid error may give a poor representation of te error - te interpolant is smoot /08/005 JASS, 005, St. Petersburg 35

36 Interpolation Operator (1D) n 1 n 1 I is a liner operator from to, wit a full rank and a trivial nullspace If te error is oscillatory even a very good coarse-grid approximation may produce a not very accurate interpolant because te interpolant is smoot nested iteration is effective wen te error is smoot Example for n = v v v = v4 = v I = 1 1 v /08/005 JASS, 005, St. Petersburg 36 v v v v v v 7

37 Restriction Operator (1D) Mapping I : Ω Ω Injection: I v = v, were v = v j j Full weigting: I v = v, were 1 ( = ) n vj v j 1+ v j + v j+ 1, 1 j -1 4 /08/005 JASS, 005, St. Petersburg 37

38 Full Weigting n 1 n 1 I is a liner operator from to, wit a full n rank and a nullspace of dimension Example for n = 8: v1 v 1 1 v v v = v 4 = v = v I v v v6 v /08/005 JASS, 005, St. Petersburg 38

39 Two-Grid Correction Sceme 1 Solve v MG( v, f ) Relax ν times on A u = f on Ω wit initial guess v Compute te fine-grid residual r = f A v and restrict it to te coarse grid by r A e = r on Ω = I r Interpolate te coarse-grid error to te fine-grid by e = I e and correct te fine-grid approxiamtion by v v + e Relax ν times on A u = f on Ω wit initial guess v /08/005 JASS, 005, St. Petersburg 39

40 Two-Grid Correction Sceme /08/005 JASS, 005, St. Petersburg 40

41 V-Cycle /08/005 JASS, 005, St. Petersburg 41

42 V-Cycle - Recursive 1 (, ) 1. Relax ν times on A u = f wit a given initial guess. If Ω coarsest grid, ten go to 4. Else 3. Correct v MV v f v ( ) f I f A v v 0 (, ) v MV v f v v + I v 4. Relax ν times on A u = f wit a given initial guess v /08/005 JASS, 005, St. Petersburg 4

43 v and f d-dimensions as te finer grid Storage Costs must be stored at eac level -d coarse grid as te number of points d ( d d Md) n Storage costs: n < 1 d d /08/005 JASS, 005, St. Petersburg 43

44 Computational Costs 1 Working Unit cost of one relaxation sweep on te fine grid Cost of V-cycle wit one pre-coarse-grid correction relaxation sweep and one post-coarse-gris relaxation sweep ( d d 3d Md ) 1 + < 1 d /08/005 JASS, 005, St. Petersburg 44

45 Convergence Analysis Continuous problem: Au = f, u = u( x ) Discrete problem: A u = f, v u Discretization error: E = u( x ) u, E K Algebraic error: e = u v Error condition: u- v < ε i p i i i i i i i Tis is guarantied if: E + e < ε E e 1/ p ε * ε < K ε < determines te number of iterations /08/005 JASS, 005, St. Petersburg 45

46 Converging to Level of Truncation ε ( ) p * * If te iteration goes until e = K on Ω ten we ave converged to te level of truncation Te V-cycle sceme as a convergence factor γ <1 independent of 1 d-dimensional problem on a grid wit = n () ( p) ( p n ) Error sould be reduced from Ο 1 to Ο = Ο ( ( )) d n n ( n) ( ) Number of V-cycles ν = Ο log costs Ο log /08/005 JASS, 005, St. Petersburg 46

47 Full Multigrid V-Cycle v FMG ( f ) Initialize f I f, f I f, Solve or relax on coarsest grid Interpolate initial guess v I 4 4 ( ) Perform V-cycle MV, ν 0 times Interpolate initial guess ( ) Perform V-cycle MV, ν 0 times I v v v f v v v v f /08/005 JASS, 005, St. Petersburg 47

48 Full Multigrid /08/005 JASS, 005, St. Petersburg 48

49 Full Multigrid - Recursive ( f ) ( f ) 1. Initialize f I f, f I f, If Ω coarsest grid, set v 0, ten go to 3. Else I 3. Correct v I 4. v f v v MV ( f ) FMG FMG v ( v, f ) ν 0 times /08/005 JASS, 005, St. Petersburg 49

50 Costs of Full Multigrid jd Te size of te WU for te coarse-grid j is times of te size of te WU on te fine-grid Cost of FMG for ν = ν =... = 1 is LESS tan 0 1 ( d d ) 1... d = 1 1 ( d ) /08/005 JASS, 005, St. Petersburg 50

51 Building A ( I ) ( ) How does A act on Range I? e Range A I u = r odd rows in A I are zeros I A I u = I r A = I A I /08/005 JASS, 005, St. Petersburg 51

52 Variational Properties Galerkin Condition: A I A I = T I c I, c ( ) = /08/005 JASS, 005, St. Petersburg 5

53 Spectral Properties of te Restriction Operator How does I act upon te modes of A? kπ n w = w k n smoot modes: I k cos k, 1 kπ n w( n k) = w k < n oscillatory modes: I sin k, 1 { } { } If W = span w, w I : W span w k k n k k k /08/005 JASS, 005, St. Petersburg 53

54 Spectral Properties of te Interpolation Operator How does I act on te modes of A? kπ kπ n w = w w k < n n I k cos k sin n k, 1 Interpolation of smoot modes excites oscillatory modes on Ω Ω /08/005 JASS, 005, St. Petersburg 54

55 Two-Grid Correction Sceme ( ) ( ) ( ) 1 ( ν I ( )) I C + C + + ν v R v f A f A R v f e I ( A ) A R e e No relaxation ( ν =0): TGw = s w + s w 1 ν I I TG k k k k n k n TGwn k = ckwk + ckwn k, 1 k CG eliminates te smoot modes but does not damp te oscillatory modes of te error Wit relaxation: TGw = λ s w + λ s w ν ν k k k k k k n k ν ν n TGwn k = λn kckwk + λn kckwn k, 1 k /08/005 JASS, 005, St. Petersburg 55

56 Algebraic Analysis ( ) ( ) ( I ) ( I ) A Range ( T ) ( ) ( ) N Range N Range N I I I I A ( ) ( I ) N I Ω = Range A e = s + t /08/005 JASS, 005, St. Petersburg 56

57 Spectral and Algebraic Decompozition Spectral decompozition: Algebraic decompozition: /08/005 JASS, 005, St. Petersburg 57

58 How it works? /08/005 JASS, 005, St. Petersburg 58

59 How it works? /08/005 JASS, 005, St. Petersburg 59

60 How it works? /08/005 JASS, 005, St. Petersburg 60

61 Is everyting really so simple??? Anisotropic operators and grids Discontinuous or anisotropic coefficients Nonlinear problems Non-scalar PDE systems Hig order discretization Algebraic Turbulence models Cemicaly reacting flows Socks Small-scale singularities /08/005 JASS, 005, St. Petersburg 61

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 2018/19 Part 4: Iterative Methods PD

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 1: Introduction to Multigrid 1 12/02/09 MG02.prz Error Smoothing 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 Initial Solution=-Error 0 10 20 30 40 50 60 70 80 90 100 DCT:

More information

Notes on Multigrid Methods

Notes on Multigrid Methods Notes on Multigrid Metods Qingai Zang April, 17 Motivation of multigrids. Te convergence rates of classical iterative metod depend on te grid spacing, or problem size. In contrast, convergence rates of

More information

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation Capter Grid Transfer Remark. Contents of tis capter. Consider a grid wit grid size and te corresponding linear system of equations A u = f. Te summary given in Section 3. leads to te idea tat tere migt

More information

Multigrid Methods for Discretized PDE Problems

Multigrid Methods for Discretized PDE Problems Towards Metods for Discretized PDE Problems Institute for Applied Matematics University of Heidelberg Feb 1-5, 2010 Towards Outline A model problem Solution of very large linear systems Iterative Metods

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

Multigrid Methods for Obstacle Problems

Multigrid Methods for Obstacle Problems Multigrid Metods for Obstacle Problems by Cunxiao Wu A Researc Paper presented to te University of Waterloo in partial fulfillment of te requirement for te degree of Master of Matematics in Computational

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

More information

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

More information

6. Multigrid & Krylov Methods. June 1, 2010

6. Multigrid & Krylov Methods. June 1, 2010 June 1, 2010 Scientific Computing II, Tobias Weinzierl page 1 of 27 Outline of This Session A recapitulation of iterative schemes Lots of advertisement Multigrid Ingredients Multigrid Analysis Scientific

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

arxiv: v1 [math.na] 3 Nov 2011

arxiv: v1 [math.na] 3 Nov 2011 arxiv:.983v [mat.na] 3 Nov 2 A Finite Difference Gost-cell Multigrid approac for Poisson Equation wit mixed Boundary Conditions in Arbitrary Domain Armando Coco, Giovanni Russo November 7, 2 Abstract In

More information

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

6. Iterative Methods for Linear Systems. The stepwise approach to the solution... 6 Iterative Methods for Linear Systems The stepwise approach to the solution Miriam Mehl: 6 Iterative Methods for Linear Systems The stepwise approach to the solution, January 18, 2013 1 61 Large Sparse

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 27, No. 4, pp. 47 492 c 26 Society for Industrial and Applied Matematics A NOVEL MULTIGRID BASED PRECONDITIONER FOR HETEROGENEOUS HELMHOLTZ PROBLEMS Y. A. ERLANGGA, C. W. OOSTERLEE,

More information

Solutions to the Multivariable Calculus and Linear Algebra problems on the Comprehensive Examination of January 31, 2014

Solutions to the Multivariable Calculus and Linear Algebra problems on the Comprehensive Examination of January 31, 2014 Solutions to te Multivariable Calculus and Linear Algebra problems on te Compreensive Examination of January 3, 24 Tere are 9 problems ( points eac, totaling 9 points) on tis portion of te examination.

More information

1.72, Groundwater Hydrology Prof. Charles Harvey Lecture Packet #9: Numerical Modeling of Groundwater Flow

1.72, Groundwater Hydrology Prof. Charles Harvey Lecture Packet #9: Numerical Modeling of Groundwater Flow 1.7, Groundwater Hydrology Prof. Carles Harvey Lecture Packet #9: Numerical Modeling of Groundwater Flow Simulation: Te prediction of quantities of interest (dependent variables) based upon an equation

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

Chapter 5 FINITE DIFFERENCE METHOD (FDM) MEE7 Computer Modeling Tecniques in Engineering Capter 5 FINITE DIFFERENCE METHOD (FDM) 5. Introduction to FDM Te finite difference tecniques are based upon approximations wic permit replacing differential

More information

1 Upwind scheme for advection equation with variable. 2 Modified equations: numerical dissipation and dispersion

1 Upwind scheme for advection equation with variable. 2 Modified equations: numerical dissipation and dispersion 1 Upwind sceme for advection equation wit variable coefficient Consider te equation u t + a(x)u x Applying te upwind sceme, we ave u n 1 = a (un u n 1), a 0 u n 1 = a (un +1 u n ) a < 0. CFL condition

More information

Research Article Cubic Spline Iterative Method for Poisson s Equation in Cylindrical Polar Coordinates

Research Article Cubic Spline Iterative Method for Poisson s Equation in Cylindrical Polar Coordinates International Scolarly Researc Network ISRN Matematical Pysics Volume 202, Article ID 2456, pages doi:0.5402/202/2456 Researc Article Cubic Spline Iterative Metod for Poisson s Equation in Cylindrical

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

Adaptive algebraic multigrid methods in lattice computations

Adaptive algebraic multigrid methods in lattice computations Adaptive algebraic multigrid methods in lattice computations Karsten Kahl Bergische Universität Wuppertal January 8, 2009 Acknowledgements Matthias Bolten, University of Wuppertal Achi Brandt, Weizmann

More information

Introduction to Scientific Computing II Multigrid

Introduction to Scientific Computing II Multigrid Introduction to Scientific Computing II Multigrid Miriam Mehl Slide 5: Relaxation Methods Properties convergence depends on method clear, see exercises and 3), frequency of the error remember eigenvectors

More information

MANY scientific and engineering problems can be

MANY scientific and engineering problems can be A Domain Decomposition Metod using Elliptical Arc Artificial Boundary for Exterior Problems Yajun Cen, and Qikui Du Abstract In tis paper, a Diriclet-Neumann alternating metod using elliptical arc artificial

More information

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential Title: Multigrid Methods Name: Luke Olson 1 Affil./Addr.: Department of Computer Science University of Illinois at Urbana-Champaign Urbana, IL 61801 email: lukeo@illinois.edu url: http://www.cs.uiuc.edu/homes/lukeo/

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

Introduction to the Multigrid Method

Introduction to the Multigrid Method Semiar: Te Iterplay betwee Matematical Modellig ad Numerical Simulatio Itroductio to te Multigrid Metod Bogojeska Jasmia JASS, 005 Abstract Te metods for solvig liear systems of equatios ca be divided

More information

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

New Multigrid Solver Advances in TOPS

New Multigrid Solver Advances in TOPS New Multigrid Solver Advances in TOPS R D Falgout 1, J Brannick 2, M Brezina 2, T Manteuffel 2 and S McCormick 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, P.O.

More information

The Laplace equation, cylindrically or spherically symmetric case

The Laplace equation, cylindrically or spherically symmetric case Numerisce Metoden II, 7 4, und Übungen, 7 5 Course Notes, Summer Term 7 Some material and exercises Te Laplace equation, cylindrically or sperically symmetric case Electric and gravitational potential,

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

du(l) 5 dl = U(0) = 1 and 1.) Substitute for U an unspecified trial function into governing equation, i.e. dx + = =

du(l) 5 dl = U(0) = 1 and 1.) Substitute for U an unspecified trial function into governing equation, i.e. dx + = = Consider an ODE of te form: Finite Element Metod du fu g d + wit te following Boundary Conditions: U(0) and du(l) 5 dl.) Substitute for U an unspecified trial function into governing equation, i.e. ^ U

More information

INTRODUCTION TO MULTIGRID METHODS

INTRODUCTION TO MULTIGRID METHODS INTRODUCTION TO MULTIGRID METHODS LONG CHEN 1. ALGEBRAIC EQUATION OF TWO POINT BOUNDARY VALUE PROBLEM We consider the discretization of Poisson equation in one dimension: (1) u = f, x (0, 1) u(0) = u(1)

More information

arxiv: v1 [math.na] 7 Mar 2019

arxiv: v1 [math.na] 7 Mar 2019 Local Fourier analysis for mixed finite-element metods for te Stokes equations Yunui He a,, Scott P. MacLaclan a a Department of Matematics and Statistics, Memorial University of Newfoundland, St. Jon

More information

Crouzeix-Velte Decompositions and the Stokes Problem

Crouzeix-Velte Decompositions and the Stokes Problem Crouzeix-Velte Decompositions and te Stokes Problem PD Tesis Strauber Györgyi Eötvös Loránd University of Sciences, Insitute of Matematics, Matematical Doctoral Scool Director of te Doctoral Scool: Dr.

More information

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 1: Introduction to Multigrid 2000 Eric de Sturler 1 12/02/09 MG01.prz Basic Iterative Methods (1) Nonlinear equation: f(x) = 0 Rewrite as x = F(x), and iterate x i+1

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

More information

9. Iterative Methods for Large Linear Systems

9. Iterative Methods for Large Linear Systems EE507 - Computational Techniques for EE Jitkomut Songsiri 9. Iterative Methods for Large Linear Systems introduction splitting method Jacobi method Gauss-Seidel method successive overrelaxation (SOR) 9-1

More information

HW4, Math 228A. Multigrid Solver. Fall 2010

HW4, Math 228A. Multigrid Solver. Fall 2010 HW4, Math 228A. Multigrid Solver Date due 11/30/2010 UC Davis, California Fall 2010 Nasser M. Abbasi Fall 2010 Compiled on January 20, 2019 at 4:13am [public] Contents 1 Problem 1 3 1.1 Restriction and

More information

LIMITATIONS OF EULER S METHOD FOR NUMERICAL INTEGRATION

LIMITATIONS OF EULER S METHOD FOR NUMERICAL INTEGRATION LIMITATIONS OF EULER S METHOD FOR NUMERICAL INTEGRATION LAURA EVANS.. Introduction Not all differential equations can be explicitly solved for y. Tis can be problematic if we need to know te value of y

More information

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes A First-Order System Approac for Diffusion Equation. I. Second-Order Residual-Distribution Scemes Hiroaki Nisikawa W. M. Keck Foundation Laboratory for Computational Fluid Dynamics, Department of Aerospace

More information

Finite Difference Methods Assignments

Finite Difference Methods Assignments Finite Difference Metods Assignments Anders Söberg and Aay Saxena, Micael Tuné, and Maria Westermarck Revised: Jarmo Rantakokko June 6, 1999 Teknisk databeandling Assignment 1: A one-dimensional eat equation

More information

Math 212-Lecture 9. For a single-variable function z = f(x), the derivative is f (x) = lim h 0

Math 212-Lecture 9. For a single-variable function z = f(x), the derivative is f (x) = lim h 0 3.4: Partial Derivatives Definition Mat 22-Lecture 9 For a single-variable function z = f(x), te derivative is f (x) = lim 0 f(x+) f(x). For a function z = f(x, y) of two variables, to define te derivatives,

More information

MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW

MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW VAN EMDEN HENSON CENTER FOR APPLIED SCIENTIFIC COMPUTING LAWRENCE LIVERMORE NATIONAL LABORATORY Abstract Since their early application to elliptic

More information

Iterative methods for Linear System

Iterative methods for Linear System Iterative methods for Linear System JASS 2009 Student: Rishi Patil Advisor: Prof. Thomas Huckle Outline Basics: Matrices and their properties Eigenvalues, Condition Number Iterative Methods Direct and

More information

Module 4 Linear Boundary value problems

Module 4 Linear Boundary value problems Module 4 Linear Boundary value problems Lecture Content Hours 1 Finite Difference Metods: Diriclet type boundary 1 condition Finite Difference Metods: Mixed boundary condition 1 3 Sooting Metod 1 4 Sooting

More information

Order of Accuracy. ũ h u Ch p, (1)

Order of Accuracy. ũ h u Ch p, (1) Order of Accuracy 1 Terminology We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, wic can be for instance te grid size or time step in a numerical

More information

Scientific Computing II

Scientific Computing II Technische Universität München ST 008 Institut für Informatik Dr. Miriam Mehl Scientific Computing II Final Exam, July, 008 Iterative Solvers (3 pts + 4 extra pts, 60 min) a) Steepest Descent and Conjugate

More information

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

= h. Geometrically this quantity represents the slope of the secant line connecting the points

= h. Geometrically this quantity represents the slope of the secant line connecting the points Section 3.7: Rates of Cange in te Natural and Social Sciences Recall: Average rate of cange: y y y ) ) ), ere Geometrically tis quantity represents te slope of te secant line connecting te points, f (

More information

A Multigrid Tutorial, 2nd Edition

A Multigrid Tutorial, 2nd Edition See discussions, stats, and author profiles for this publication at: https://www.researchgate.net/publication/220690328 A Multigrid Tutorial, 2nd Edition Book January 2000 Source: DBLP CITATIONS 44 READS

More information

Iterative Methods. Splitting Methods

Iterative Methods. Splitting Methods Iterative Methods Splitting Methods 1 Direct Methods Solving Ax = b using direct methods. Gaussian elimination (using LU decomposition) Variants of LU, including Crout and Doolittle Other decomposition

More information

Differentiation in higher dimensions

Differentiation in higher dimensions Capter 2 Differentiation in iger dimensions 2.1 Te Total Derivative Recall tat if f : R R is a 1-variable function, and a R, we say tat f is differentiable at x = a if and only if te ratio f(a+) f(a) tends

More information

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

More information

Preconditioning in H(div) and Applications

Preconditioning in H(div) and Applications 1 Preconditioning in H(div) and Applications Douglas N. Arnold 1, Ricard S. Falk 2 and Ragnar Winter 3 4 Abstract. Summarizing te work of [AFW97], we sow ow to construct preconditioners using domain decomposition

More information

Mass Lumping for Constant Density Acoustics

Mass Lumping for Constant Density Acoustics Lumping 1 Mass Lumping for Constant Density Acoustics William W. Symes ABSTRACT Mass lumping provides an avenue for efficient time-stepping of time-dependent problems wit conforming finite element spatial

More information

A Generalized Eigensolver Based on Smoothed Aggregation (GES-SA) for Initializing Smoothed Aggregation Multigrid (SA)

A Generalized Eigensolver Based on Smoothed Aggregation (GES-SA) for Initializing Smoothed Aggregation Multigrid (SA) NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2007; 07: 6 [Version: 2002/09/8 v.02] A Generalized Eigensolver Based on Smoothed Aggregation (GES-SA) for Initializing Smoothed Aggregation

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

232 Calculus and Structures

232 Calculus and Structures 3 Calculus and Structures CHAPTER 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS FOR EVALUATING BEAMS Calculus and Structures 33 Copyrigt Capter 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS 17.1 THE

More information

Research Article Smoothing Analysis of Distributive Red-Black Jacobi Relaxation for Solving 2D Stokes Flow by Multigrid Method

Research Article Smoothing Analysis of Distributive Red-Black Jacobi Relaxation for Solving 2D Stokes Flow by Multigrid Method Matematical Problems in Engineering Volume 205, Article ID 57298, 7 pages ttp://dx.doi.org/0.55/205/57298 Researc Article Smooting Analysis of Distributive Red-Black Jacobi Relaxation for Solving 2D Stokes

More information

Introduction to Multigrid Methods Sampling Theory and Elements of Multigrid

Introduction to Multigrid Methods Sampling Theory and Elements of Multigrid Introduction to Multigrid Methods Sampling Theory and Elements of Multigrid Gustaf Söderlind Numerical Analysis, Lund University Contents V3.15 What is a multigrid method? Sampling theory Digital filters

More information

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58 Background C. T. Kelley NC State University tim kelley@ncsu.edu C. T. Kelley Background NCSU, Spring 2012 1 / 58 Notation vectors, matrices, norms l 1 : max col sum... spectral radius scaled integral norms

More information

Solution. Solution. f (x) = (cos x)2 cos(2x) 2 sin(2x) 2 cos x ( sin x) (cos x) 4. f (π/4) = ( 2/2) ( 2/2) ( 2/2) ( 2/2) 4.

Solution. Solution. f (x) = (cos x)2 cos(2x) 2 sin(2x) 2 cos x ( sin x) (cos x) 4. f (π/4) = ( 2/2) ( 2/2) ( 2/2) ( 2/2) 4. December 09, 20 Calculus PracticeTest s Name: (4 points) Find te absolute extrema of f(x) = x 3 0 on te interval [0, 4] Te derivative of f(x) is f (x) = 3x 2, wic is zero only at x = 0 Tus we only need

More information

Notes for CS542G (Iterative Solvers for Linear Systems)

Notes for CS542G (Iterative Solvers for Linear Systems) Notes for CS542G (Iterative Solvers for Linear Systems) Robert Bridson November 20, 2007 1 The Basics We re now looking at efficient ways to solve the linear system of equations Ax = b where in this course,

More information

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009)

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009) Iterative methods for Linear System of Equations Joint Advanced Student School (JASS-2009) Course #2: Numerical Simulation - from Models to Software Introduction In numerical simulation, Partial Differential

More information

= 0 and states ''hence there is a stationary point'' All aspects of the proof dx must be correct (c)

= 0 and states ''hence there is a stationary point'' All aspects of the proof dx must be correct (c) Paper 1: Pure Matematics 1 Mark Sceme 1(a) (i) (ii) d d y 3 1x 4x x M1 A1 d y dx 1.1b 1.1b 36x 48x A1ft 1.1b Substitutes x = into teir dx (3) 3 1 4 Sows d y 0 and states ''ence tere is a stationary point''

More information

Calculus I Homework: The Derivative as a Function Page 1

Calculus I Homework: The Derivative as a Function Page 1 Calculus I Homework: Te Derivative as a Function Page 1 Example (2.9.16) Make a careful sketc of te grap of f(x) = sin x and below it sketc te grap of f (x). Try to guess te formula of f (x) from its grap.

More information

Finite Difference Method

Finite Difference Method Capter 8 Finite Difference Metod 81 2nd order linear pde in two variables General 2nd order linear pde in two variables is given in te following form: L[u] = Au xx +2Bu xy +Cu yy +Du x +Eu y +Fu = G According

More information

Algebra C Numerical Linear Algebra Sample Exam Problems

Algebra C Numerical Linear Algebra Sample Exam Problems Algebra C Numerical Linear Algebra Sample Exam Problems Notation. Denote by V a finite-dimensional Hilbert space with inner product (, ) and corresponding norm. The abbreviation SPD is used for symmetric

More information

THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS. L. Trautmann, R. Rabenstein

THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS. L. Trautmann, R. Rabenstein Worksop on Transforms and Filter Banks (WTFB),Brandenburg, Germany, Marc 999 THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS L. Trautmann, R. Rabenstein Lerstul

More information

Recall from our discussion of continuity in lecture a function is continuous at a point x = a if and only if

Recall from our discussion of continuity in lecture a function is continuous at a point x = a if and only if Computational Aspects of its. Keeping te simple simple. Recall by elementary functions we mean :Polynomials (including linear and quadratic equations) Eponentials Logaritms Trig Functions Rational Functions

More information

A compact upwind second order scheme for the Eikonal equation

A compact upwind second order scheme for the Eikonal equation A compact upwind second order sceme for te Eikonal equation Jean-David Benamou Songting Luo Hongkai Zao Abstract We present a compact upwind second order sceme for computing te viscosity solution of te

More information

Von Neumann Analysis of Jacobi and Gauss-Seidel Iterations

Von Neumann Analysis of Jacobi and Gauss-Seidel Iterations Von Neumann Analysis of Jacobi and Gauss-Seidel Iterations We consider the FDA to the 1D Poisson equation on a grid x covering [0,1] with uniform spacing h, h (u +1 u + u 1 ) = f whose exact solution (to

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

Continuity and Differentiability Worksheet

Continuity and Differentiability Worksheet Continuity and Differentiability Workseet (Be sure tat you can also do te grapical eercises from te tet- Tese were not included below! Typical problems are like problems -3, p. 6; -3, p. 7; 33-34, p. 7;

More information

Section 2.7 Derivatives and Rates of Change Part II Section 2.8 The Derivative as a Function. at the point a, to be. = at time t = a is

Section 2.7 Derivatives and Rates of Change Part II Section 2.8 The Derivative as a Function. at the point a, to be. = at time t = a is Mat 180 www.timetodare.com Section.7 Derivatives and Rates of Cange Part II Section.8 Te Derivative as a Function Derivatives ( ) In te previous section we defined te slope of te tangent to a curve wit

More information

JACOBI S ITERATION METHOD

JACOBI S ITERATION METHOD ITERATION METHODS These are methods which compute a sequence of progressively accurate iterates to approximate the solution of Ax = b. We need such methods for solving many large linear systems. Sometimes

More information

Solving Sparse Linear Systems: Iterative methods

Solving Sparse Linear Systems: Iterative methods Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccs Lecture Notes for Unit VII Sparse Matrix Computations Part 2: Iterative Methods Dianne P. O Leary c 2008,2010

More information

Solving Sparse Linear Systems: Iterative methods

Solving Sparse Linear Systems: Iterative methods 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 2: Iterative Methods Dianne P. O Leary

More information

How to Find the Derivative of a Function: Calculus 1

How to Find the Derivative of a Function: Calculus 1 Introduction How to Find te Derivative of a Function: Calculus 1 Calculus is not an easy matematics course Te fact tat you ave enrolled in suc a difficult subject indicates tat you are interested in te

More information

158 Calculus and Structures

158 Calculus and Structures 58 Calculus and Structures CHAPTER PROPERTIES OF DERIVATIVES AND DIFFERENTIATION BY THE EASY WAY. Calculus and Structures 59 Copyrigt Capter PROPERTIES OF DERIVATIVES. INTRODUCTION In te last capter you

More information

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER*

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER* EO BOUNDS FO THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BADLEY J. LUCIE* Abstract. Te expected error in L ) attimet for Glimm s sceme wen applied to a scalar conservation law is bounded by + 2 ) ) /2 T

More information

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for 1 Iteration basics Notes for 2016-11-07 An iterative solver for Ax = b is produces a sequence of approximations x (k) x. We always stop after finitely many steps, based on some convergence criterion, e.g.

More information

AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS

AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS GRADY B. WRIGHT, ROBERT D. GUY, AND AARON L. FOGELSON Abstract. We develop a computational metod for simulating models of gel dynamics

More information

A compact upwind second order scheme for the Eikonal equation

A compact upwind second order scheme for the Eikonal equation A compact upwind second order sceme for te Eikonal equation J.-D. Benamou INRIA, INRIA B.P. 05, 7853 Le Cesnay Cedex, France. jean-david.benamou@inria.fr Songting Luo Department of Matematics, Micigan

More information

lecture 26: Richardson extrapolation

lecture 26: Richardson extrapolation 43 lecture 26: Ricardson extrapolation 35 Ricardson extrapolation, Romberg integration Trougout numerical analysis, one encounters procedures tat apply some simple approximation (eg, linear interpolation)

More information

Bootstrap AMG. Kailai Xu. July 12, Stanford University

Bootstrap AMG. Kailai Xu. July 12, Stanford University Bootstrap AMG Kailai Xu Stanford University July 12, 2017 AMG Components A general AMG algorithm consists of the following components. A hierarchy of levels. A smoother. A prolongation. A restriction.

More information

Exercise 19 - OLD EXAM, FDTD

Exercise 19 - OLD EXAM, FDTD Exercise 19 - OLD EXAM, FDTD A 1D wave propagation may be considered by te coupled differential equations u x + a v t v x + b u t a) 2 points: Derive te decoupled differential equation and give c in terms

More information

GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES

GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES Cristoper J. Roy Sandia National Laboratories* P. O. Box 5800, MS 085 Albuquerque, NM 8785-085 AIAA Paper 00-606 Abstract New developments

More information

Practice Problem Solutions: Exam 1

Practice Problem Solutions: Exam 1 Practice Problem Solutions: Exam 1 1. (a) Algebraic Solution: Te largest term in te numerator is 3x 2, wile te largest term in te denominator is 5x 2 3x 2 + 5. Tus lim x 5x 2 2x 3x 2 x 5x 2 = 3 5 Numerical

More information