AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

Size: px
Start display at page:

Download "AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends"

Transcription

1 AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 25: Introduction to Discontinuous Galerkin Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 15

2 Outline 1 Overview of Discontinuous Galerkin 2 Discontinuous Galerkin for Hyperbolic Equations 3 Discontinuous Galerkin for Elliptic Equations Xiangmin Jiao Finite Element Methods 2 / 15

3 Discontinuous Basis Functions Discontinuous Galerkin uses discontinuous basis functions Continuous vs. discontinuous basis functions (Source: FEniCS Course). Xiangmin Jiao Finite Element Methods 3 / 15

4 Why Discontinuous Galerkin? High-order accuracy (higher than second order), which is desirable if 1 High precision is required Long-time integration High-dimensional problems are considered Memory restrictions become bottleneck Without continuity constraints, DG is easier with h- or p-adaptivity 2 Compact stencil (compared to finite volume methods) Better at solving hyperbolic problems (compared to finite elements) Multiphysics problems 1 1 J. S. Hesthaven, lecture notes on Discontinuous Galerkin Method. 2 FEniCS course on DG for elliptic problems Xiangmin Jiao Finite Element Methods 4 / 15

5 Outline 1 Overview of Discontinuous Galerkin 2 Discontinuous Galerkin for Hyperbolic Equations 3 Discontinuous Galerkin for Elliptic Equations Xiangmin Jiao Finite Element Methods 5 / 15

6 DG Scheme in 1-D Consider scalar problem u t + f (u) x = g(x), x [L, R] = Ω Form local residual x D k : R h (x, t) = uk h t + f h k x g(x) and require this to vanish locally in Galerkin sense D k R h (x, t)l k j (x) dx = 0 where l k j is restriction of test function ψ j over D k Xiangmin Jiao Finite Element Methods 6 / 15

7 DG Scheme in 1-D u h and ψ j is discontinuous across element boundaries Apply Gauss s theorem D k uh k t lk j fh k l k [ ] j x x glk j dx = fh k k+1 lk j x k Xiangmin Jiao Finite Element Methods 7 / 15

8 DG Scheme in 1-D Lack of uniqueness at interface is addressed by numerical flux f = f (u h, u+ h ) D k uh k t lk j fh k l k [ ] j x x glk j dx = f l k k+1 j x k Its corresponding variational form is then [ ] x R h (x, t)l k j (x) dx = (fh k f )l k k+1 j D k x k Choice of flux is important for accuracy and stability of DG! Flux scheme is adopted from finite-volume methods, such as Lax-Friedrich flux Riemann solvers Godunov fluxes, etc. Xiangmin Jiao Finite Element Methods 8 / 15

9 A Brief History of DG DG-FEM was first proposed by Reed/Hill in 1973 for advection-reaction equations First analysis was done by Lesaint and Raviart in 1974 to be O(h p ) in general and optimally O(h p+1 ) for special meshes with degree-p basis In 1986, Johnson showed sharp bound of O(h p+1/2 ) Extended to systems of conservation laws in 1990s by Cockburn and Shu It became popular in early 2000s Xiangmin Jiao Finite Element Methods 9 / 15

10 Outline 1 Overview of Discontinuous Galerkin 2 Discontinuous Galerkin for Hyperbolic Equations 3 Discontinuous Galerkin for Elliptic Equations Xiangmin Jiao Finite Element Methods 10 / 15

11 Derivation of a DG Formulation for Poisson Equation Consider Poisson s equation with homogeneous Dirichlet BCs u = f u = 0 in Ω on Ω Its variational form is Ω u v dx = Ω fv dx Assume we have mesh T on Ω with elements {T } Split left integral into sum over elements: u v dx = u v dx Ω T T T FEM applies integration by parts over Ω. DG applies it to elements: u v dx = u v dx nu v ds T T T Xiangmin Jiao Finite Element Methods 11 / 15

12 Derivation of a DG Cont d Then, T T T u v dx T T T nu v ds = Ω fv dx Each interior facet is shared by two elements T + and T Denote all interior facets by F i and all exterior faces by F e Redistribute integrals over element boundaries to integrals over F: nuv ds = ( n +u+ v + + n u v )ds+ nuv ds F i T T T F e Xiangmin Jiao Finite Element Methods 12 / 15

13 Derivation of a DG Formulation Cont d Let n + = n and n = n (i.e., geometry is continuous). Then, nuvds = ( u + v + u v ) nds + nuv ds F i T T T = u v ds + F i F e nu v ds F e where b denotes jump of vector field b, b (b + b ) n Jump identity: bv = b v + b v, where v = 1 2 (v + + v ), b = 1 2 (b+ + b ), and v = (v + v )n Applying jump identity to first term above, we have nuvds = u v + u v ds+ F i T T T F e nu v ds Xiangmin Jiao Finite Element Methods 13 / 15

14 Derivation of a DG Formulation Cont d Recall that T T T u v dx T T T nu v ds = Ω fv dx Weakly enforce following: Continuity of flux: u = 0 over all interior faces Continuity of solution: u = 0 over all interior faces Needs to stabilize by adding additional term Symmetric Interior Penalty (SIP/DG) formulation for Poisson equation: Find u V h = DG k (T ), such that u v dx T T T + F i + F e u v u v + S i (u, v) ds nu v + S e (u, v) ds = Ω fv dx where S i (u, v) = α h u v and S e(u, v) = γ h uv, with α, γ > 0, are introduced to stabilize solution Xiangmin Jiao Finite Element Methods 14 / 15

15 Example Problem Solves Poisson equation on unit square with source u(x, y) = f (x, y) f (x, y) = 100e 50((x 0.5)2 +(y 0.5) 2 ) and boundary conditions given by where u(x, y) = u 0 on x = 0 and x = 1 n u(x, y) = g on y = 0 and y = 1 using SIP/DG formulation Jupyter Notebook u 0 = x sin(2πx) g = (y 0.5) 2 Xiangmin Jiao Finite Element Methods 15 / 15

Discontinuous Galerkin methods Lecture 2

Discontinuous Galerkin methods Lecture 2 y y RMMC 2008 Discontinuous Galerkin methods Lecture 2 1 Jan S Hesthaven Brown University Jan.Hesthaven@Brown.edu y 1 0.75 0.5 0.25 0-0.25-0.5-0.75 y 0.75-0.0028-0.0072-0.0117 0.5-0.0162-0.0207-0.0252

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations Khosro Shahbazi 1, Paul F. Fischer 2 and C. Ross Ethier 1 1 University of Toronto and 2 Argonne National

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

New DPG techniques for designing numerical schemes

New DPG techniques for designing numerical schemes New DPG techniques for designing numerical schemes Jay Gopalakrishnan University of Florida Collaborator: Leszek Demkowicz October 2009 Massachusetts Institute of Technology, Boston Thanks: NSF Jay Gopalakrishnan

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

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

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 Analysis of Higher Order Discontinuous Galerkin Finite Element Methods

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Contents Ralf Hartmann Institute of Aerodynamics and Flow Technology DLR (German Aerospace Center) Lilienthalplatz 7, 3808

More information

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

More information

Hybridized DG methods

Hybridized DG methods Hybridized DG methods University of Florida (Banff International Research Station, November 2007.) Collaborators: Bernardo Cockburn University of Minnesota Raytcho Lazarov Texas A&M University Thanks:

More information

A SIMPLE TUTORIAL ON DISCONTINUOUS GALERKIN METHODS. Jennifer Proft CERMICS, ENPC. J. Proft CERMICS, ENPC

A SIMPLE TUTORIAL ON DISCONTINUOUS GALERKIN METHODS. Jennifer Proft CERMICS, ENPC. J. Proft CERMICS, ENPC A SIMPLE TUTORIAL ON DISCONTINUOUS GALERKIN METHODS Jennifer Proft Outline Definitions A simple example Issues Historical development elliptic equations hyperbolic equations Discontinuous vs. continuous

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

An Introduction to the Discontinuous Galerkin Method

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

More information

Discontinuous Galerkin Methods: Theory, Computation and Applications

Discontinuous Galerkin Methods: Theory, Computation and Applications Discontinuous Galerkin Methods: Theory, Computation and Applications Paola. Antonietti MOX, Dipartimento di Matematica Politecnico di Milano.MO. X MODELLISTICA E CALCOLO SCIENTIICO. MODELING AND SCIENTIIC

More information

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee Wednesday April 4,

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

High-order finite volume method for curved boundaries and non-matching domain-mesh problems

High-order finite volume method for curved boundaries and non-matching domain-mesh problems High-order finite volume method for curved boundaries and non-matching domain-mesh problems May 3-7, 0, São Félix, Portugal Ricardo Costa,, Stéphane Clain,, Gaspar J. Machado, Raphaël Loubère Institut

More information

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

Finite Difference Methods for Boundary Value Problems

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

More information

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

ANALYSIS OF AN INTERFACE STABILISED FINITE ELEMENT METHOD: THE ADVECTION-DIFFUSION-REACTION EQUATION

ANALYSIS OF AN INTERFACE STABILISED FINITE ELEMENT METHOD: THE ADVECTION-DIFFUSION-REACTION EQUATION ANALYSIS OF AN INTERFACE STABILISED FINITE ELEMENT METHOD: THE ADVECTION-DIFFUSION-REACTION EQUATION GARTH N. WELLS Abstract. Analysis of an interface stabilised finite element method for the scalar advectiondiffusion-reaction

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

FROM GODUNOV TO A UNIFIED HYBRIDIZED DISCONTINUOUS GALERKIN FRAMEWORK FOR PARTIAL DIFFERENTIAL EQUATIONS

FROM GODUNOV TO A UNIFIED HYBRIDIZED DISCONTINUOUS GALERKIN FRAMEWORK FOR PARTIAL DIFFERENTIAL EQUATIONS FROM GODUNOV TO A UNIFIED HYBRIDIZED DISCONTINUOUS GALERKIN FRAMEWORK FOR PARTIAL DIFFERENTIAL EQUATIONS TAN BUI-THANH Abstract. By revisiting the basic Godunov approach for linear system of 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

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II Supplementary Material on Finite Different Methods for Two-Point Boundary-Value Problems Xiangmin Jiao Stony Brook University Xiangmin Jiao Stony Brook University AMS527:

More information

A Brief Overview of Uncertainty Quantification and Error Estimation in Numerical Simulation

A Brief Overview of Uncertainty Quantification and Error Estimation in Numerical Simulation A Brief Overview of Uncertainty Quantification and Error Estimation in Numerical Simulation Tim Barth Exploration Systems Directorate NASA Ames Research Center Moffett Field, California 94035-1000 USA

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

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

Application of Nodal Discontinuous Glaerkin Methods in Acoustic Wave Modeling

Application of Nodal Discontinuous Glaerkin Methods in Acoustic Wave Modeling 1 Application of Nodal Discontinuous Glaerkin Methods in Acoustic Wave Modeling Xin Wang ABSTRACT This work will explore the discontinuous Galerkin finite element method (DG-FEM) for solving acoustic wave

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

The Mortar Boundary Element Method

The Mortar Boundary Element Method The Mortar Boundary Element Method A Thesis submitted for the degree of Doctor of Philosophy by Martin Healey School of Information Systems, Computing and Mathematics Brunel University March 2010 Abstract

More information

Maximum-norm a posteriori estimates for discontinuous Galerkin methods

Maximum-norm a posteriori estimates for discontinuous Galerkin methods Maximum-norm a posteriori estimates for discontinuous Galerkin methods Emmanuil Georgoulis Department of Mathematics, University of Leicester, UK Based on joint work with Alan Demlow (Kentucky, USA) DG

More information

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

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

Numerical Analysis and Methods for PDE I

Numerical Analysis and Methods for PDE I Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling

More information

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

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

More information

Analysis of Hybrid Discontinuous Galerkin Methods for Incompressible Flow Problems

Analysis of Hybrid Discontinuous Galerkin Methods for Incompressible Flow Problems Analysis of Hybrid Discontinuous Galerkin Methods for Incompressible Flow Problems Christian Waluga 1 advised by Prof. Herbert Egger 2 Prof. Wolfgang Dahmen 3 1 Aachen Institute for Advanced Study in Computational

More information

A DISCONTINUOUS GALERKIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION

A DISCONTINUOUS GALERKIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION A DISCONTINUOUS GALERIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION GRÉGORY GUYOMARC H AND CHANG-OC LEE Abstract. We present a discontinuous Galerkin (DG) method to solve

More information

arxiv: v5 [math.na] 1 Sep 2018

arxiv: v5 [math.na] 1 Sep 2018 High-Order Adaptive Extended Stencil FEM (AES-FEM) Part I: Convergence and Superconvergence Xiangmin Jiao Rebecca Conley Tristan J. Delaney arxiv:1603.09325v5 [math.na] 1 Sep 2018 Abstract Finite elements

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 16: Rayleigh Quotient Iteration Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 10 Solving Eigenvalue Problems All

More information

Development of discontinuous Galerkin method for linear strain gradient elasticity

Development of discontinuous Galerkin method for linear strain gradient elasticity Development of discontinuous Galerkin method for linear strain gradient elasticity R Bala Chandran Computation for Design and Optimizaton Massachusetts Institute of Technology Cambridge, MA L. Noels* Aerospace

More information

The Fast Sweeping Method. Hongkai Zhao. Department of Mathematics University of California, Irvine

The Fast Sweeping Method. Hongkai Zhao. Department of Mathematics University of California, Irvine The Fast Sweeping Method Hongkai Zhao Department of Mathematics University of California, Irvine Highlights of fast sweeping mehtod Simple (A Gauss-Seidel type of iterative method). Optimal complexity.

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

An Equal-order DG Method for the Incompressible Navier-Stokes Equations

An Equal-order DG Method for the Incompressible Navier-Stokes Equations An Equal-order DG Method for the Incompressible Navier-Stokes Equations Bernardo Cockburn Guido anschat Dominik Schötzau Journal of Scientific Computing, vol. 40, pp. 188 10, 009 Abstract We introduce

More information

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation Chapter 12 Partial di erential equations 12.1 Di erential operators in R n The gradient and Jacobian We recall the definition of the gradient of a scalar function f : R n! R, as @f grad f = rf =,..., @f

More information

A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations

A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations Fengyan Li, Chi-Wang Shu, Yong-Tao Zhang 3, and Hongkai Zhao 4 ABSTRACT In this paper, we construct a second order fast

More information

Space-time Finite Element Methods for Parabolic Evolution Problems

Space-time Finite Element Methods for Parabolic Evolution Problems Space-time Finite Element Methods for Parabolic Evolution Problems with Variable Coefficients Ulrich Langer, Martin Neumüller, Andreas Schafelner Johannes Kepler University, Linz Doctoral Program Computational

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

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

More information

Investigation of Godunov Flux Against Lax Friedrichs' Flux for the RKDG Methods on the Scalar Nonlinear Conservation Laws Using Smoothness Indicator

Investigation of Godunov Flux Against Lax Friedrichs' Flux for the RKDG Methods on the Scalar Nonlinear Conservation Laws Using Smoothness Indicator American Review of Mathematics and Statistics December 2014, Vol. 2, No. 2, pp. 43-53 ISSN: 2374-2348 (Print), 2374-2356 (Online) Copyright The Author(s). 2014. All Rights Reserved. Published by American

More information

On a Discontinuous Galerkin Method for Surface PDEs

On a Discontinuous Galerkin Method for Surface PDEs On a Discontinuous Galerkin Method for Surface PDEs Pravin Madhavan (joint work with Andreas Dedner and Bjo rn Stinner) Mathematics and Statistics Centre for Doctoral Training University of Warwick Applied

More information

Discontinuous Galerkin FEMs for CFD: A Posteriori Error Estimation and Adaptivity p.1/82

Discontinuous Galerkin FEMs for CFD: A Posteriori Error Estimation and Adaptivity p.1/82 Discontinuous Galerkin FEMs for CFD: A Posteriori Error Estimation and Adaptivity Paul Houston University of Nottingham Funded by EPSRC Papers available from: http://www.maths.nottingham.ac.uk/ ph Discontinuous

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

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying A DISCRETE DIVERGENCE FREE WEAK GALERKIN FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU, JUNPING WANG, AND XIU YE Abstract. A discrete divergence free weak Galerkin finite element method is developed

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

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

First order BSSN formulation of Einstein s field equations

First order BSSN formulation of Einstein s field equations David Brown 1 Peter Diener 2 3 Jan Hesthaven 4 Frank Herrmann 3 Abdul Mroué 5 Olivier Sarbach 6 Erik Schnetter 7 Manuel Tiglio 3 Michael Wagman 4 1 North Carolina State University 2 Louisiana State University

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

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu and Roy H. Stogner roystgnr@cfdlab.ae.utexas.edu Univ. of Texas at Austin September 9, 2008 1 Introduction 2 Weighted Residuals

More information

Trefftz-DG solution to the Helmholtz equation involving integral equations

Trefftz-DG solution to the Helmholtz equation involving integral equations Trefftz-DG solution to the Helmholtz equation involving integral equations H. Barucq, A. Bendali, M. Fares, V. Mattesi, S. Tordeux Magique 3D Inria Bordeaux Sud Ouest LMA UMR CNRS 5142 INSA of Toulouse

More information

Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations

Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations Igor Mozolevski, Endre Süli Federal University of Santa Catarina, Brazil Oxford University Computing Laboratory,

More information

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying A SIMPLE FINITE ELEMENT METHOD FOR LINEAR HYPERBOLIC PROBLEMS LIN MU AND XIU YE Abstract. In this paper, we introduce a simple finite element method for solving first order hyperbolic equations with easy

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

arxiv: v2 [math.na] 9 Apr 2018

arxiv: v2 [math.na] 9 Apr 2018 oname manuscript o. will be inserted by the editor) The BR1 Scheme is Stable for the Compressible avier-stokes Equations Gregor J. Gassner Andrew R. Winters Florian J. Hindenlang David A. Kopriva arxiv:1704.03646v

More information

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE]

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] Chapter 6 Finite Volume Methods In the previous chapter we have discussed finite difference methods for the discretization of PDEs. In developing finite difference methods we started from the differential

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

A posteriori analysis of a discontinuous Galerkin scheme for a diffuse interface model

A posteriori analysis of a discontinuous Galerkin scheme for a diffuse interface model A posteriori analysis of a discontinuous Galerkin scheme for a diffuse interface model Jan Giesselmann joint work with Ch. Makridakis (Univ. of Sussex), T. Pryer (Univ. of Reading) 9th DFG-CNRS WORKSHOP

More information

A local-structure-preserving local discontinuous Galerkin method for the Laplace equation

A local-structure-preserving local discontinuous Galerkin method for the Laplace equation A local-structure-preserving local discontinuous Galerkin method for the Laplace equation Fengyan Li 1 and Chi-Wang Shu 2 Abstract In this paper, we present a local-structure-preserving local discontinuous

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

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

Discontinuous Galerkin methods for compressible flows: higher order accuracy, error estimation and adaptivity

Discontinuous Galerkin methods for compressible flows: higher order accuracy, error estimation and adaptivity Discontinuous Galerkin methods for compressible flows: higher order accuracy, error estimation and adaptivity Ralf Hartmann Institute of Aerodynamics and Flow Technology German Aerospace Center (DLR) Lilienthalplatz

More information

RECENT DEVELOPMENTS IN VERY HIGH ORDER RESIDUAL DISTRIBUTION SCHEMES

RECENT DEVELOPMENTS IN VERY HIGH ORDER RESIDUAL DISTRIBUTION SCHEMES RECENT DEVELOPMENTS IN VERY HIGH ORDER RESIDUAL DISTRIBUTION SCHEMES FOR INVISCID AND VISCOUS PROBLEMS. R. Abgrall Team Bacchus INRIA Bordeaux Sud Ouest and UniversitédeBordeauxTalence,France Roscoff,

More information

On Dual-Weighted Residual Error Estimates for p-dependent Discretizations

On Dual-Weighted Residual Error Estimates for p-dependent Discretizations On Dual-Weighted Residual Error Estimates for p-dependent Discretizations Aerospace Computational Design Laboratory Report TR-11-1 Masayuki Yano and David L. Darmofal September 21, 2011 Abstract This report

More information

Xingye Yue. Soochow University, Suzhou, China.

Xingye Yue. Soochow University, Suzhou, China. Relations between the multiscale methods p. 1/30 Relationships beteween multiscale methods for elliptic homogenization problems Xingye Yue Soochow University, Suzhou, China xyyue@suda.edu.cn Relations

More information

An efficient implementation of the divergence free constraint in a discontinuous Galerkin method for magnetohydrodynamics on unstructured meshes

An efficient implementation of the divergence free constraint in a discontinuous Galerkin method for magnetohydrodynamics on unstructured meshes An efficient implementation of the divergence free constraint in a discontinuous Galerkin method for magnetohydrodynamics on unstructured meshes Christian Klingenberg, Frank Pörner, Yinhua Xia Abstract

More information

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation Code: MAT MTB Today s topics Finite-difference method in D Poisson equation Wave equation Finite-difference method for elliptic PDEs in D Recall that u is the short version of u x + u y Dirichlet BVP:

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

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

A New Class of High-Order Energy Stable Flux Reconstruction Schemes

A New Class of High-Order Energy Stable Flux Reconstruction Schemes DOI 10.1007/s10915-010-940-z A New Class of High-Order Energy Stable Flux Reconstruction Schemes P.E. Vincent P. Castonguay A. Jameson Received: May 010 / Revised: September 010 / Accepted: 5 September

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 Sobolev Embedding Theorems Embedding Operators and the Sobolev Embedding Theorem

More information

Superconvergence and H(div) Projection for Discontinuous Galerkin Methods

Superconvergence and H(div) Projection for Discontinuous Galerkin Methods INTRNATIONAL JOURNAL FOR NUMRICAL MTHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 00:1 6 [Version: 2000/07/27 v1.0] Superconvergence and H(div) Projection for Discontinuous Galerkin Methods Peter Bastian

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

Interior penalty tensor-product preconditioners for high-order discontinuous Galerkin discretizations

Interior penalty tensor-product preconditioners for high-order discontinuous Galerkin discretizations Interior penalty tensor-product preconditioners for high-order discontinuous Galerkin discretizations Will Pazner Brown University, 8 George St., Providence, RI, 9, U.S.A. Per-Olof Persson University of

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

arxiv: v1 [math.na] 29 Feb 2016

arxiv: v1 [math.na] 29 Feb 2016 EFFECTIVE IMPLEMENTATION OF THE WEAK GALERKIN FINITE ELEMENT METHODS FOR THE BIHARMONIC EQUATION LIN MU, JUNPING WANG, AND XIU YE Abstract. arxiv:1602.08817v1 [math.na] 29 Feb 2016 The weak Galerkin (WG)

More information

Hybrid Discontinuous Galerkin methods for incompressible flow problems

Hybrid Discontinuous Galerkin methods for incompressible flow problems Hybrid Discontinuous Galerkin methods incompressible flow problems Christoph Lehrenfeld, Joachim Schöberl MathCCES Computational Mathematics in Engineering Workshop Linz, May 31 - June 1, 2010 Contents

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

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

A note on discontinuous Galerkin divergence-free solutions of the Navier-Stokes equations

A note on discontinuous Galerkin divergence-free solutions of the Navier-Stokes equations A note on discontinuous Galerkin divergence-free solutions of the Navier-Stokes equations Bernardo Cockburn Guido anschat Dominik Schötzau June 1, 2007 Journal of Scientific Computing, Vol. 31, 2007, pp.

More information

arxiv: v2 [math.na] 20 Oct 2017

arxiv: v2 [math.na] 20 Oct 2017 On the penalty stabilization mechanism for upwind discontinuous Galerkin formulations of first order hyperbolic systems Jesse Chan a,, T. Warburton b a Department of Computational and Applied Mathematics,

More information

A minimum entropy principle of high order schemes for gas dynamics. equations 1. Abstract

A minimum entropy principle of high order schemes for gas dynamics. equations 1. Abstract A minimum entropy principle of high order schemes for gas dynamics equations iangxiong Zhang and Chi-Wang Shu 3 Abstract The entropy solutions of the compressible Euler equations satisfy a minimum principle

More information

REVIEW OF SUMMATION-BY-PARTS SCHEMES FOR INITIAL-BOUNDARY-VALUE PROBLEMS

REVIEW OF SUMMATION-BY-PARTS SCHEMES FOR INITIAL-BOUNDARY-VALUE PROBLEMS REVIEW OF SUMMATION-BY-PARTS SCHEMES FOR INITIAL-BOUNDARY-VALUE PROBLEMS MAGNUS SVÄRD AND JAN NORDSTRÖM Abstract. High-order finite difference methods are efficient, easy to program, scale well in multiple

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

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

Chapter 1. Introduction and Background. 1.1 Introduction

Chapter 1. Introduction and Background. 1.1 Introduction Chapter 1 Introduction and Background 1.1 Introduction Over the past several years the numerical approximation of partial differential equations (PDEs) has made important progress because of the rapid

More information

Numerical Methods for Partial Differential Equations CAAM 452. Spring 2005

Numerical Methods for Partial Differential Equations CAAM 452. Spring 2005 Numerical Methods for Partial Differential Equations Instructor: Tim Warburton Class Location: Duncan Hall 1046 Class Time: 9:5am to 10:40am Office Hours: 10:45am to noon in DH 301 CAAM 45 Spring 005 Homeworks

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

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information