CLASSROOM NOTES PART II: SPECIAL TOPICS. APM526, Spring 2018 Last update: Apr 11

Size: px
Start display at page:

Download "CLASSROOM NOTES PART II: SPECIAL TOPICS. APM526, Spring 2018 Last update: Apr 11"

Transcription

1 CLASSROOM NOTES PART II: SPECIAL TOPICS APM526, Spring 2018 Last update: Apr 11 1

2 Function Space Methods General Setting: Projection into finite dimensional subspaces t u = F (u), u(t = 0) = u I, F : B 0 ( B 1 ) B 1, P N : Projection into an N dimensional subspace B N of B 1. Obtain a finite dimensional evolution equation (= an ODE system). P N : B 1 B N ( B 1 ), B N = span{φ 1,.., φ N } u u N B N, t u N = P N F (u N ), u N (t = 0) = P N u I 2

3 Readings: D. Gottlieb, S. Orszag: Numerical analysis of spectral methods, CBMS-NSF, Conference series, SIAM (1981). B. Fornberg: A practical guide to pseudo - spectral methods, Cambridge Monographs on Appl. Math., Cambridge University Press (1996). Canuto, Quarteroni, Hussaini, Zhang: Spectral methods and applications, Springer (1996). 3

4 The Galerkin projector: B 1 Hilbert space: Scalar product in B 1 u, v {φ n } orthonormal system (ONS): φ n, φ m = δ nm u P N u = min{ u v : v B N }, u := u, u Implies: u P N u B N {φ n } ONS P N u = Expansion into general ONS: t u = F (u), u N = N n=1 a n (t)φ n n φ m, φ n t a n =< φ m, F ( n N n=1 c n φ n, c n = φ n, u a n φ n ) >, m = 1 : N M mn = φ m, φ n : mass matrix, ONS: < φ m, φ n >= δ mn Example: The viscous Burger equation. 4

5 A sketch of convergence theory: Difference schemes: Stability + Consistency Convergence. SM: Stability + Approximation Convergence. t u = Lu, u(t = 0) = u I, t u N = P N L(u N ), u N (x, t = 0) = P N u I The global error: e = u N u The local error: z = P N u u (interpolated exact solution). Split: e = y + z, y = u N P N u Stability: t y = P L(u N u) = P Ly + P Lz, y(0) = 0 t y = P Ly + f, y, f B N y K f e K P Lz K P L P N u u Approximation: P N u u = α(n) e = O(α(N)) 5

6 The approximation error for Fourier series: u(x) = n Remainder: û(n)e inx û(n) = 1 2π û(n) = 1 1 2π ( in) p n >N e inx p xu(x) dx û(n)e inx = O(N 1 p ) p xu L 1 implies α(n) = O(N 1 p ) u(x)e inx dx 6

7 The interpolation projector - Collocation and Pseudo - spectral methods Problem: Cannot evaluate φ n, F (u N ) with Galerkin for general F. Example: t u = xu 2 e u, f, g = φ n, F (u) = π π f g dx, e inx m ( m 2 a m e imx ) dx φ n = e inx e inx exp[ m a m e imx ] dx Interpolation projector: Choose points x 1,.., x N ( collocation points, nodes, etc.) P N u = N n=1 a n φ n, P N u(x j ) = u(x j ), j = 1,.., N 7

8 (N ODEs in N unknowns for the a n ). t u N = P N F (u N ), t u N (x j ) = P N F (u N )(x j ) = F (u N )(x j ), j = 1,.., N N m=1 t a m e imx j = m ( m 2 a m e imx j) exp[ m a m e imx j], j = 1,.., N Change of basis and cardinal functions: Parametrize u N not by a n but by its values at x j. Example: t u = 2 xu e u, t u N (x j ) = 2 xu N (x j ) e u N(x j ), t u j = n u n 2 xψ n (x j ) e u j Re - write the interpolation operator as a Galerkin projector f, g = N n=1 w n f(x n )g(x n ) 8

9 Cardinal functions: ψ m (x) B N, ψ m (x j ) = δ mj, ψ m (x) = N n=1 φ n (x) ˆΨ(n, m) u N (x) = m u m ψ m (x) = n a n φ n (x) u N (x j ) = u j t u j = F (u N )(x j ) The differentiation matrix: Write collocation scheme as difference scheme with full stencil. t u j = n D 2 (j, n)u n e u j, D 2 (j, n) := 2 xψ n (x j ) 9

10 In general: 1. Choose basis functions φ n 2. Compute cardinal functions ψ n ψ n (x) = N m=1 φ m (x)ψ(m, n), ψ n (x j ) = δ nj 3. Compute differentiation matrices D 1 (j, n) = x ψ n (x j ), D 2 (j, n) = 2 xψ n (x j ), Replace derivatives k x by the matrices D k. 10

11 Choices: 1. How to choose finite dimensional subspace B N (the φ n ). 2. How to choose projection (Galerkin or interpolation). 3. How to choose collocation nodes x j, j = 1,.., N. 11

12 Choose x n as Gaussian integration nodes with a certain weight function in [a, b]: b a ω(x)p(x) dx = N n=1 w n p(x n ), p P 2N 1 Gaussian integration: Choose x n as the zeros of the N th orthogonal polynomial p N P N 1, p N (x n ) = 0, n = 1 : N 12

13 SUMMARY: Spectral methods and Galerkin: α(n) higher than polynomial in N. Example: Fourier series. Spectral methods and Collocation: Nodes x j have to be chosen such that interpolation converges for N. How to choose the collocation nodes:, weighted scalar product f, g = w(x)f (x)g(x) dx Gaussian integration rule: N j=0 ω j φ m (x j ) φ n (x j ) = δ mn, n, m = 0,.., N 13

14 Orthogonal polynomials: 1. Finite interval [a, b] = [ 1, 1]: (1a) ω = 1, Legendre polynomials (1b) ω = 1, Chebyshev polynomials 1 x 2 2. Infinite intervals (2a) [a, b] = R, ω = e x2 /2, Hermite polynomials (2b)[a, b] = [0, ), ω = e x, Laguerre polynomials 14

15 3. On a sphere: Spherical Harmonics x = r(y, 1 y 2 cos α, 1 y 2 sin α), y [ 1, 1], α [ π, π] S mn (x) = L mn (y)(1 y 2 ) n/2 e inα L mn : associated Legendre polynomials Remark: Spectral methods yield full matrices fast transform methods. 15

16 Fast Fourier Transform (FFT): Discrete Fourier Transform: u(n x) = ξ N 1 2π ν= N û(ν ξ) = x N 1 2π n= N û(ν ξ)e inν x ξ u(n x)e inν x ξ for N x ξ = π The differentiation matrix for a Fourier pseudo spectral method: (D k u)(n x) = ξ N 1 2π ν= N (iν ξ) k û(ν ξ)e inν x ξ 16

17 gives in matrix form D k = ΩΛΩ 1 Ω(n, ν) = ξ 2π e inν x ξ, Λ = [diag(iν ξ) k ] direct evaluation of D k : the product Du needs O(N 2 operations. the products Ωu, Ω 1 û can be done in O(N log 2 N) operations, using FFT! Λ diagonal N operations. 17

18 The FFT concept: How to compute the terms y(n) = renumber x: M = JK M 1 m=0 x(m) exp[inm 2π M ] x(j + Jk) = z(j, k), j = 0 : J 1, k = 0 : K 1 y n = J 1 j=0 exp[inj 2π K 1 JK ] k=0 z(j, k) exp[ink 2π K ] 18

19 compute: v(n, j) = K 1 k=0 z(j, k) exp[ink 2π ], n = 0 : K 1, j = 0 : J 1 K Periodicity: v(n + K, j) = v(n, j)!!! and y(n) = J 1 j=0 exp[inj 2π ]v(n, j), n = 0 : JK 1 JK total: M(J + K) operations instead of MJK operations! Recursion: set K = LS and z(j, k) = z 1 (j, l, s) v(n, j) = K 1 k=0 z(j, k) exp[ink 2π ], n = 0 : K 1, j = 0 : J 1 K perform this step in JK(L + S) instead of JK 2 operations! 19

20 RIEMANN SOLVERS (GENERAL IDEA) t u(x, t) + x f(u, x, t) = 0 Assume u(x, t) piecewise constant. cell n. u(x, t) = u n (t)forx Solve t u(x, t) + x f(u, x, t) = 0 exactly, computing ũ(x, t + t). Compute u(x, t + t), piecewise constant on the cells, by averaging ũ(x, t + t). 20

21 THE METHOD OF CHARACTERISTICS (semilinear) Consider the hyperbolic equation t u + a(x) x u = b(x, u), Consider the ODE system d dtξ(y, t) = a(ξ), ξ(y, 0) = y d dt w(y, t) = b(ξ, w), w(y, 0) = ui (y) this implies u(ξ(y, t), t) = w(y, t) for all y u(x, 0) = u I (x) To compute the solution at (x, t), this process has to be inverted. Find the general solution of d dt ξ(y, t) = a(ξ), ξ(y, 0) = y d dt w(y, t) = b(ξ, w), w(y, 0) = ui (y) For a given x, t find y such that ξ(y, t) = x. Set u(x, t) = w(y, t) 21

22 THE METHOD OF CHARACTERISTICS (nonlinear) Consider the hyperbolic equation t u + a(x, u) x u = b(x, u), Consider the ODE system d dtξ(y, t) = a(ξ, w), ξ(y, 0) = y d dt w(y, t) = b(ξ, w), w(y, 0) = ui (y) this implies u(ξ(y, t), t) = w(y, t) for all y u(x, 0) = u I (x) To compute the solution at (x, t), this process has to be inverted. Find the general solution of d dt ξ(y, t) = a(ξ, w), ξ(y, 0) = y d dt w(y, t) = b(ξ, w), w(y, 0) = ui (y) For a given x, t find y such that ξ(y, t) = x. Set u(x, t) = w(y, t) 22

23 d dt ξ(y, t) = a(ξ, w), ξ(y, 0) = y d dt w(y, t) = b(ξ, w), w(y, 0) = ui (y) Example: Burger s equation (nonlinear autonomous) t u + x ( 1 2 u2 ) = 0, a(x, u) = u, b(x, u) = 0 yields multiple solutions (dependent on the form of u I (x))! In the nonlinear case characteristics can intersect Discontinuities (shocks) develop. 23

24 THE CONCEPT OF WEAK SOLUTIONS t u + x f(u) = 0, u(x, 0) = u I (x) (1) u discontinuous need to re- define derivatives ψ sufficiently smooth test function, ψ C 0 Definition: u is a weak solution of (1) iff 0 dt dx [u t ψ + f(u) x ψ] = dx [ψ(x, 0)u I (x)] ψ Remark: u differentiable u classical solution. Example: t u + x [H(x)u + 1 H( x)u] = 0, 2 u(x, 0) = ui (x) 24

25 THE RANKINE - HUGONIOT CONDITION THE HUGONIOT LOCUS Relates shockheight to shockspeed if there is a shock. t u + x f(u) = 0, Assume: 1. u differentiable away from the shock curve x = γ(t). 2. u is a weak solution. Implies: γ (t)(u + u )(γ(t), t) = (f + f )(γ(t), t) Riemann problem: t u + x f(u) = 0, ( u for x < 0, u(x, 0) = u + for x > 0, ), u > u + 25

26 RAREFACTION WAVES AND THE BARENBLATT SOLU- TION Riemann problem: t u + x f(u) = 0, ( ) u for x < 0, u(x, 0) =, u u + for x > 0, < u + Characteristics do not cover the x, t domain! t u + x f(u) = 0, set u(x, t) = g( x t ) f (g(z)) = z u(x, t) = (f ) 1 ( x t ) gives continuous solution! For this to work f has to be convex! Example (Burger): f(u) = 1 2 u2 26

27 GODUNOV S METHOD Scalar problems: Equation for averages: t u + x f(u) = 0 U n j = 1 x xj+1 x j u(x, t n )dx, F n j = 1 t tn+1 t n f(u(x j, t))dt. U n+1 j U n j + t x (F n j+1 F n j ) = 0 Numerical approximation: compute F n j from U n j 1, U n j Piecewise constant approximation: Assume u(x, t n ) = Uj n for x j < x < x j+1. Solve problem with piecewise constant initial data (the Riemann problem) exactly. 27

28 GODUNOV AND THE RIEMANN PROBLEM t u + x f(u) = 0, u(x, 0) = ( UL for ) x < 0 U R for x > 0 For Godunov s method we have to compute F = t 1 from the cell averages U L, U R. t 0 f(u(0, t))dt Characteristics: x = f (u), u = 0 Characteristic slopes given by f (U L ), f (U R ) Five cases: 1-4: Shock curve according to Rankine - Hugoniot: γ = f(u R) f(u L ) U R U L 5: rarefaction wave 28

29 Case 1: f (U R ) > 0, f (U L ) > 0 F = f(u L ) Case 2: f (U R ) < 0, f (U L ) < 0 F = f(u R ) Case 3: f (U R ) < 0 < f (U L ) and γ > 0 F = f(u L ) Case 4: f (U R ) < 0 < f (U L ) and γ < 0 F = f(u R ) Case 5: f (U L ) < 0 < f (U R ): rarefaction wave and the Barenblatt solution. 29

30 GODUNOV S METHOD: γ := f(u n j ) f(u n j 1 ) U n j U n j 1 Case 1: f (U n j ) > 0, f (U n j 1 ) > 0 F n j = f(u n j 1 ) Case 2: f (U n j ) < 0, f (U n j 1 ) < 0 F n j = f(u n j ) Case 3: f (U n j ) < 0 < f (U n j 1 ) and γ > 0 F n j = f(u n j 1 ) Case 4: f (U n j ) < 0 < f (U n j 1 ) and γ < 0 F n j = f(u n j ) Case 5: f (U n j 1 ) < 0 < f (U n j ) F n j = f(u s) with f (u s ) = 0. u s : sonic point 30

31 STABILITY IN W 1 1 THE NORM (THE TVD PROPERTY) u W q p = q xu Lp = ( q xu p dx) 1 p Non-oscillatory schemes: Definition: A scheme is TVD j (T 1)Uj n+1 j (T 1)U n j The linear case: Write scheme solely in terms of derivatives. U n+1 = U n T 1 (A n V n ) + B n V n, Theorem: A, B 0, A + B 1 T V D V n := (T 1)U n Example: Lax-Friedrichs TVD, Lax Wendroff not TVD Problem: TVD methods are maximally second order! 31

32 FLUX LIMITER METHODS U n+1 = U n c(t 1)F n Idea: Lower order method with numerical flux F L. Higher order method with numerical flux F H. Lower order method nonoscillatory. Combine: F = F L + Φ(F H F L ) Smooth part: φ 1; Non-oscillatory otherwise, i.e. total method is TVD. Total method formally only first order but higher order in smooth regions. 32

33 THE FLUX LIMITER Condition 1: (Smooth order) Φ = Φ( (1 T 1 )U (T 1)U ), φ(1) = 1 Condition 2: Choose φ such that total method is TVD. Derive φ for linear case and use in general. 33

34 t u + a x u = 0, a > 0 Example: Upwind and Lax Wendroff U n+1 = U n (T 1)F n upwind (for a > 0): U n+1 = U n a t x (1 T 1 )U n upwind flux F L = νt 1 U = νu νt 1 V with ν = a t x = ac and 0 ν 1 because of the CFL condition. Lax-Wendroff: U n+1 = U n 2 x a t (T T 1 )U n + a2 t 2 2 x 2 (T 2 + T 1 )U n Lax -Wendroff flux F H = ν 2 [(1+T 1 )U ν(1 T 1 )U] = νt 1 U + ν 2 (1 ν)t 1 V 34

35 Flux limiter flux F = F L +(F H F L )φ = νu νt 1 V + φ ν 2 (1 ν)t 1 V, V = (T 1)U (T 1)F = (T φ) ν 2 (1 ν)v + νt 1 V φ ν 2 (1 ν)t 1 V TVD: U n+1 = [U T 1 (AV ) + BV ] n and φ = φ(θ), θ = V T 1 V T φ ν 2 (1 ν)θt 1 V +νt 1 V φ ν 2 (1 ν)t 1 V = T 1 (AV ) BV set B = 0, T 1 A = (T φ) ν 2 (1 ν)θ + ν φν (1 ν), 0 A ν [φ(t θ)(1 ν)θ + 1 φ(θ)(1 ν)] 1, ν [0, 1], θ 2 0 ψ(ν, θ 1, θ 2 ) 2 for all ν [0, 1] and all θ 1, θ 2 ψ(ν, θ 1, θ 2 ) = ν[φ(θ 2 )(1 ν)θ φ(θ 1 )(1 ν)] 35

36 Two standard choices: 1. Superbee: φ(θ) = max{0, min{1, 2θ}, min{θ, 2}} 2. Van Leer: φ(θ) = θ + θ 1 + θ 36

37 SPECIAL TOPICS: t u + x f(u) = 0 LEAPFROG AND THE YI CELL: u n+1 = u n 1 t 2 x (T T 1 )f(u n ) von Neumann stability: plane waves for f(u) = au u(x, t) = exp[iξ(x vt) + rt] T T 1 = e iξ x e iξ x = 2i sin(ξ x), λ 1 λ û n+1 û n 1 = 2iαû n = 2iα, α = a t x λ 2 + 2iα 1 = 0, λ 12 = iα ± sin(ξ x) a tξ 1 α 2, λ 1 iα + (1 α2 2 ), λ 2 iα (1 α2 2 ) 37

38 λ 1 iα + (1 α2 2 ), λ 2 iα (1 α2 2 ) λ 1 real mode, λ 2 spurious mode has to be kept small by the initial conditions! λ 12 2 = ( iα + 1 α 2 )(iα + 1 α 2 ) = 1 for α 1 λ 12 = e r 12 t = 1 r 12 = 0 no damping and no artificial diffusion! 38

39 LEAPFROG FOR THE SECOND ORDER WAVE EQUA- TION t u = a x w, t w = b x u 2 t u = ab 2 xu u n+1 u n = a t x (T 1 2 T 1 2)w n, w n+1 w n = b t x (T 1 2 T 1 2)u n+1, u n+1 2u n + u n 1 = ab t2 x 2(T 1 2 T 1 2) 2 u n plane wave: u(x, t) = e iξ(x vt)+rt, λ = e rt λ 2 2λ+1 = abα 2 λ, α = t x [eiξ x/2 e iξ x/2 ] = 2i t x sin(ξ x/2) λ 2 2λ+1 = 4βλ, 4β = abα 2 = 4ab t2 x 2 sin2 (ξ x/2), 0 β 1 λ 2 2(1 2β)λ+1 = 0, λ 12 = (1 2β)±i Again, no artificial diffusion! 4β(1 β) λ 12 = 1, r = 0 39

40 the Yi cell: t u = A x w, t w = B x u, u, w, x R 3 u n+1 = u n + t x A(T 1 2 T 1 2)w n, w n+1 = w n + t x B(T 1 2 T 1 2)u n+1 Application: Maxwell s equations A x w = curl(w), B x u = curl(u) t u = curl(w), t w = curl(u), u, w, x R 3 u : electric field, w : magnetic field 40

41 BOUNDARY CONDITIONS AND GHOSTPOINTS FOR HYPERBOLIC SYSTEMS t u + x [A(x, t)u] = 0, x 0, Bu(0, t) = u b, u R N, B R K N Necessary condition for well posedness: Relation of B to A: Influx given in terms of outflux! Diagonalization: A(0, t) = EDE 1, D = Important!! dim(d + ) = K K Projections: partition E ( D+ 0 0 D E = (E +, E ), E + : N K, E 1 = ( R+ R ), D + > 0, D 0 ), R + : K N BE + : K K, Necessary: (BE + ) 1 41

42 Ghostpoint: Choose extra gridpoint(s) x. Diagonalize locally and split and use extrapolation. Example: three point stencil, second order method. V = ( V+ V ( ) V+ V U( x) = 2E ) = ( R+ R ( x) = ) U, U = ( E +, E ) ( V + V ( ) 2V b + V + ( x) 2V (0) V ( x) V b + = (BE +) 1 [u b BE V (0)] ( (BE+ ) 1 [u b BE R U(0)] R U(0) ) ) U( x) Use U( x) to compute U(0, t + t) with the difference method. Important: the accuracy of the extrapolation has to be at least as high as the accuracy of the difference method. 42

43 BOUNDARY CONDITIONS AND LAGRANGE MULTIPLI- ERS Concept for constrained ODEs: Mȧ = G(a), a R N constraint (BC) : B T a = b(t), B R N K, b R K (M: mass matrix), define F (a) = M 1 G(a) ȧ = F (a) ȧ = P M 1 G(a) P : projection of ȧ on the manifold M = {u : B T u = ḃ} y T (P u u) = 0, y : B T y = 0 and B T P u = ḃ P u u = Bλ, λ R K and B T P u = ḃ P u = [I B(B T B) 1 B]u + B(B T B) 1 ḃ projected equation: ȧ = [I B(B T B) 1 B T ]F (a) + B(B T B) 1 ḃ B T ȧ = ḃ B T a(t) = b(t) for all time if B T a(0) = b(0) 43

44 Spectral methods: M mn = φ m, φ n, G m = φ m, F ( n a n φ n ), Galerkin: f, g = ωfg dx, Collocation: f, g = j w j f(x j )g(x j ) Example: (Dirichlet BC for x [α, β]) B(n, 1) = φ n (α), B(n, 2) = φ n (β) A special case: collocation points include the end points (x 1 = α, x N = β) reduces to ȧ 1 = t u(x 1 ) = ḃ α, ȧ N = t u(x N ) = ḃ β Lobatto points: Force x 1 = 1, x N = 1 by reducing the degree of the polynomials for which Gauss integration is exact by 2. 44

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2 Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer ringhofer@asu.edu, C2 b 2 2 h2 x u http://math.la.asu.edu/ chris Last update: Jan 24, 2006 1 LITERATURE 1. Numerical Methods for Conservation

More information

FDM for wave equations

FDM for wave equations FDM for wave equations Consider the second order wave equation Some properties Existence & Uniqueness Wave speed finite!!! Dependence region Analytical solution in 1D Finite difference discretization Finite

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 Introduction to Hyperbolic Equations The Hyperbolic Equations n-d 1st Order Linear

More information

Info. No lecture on Thursday in a week (March 17) PSet back tonight

Info. No lecture on Thursday in a week (March 17) PSet back tonight Lecture 0 8.086 Info No lecture on Thursday in a week (March 7) PSet back tonight Nonlinear transport & conservation laws What if transport becomes nonlinear? Remember: Nonlinear transport A first attempt

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

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes Math 660-Lecture 3: Gudonov s method and some theories for FVM schemes 1 The idea of FVM (You can refer to Chapter 4 in the book Finite volume methods for hyperbolic problems ) Consider the box [x 1/,

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Finite Volume Schemes: an introduction

Finite Volume Schemes: an introduction Finite Volume Schemes: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola di dottorato

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

More information

Discontinuous Galerkin methods for fractional diffusion problems

Discontinuous Galerkin methods for fractional diffusion problems Discontinuous Galerkin methods for fractional diffusion problems Bill McLean Kassem Mustapha School of Maths and Stats, University of NSW KFUPM, Dhahran Leipzig, 7 October, 2010 Outline Sub-diffusion Equation

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

Numerical Methods for Hyperbolic Conservation Laws Lecture 4

Numerical Methods for Hyperbolic Conservation Laws Lecture 4 Numerical Methods for Hyperbolic Conservation Laws Lecture 4 Wen Shen Department of Mathematics, Penn State University Email: wxs7@psu.edu Oxford, Spring, 018 Lecture Notes online: http://personal.psu.edu/wxs7/notesnumcons/

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

Partial Differential Equations

Partial Differential Equations Part II Partial Differential Equations Year 2015 2014 2013 2012 2011 2010 2009 2008 2007 2006 2005 2015 Paper 4, Section II 29E Partial Differential Equations 72 (a) Show that the Cauchy problem for u(x,

More information

0.3.4 Burgers Equation and Nonlinear Wave

0.3.4 Burgers Equation and Nonlinear Wave 16 CONTENTS Solution to step (discontinuity) initial condition u(x, 0) = ul if X < 0 u r if X > 0, (80) u(x, t) = u L + (u L u R ) ( 1 1 π X 4νt e Y 2 dy ) (81) 0.3.4 Burgers Equation and Nonlinear Wave

More information

Sung-Ik Sohn and Jun Yong Shin

Sung-Ik Sohn and Jun Yong Shin Commun. Korean Math. Soc. 17 (2002), No. 1, pp. 103 120 A SECOND ORDER UPWIND METHOD FOR LINEAR HYPERBOLIC SYSTEMS Sung-Ik Sohn and Jun Yong Shin Abstract. A second order upwind method for linear hyperbolic

More information

Finite Element methods for hyperbolic systems

Finite Element methods for hyperbolic systems Finite Element methods for hyperbolic systems Eric Sonnendrücker Max-Planck-Institut für Plasmaphysik und Zentrum Mathematik, TU München Lecture notes Wintersemester 14-15 January 19, 15 Contents 1 Introduction

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

Definition and Construction of Entropy Satisfying Multiresolution Analysis (MRA)

Definition and Construction of Entropy Satisfying Multiresolution Analysis (MRA) Utah State University DigitalCommons@USU All Graduate Theses and Dissertations Graduate Studies 6 Definition and Construction of Entropy Satisfying Multiresolution Analysis (MRA Ju Y. Yi Utah State University

More information

The RAMSES code and related techniques I. Hydro solvers

The RAMSES code and related techniques I. Hydro solvers The RAMSES code and related techniques I. Hydro solvers Outline - The Euler equations - Systems of conservation laws - The Riemann problem - The Godunov Method - Riemann solvers - 2D Godunov schemes -

More information

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows:

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows: Topic 7 Fluid Dynamics Lecture The Riemann Problem and Shock Tube Problem A simple one dimensional model of a gas was introduced by G.A. Sod, J. Computational Physics 7, 1 (1978), to test various algorithms

More information

MATH 220: MIDTERM OCTOBER 29, 2015

MATH 220: MIDTERM OCTOBER 29, 2015 MATH 22: MIDTERM OCTOBER 29, 25 This is a closed book, closed notes, no electronic devices exam. There are 5 problems. Solve Problems -3 and one of Problems 4 and 5. Write your solutions to problems and

More information

A Very Brief Introduction to Conservation Laws

A Very Brief Introduction to Conservation Laws A Very Brief Introduction to Wen Shen Department of Mathematics, Penn State University Summer REU Tutorial, May 2013 Summer REU Tutorial, May 2013 1 / The derivation of conservation laws A conservation

More information

AMath 574 February 11, 2011

AMath 574 February 11, 2011 AMath 574 February 11, 2011 Today: Entropy conditions and functions Lax-Wendroff theorem Wednesday February 23: Nonlinear systems Reading: Chapter 13 R.J. LeVeque, University of Washington AMath 574, February

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

The Discontinuous Galerkin Method for Hyperbolic Problems

The Discontinuous Galerkin Method for Hyperbolic Problems Chapter 2 The Discontinuous Galerkin Method for Hyperbolic Problems In this chapter we shall specify the types of problems we consider, introduce most of our notation, and recall some theory on the DG

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

Numerical Schemes Applied to the Burgers and Buckley-Leverett Equations

Numerical Schemes Applied to the Burgers and Buckley-Leverett Equations University of Reading Numerical Schemes Applied to the Burgers and Buckley-Leverett Equations by September 4 Department of Mathematics Submitted to the Department of Mathematics, University of Reading,

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

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS JOHN A. TRANGENSTEIN Department of Mathematics, Duke University Durham, NC 27708-0320 Ш CAMBRIDGE ЩР UNIVERSITY PRESS Contents 1 Introduction

More information

Numerical solution of linear time delay systems using Chebyshev-tau spectral method

Numerical solution of linear time delay systems using Chebyshev-tau spectral method Available at http://pvamu.edu/aam Appl. Appl. Math. ISSN: 93-9466 Applications and Applied Mathematics: An International Journal (AAM) Vol., Issue (June 07), pp. 445 469 Numerical solution of linear time

More information

PARTIAL DIFFERENTIAL EQUATIONS. Lecturer: D.M.A. Stuart MT 2007

PARTIAL DIFFERENTIAL EQUATIONS. Lecturer: D.M.A. Stuart MT 2007 PARTIAL DIFFERENTIAL EQUATIONS Lecturer: D.M.A. Stuart MT 2007 In addition to the sets of lecture notes written by previous lecturers ([1, 2]) the books [4, 7] are very good for the PDE topics in the course.

More information

Spatial Discretization

Spatial Discretization Spatial Discretization Shengtai Li and Hui Li Los Alamos National Laboratory 1 Overview Finite Difference Method Finite Difference for Linear Advection Equation 3 Conservation Laws Modern Finite Difference

More information

30 crete maximum principle, which all imply the bound-preserving property. But most

30 crete maximum principle, which all imply the bound-preserving property. But most 3 4 7 8 9 3 4 7 A HIGH ORDER ACCURATE BOUND-PRESERVING COMPACT FINITE DIFFERENCE SCHEME FOR SCALAR CONVECTION DIFFUSION EQUATIONS HAO LI, SHUSEN XIE, AND XIANGXIONG ZHANG Abstract We show that the classical

More information

Recovery of high order accuracy in radial basis function approximation for discontinuous problems

Recovery of high order accuracy in radial basis function approximation for discontinuous problems Recovery of high order accuracy in radial basis function approximation for discontinuous problems Chris L. Bresten, Sigal Gottlieb 1, Daniel Higgs, Jae-Hun Jung* 2 Abstract Radial basis function(rbf) methods

More information

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws Mehdi Dehghan, Rooholah Jazlanian Department of Applied Mathematics, Faculty of Mathematics and Computer Science, Amirkabir University

More information

APM526 CLASSROOM NOTES PART IB. APM526, Spring 2018 Last update: MAR 12

APM526 CLASSROOM NOTES PART IB. APM526, Spring 2018 Last update: MAR 12 APM526 CLASSROOM NOTES PART IB APM526, Spring 2018 Last update: MAR 12 1 PARTICLE METHODS 1. Particle based methods: Large systems of ODEs for individual particles. 2. Partial differential equations: Equations

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

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

Fourier analysis for discontinuous Galerkin and related methods. Abstract

Fourier analysis for discontinuous Galerkin and related methods. Abstract Fourier analysis for discontinuous Galerkin and related methods Mengping Zhang and Chi-Wang Shu Abstract In this paper we review a series of recent work on using a Fourier analysis technique to study the

More information

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

More information

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Scuola di Dottorato THE WAVE EQUATION Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Lucio Demeio - DIISM wave equation 1 / 44 1 The Vibrating String Equation 2 Second

More information

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients Superconvergence of discontinuous Galerkin methods for -D linear hyperbolic equations with degenerate variable coefficients Waixiang Cao Chi-Wang Shu Zhimin Zhang Abstract In this paper, we study the superconvergence

More information

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

Final Exam May 4, 2016

Final Exam May 4, 2016 1 Math 425 / AMCS 525 Dr. DeTurck Final Exam May 4, 2016 You may use your book and notes on this exam. Show your work in the exam book. Work only the problems that correspond to the section that you prepared.

More information

Partial Differential Equations and the Finite Element Method

Partial Differential Equations and the Finite Element Method Partial Differential Equations and the Finite Element Method Pavel Solin The University of Texas at El Paso Academy of Sciences ofthe Czech Republic iwiley- INTERSCIENCE A JOHN WILEY & SONS, INC, PUBLICATION

More information

An Improved Non-linear Weights for Seventh-Order WENO Scheme

An Improved Non-linear Weights for Seventh-Order WENO Scheme An Improved Non-linear Weights for Seventh-Order WENO Scheme arxiv:6.06755v [math.na] Nov 06 Samala Rathan, G Naga Raju Department of Mathematics, Visvesvaraya National Institute of Technology, Nagpur,

More information

Lecture 4.6: Some special orthogonal functions

Lecture 4.6: Some special orthogonal functions Lecture 4.6: Some special orthogonal functions Matthew Macauley Department of Mathematical Sciences Clemson University http://www.math.clemson.edu/~macaule/ Math 4340, Advanced Engineering Mathematics

More information

A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning

A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning Int. J. Contemp. Math. Sciences, Vol. 2, 2007, no. 22, 1097-1106 A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning M. T. Darvishi a,, S.

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

Construction of very high order Residual Distribution Schemes for steady problems

Construction of very high order Residual Distribution Schemes for steady problems Construction of very high order Residual Distribution Schemes for steady problems Rémi Abgrall, Mario Ricchiuto, Cédric Tavé, Nadège Villedieu and Herman Deconinck Mathématiques Appliquées de Bordeaux,

More information

Solutions: Problem Set 3 Math 201B, Winter 2007

Solutions: Problem Set 3 Math 201B, Winter 2007 Solutions: Problem Set 3 Math 201B, Winter 2007 Problem 1. Prove that an infinite-dimensional Hilbert space is a separable metric space if and only if it has a countable orthonormal basis. Solution. If

More information

A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations

A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations Sashank Srinivasan a, Jonathan Poggie a, Xiangxiong Zhang b, a School of Aeronautics and Astronautics,

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

Generalised Summation-by-Parts Operators and Variable Coefficients

Generalised Summation-by-Parts Operators and Variable Coefficients Institute Computational Mathematics Generalised Summation-by-Parts Operators and Variable Coefficients arxiv:1705.10541v [math.na] 16 Feb 018 Hendrik Ranocha 14th November 017 High-order methods for conservation

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 Modified Equation of a Difference Scheme What is a Modified Equation of a Difference

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

PDEs, part 3: Hyperbolic PDEs

PDEs, part 3: Hyperbolic PDEs PDEs, part 3: Hyperbolic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2011 Hyperbolic equations (Sections 6.4 and 6.5 of Strang). Consider the model problem (the

More information

Biorthogonal Spline Type Wavelets

Biorthogonal Spline Type Wavelets PERGAMON Computers and Mathematics with Applications 0 (00 1 0 www.elsevier.com/locate/camwa Biorthogonal Spline Type Wavelets Tian-Xiao He Department of Mathematics and Computer Science Illinois Wesleyan

More information

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of Conservation Laws Sirui Tan and Chi-Wang Shu 3 Abstract We develop a high order finite difference numerical boundary condition for solving

More information

Finite volume method for conservation laws V

Finite volume method for conservation laws V Finite volume method for conservation laws V Schemes satisfying entropy condition Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore

More information

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow Outline Scalar nonlinear conservation laws Traffic flow Shocks and rarefaction waves Burgers equation Rankine-Hugoniot conditions Importance of conservation form Weak solutions Reading: Chapter, 2 R.J.

More information

Chapter 4: Interpolation and Approximation. October 28, 2005

Chapter 4: Interpolation and Approximation. October 28, 2005 Chapter 4: Interpolation and Approximation October 28, 2005 Outline 1 2.4 Linear Interpolation 2 4.1 Lagrange Interpolation 3 4.2 Newton Interpolation and Divided Differences 4 4.3 Interpolation Error

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

Numerical resolution of discontinuous Galerkin methods for time dependent. wave equations 1. Abstract

Numerical resolution of discontinuous Galerkin methods for time dependent. wave equations 1. Abstract Numerical resolution of discontinuous Galerkin methods for time dependent wave equations Xinghui Zhong 2 and Chi-Wang Shu Abstract The discontinuous Galerkin DG method is known to provide good wave resolution

More information

Lecture Notes on PDEs

Lecture Notes on PDEs Lecture Notes on PDEs Alberto Bressan February 26, 2012 1 Elliptic equations Let IR n be a bounded open set Given measurable functions a ij, b i, c : IR, consider the linear, second order differential

More information

TD 1: Hilbert Spaces and Applications

TD 1: Hilbert Spaces and Applications Université Paris-Dauphine Functional Analysis and PDEs Master MMD-MA 2017/2018 Generalities TD 1: Hilbert Spaces and Applications Exercise 1 (Generalized Parallelogram law). Let (H,, ) be a Hilbert space.

More information

Math 46, Applied Math (Spring 2009): Final

Math 46, Applied Math (Spring 2009): Final Math 46, Applied Math (Spring 2009): Final 3 hours, 80 points total, 9 questions worth varying numbers of points 1. [8 points] Find an approximate solution to the following initial-value problem which

More information

MATH 220: Problem Set 3 Solutions

MATH 220: Problem Set 3 Solutions MATH 220: Problem Set 3 Solutions Problem 1. Let ψ C() be given by: 0, x < 1, 1 + x, 1 < x < 0, ψ(x) = 1 x, 0 < x < 1, 0, x > 1, so that it verifies ψ 0, ψ(x) = 0 if x 1 and ψ(x)dx = 1. Consider (ψ j )

More information

Notes on Numerical Analysis

Notes on Numerical Analysis Notes on Numerical Analysis Alejandro Cantarero This set of notes covers topics that most commonly show up on the Numerical Analysis qualifying exam in the Mathematics department at UCLA. Each section

More information

An Empirical Chaos Expansion Method for Uncertainty Quantification

An Empirical Chaos Expansion Method for Uncertainty Quantification An Empirical Chaos Expansion Method for Uncertainty Quantification Melvin Leok and Gautam Wilkins Abstract. Uncertainty quantification seeks to provide a quantitative means to understand complex systems

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

multiply both sides of eq. by a and projection overlap

multiply both sides of eq. by a and projection overlap Fourier Series n x n x f xa ancos bncos n n periodic with period x consider n, sin x x x March. 3, 7 Any function with period can be represented with a Fourier series Examples (sawtooth) (square wave)

More information

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows.

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows. A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows Tao Xiong Jing-ei Qiu Zhengfu Xu 3 Abstract In Xu [] a class of

More information

YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG

YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG Abstract. The central scheme of

More information

Math Partial Differential Equations 1

Math Partial Differential Equations 1 Math 9 - Partial Differential Equations Homework 5 and Answers. The one-dimensional shallow water equations are h t + (hv) x, v t + ( v + h) x, or equivalently for classical solutions, h t + (hv) x, (hv)

More information

Notes on Computational Mathematics

Notes on Computational Mathematics Notes on Computational Mathematics James Brunner August 19, 2013 This document is a summary of the notes from UW-Madison s Math 714, fall 2012 (taught by Prof. Shi Jin) and Math 715, spring 2013 (taught

More information

Weighted ENO Schemes

Weighted ENO Schemes Xiaolei Chen Advisor: Prof. Xiaolin Li Department of Applied Mathematics and Statistics Stony Brook University, The State University of New York February 7, 014 1 3 Mapped WENO-Z Scheme 1D Scalar Hyperbolic

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

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

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Jianxian Qiu School of Mathematical Science Xiamen University jxqiu@xmu.edu.cn http://ccam.xmu.edu.cn/teacher/jxqiu

More information

AN OPTIMALLY ACCURATE SPECTRAL VOLUME FORMULATION WITH SYMMETRY PRESERVATION

AN OPTIMALLY ACCURATE SPECTRAL VOLUME FORMULATION WITH SYMMETRY PRESERVATION AN OPTIMALLY ACCURATE SPECTRAL VOLUME FORMULATION WITH SYMMETRY PRESERVATION Fareed Hussain Mangi*, Umair Ali Khan**, Intesab Hussain Sadhayo**, Rameez Akbar Talani***, Asif Ali Memon* ABSTRACT High order

More information

Second Order Elliptic PDE

Second Order Elliptic PDE Second Order Elliptic PDE T. Muthukumar tmk@iitk.ac.in December 16, 2014 Contents 1 A Quick Introduction to PDE 1 2 Classification of Second Order PDE 3 3 Linear Second Order Elliptic Operators 4 4 Periodic

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

Numerical methods for a fractional diffusion/anti-diffusion equation

Numerical methods for a fractional diffusion/anti-diffusion equation Numerical methods for a fractional diffusion/anti-diffusion equation Afaf Bouharguane Institut de Mathématiques de Bordeaux (IMB), Université Bordeaux 1, France Berlin, November 2012 Afaf Bouharguane Numerical

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

Second Order Positive Schemes by means of Flux Limiters for the Advection Equation

Second Order Positive Schemes by means of Flux Limiters for the Advection Equation Second Order Positive Schemes by means of Flux Limiters for the Advection Equation Riccardo Fazio and Alessandra Jannelli Abstract In this paper, we study first and second order positive numerical methods

More information

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes Root finding: 1 a The points {x n+1, }, {x n, f n }, {x n 1, f n 1 } should be co-linear Say they lie on the line x + y = This gives the relations x n+1 + = x n +f n = x n 1 +f n 1 = Eliminating α and

More information

A fast and well-conditioned spectral method: The US method

A fast and well-conditioned spectral method: The US method A fast and well-conditioned spectral method: The US method Alex Townsend University of Oxford Leslie Fox Prize, 24th of June 23 Partially based on: S. Olver & T., A fast and well-conditioned spectral method,

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

Numerical Methods for Two Point Boundary Value Problems

Numerical Methods for Two Point Boundary Value Problems Numerical Methods for Two Point Boundary Value Problems Graeme Fairweather and Ian Gladwell 1 Finite Difference Methods 1.1 Introduction Consider the second order linear two point boundary value problem

More information

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Diploma Thesis Institute for Numerical Simulation, TUHH On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Corrected version Katja Baumbach August 17, 2006 Supervisor: Prof. Dr.

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Positivity-preserving high order schemes for convection dominated equations

Positivity-preserving high order schemes for convection dominated equations Positivity-preserving high order schemes for convection dominated equations Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Xiangxiong Zhang; Yinhua Xia; Yulong Xing; Cheng

More information