Outline. 1 Partial Differential Equations. 2 Numerical Methods for PDEs. 3 Sparse Linear Systems

Size: px
Start display at page:

Download "Outline. 1 Partial Differential Equations. 2 Numerical Methods for PDEs. 3 Sparse Linear Systems"

Transcription

1 Outline Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems 1 Partial Differential Equations 2 Numerical Methods for PDEs 3 Sparse Linear Systems Michael T Heath Scientific omputing 2 / 105

2 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Partial Differential Equations Partial Differential Equations haracteristics lassification Partial differential equations (PDEs) involve partial derivatives with respect to more than one independent variable Independent variables typically include one or more space dimensions and possibly time dimension as well More dimensions complicate problem formulation: we can have pure initial value problem, pure boundary value problem, or mixture of both Equation and boundary data may be defined over irregular domain Michael T Heath Scientific omputing 3 / 105

3 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Partial Differential Equations haracteristics lassification Partial Differential Equations, continued For simplicity, we will deal only with single PDEs (as opposed to systems of several PDEs) with only two independent variables, either two space variables, denoted by x and y, or one space variable denoted by x and one time variable denoted by t Partial derivatives with respect to independent variables are denoted by subscripts, for example u t u xy 2 u/@x@y Michael T Heath Scientific omputing 4 / 105

4 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems lassification of PDEs Partial Differential Equations haracteristics lassification Order of PDE is order of highest-order partial derivative appearing in equation For example, advection equation is first order Important second-order PDEs include Heat equation : u t = u xx Wave equation : u tt = u xx Laplace equation : u xx + u yy =0 Michael T Heath Scientific omputing 8 / 105

5 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems lassification of PDEs, continued Partial Differential Equations haracteristics lassification Second-order linear PDEs of general form au xx + bu xy + cu yy + du x + eu y + fu+ g =0 are classified by value of discriminant b 2 4ac b 2 b 2 b 2 4ac > 0: hyperbolic (eg, wave equation) 4ac =0: parabolic (eg, heat equation) 4ac < 0: elliptic (eg, Laplace equation) Michael T Heath Scientific omputing 9 / 105

6 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems lassification of PDEs, continued Partial Differential Equations haracteristics lassification lassification of more general PDEs is not so clean and simple, but roughly speaking Hyperbolic PDEs describe time-dependent, conservative physical processes, such as convection, that are not evolving toward steady state Parabolic PDEs describe time-dependent, dissipative physical processes, such as diffusion, that are evolving toward steady state Elliptic PDEs describe processes that have already reached steady state, and hence are time-independent Michael T Heath Scientific omputing 10 / 105

7 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Time-Dependent Problems Time-Dependent Problems Time-Independent Problems Time-dependent PDEs usually involve both initial values and boundary values Michael T Heath Scientific omputing 11 / 105

8 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Time-Dependent Problems Time-Dependent Problems Time-Independent Problems Time-dependent PDEs usually involve both initial values and boundary values Time Space Michael T Heath Scientific omputing 11 / 105

9 Example: Poisson Equation in 2 u 2 = f(x, u = 0on@ u =0 Ex 1: If f(x, y) =sin x sin y, Ex 2: If f(x, y) =1, u(x, y) = 1 sin x sin y 2 2 u(x, y) = 1,1 X k,l odd 16 sin k x sin l y 2 kl(k 2 + l 2 ) Q: How large must k and l be for exact solution to be correct to M? Spectral collocation would yield u = u exact ± M by N 15

10 Numerical Solution: Finite Di erences n y u i 1,j u i,j+1 u ij u i,j 1 u ui+1,j 2u ij u i 1,j x 2 + u i,j+1 2u ij u i,j 1 y 2 = f ij 1 i =1 n x j =0 i = n x +1 5-point finite-di erence stencil j =1 n y Here, the unknowns are u =[u 11,u 21,,u nx,n y ] T This particular (so-called natural or lexicographical) ordering gives rise to abandedsystemmatrixforu As in the 1D case, the error is O( x 2 )+O( y 2 )=O(h 2 )ifwetake x = y =: h Assuming for simplicity that N = n x = n y,wehaven = N 2 unknowns

11 For i, j 2 [1,,N] 2, the governing finite di erence equations are ui+1,j 2u i,j + u i 1,j x 2 + u i,j+1 2u i,j + u i,j 1 y 2 = f ij Assuming a lexicographical ordering in which the i- (x-) index advances fastest, the system matrix has the form 1 h A {z } A u 11 u 21 u N1 u 12 u 22 u N2 u 1N u 2N u NN 1 A {z } u = f 11 f 21 f N1 f 12 f 22 f N2 f 1N f 2N f NN 1 A {z } f

12 The system matrix A is sparse, with 5 nonzeros per row (good) and has a bandwith N (bad) The di culty is that solving Au = f using Gaussian elimination results in signifcant fill eachofthefactorsl and U have N 3 = n 3/2 nonzeros Worse, for 3D problems with N 3 unknowns, u =[u 111,u 211,,u nx,n y,n z ] T, A is sparse, with 7 nonzeros per row (good) and has a bandwith N 2 (awful) In 3D, LU decomposition yields N 5 =n 5/3 nonzeros in L and U The situation can be rescued in 2D with a reordering of the unknowns (eg, via nesteddissection) to yield O(n log n) nonzerosinl and U In 3D, nested-dissection yields O(n 3/2 ) nonzeros in the factors Direct solution is not scalable for more than two space dimensions The following Matlab examples illustrate the issue of fill: fd poisson 2dm fd poisson 3dm

13 Matrix-Fill for 2D and 3D Poisson, Lexicographical Ordering nnz 3D As expected, the error scales like h 2 1/N 2 in both 2D and 3D The resepctive storage costs (and work per rhs) are N 3 and N 5 nnz 2D Alternative orderings are asymptotically better, but the constants tend to be large error 2D,3D

14 Matrix-Fill for 2D Poisson, symamd Ordering N 3 nnz 2D error 2D We see for N =80(n =6400)a5 reduction in number of nonzeros by reording with matlab s symamd function The requirements for indirect addressing to access elements of the complacty-stored matrix further adds to overhead Gains tend to be realized only for very large N and are even less beneficial in 3D Despite this, it s still a reasonable idea to reorder in matlab because it s available and easy to use

15 Iterative Solvers The curse of dimensionality for d>2 resulted in a move towards iterative (rather than direct-, LU-based) linear solvers once computers became fast enough to tackle 3D problems in the mid-80s With iterative solvers, factorization is replaced by, say, Au = f =) u = A 1 f = U 1 L 1 f u k+1 = u k + M 1 (f Au k ), which only requires matrix-vector products With e k := u u k, we have e k+1 = I M 1 A e k, (as we ve seen before) This is known as Richardson iteration For the particular case M = D =diag(a), it is Jacobi iteration We can derive Jacobi iteration (and multigrid by looking at a parabolic PDE, known as the (unsteady) heat equation (The Poisson equation is sometimes referred to as the steady-state heat equation)

16 The intrinsic advantage of iterative solvers is that there is no fill associated with matrix factorization Often one does not even construct the matrix Rather, we simply evaluate the residual r k := f Au k and set u k+1 = u k + M 1 r k For a sparse matrix A, the operation count is O(n) periteration Assuming the preconditioner cost is also sparse, the overall cost is O(nk max ), where k max is the number of iterations required to reach a desired tolerance The choice of iteration (Richardson, conjugate gradient, GMRES) can greatly influence k max Even more significant is the choice of M Usually, one seeks an M such that the cost of solving Mz = r is O(n) andthat k max = O(1) That is, the iteration count is bounded, independent of n The overall algorithm is therefore O(n), which is optimal

17 Iterative Solvers - Linear Elliptic Problems PDEs give rise to large sparse linear systems of the form Au = f Here, we ll take A to be the (SPD) matrix arising from finite di erences applied to the Poisson 2 u = f(x, y) x, y 2 [0, 1] 2, u =0on@ 2 2 u x u y 2 ij f ij, Assuming uniform spacing in x and y we have 2 u x := u i+1,j 2u ij + u i 1,j 2 h 2 and 2 u y := u i,j+1 2u ij + u i,j 1 2 h 2

18 Our finite di erence formula is thus, 1 h 2 (u i+1,j + u i 1,j 4u ij + u i,j+1 + u i,j 1 )=f ij Rearranging, we can solve for u ij : 4 h 2u ij = f ij + 1 h 2 (u i+1,j + u i 1,j + u i,j+1 + u i,j 1 ) u ij = h2 4 f ij (u i+1,j + u i 1,j + u i,j+1 + u i,j 1 )

19 Jacobi iteration uses the preceding expression as a fixed-point iteration: u k+1 ij = h2 4 f ij uk i+1,j + u k i 1,j + u k i,j+1 + u k i,j 1 Note that this is analogous to u k+1 ij = u k ij + h2 4 = h2 4 f ij + average of current neighbor values apple f ij + 1 h 2 u k i+1,j + u k i 1,j 4u k ij + u k i,j+1 + u k i,j 1 u k+1 = u k + t (f Au k ), t := h2 4, which is Euler forward applied to du dt = Au + f We note that we have stability if t < 2

20 Recall that the eigenvalues for the 1D di usion operator are j = 2 h 2 (1 cos j x) < 4 h 2 In 2D, we pick up contributions from both 2 u x 2 and 2 u y 2, so and we have stability since max < 8 h 2 max t < 8 h 2 h 2 4 =2 So, Jacobi iteration is equivalent to solving Au = f by time marching du dt = Au + f using EF with maximum allowable timestep size, t = h2 4

21 Jacobi Iteration in Matrix Form Our unsteady heat equation has the matrix form u k+1 = u k + t (f Au k ) For variable diagonal entries, Richardson iteration is u k+1 = u k + M 1 (f Au k ) If =1andM = D 1 =diag(a) [d ii =1/a ii, d ij =0,i6= j], we have standard Jacobi iteration If < 1 we have damped Jacobi M is generally known as a smoother or a preconditioner, depending on context

22 Rate of onvergence for Jacobi Iteration Let e k := u u k Since Au = f, wehave u k+1 = u k + t (Au Au k ) u = u e k+1 = e k tae k e k+1 = (I ta) e k e k = (I ta) k e 0 = (I ta) k u if u 0 =0 If < 1, then the high wavenumber error components will decay because t will be well within the stability region for EF

23 The low-wavenumber components of the solution (and error) evolve like e tk, because these will be well-resolved in time by Euler forward Thus, we can anticipate If with min 2 2 (for 2D) 1, we have e k u e min tk e k u e 2 2 (h 2 /4)k apple tol Example, find the number of iterations when tol=10 12 e ( 2 h 2 /4)k ( 2 h 2 /4)k ln (276) k h 2 6N 2 Here, N=number of points in each direction

24 Recap Low-wavenumber components decay at a fixed rate: e min tk Stability mandates t<h 2 /4=1/4(N +1) 2 Number of steps scales like N 2 Note, if = 1, thenhighest and lowest wavenumber components decay at same rate If 1 2 < < 1, high wavenumber components of error decay very fast We say that damped Jacobi iteration is a smoother

25 Example: 1D Jacobi Iteration Solution after 1 iteration Error after 1 iteration Solution after 5 itierations Error after 5 itierations

26 Observations: Error, e k is smooth after just a few iterations: Error components are û j e j2 kh 2 2 /4 sin k x j, and components for j>1rapidlygotozero Exact solution is u = u k + e k (e k unknown, but smooth) Error satisfies, and can be computed from, Ae k = r k (:= f Au k = Au Au k = Ae k ) These observations suggest that the error can be well approximated on a coarser grid and added back to u k to improve the current guess The two steps, smooth and coarse-grid correction are at the heart of one of the fastest iteration strategies, known as multigrid

27 Multigrid: Solve Ae k = r k approximately on a coarse grid and set ũ k = u k + ẽ k Approximation strategy is similar to least squares Let ẽ k = V e c, and AV e c r, where V is an n n c matrix with n c n/2 Typically, columns of V interpolate coarse point values to their midpoints Most common approach (for A SPD) is to require e c to solve V T [AV e c r] = 0 =) ẽ k = V V T AV 1 V T r = V V T AV 1 V T A e k For A SPD, ẽ k is the A-orthogonal projection of e k onto R(V )

28 An example of V for n =5andn c =2 is V = i = n x +1 oarse-to-fine interpolation poisson_mgm demo

29 Example: Damped Jacobi (Richardson) Iteration Solution after 1 iteration Error after 1 iteration Solution after 5 itierations Error after 5 itierations

30 Multigrid Summary Main Ideas Solution after 5 iterations Error after 5 iterations Take a few damped-jacobi steps (smoothing the error), to get u k Approximate this smooth error, e k := u u k, on a coarser grid Exact error satisfies Ae k = Au Au k = f Au =: r k Let e f := V e c be the interpolant of e c, the coarse-grid approximation to e k e f is closest element in R(V )toe k (in the A-norm), given by the projection: e f = V V T AV 1 V T Ae k = V A c ) 1 V T r k Update u k with the coarse-grid correction: u k u k + e f Smooth again and repeat

31 Example: Two-Level Multigrid Solution after 1 iteration Error after 1 iteration Solution after 5 itierations Error after 5 itierations

32 Example: Two-Level Multigrid Solution after 1 iteration Error after 1 iteration Iteration History Error after 5 itierations

33 Multigrid omments Smoothing can be improved using under-relaxation ( ¾ = 2/3 is optimal for 1D case) asically want more of the high-end error spectrum to be damped System in A c is less expensive to solve, but is typically best solved by repeating the smooth/ coarse-grid correct pair on yet another level down an recur until n c ~ 1, at which point system is easy to solve Typical MG complexity is O(n) or O(n log n), with very good constants in higher space dimensions (N c = N/2 à n c = n/8 in 3D) For high aspect-ratio cells, variable coefficients, etc, smoothing and coarsening strategies require more care, so this continues to be an active research area

34 Stability Region for Euler s Method Unstable Stable -2-1 Region where 1 + h < 1

35 Growth Factors for Real e t G G t t t Each growth factor approximates e t for t à 0 For EF, G is not bounded by 1 For Trapezoidal Rule, local (small t) approximation is O( t 2 ), but G à -1 as t à -1 [ Trapezoid method is not L-stable ] DF2 will give 2 nd -order accuracy, stability, and G à0 as t à -1

36

37 Time Dependent Problems We ll consider two examples: di usion (heat equation) and advection heat s and I + s and I

38 > 0 2 For the heat equation, the solution evolves in the direction of local curvature If the the solution is locally concave down, u decreases there If the the solution is concave up, u 2 < 0 < 2 2 > 0 +

39 Example Solutions (eigenfunctions): u t = u xx,u(0) = u(1) = 0 u(x, t) = = dû dt dû dt sin x = 2 = 2 û û = e 2t û(0) û sin x u(x, t) = = dû dt dû dt sin x = = û û = e 100 2t û(0)! Very rapid decay û sin x (1) + 05(2)

40 Solution of Partial Di erential Equations Unsteady Heat Equation: u t = u xx + q(x, t), u(x =0,t)=u(x = L, t) =0, u(x, t =0)=u 0 (x) Discretize in space: Finite di erence Weighted residual technique (FEM, Galerkin + high-order polynomials, etc)

41 Finite Di erence ase: u j 1 u j u j+1 0=:x 0 x 1 x 2 x j 1 x j x j+1 x n+1 := 1 In ODE form: du i dt du dt = (Au) i + q i, i =1,,n = Au + q, u(t =0)=u 0 0 1

42 Here, Eigenvalues: x =1/(n +1)andA is the SPD tridiagonal matrix A = x 2 1 A 1 2 (A) = 2 x (1 cos(k x)) (1 + O( x 2 )), 4(n +1) (1 + O( x 2 4 )), x 2

43 an view this semi-discrete form as a system of ODEs: du dt = f(u) := Au + q(x,t) Jacobian df i du j = a ij J = A Stability is determined by the eigenvalues of J and by the choice of timestepper Some possible explicit timesteppers EF: u k+1 = u k + t f k 23 A3: u k+1 = u k + t 12 f k f k f k 2 Stable, as long as (J) t in the stability region

44 Stability: (J) = (A) = 2 (1 cos k x) x2 Worst case is (J) 4 x 2 For Euler forward (EF), require Stability Regions, EF, A2, A3 t (J) < 2 or t < 2 x2 4 = x2 2, which is a very severe timestep restriction Question: What is the maximum allowable timestep size for A3 in this case?

45 Question: What is the maximum allowable timestep size for A3 in this case? Stability Regions, EF, A2, A3

46 Severity of explicit timestep restriction: Suppose =1andyouwanterror 10 6! x 10 3! t 10 6, just for stability This is an example of a sti system High wavenumbers ( (A)) are uninteresting but restrict the timestep size For this reason, the heat equation is most often treated implicitly

47 Possible Implicit Approaches: 8 < Examples: du dt = f(u) : E Trapezoid (aka rank-nicolson) DF2 or DF3 E: u k+1 = u k + t Au k+1 + q(x,t k+1 ) N: u k+1 t u k = Au k+1 + q k+1 Au k + q k DF2: 3u k+1 4u k + u k 1 2 t = Au k+1 + q(x,t k+1 )

48 E Example: u k+1 + tau k+1 = u k + tq k+1 [I + ta] u k+1 = u k + tq k+1 Hu k+1 = u k + tq k+1 Here, H := [I + ta] is SPD, tridiagonal, and strongly diagonally dominant (In all number of space dimensions) Hu = f is easier to solve than Au = f Jacobi- (diagonal-) preconditioned conjugate gradient iteration is often the best choice of solver, particularly in higher space dimensions Note that all the implicit solvers end up with the form Hu = f and generally have the same costs for the linear heat equation considered here Note that N (aka trapezoid method) is not L-stable and will have potential di culties noted in our discussion of IVPs

49 Discretization ased on Weighted Residual Technique in Space oming back to the heat equation (with s/is), u t = u xx + q(x, t), WRT - residual orthogonal to test functions Z v( u xx + q(x, t) u t ) dx = 0 8 vx N 0 If u = LHS: nx j=1 Z u j (t) j (x) and v dx = nx j=1 i i (x), then j dx! u j (t) = du dt, with the mass matrix having entries Z ij := i(x) j (x) dx

50 On the right, we have Z RHS = = Z dx + dx + vq dx Z vq dx Setting v = i and u = P j ju j (t), RHS = nx j=1 Z d i dx d i dx dx u j (t) + Z iqdx = Au + b, 8 >< >: Z d i d i a ij := Z dx dx dx b i := iqdx

51 In summary, the WRT formulation is, Find u(x, t) 2 X0 N such that, Z @x dx + vq dx 8 v 2 X0 N, which leads to the ODE du dt In standard form, = Au + b, plus initial condition u(t =0)=u 0 du dt = 1 Au + 1 b, Stability is thus governed by (J) = ( 1 A), not just (A) Presence of in front of du dt must not be ignored hoice of timestepper motivated by same concerns as for finite-di erences: (J) O( x 2 ) Implicit timestepping generally preferred SPD systems Jacobi (diagonal) preconditioned conjugate gradient iteration is generally the solver of choice

52 Time Stepping for Di usion Equation: Recall, with boundary conditions u(0) = u(1) = 0, the finite di erence operator Au = h 2 [u j+1 u j u j 1 ] with h := 1/(n + 1) has eigenvalues in the interval [0,M] with M = max k k = max k 2 h 2 [1 cos k h] 4 h 2 Our ODE is u t = Au, so we are concerned with k With Euler Forward, we require t < 2forstability,! t< h2 2 no matter how smooth the initial condition This intrinsic sti ness motivates the use of implicit methods for the heat equation (DF2 is a good one) heat1d_efm matlab example: and heat1d_ebm heat1dm

53

54 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Example: Advection Equation Partial Differential Equations haracteristics lassification Advection equation u t = cu x where c is nonzero constant Unique solution is determined by initial condition u(0,x)=u 0 (x), 1 <x<1 where u 0 is given function defined on R We seek solution u(t, x) for t 0 and all x 2 R From chain rule, solution is given by u(t, x) =u 0 (x ct) Solution is initial function u 0 shifted by ctto right if c>0, or to left if c<0 Michael T Heath Scientific omputing 5 / 105

55 Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Example, continued Partial Differential Equations haracteristics lassification Typical solution of advection equation, with initial function advected (shifted) over time < interactive example > Michael T Heath Scientific omputing 6 / 105

56 haracteristics Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Partial Differential Equations haracteristics lassification haracteristics for PDE are level curves of solution For advection equation u t = straight lines of slope c cu x, characteristics are haracteristics determine where boundary conditions can or must be imposed for problem to be well-posed Michael T Heath Scientific omputing 7 / 105

57 Matlab Demo: onvection

58 Matlab Demo: onvection

59 Time Stepping for Unlike the di usion equation, which smears out the initial condition (with high wavenumber components decaying particularly fast), the advection equation simply moves things around, with no decay This property is evidenced by the spatial operator having purely (or close to purely) imaginary eigenvalues Preserving high-wavenumber content (in space) for all time makes this problem particularly challenging There is always some spatial discretization error Its e ects accumulate over time (with no decay of the error) For su ciently large final time T any fixed grid (ie, fixed n) simulation for general problems will eventually have too much error Long time-integrations, therefore, typically require relatively fine meshes and/or high-order spatial discretizations

60 FL, Eigenvalues, and Stability: Fourier Analysis onsider: u t = cu x, u(0) = u(1) (periodic s) entered di erence formula in space: du j dt = c 2 x (u j+1 u j 1 ) = u j = 1 2 x Periodic Matrix

61 Periodic Domain Periodicity: u 0 u n u j 1 u j u j+1 x 0 x 1 x 2 x j 1 x j x j+1 x n Allows us to run for long times without having to have averylongdomain Allows us to analyze the properties of our spatial discretization

62 FL, Eigenvalues, and Stability: Fourier Analysis onsider: u t = cu x, u(0) = u(1) (periodic s) entered di erence formula in space: du j dt = c 2 x (u j+1 u j 1 ) = u j Eigenvector: u j = e i2 kx j Eigenvalue: u j = c 2 x ei2 k x e i2 k x e i2 kx j = 2ic 2 x e i2 k x e i2 k x 2i u j = k u j k = ic x sin(2 k x)

63 FL, Eigenvalues, and Stability: Fourier Analysis Eigenvalue: u j = = c 2 x ei2 k x e i2 k x e i2 kx j 2ic 2 x = k u j e i2 k x e i2 k x 2i u j k = ic x sin(2 k x) Eigenvalues are purely imaginary, max modulus is For constant c and equation as max k k = c x x, wedefinetheflfortheadvection FL = t c x ourant Number

64 ourant Number, Eigenvalues, and Stability: Fourier Analysis For constant c and x, wedefinetheflfortheadvection equation as FL = t c x FL=1 would correspond to a timestep size where a particle moving at speed c would move one grid spacing in a single timestep For centered finite di erences in space, FL=1 also corresponds t =1 From our IVP stability analysis, we know that we need t <7236 for A3 and < 2828 for RK4 This would correspond to FL <7236 and 2828, respectively

65 FL, Eigenvalues, and Stability: Fourier Analysis MATLA EXAMPLE: conv_ab3m

66 Advection For advection, no decay in physical solution Solution is persistent Numerical method is either dispersive, dissipative, or both If = T, discrete operator is skew-symmetric (imaginary eigenvalues) and numerical method has no decay (due to spatial error, at least) ut it will be dispersive We come back to dissipative shortly

67 Long time-integration! accumulation of error Second-order, O( x 2 ), accuracy is not su cient Modulo boundary conditions (or with periodicity), we can easily extend our 2nd-order centered-di erence formula to O( x 4 )throughrichardson extrapolation Let and h u j := c 2 x [u j+1 u j 1 ] 2h u j := c 4 x [u j+2 u j 2 ] for j =1,,n (with wrap for periodic ends)

68 Instead of now use du dt = du dt = h u apple 4 3 hu 1 3 2hu For A3, say, 23 u k+1 = u k + t 12 f k f k f k 2 apple 4 f k = 3 hu k 1 3 2hu k Don t re-evaluate f k 1 or f k 2 Just re-use the previously computed values

69 Numerical Dissipation Numerical Dissipation So far, we ve consider only central di erence formulas Upwind discretizations o er more stability, through the introduction of numerical dissipation You must be very careful about the wind direction!

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

Outline. 1 Boundary Value Problems. 2 Numerical Methods for BVPs. Boundary Value Problems Numerical Methods for BVPs

Outline. 1 Boundary Value Problems. 2 Numerical Methods for BVPs. Boundary Value Problems Numerical Methods for BVPs Boundary Value Problems Numerical Methods for BVPs Outline Boundary Value Problems 2 Numerical Methods for BVPs Michael T. Heath Scientific Computing 2 / 45 Boundary Value Problems Numerical Methods for

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

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

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

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

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

More information

Finite difference methods for the diffusion equation

Finite difference methods for the diffusion equation Finite difference methods for the diffusion equation D150, Tillämpade numeriska metoder II Olof Runborg May 0, 003 These notes summarize a part of the material in Chapter 13 of Iserles. They are based

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

7 Hyperbolic Differential Equations

7 Hyperbolic Differential Equations Numerical Analysis of Differential Equations 243 7 Hyperbolic Differential Equations While parabolic equations model diffusion processes, hyperbolic equations model wave propagation and transport phenomena.

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

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

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

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

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

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit III: Numerical Calculus Lecturer: Dr. David Knezevic Unit III: Numerical Calculus Chapter III.3: Boundary Value Problems and PDEs 2 / 96 ODE Boundary Value Problems 3 / 96

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

Tutorial 2. Introduction to numerical schemes

Tutorial 2. Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes c 2012 Classifying PDEs Looking at the PDE Au xx + 2Bu xy + Cu yy + Du x + Eu y + Fu +.. = 0, and its discriminant, B 2

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

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

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

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

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

More information

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

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices 1 General concepts Numerical Methods and Simulation / Umberto Ravaioli Introduction to the Numerical Solution of Partial Differential

More information

Multi-Factor Finite Differences

Multi-Factor Finite Differences February 17, 2017 Aims and outline Finite differences for more than one direction The θ-method, explicit, implicit, Crank-Nicolson Iterative solution of discretised equations Alternating directions implicit

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

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

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

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

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

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

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

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

High Performance Nonlinear Solvers

High Performance Nonlinear Solvers What is a nonlinear system? High Performance Nonlinear Solvers Michael McCourt Division Argonne National Laboratory IIT Meshfree Seminar September 19, 2011 Every nonlinear system of equations can be described

More information

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

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

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Solving linear systems (6 lectures)

Solving linear systems (6 lectures) Chapter 2 Solving linear systems (6 lectures) 2.1 Solving linear systems: LU factorization (1 lectures) Reference: [Trefethen, Bau III] Lecture 20, 21 How do you solve Ax = b? (2.1.1) In numerical linear

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Partial Differential Equations (Lecture 1, Week 1) Markus Schmuck Department of Mathematics and Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

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

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

Preliminary Examination, Numerical Analysis, August 2016

Preliminary Examination, Numerical Analysis, August 2016 Preliminary Examination, Numerical Analysis, August 2016 Instructions: This exam is closed books and notes. The time allowed is three hours and you need to work on any three out of questions 1-4 and any

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University A Model Problem in a 2D Box Region Let us consider a model problem of parabolic

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

ME Computational Fluid Mechanics Lecture 5

ME Computational Fluid Mechanics Lecture 5 ME - 733 Computational Fluid Mechanics Lecture 5 Dr./ Ahmed Nagib Elmekawy Dec. 20, 2018 Elliptic PDEs: Finite Difference Formulation Using central difference formulation, the so called five-point formula

More information

A Linear Multigrid Preconditioner for the solution of the Navier-Stokes Equations using a Discontinuous Galerkin Discretization. Laslo Tibor Diosady

A Linear Multigrid Preconditioner for the solution of the Navier-Stokes Equations using a Discontinuous Galerkin Discretization. Laslo Tibor Diosady A Linear Multigrid Preconditioner for the solution of the Navier-Stokes Equations using a Discontinuous Galerkin Discretization by Laslo Tibor Diosady B.A.Sc., University of Toronto (2005) Submitted to

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Philippe B. Laval KSU Current Semester Philippe B. Laval (KSU) Key Concepts Current Semester 1 / 25 Introduction The purpose of this section is to define

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

Qualifying Examination

Qualifying Examination Summer 24 Day. Monday, September 5, 24 You have three hours to complete this exam. Work all problems. Start each problem on a All problems are 2 points. Please email any electronic files in support of

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

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

Domain decomposition on different levels of the Jacobi-Davidson method

Domain decomposition on different levels of the Jacobi-Davidson method hapter 5 Domain decomposition on different levels of the Jacobi-Davidson method Abstract Most computational work of Jacobi-Davidson [46], an iterative method suitable for computing solutions of large dimensional

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

Chapter 3 Second Order Linear Equations

Chapter 3 Second Order Linear Equations Partial Differential Equations (Math 3303) A Ë@ Õæ Aë áöß @. X. @ 2015-2014 ú GA JË@ É Ë@ Chapter 3 Second Order Linear Equations Second-order partial differential equations for an known function u(x,

More information

Notes on PCG for Sparse Linear Systems

Notes on PCG for Sparse Linear Systems Notes on PCG for Sparse Linear Systems Luca Bergamaschi Department of Civil Environmental and Architectural Engineering University of Padova e-mail luca.bergamaschi@unipd.it webpage www.dmsa.unipd.it/

More information

Numerical Methods for Engineers and Scientists

Numerical Methods for Engineers and Scientists Numerical Methods for Engineers and Scientists Second Edition Revised and Expanded Joe D. Hoffman Department of Mechanical Engineering Purdue University West Lafayette, Indiana m MARCEL D E К К E R MARCEL

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Problems 1. Numerical Differentiation. Find the best approximation to the second drivative d 2 f(x)/dx 2 at x = x you can of a function f(x) using (a) the Taylor series approach

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

2.2. Methods for Obtaining FD Expressions. There are several methods, and we will look at a few:

2.2. Methods for Obtaining FD Expressions. There are several methods, and we will look at a few: .. Methods for Obtaining FD Expressions There are several methods, and we will look at a few: ) Taylor series expansion the most common, but purely mathematical. ) Polynomial fitting or interpolation the

More information

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 3: Preconditioning 2 Eric de Sturler Preconditioning The general idea behind preconditioning is that convergence of some method for the linear system Ax = b can be

More information

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations Numerical Analysis of Differential Equations 215 6 Numerical Solution of Parabolic Equations 6 Numerical Solution of Parabolic Equations TU Bergakademie Freiberg, SS 2012 Numerical Analysis of Differential

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Introduction to PDEs and Numerical Methods: Exam 1

Introduction to PDEs and Numerical Methods: Exam 1 Prof Dr Thomas Sonar, Institute of Analysis Winter Semester 2003/4 17122003 Introduction to PDEs and Numerical Methods: Exam 1 To obtain full points explain your solutions thoroughly and self-consistently

More information

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems.

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems. Review Outline To review for the final, look over the following outline and look at problems from the book and on the old exam s and exam reviews to find problems about each of the following topics.. Basics

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13 REVIEW Lecture 12: Spring 2015 Lecture 13 Grid-Refinement and Error estimation Estimation of the order of convergence and of the discretization error Richardson s extrapolation and Iterative improvements

More information

Applied Numerical Analysis

Applied Numerical Analysis Applied Numerical Analysis Using MATLAB Second Edition Laurene V. Fausett Texas A&M University-Commerce PEARSON Prentice Hall Upper Saddle River, NJ 07458 Contents Preface xi 1 Foundations 1 1.1 Introductory

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Finite Difference and Finite Element Methods

Finite Difference and Finite Element Methods Finite Difference and Finite Element Methods Georgy Gimel farb COMPSCI 369 Computational Science 1 / 39 1 Finite Differences Difference Equations 3 Finite Difference Methods: Euler FDMs 4 Finite Element

More information

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC Lecture 17 Copyright by Hongyun Wang, UCSC Recap: Solving linear system A x = b Suppose we are given the decomposition, A = L U. We solve (LU) x = b in 2 steps: *) Solve L y = b using the forward substitution

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

Iterative Solvers. Lab 6. Iterative Methods

Iterative Solvers. Lab 6. Iterative Methods Lab 6 Iterative Solvers Lab Objective: Many real-world problems of the form Ax = b have tens of thousands of parameters Solving such systems with Gaussian elimination or matrix factorizations could require

More information

Spectral Processing. Misha Kazhdan

Spectral Processing. Misha Kazhdan Spectral Processing Misha Kazhdan [Taubin, 1995] A Signal Processing Approach to Fair Surface Design [Desbrun, et al., 1999] Implicit Fairing of Arbitrary Meshes [Vallet and Levy, 2008] Spectral Geometry

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

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

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

More information

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A.

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A. AMSC/CMSC 661 Scientific Computing II Spring 2005 Solution of Sparse Linear Systems Part 2: Iterative methods Dianne P. O Leary c 2005 Solving Sparse Linear Systems: Iterative methods The plan: Iterative

More information

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

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

More information

Some notes about PDEs. -Bill Green Nov. 2015

Some notes about PDEs. -Bill Green Nov. 2015 Some notes about PDEs -Bill Green Nov. 2015 Partial differential equations (PDEs) are all BVPs, with the same issues about specifying boundary conditions etc. Because they are multi-dimensional, they can

More information

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 1 SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 2 OUTLINE Sparse matrix storage format Basic factorization

More information

Linear Systems of Equations. ChEn 2450

Linear Systems of Equations. ChEn 2450 Linear Systems of Equations ChEn 450 LinearSystems-directkey - August 5, 04 Example Circuit analysis (also used in heat transfer) + v _ R R4 I I I3 R R5 R3 Kirchoff s Laws give the following equations

More information

1 Extrapolation: A Hint of Things to Come

1 Extrapolation: A Hint of Things to Come Notes for 2017-03-24 1 Extrapolation: A Hint of Things to Come Stationary iterations are simple. Methods like Jacobi or Gauss-Seidel are easy to program, and it s (relatively) easy to analyze their convergence.

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

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

More information

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations.

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations. An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations by Tong Chen A thesis submitted in conformity with the requirements

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

Finite Differences: Consistency, Stability and Convergence

Finite Differences: Consistency, Stability and Convergence Finite Differences: Consistency, Stability and Convergence Varun Shankar March, 06 Introduction Now that we have tackled our first space-time PDE, we will take a quick detour from presenting new FD methods,

More information