A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations

Size: px
Start display at page:

Download "A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations"

Transcription

1 Motivation Numerical methods Numerical tests Conclusions A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Xiaofeng Cai Department of Mathematics University of Houston Joint work with Wei Guo (Michigan State University) and Jingmei Qiu (University of Houston) IMAGe 2017 Theme of the Year Workshop on Multiscale Geoscience Numerics 1 / 32

2 Motivation Numerical methods Numerical tests Conclusions Outline 1 Motivation The transport equation 2 Numerical methods A new SLDG formulation for 1D transport problems A nonsplitting SLDG formulation for 2D transport problems 3 Numerical tests 2D linear problem The rotational problem The swirling deformation problem 4 Conclusions 2 / 32

3 Motivation Numerical methods Numerical tests Conclusions The transport equation Transport equation We are concerned with the transport equation u + (au) = 0, t where a is the advection coefficient and could depend on space and time. 3 / 32

4 Motivation Numerical methods Numerical tests Conclusions The transport equation Existing numerical methods Lagrangian approach Tracking macro-particle trajectories, e.g., Particle-in-cell (PIC). No CFL restriction. inherent numerical noise O(1/ N). Eulerian approach Grid-based scheme. Arbitrary order of accuracy in both space and time. CFL restriction for stability with explicit time-stepping method. e.g. The RKDG scheme suffers the stringent CFL stability restriction 1, where k is the degree of polynomials. 2k+1 Semi-Lagrangian (SL) approach Combination of Eulerian approach and Lagrangian approach. Grid-based scheme. Numerical solution is updated by following the characteristics. Allowing for a very large CFL number. 4 / 32

5 Motivation Numerical methods Numerical tests Conclusions The transport equation High order SLDG methods SLDG method: low numerical dissipation; compactness; flexibility for boundary and parallel implementation; superconvergence. could take about 10 to 25+ times the time stepping size of RKDG with accuracy and stability, leading to gain in efficiency. mass conservation can be preserved. A history of SLDG: Qiu-Shu, Rossmanith-Seal (JCP, 2011): 1D SLDG schemes. Guo-Nair-Qiu (MWR, 2014): SLDG scheme on cubed-sphere. Dimensional splitting error of 1D SLDG schemes. 5 / 32

6 Motivation Numerical methods Numerical tests Conclusions The transport equation High order SLDG methods (CONT.) Desired properties of mutli-dimensional SLDG: 1 no dimensional splitting error 2 third order accuracy 3 mass conservation 4 large time stepping size 5 oscillations free 6 positivity preservation 6 / 32

7 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti One-dimensional SLDG Consider a one-dimensional linear transport problem u t + (a(x, t)u) = 0 x with appropriate initial and boundary conditions. The solution and test function space of DG is {v h : v h Ij P k (I j ), the set of polynomials of degree at most k}, where j = 1,, N x. 7 / 32

8 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Weak formulation of characteristic Galerkin method We consider an adjoint problem for the test function ψ(x, t): ( ψt + a(x, t)ψ x = 0, ψ(t = t n+1 ) = Ψ(x). Let Ij e (t) is a dynamic interval bounded by characteristics emanating from cell boundaries of I j at t = t n+1, and then it can be shown that Z d u(x, t)ψ(x, t)dx = 0. dt ei j (t) Z I j u n+1 Ψdx = Z I j u(x, t n )ψ(x, t n )dx. Guo, Nair and Qiu, MWR, / 32

9 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Evaluation of R I j u(x, tn )ψ(x, t n )dx: Guo, Nair and Qiu. 1 collect the intervals and sub-intervals denoted dx(t) dt x j 1 2 = a(x(t), t) x j 1 2 x j+ 1 2 I j,1 I j,2 x j,1,ig x j,1,ig x j+ 1 2 t n+1 t n by I j,l. 2 Locate (k + 1) Gauss-Legendre-Lobatto (GLL) points (red circles) over I j,l denoted as x j,l,ig. 3 Trace characteristics forward in time from x j,l,ig to x j,l,ig (green circles). 4 R I j P l u(x, t n )ψ(x, t n )dx = Š Pig ω igu(x j,l,ig, tn )Ψ(x j,l,ig )l(i j,l ) Recently, there is a 2D extension of the this scheme by (D. Lee, R. Lowrie, M. Petersen, T. Ringler, M. Hecht, JCP, 2016) 9 / 32

10 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Evaluation of R I j u(x, tn )ψ(x, t n )dx: New formualtion 1 locate the boundary points of the upstream x j,p x j 1 2 x j+ 1 2 cell, x j± 1 ; and collect all the overlapping 2 intervals or sub-intervals as Ij,l t n+1 2 Choose (k + 1) interpolation points x j,q, such as the GLL points over I j. x j 1 2 Z I j 3 Locate the feet x x j,q by tracking the j+ 1 2 t n characteristics backward from t n+1 to t n, (x j,p, Ψ(x j,p)) ψ and we have ψ(x j,q (x), tn ) = Ψ(x j,q ). 4 (x j,p interpolate, Ψ(x j,p)) ψ (x). u(x, t n )ψ(x, t n )dx = X l Z I j,l u(x, t n )ψ (x, t n )dx 10 / 32

11 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Two-dimensional SLDG Consider a two-dimensional linear transport problem u t + x (a(x, y, t)u) + (b(x, y, t)u) = 0 y with appropriate initial and boundary conditions. The solution space and test function space of DG is {v h : v h Aj P k (A j ), the set of polynomials of degree at most k}, where j = 1,, N x N y is the Cartesian grid. 11 / 32

12 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Weak formulation of characteristic Galerkin method We consider an adjoint problem for the test function ψ(x, y, t): ( ψt + a(x, y, t)ψ x + b(x, y, t)ψ y = 0, ψ(t = t n+1 ) = Ψ(x, y). Let Aj Ü (t) be the dynamic element bounded by characteristics emanating from cell edges of A j, then it can be shown that ψ P k (A j ), Z d u(x, y, t)ψ(x, y, t)dxdy = 0. dt ea j (t) Z A j u(x, y, t n+1 )Ψ(x, y)dxdy = Guo, Nair and Qiu, MWR, Z A j u(x, y, t n )ψ(x, y, t n )dxdy. 12 / 32

13 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Evaluation of R A j u(x, y, tn )ψ(x, y, t n )dxdy v 4 A l A j A j A l A j,l v 4 A j Characteristics tracing: Locate four vertices of upstream cell A j : v 1, v 2, v 3 and v 4 by solving the characteristics equations, 8 >< >: dx(t) dt dy(t) dt = a(x(t), y(t), t), = b(x(t), y(t), t), x(t n+1 ) = x(v q ), y(t n+1 ) = y(v q ), starting from the four vertices of A j : v 1, v 2, v 3 and v / 32

14 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Evaluation of R A j u(x, y, tn )ψ(x, y, t n )dxdy v 4 A j Two observations: 1 ψ(x, y, t n ) may not be a polynomial. v 4 A l A j 2 u(x, y, t n ) is a piecewise polynomial function on background cells. Strategies: We can reconstruct ψ (x, y) approximating ψ(x, y, t n ) on A j by a least square strategy, based on A l A j A j,l ψ(x(v q ), y(v q ), t n ) = Ψ(x(v q ), y(v q )), q = 1, 2, 3, 4. Evaluation of the integrand over the upstream cell has to be done subregion-by-subregion. 14 / 32

15 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti v 4 A l A j A l A j A j,l v 4 A j Subregions can be of irregular shape. It is difficult to obtain the integral on a subregion. = Z Z = X l = X l A j u(x, y, t n+1 )Ψ(x, y)dxdy A j u(x, y, t n )ψ(x, y, t n )dxdy Z I A j,l A j,l u(x, y, t n )ψ(x, y, t n )dxdy P dx + Qdy with P x = uψ, due to the Green theorem. a y + Q a CSLAM: Lauritzen, Nair, and Ullrich, JCP, / 32

16 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti L q s 2 s 3 s 4 c 1 S q s1 Figure: Search algorithm for outer (left, L q) and inner (right, S q) segments. X I l A j,l P dx + Qdy = 2 X 4 No q=1 Z X Z N i + L q q=1 S q 3 5 [P dx + Qdy]. 16 / 32

17 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Implementation procedure 1 Characteristics tracing (High order Runge-Kutta method) for four vertices of upstream cell A j : v 1, v 2, v 3 and v 4 and connect the four vertices as a quadrilateral approximation to the upstream cell. 2 Least square approximation of test function ψ(x, y, t n ) on upstream cells. 3 Search algorithm of line segments as edges of sub-regions. 4 Line integral evaluations (Gaussian quadrature) along outer segments along upstream cell edges and inner segments along background cells edges. 17 / 32

18 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Third order P 2 SLDG scheme v 7 A j η v 7 A l A A j j,l v 1 v 2 v 3 ξ Figure: Schematic illustration of the P 2 SLDG formulation in two dimension. Right: An upstream edge approximated by constructing a quadratic through three points, v 1, v 2, v / 32

19 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Quadratic curved edge: Construction η Construct a coordinate transformation x y to ξ η such that the coordinates of v 1 and v 3 are ( 1, 0) and (1, 0) in ξ η space, respectively. x = x 3 x 1 2 ξ + y3 y1 2 + x1+x3 2, y = y3 y1 2 ξ x3 x1 2 + y1+y3 2 v 1 v 2 v 3 ξ Get the ξ η coordinate for the point v 2 as (ξ 2, η 2 ). Based on ( 1, 0), (ξ 2, η 2 ) and (1, 0), we construct the parabola: η = η 2 ξ 2 2 1(ξ2 1). 19 / 32

20 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Quadratic curved edge: Line integral evaluation P Ni R q=1 S q [P dx + Qdy] is evaluated in the same way as P 1 case. P No R q=1 L q [P dx + Qdy] is evaluated by the following parameterization on each edge. x(ξ) = x 3 x 1 ξ + y 3 y 1 η ξ (ξ2 1) + x 3+x 1, 2 y(ξ) = y 3 y 1 ξ x 3 x 1 η ξ (ξ2 1) + y 3+y 1. 2 Hence, Z L q [P dx+qdy] = Z ξ (q+1) ξ (q) [P (x(ξ, η), y(ξ, η))x (ξ)+q((ξ, η), y(ξ, η))y (ξ)]dξ, where (ξ (q), η (q) ) and (ξ (q+1), η (q+1) ) are the starting point and the end point of L q in ξ η coordinate, respectively. 20 / 32

21 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Implementation procedure 1 Characteristics tracing for nine vertices of upstream cell A j. 2 Least square approximation of test function ψ(x, y, t n ) on upstream cells. 3 Construction of quadratic curves in approximating edges of upstream cells. 4 Search algorithm of line segments as edges of sub-regions. 5 Line integral evaluations along outer segments along upstream cell edges and inner segments along background Cartesian grids. 21 / 32

22 Motivation Numerical methods Numerical tests Conclusions A new SLDG formulation for 1D transport problems A nonsplitti Properties of SLDG Mass conservation: mass conservation is guaranteed due to the weak formulation and the CSLAM idea. Accuracy: high order accurate in the DG framework. Efficiency: allowing for large time step evolution by characteristics tracing mechanism. Controlling oscillations: a WENO limiter by Zhong and Shu (2013). Positivity preserving: positivity limiter by Zhang and Shu (2011). The numerical solution u(x, y, t n ) in cell A j is modified by eu(x, y) eu(x, y) = θ(u(x, t, t n ) u) + u, θ = min u m u ª, 1 where u is the cell average of the numerical solution and m is the minimum value of u(x, y, t n ) over A j., 22 / 32

23 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma 2D linear problem: u t + u x + u y = 0 Table: Errors of SLDG solutions. u(x, y, 0) = sin(x + y) at T = π. mesh L 2 error Order L 2 error Order P 1 SLDG CF L = 1 CF L = E E E E E E E E P 2 SLDG CF L = 1 CF L = E E E E E E E E / 32

24 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma 2D linear problem: SLDG vs. RKDG Table: 2D linear equation. u t + u x + u y = 0, x [ π, π], y [ π, π] with the initial condition u(x, y, 0) = sin(x + y) and the periodic boundary conditions in both x and y directions. T = π. scheme Mesh CF L L 2 error L error CPU time (s) P 1 SLDG E E P 1 SLDG E E P 1 SLDG E E P 1 SLDG E E P 1 RKDG E E P 2 SLDG E E P 2 SLDG E E P 2 SLDG E E P 2 SLDG E E P 2 RKDG E E For computing a time step, the cost of P 1 SLDG is around 2 times larger than that of P 1 RKDG. the cost of P 2 SLDG is around 2 times larger than that of P 2 RKDG. 24 / 32

25 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma Rigid body rotation: u t (yu) x + (xu) y = 0 Table: Errors of SLDG solutions. u(x, y, 0) = exp( x 2 y 2 ) at T = 2π. mesh L 2 error Order L 2 error Order P 1 SLDG t = 0.5 x t = 2.5 x E E E E E E E E P 2 SLDG t = 0.5 x t = 2.5 x E E E E E E E E / 32

26 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma Rigid body rotation: SLDG vs. RKDG Table: Rigid body rotation. u t (yu) x + (xu) y = 0, x [ 2π, 2π], y [ 2π, 2π] with the initial condition u(x, y, 0) = exp( x 2 y 2 ). T = 2π. scheme Mesh CF L L 2 error L error CPU time (s) P 1 SLDG E E P 1 SLDG E E P 1 SLDG E E P 1 SLDG E E P 1 RKDG E E P 2 SLDG E E P 2 SLDG E E P 2 SLDG E E P 2 SLDG E E P 2 RKDG E E For computing a time step, the cost of P 1 SLDG is around 4 times larger than that of P 1 RKDG. the cost of P 2 SLDG is around 3 times larger than that of P 2 RKDG. 26 / 32

27 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma The swirling deformation problem Table: u t sin(y) cos 2πt 3 πu x + sin(x) cos2 y 2 cos 2 x 2 initial condition is a smooth cosine bell. T = 1.5. cos 2πt 3 πu = 0. The y mesh L 2 error Order L 2 error Order P 1 SLDG CFL = 1 CFL = E E E E E E E E P 2 SLDG CFL = 1 CFL = E E E E E E E E P 2 SLDG-QC CFL = 1 CFL = E E E E E E E E / 32

28 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma The swirling deformation problem x u t cos 2 sin(y)g(t)u 2 x y + sin(x) cos 2 g(t)u = 0 2 y with Š πt g(t) = cos T π, x [ π, π], y [ π, π], The initial condition as shown on the right. 28 / 32

29 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma Figure: Swirling deformation problem. Third order SLDG scheme: T = 0.75 (left) and T = 1.5 (right). The numerical mesh is with CFL = / 32

30 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma Exact Exact P 1 SLDG+WENO+BP + P SLDG P 2 SLDG P 2 SLDG-QC P 2 SLDG+WENO+BP P 2 SLDG-QC+WENO+BP u u x x Figure: Plots of the 1D cuts of the numerical solution for the swirling deformation problem at y = π 2. The solid line depicts the exact solution. The numerical mesh has a resolution of / 32

31 Motivation Numerical methods Numerical tests Conclusions 2D linear problem The rotational problem The swirling deforma (a) P 2 SLDG (b) P 2 SLDG-QC Figure: The relative mass error for SLDG. The numerical mesh has a resolution of t = 2.5 x. 31 / 32

32 Motivation Numerical methods Numerical tests Conclusions Summary and future work We develop a robust truly multi-dimensional SLDG solver with no dimensional splitting error mass conservation large time stepping size positivity-preserving Ongoing work Cai-Guo-Qiu (2017): Couple the SLDG solver with high order characteristics tracing schemes for nonlinear Vlasov systems. In collaboration with R. Nair: Multi-D SLDG scheme on cubed-sphere. General boundary conditions. Adaptive mesh refinement for multi-d SLDG. SLDG scheme for transport equations with source terms and diffusive terms. Qiu and Russo, JSC, / 32

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

More information

High Order Semi-Lagrangian WENO scheme for Vlasov Equations

High Order Semi-Lagrangian WENO scheme for Vlasov Equations High Order WENO scheme for Equations Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Andrew Christlieb Supported by AFOSR. Computational Mathematics Seminar, UC Boulder

More information

Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation

Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation Numerical Analysis and Scientific Computing Preprint Seria Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation W. Guo J. Qiu Preprint #21 Department of Mathematics University

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

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

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Division of Applied Mathematics Brown University Outline Introduction Maximum-principle-preserving for scalar conservation

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

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

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

CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION

CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION 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

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations Ch. Altmann, G. Gassner, F. Lörcher, C.-D. Munz Numerical Flow Models for Controlled

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

A semi-lagrangian finite difference WENO scheme for scalar nonlinear conservation laws

A semi-lagrangian finite difference WENO scheme for scalar nonlinear conservation laws A semi-lagrangian finite difference WENO scheme for scalar nonlinear conservation laws Chieh-Sen Huang a,, Todd Arbogast b,, Chen-Hui Hung c a Department of Applied Mathematics, National Sun Yat-sen University,

More information

A Nodal High-Order Discontinuous Galerkin Dynamical Core for Climate Simulations

A Nodal High-Order Discontinuous Galerkin Dynamical Core for Climate Simulations A Nodal High-Order Discontinuous Galerkin Dynamical Core for Climate Simulations Institute for Mathematics Applied to the Geosciences (IMAGe) National Center for Atmospheric Research (NCAR) Boulder CO

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

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 Class of Deformational Flow Test Cases for Linear Transport Problems on the Sphere

A Class of Deformational Flow Test Cases for Linear Transport Problems on the Sphere A Class of Deformational Flow Test Cases for Linear Transport Problems on the Sphere Ramachandran D. Nair,a, Peter H. Lauritzen b a Institute for Mathematics Applied to Geosciences (IMAGe), National Center

More information

Chapter 17. Finite Volume Method The partial differential equation

Chapter 17. Finite Volume Method The partial differential equation Chapter 7 Finite Volume Method. This chapter focusses on introducing finite volume method for the solution of partial differential equations. These methods have gained wide-spread acceptance in recent

More information

Numerical Smoothness and PDE Error Analysis

Numerical Smoothness and PDE Error Analysis Numerical Smoothness and PDE Error Analysis GLSIAM 2013 Central Michigan University Tong Sun Bowling Green State University April 20, 2013 Table of contents Why consider Numerical Smoothness? What is Numerical

More information

Atmospheric Dynamics with Polyharmonic Spline RBFs

Atmospheric Dynamics with Polyharmonic Spline RBFs Photos placed in horizontal position with even amount of white space between photos and header Atmospheric Dynamics with Polyharmonic Spline RBFs Greg Barnett Sandia National Laboratories is a multimission

More information

AMERICAN METEOROLOGICAL SOCIETY

AMERICAN METEOROLOGICAL SOCIETY AMERICAN METEOROLOGICAL SOCIETY Monthly Weather Review EARLY ONLINE RELEASE This is a preliminary PDF of the author-produced manuscript that has been peer-reviewed and accepted for publication. Since it

More information

An Eulerian-Lagrangian WENO Scheme for Nonlinear Conservation Laws

An Eulerian-Lagrangian WENO Scheme for Nonlinear Conservation Laws An Eulerian-Lagrangian WENO Scheme for Nonlinear Conservation Laws Chieh-Sen Huang a,, Todd Arbogast b, a Department of Applied Mathematics, National Sun Yat-sen University, Kaohsiung 84, Taiwan, R.O.C.

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

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

Well-balanced DG scheme for Euler equations with gravity

Well-balanced DG scheme for Euler equations with gravity Well-balanced DG scheme for Euler equations with gravity Praveen Chandrashekar praveen@tifrbng.res.in Center for Applicable Mathematics Tata Institute of Fundamental Research Bangalore 560065 Higher Order

More information

Well-balanced DG scheme for Euler equations with gravity

Well-balanced DG scheme for Euler equations with gravity Well-balanced DG scheme for Euler equations with gravity Praveen Chandrashekar praveen@tifrbng.res.in Center for Applicable Mathematics Tata Institute of Fundamental Research Bangalore 560065 Dept. of

More information

Earth System Modeling Domain decomposition

Earth System Modeling Domain decomposition Earth System Modeling Domain decomposition Graziano Giuliani International Centre for Theorethical Physics Earth System Physics Section Advanced School on Regional Climate Modeling over South America February

More information

On simplifying incremental remap -based transport schemes

On simplifying incremental remap -based transport schemes On simplifying incremental remap -based transport schemes Peter H. Lauritzen a,, Christoph Erath b, Rashmi Mittal c a Climate and Global Dynamics Division, National Center for Atmospheric Research, P.O.

More information

High order positivity-preserving discontinuous Galerkin methods for radiative transfer equations

High order positivity-preserving discontinuous Galerkin methods for radiative transfer equations High order positivity-preserving discontinuous Galerkin methods for radiative transfer equations Daming Yuan 1, Juan Cheng 2 and Chi-Wang Shu 3 Abstract The positivity-preserving property is an important

More information

High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory!

High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory! High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory! Why Higher Order?! Locally-refined grids, mapped-multiblock grids smooth except

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

A Third Order Fast Sweeping Method with Linear Computational Complexity for Eikonal Equations

A Third Order Fast Sweeping Method with Linear Computational Complexity for Eikonal Equations DOI.7/s95-4-9856-7 A Third Order Fast Sweeping Method with Linear Computational Complexity for Eikonal Equations Liang Wu Yong-Tao Zhang Received: 7 September 23 / Revised: 23 February 24 / Accepted: 5

More information

Some considerations for high-order incremental remap -based transport schemes: edges, reconstructions and area integration

Some considerations for high-order incremental remap -based transport schemes: edges, reconstructions and area integration INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 0000; 00: 4 Published online in Wiley InterScience (www.interscience.wiley.com). DOI: 0.00/fld Some considerations for

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

On the positivity of linear weights in WENO approximations. Abstract

On the positivity of linear weights in WENO approximations. Abstract On the positivity of linear weights in WENO approximations Yuanyuan Liu, Chi-Wang Shu and Mengping Zhang 3 Abstract High order accurate weighted essentially non-oscillatory (WENO) schemes have been used

More information

A recovery-assisted DG code for the compressible Navier-Stokes equations

A recovery-assisted DG code for the compressible Navier-Stokes equations A recovery-assisted DG code for the compressible Navier-Stokes equations January 6 th, 217 5 th International Workshop on High-Order CFD Methods Kissimmee, Florida Philip E. Johnson & Eric Johnsen Scientific

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

Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids

Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids Jochen Garcke joint work with Axel Kröner, INRIA Saclay and CMAP, Ecole Polytechnique Ilja Kalmykov, Universität

More information

A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws

A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws Chieh-Sen Huang a,, Todd Arbogast b,, Chen-Hui Hung c,3 a Department of Applied Mathematics and National

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

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

Emerging Numerical Methods for Atmospheric Modeling

Emerging Numerical Methods for Atmospheric Modeling Chapter 9 Emerging Numerical Methods for Atmospheric Modeling Ramachandran D. Nair, Michael N. Levy and Peter H. Lauritzen Abstract This chapter discusses the development of discontinuous Galerkin (DG)

More information

Scientific Computing: Numerical Integration

Scientific Computing: Numerical Integration Scientific Computing: Numerical Integration Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Fall 2015 Nov 5th, 2015 A. Donev (Courant Institute) Lecture

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 The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

Flux form Semi-Lagrangian methods for parabolic problems

Flux form Semi-Lagrangian methods for parabolic problems Flux form Semi-Lagrangian methods for parabolic problems arxiv:1505.00940v1 [math.na] 5 May 2015 Luca Bonaventura (1, Roberto Ferretti (2 May 6, 2015 (1 MOX Modelling and Scientific Computing, Dipartimento

More information

The Discontinuous Galerkin Method on Cartesian Grids with Embedded Geometries: Spectrum Analysis and Implementation for Euler Equations

The Discontinuous Galerkin Method on Cartesian Grids with Embedded Geometries: Spectrum Analysis and Implementation for Euler Equations The Discontinuous Galerkin Method on Cartesian Grids with Embedded Geometries: Spectrum Analysis and Implementation for Euler Equations by Ruibin Qin A thesis presented to the University of Waterloo in

More information

Efficient Runge-Kutta Based Local Time-Stepping Methods

Efficient Runge-Kutta Based Local Time-Stepping Methods Efficient Runge-utta Based Local Time-Stepping Methods by Alex Ashbourne A thesis presented to the University of Waterloo in fulfillment of the thesis requirement for the degree of Master of Mathematics

More information

Partial Differential Equations

Partial Differential Equations M3M3 Partial Differential Equations Solutions to problem sheet 3/4 1* (i) Show that the second order linear differential operators L and M, defined in some domain Ω R n, and given by Mφ = Lφ = j=1 j=1

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

A high-order fully explicit incremental-remap -based semi-lagrangian shallow-water model

A high-order fully explicit incremental-remap -based semi-lagrangian shallow-water model INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 0000; 00:1 33 Published online in Wiley InterScience (www.interscience.wiley.com). A high-order fully explicit incremental-remap

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

The Spectral-Element Method: Introduction

The Spectral-Element Method: Introduction The Spectral-Element Method: Introduction Heiner Igel Department of Earth and Environmental Sciences Ludwig-Maximilians-University Munich Computational Seismology 1 / 59 Outline 1 Introduction 2 Lagrange

More information

A Stable Spectral Difference Method for Triangles

A Stable Spectral Difference Method for Triangles A Stable Spectral Difference Method for Triangles Aravind Balan 1, Georg May 1, and Joachim Schöberl 2 1 AICES Graduate School, RWTH Aachen, Germany 2 Institute for Analysis and Scientific Computing, Vienna

More information

A finite difference Poisson solver for irregular geometries

A finite difference Poisson solver for irregular geometries ANZIAM J. 45 (E) ppc713 C728, 2004 C713 A finite difference Poisson solver for irregular geometries Z. Jomaa C. Macaskill (Received 8 August 2003, revised 21 January 2004) Abstract The motivation for this

More information

DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS

DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS CHI-WANG SHU Abstract. In these lectures we give a general survey on discontinuous Galerkin methods for solving

More information

Homogenization with stochastic differential equations

Homogenization with stochastic differential equations Homogenization with stochastic differential equations Scott Hottovy shottovy@math.arizona.edu University of Arizona Program in Applied Mathematics October 12, 2011 Modeling with SDE Use SDE to model system

More information

A Robust CFL Condition for the Discontinuous Galerkin Method on Triangular Meshes

A Robust CFL Condition for the Discontinuous Galerkin Method on Triangular Meshes A Robust CFL Condition for the Discontinuous Galerkin Method on Triangular Meshes N. Chalmers and L. Krivodonova Abstract When the discontinuous Galerkin (DG) method is applied to hyperbolic problems in

More information

Design of optimal Runge-Kutta methods

Design of optimal Runge-Kutta methods Design of optimal Runge-Kutta methods David I. Ketcheson King Abdullah University of Science & Technology (KAUST) D. Ketcheson (KAUST) 1 / 36 Acknowledgments Some parts of this are joint work with: Aron

More information

A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations

A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations Int. Conference on Boundary and Interior Layers BAIL 6 G. Lube, G. Rapin Eds c University of Göttingen, Germany, 6 A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations. Introduction

More information

Nonlinear Diffusion. Journal Club Presentation. Xiaowei Zhou

Nonlinear Diffusion. Journal Club Presentation. Xiaowei Zhou 1 / 41 Journal Club Presentation Xiaowei Zhou Department of Electronic and Computer Engineering The Hong Kong University of Science and Technology 2009-12-11 2 / 41 Outline 1 Motivation Diffusion process

More information

Conservation Laws & Applications

Conservation Laws & Applications Rocky Mountain Mathematics Consortium Summer School Conservation Laws & Applications Lecture V: Discontinuous Galerkin Methods James A. Rossmanith Department of Mathematics University of Wisconsin Madison

More information

A central discontinuous Galerkin method for Hamilton-Jacobi equations

A central discontinuous Galerkin method for Hamilton-Jacobi equations A central discontinuous Galerkin method for Hamilton-Jacobi equations Fengyan Li and Sergey Yakovlev Abstract In this paper, a central discontinuous Galerkin method is proposed to solve for the viscosity

More information

AM205: Assignment 3 (due 5 PM, October 20)

AM205: Assignment 3 (due 5 PM, October 20) AM25: Assignment 3 (due 5 PM, October 2) For this assignment, first complete problems 1, 2, 3, and 4, and then complete either problem 5 (on theory) or problem 6 (on an application). If you submit answers

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

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

Runge-Kutta discontinuous Galerkin method with a simple and compact Hermite WENO limiter

Runge-Kutta discontinuous Galerkin method with a simple and compact Hermite WENO limiter Runge-Kutta discontinuous Galerkin method with a simple and compact Hermite WENO limiter Jun Zhu, inghui Zhong, Chi-Wang Shu 3 and Jianxian Qiu 4 Abstract In this paper, we propose a new type of weighted

More information

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction Many astrophysical scenarios are modeled using the field equations of fluid dynamics. Fluids are generally challenging systems to describe analytically, as they form a nonlinear

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 Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

Continuous adjoint based error estimation and r-refinement for the active-flux method

Continuous adjoint based error estimation and r-refinement for the active-flux method Continuous adjoint based error estimation and r-refinement for the active-flux method Kaihua Ding, Krzysztof J. Fidkowski and Philip L. Roe Department of Aerospace Engineering, University of Michigan,

More information

POD for Parametric PDEs and for Optimality Systems

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

More information

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere Michael Levy University of Colorado at Boulder Department of Applied Mathematics August 10, 2007 Outline 1 Background

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

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

CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE

CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE 1. Linear Partial Differential Equations A partial differential equation (PDE) is an equation, for an unknown function u, that

More information

Francis X. Giraldo,

Francis X. Giraldo, 1 Time-Integrators Francis X. Giraldo, giraldo@nrlmry.navy.mil, www.nrlmry.navy.mil/~giraldo/projects/nseam.html 1.1 Introduction Roughly speaking, there are 2 classes of TIs: 1. EulerianMethods(fixed-frame-e.g.,arockatthebottomofaflowing

More information

Extension to moving grids

Extension to moving grids Extension to moving grids P. Lafon 1, F. Crouzet 2 & F. Daude 1 1 LaMSID - UMR EDF/CNRS 2832 2 EDF R&D, AMA April 3, 2008 1 Governing equations Physical coordinates Generalized coordinates Geometrical

More information

Entropy stable high order discontinuous Galerkin methods. for hyperbolic conservation laws

Entropy stable high order discontinuous Galerkin methods. for hyperbolic conservation laws Entropy stable high order discontinuous Galerkin methods for hyperbolic conservation laws Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Tianheng Chen, and with Yong Liu

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

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

Experience with DNS of particulate flow using a variant of the immersed boundary method

Experience with DNS of particulate flow using a variant of the immersed boundary method Experience with DNS of particulate flow using a variant of the immersed boundary method Markus Uhlmann Numerical Simulation and Modeling Unit CIEMAT Madrid, Spain ECCOMAS CFD 2006 Motivation wide range

More information

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence 1 CONVERGENCE THEOR G. ALLAIRE CMAP, Ecole Polytechnique 1. Maximum principle 2. Oscillating test function 3. Two-scale convergence 4. Application to homogenization 5. General theory H-convergence) 6.

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

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 9 Number 2 December 2006 Pages 0 INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR

More information

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

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

Cubed-Sphere Grids and Galerkin Approaches

Cubed-Sphere Grids and Galerkin Approaches 2008 Global Atmospheric Core Workshop National Center for Atmospheric Research (NCAR) September 23-24, Boulder CO, USA. Institute for Mathematics Applied to the Geosciences (IMAGe) Cubed-Sphere: Central

More information

On limiting for higher order discontinuous Galerkin method for 2D Euler equations

On limiting for higher order discontinuous Galerkin method for 2D Euler equations On limiting for higher order discontinuous Galerkin method for 2D Euler equations Juan Pablo Gallego-Valencia, Christian Klingenberg, Praveen Chandrashekar October 6, 205 Abstract We present an implementation

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

Implicit-explicit exponential integrators

Implicit-explicit exponential integrators Implicit-explicit exponential integrators Bawfeh Kingsley Kometa joint work with Elena Celledoni MaGIC 2011 Finse, March 1-4 1 Introduction Motivation 2 semi-lagrangian Runge-Kutta exponential integrators

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

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

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

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

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

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

More information

A second-order asymptotic-preserving and positive-preserving discontinuous. Galerkin scheme for the Kerr-Debye model. Abstract

A second-order asymptotic-preserving and positive-preserving discontinuous. Galerkin scheme for the Kerr-Debye model. Abstract A second-order asymptotic-preserving and positive-preserving discontinuous Galerkin scheme for the Kerr-Debye model Juntao Huang 1 and Chi-Wang Shu Abstract In this paper, we develop a second-order asymptotic-preserving

More information

A spectral finite volume transport scheme on the cubed-sphere

A spectral finite volume transport scheme on the cubed-sphere Applied Numerical Mathematics 57 (2007) 1021 1032 www.elsevier.com/locate/apnum A spectral finite volume transport scheme on the cubed-sphere Vani Cheruvu a,, Ramachandran D. Nair b, Henry M. Tufo a,b

More information

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg Advanced numerical methods for nonlinear advectiondiffusion-reaction equations Peter Frolkovič, University of Heidelberg Content Motivation and background R 3 T Numerical modelling advection advection

More information