A DG-based incompressible Navier-Stokes solver

Size: px
Start display at page:

Download "A DG-based incompressible Navier-Stokes solver"

Transcription

1 A DG-based incompressible Navier-Stokes solver Higer-order DG metods and finite element software for modern arcitectures - Bat 2016 Marian Piatkowski 1 Peter Bastian 1 1 Interdisciplinary Center for Scientific Computing, Heidelberg University Tursday, June 2, 2016 Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

2 Navier-Stokes DG-discretization Instationary incompressible Navier-Stokes equations ρb t v µ v ` ρpv qv ` p f v 0 in Ω ˆ p0, T s in Ω ˆ p0, T s vpx, t 0q v 0 pxq # + # + v g for Γ D BΩ v g on Γ D tbω, Hu pdx 0 or v n p n 0 on Γ N BΩzΓ D Ω Stationary Stokes equations as a minimization problem under constraints 1 min v 2 p v, vq 0,Ω pf, vq 0,Ω s.t. v 0 Lagrangian Lpv, pq 1 2 p v, vq 0,Ω pf, vq 0,Ω pp, vq 0,Ω First order optimality conditions lead to weak formulation Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

3 Navier-Stokes DG-discretization DG discretization I SIPG / NIPG for diffusion apu, vq ÿ ÿ u : vdx E t uu n e rvs ɛt vu n e rusds e EPE epγ int u int n e v int ds ` ɛ v int n e pu int gqds Γ D Γ D J 0 pu, vq ÿ σ e ÿ σ e rus rvsds ` e e epγ int epγ e e puint gq v int ds D $ & minp E peq, E `peq q e, e P Γ int e, E peq X E `peq e % e P BΩ, E peq X BΩ e E peq e Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

4 Navier-Stokes DG-discretization DG discretization II Velocity-pressure coupling + convective term b m pv, pq ÿ ÿ p vdx ` E tpurvs n eds ` p int v int nds e Γ D EPE epγ int bpv, pq b m pv, pq p int g nds Γ D cpw, v, φq conservative form + upwind discretization of pw qv. Variational formulation: Find pv, p q P X ˆ M s.t. ρpb t v, φ q ` µ pa ` J 0 qpv, φ q ` ρcpv ; v, φ q ` b m pφ, p q pf, φ q P X bpv, q q P M X, M piecewise polynomial spaces Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

5 Operator Splitting / Projection Metods Wy Discontinuous Galerkin and wy projection metods? Local mass conservation per element Block vector and block matrix structure, contiguous memory access Wit te projection metods: Easier solution of te transient Navier-Stokes equations at ig Reynolds numbers All metods presented in tis talk ave been implemented in te DUNE software framework Dune Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

6 Operator Splitting / Projection Metods Pressure-correction scemes Pressure-correction scemes: Fractional-step tecnique General approac: Split between incompressibility and dynamics 1 One time step wit explicit pressure p,k`1 in momentum equation, straigtforward in DG-discretization. Gives tentative velocity ṽ k`1. 2 Projection of ṽ k`1 onto solenoidal space, requires investigation for DG. Can be reformulated as a Poisson problem for te pressure correction ψ k`1. 3 L 2 -projection wit ψ k`1 Variants: obtain pressure update p k`1 and optional divergence correction of ṽ k`1 Implicit Euler, p,k`1 0, no divergence correction Corin s projection metod p,k`1 p k, no divergence correction Incremental Pressure Correction Sceme (IPCS) p,k`1 p k, wit divergence correction Rotational Incremental Pressure Correction Sceme (RIPCS) Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18 to

7 Operator Splitting / Projection Metods Solution approac Solution approaces in te subproblems Momentum equation Impl. Euler, BDF2, DIRK-metods suc as Alexander2, Alexander3 for time stepping Navier-Stokes case: Newton s metod wit analytical evaluation of jacobians (no numerical differentiation etc.) Pressure Poisson equation Zero mean condition pif Γ D BΩq is imposed in a post-processing step Hybrid AMG for DG wit correction in conforming Q 1 subspace E AMG4DG pi W 1 DG A DGq ν 2 pi R T B AMG RA DG qpi W 1 DG A DGq ν 1 R T prolongation from CG-subspace to DG W DG smooter on DG level Compute A CG RA DG R T directly pa CG q ij ÿ EPE E ϕcg j ϕ CG i dx ` ÿ epγ N e σ e ϕ CG j e ϕ CG i ϕ CG j nϕ CG i B AMG one V-cycle of AMG preconditioner applied to A CG ϕ CG i nϕ CG j ds Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

8 Towards a fast DG-implementation Fast DG assembler Assembler tailored to te data structure in DG Relevant properties of DG Contiguous memory access Block vector and block matrix structure Taking tese properties into account No data copying for coefficients vector, output result Treat in block-based fasion, blocks interpreted as one DOF Can andle te scalar case, and systems of te form X ˆ... ˆ X Furter exploitation of tese ideas No data copying in evaluation of explicit parameter functions (e.g. pressure in momentum equation, velocity in pressure Poisson equation) Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

9 Towards a fast DG-implementation Sum factorization Fast evaluation of residuals and jacobians: Exploiting tensor product structure Tensor product basis: ϕ j pxq ϕ j1,...,j d px 1,..., x d q θ jd px d q... θ j1 px 1 q Tensor product quadrature: Ξ i pξ i1,..., ξ id q T j pj 1,..., j d q P J d t1,.., nu d, i pi 1,..., i d q P I d t1,.., mu d Evaluate finite element function on reference element at quadrature points: u pξ i q ÿ x j ϕ j pξ i q jpj d ÿ... ÿ θ jd pξ id q... θ j1 pξ i1 q x j1,...,j d j d PJ j 1 PJ ÿ... ÿ j d PJ j 1 PJ A pdq i d,j d... A p1q i 1,j 1 X p0q j 1,...,j d : Y i1,...,i d All basis functions at all quadrature points as matrix-matrix product. Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

10 Towards a fast DG-implementation Sum factorization Fast evaluation of residuals and jacobians II: Sum factorization Y i1,...,i d ÿ... ÿ j d PJ ÿ j d PJ j 1 PJ... ÿ A pdq i d,j d... ÿ j d PJ A pdq i d,j d... A p1q i 1,j 1 X p0q j 1,...,j d j 2 PJ A p2q i 2,j 2 ÿ A pdq i d,j d X pd 1q j d,i 1...i d 1 A p1q i 1,j 1 X p0q j 1,...,j d j 1 PJ loooooooooomoooooooooon X p1q j 2,i 1...,j d Dim by dim approac as matrix-matrix product A pkq X pk 1q X pkq. B k u pξ i q and residual computation similar Face integrals similar, reduction to pd 1q dimensions Same for evaluation of explicit parameter functions Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

11 Towards a fast DG-implementation Sum factorization Fast evaluation of residuals and jacobians III Vectorization over solution and its gradient: pu pξ i q, u pξ i qq T ÿ jpj d x j pϕ j pξ i q, ϕ j pξ i qq T, i P I d Use vector class library by Agner Fog, ttp:// Summary: Assembly of volume and face terms 1 Compute solution and its gradient at all quadrature points 2 Gauss-quadrature loop, compute part witout test functions 3 Compute residuals, compute jacobian If jacobian is set up explicitly compute trial functions and and teir gradients on-te-fly at quadrature points for columnwise accumulation Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

12 Towards a fast DG-implementation Performance comparison Performance comparison: Velocity mom residual evaluation Compute µpa ` J 0 qpv, φ q ` b m pφ, p q pf, φ q P X for given rational v, p and f. Compare against (I) Fast implementation: Sum factorization and fast DG assembler (II) Default implementation: Naive version and standard assembler Polynomial degrees: Q 2 {Q 1 in 2D and Q 3 {Q 2 in 3D Intel Xeon E v3 16 core processor (30.4 GFLOPS peak / core) Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

13 Towards a fast DG-implementation Performance comparison Velocity mom., residual evaluation, 2D, Q 2 {Q 1 -DG space - Fast implementation - Default implementation Part Time GFLOPS alpa boundary alpa skeleton alpa volume lambda boundary lambda skeleton lambda volume local operator total Part Time GFLOPS alpa boundary alpa skeleton alpa volume lambda boundary lambda skeleton lambda volume local operator total absolute overead: s relative overead: 0.58 absolute overead: s relative overead: 0.34 Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

14 Towards a fast DG-implementation Performance comparison Residual evaluation: Detailed measurement Part Time GFLOPS total alpa boundary alpa skeleton skeleton coefficients skeleton gauss skeleton residual alpa volume volume coefficients volume gauss volume residual Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

15 Towards a fast DG-implementation Performance comparison Velocity mom., residual evaluation, 3D, Q 3 {Q 2 -DG space - Fast implementation - Default implementation Part Time GFLOPS alpa boundary alpa skeleton alpa volume lambda boundary lambda skeleton lambda volume local operator total Part Time GFLOPS alpa boundary alpa skeleton alpa volume lambda boundary lambda skeleton lambda volume local operator total absolute overead: s relative overead: 0.31 absolute overead: s relative overead: 0.04 Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

16 Towards a fast DG-implementation Simulation results 2D Driven Cavity flow at Re = Q 2 {Q 1 discretization, anisotropic mes wit aspect ratios up to factor 10 Plot of te vorticity ω ˆ v at two different time snapsots. Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

17 Outlook Outlook Extend matrix-based / matrix-free approac in subproblems of pressure-correction scemes Velocity momentum equation: Matrix-free Newton + GMRes-Ricardson, NIPG discretization Pressure Poisson equation: Hybrid AMG for DG, matrix-based or matrix-free approac on te DG level Matrix-free L 2 -projection of tentative velocity onto solenoidal subspace 3D DNS of atmospere-subsurface coupling in te ABL Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

18 Outlook Outlook Extend matrix-based / matrix-free approac in subproblems of pressure-correction scemes Velocity momentum equation: Matrix-free Newton + GMRes-Ricardson, NIPG discretization Pressure Poisson equation: Hybrid AMG for DG, matrix-based or matrix-free approac on te DG level Matrix-free L 2 -projection of tentative velocity onto solenoidal subspace 3D DNS of atmospere-subsurface coupling in te ABL Tank you for your attention! Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

19 Outlook Residual evaluation 3D Q 3 {Q 2 -DG space: Detailed measurement Part Time GFLOPS total alpa boundary alpa skeleton skeleton coefficients skeleton gauss skeleton residual alpa volume volume coefficients volume gauss volume residual Marian Piatkowski (IWR) Navier-Stokes-DG Projection Tursday, June 2, / 18

New Streamfunction Approach for Magnetohydrodynamics

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

More information

Minimal stabilization techniques for incompressible flows

Minimal stabilization techniques for incompressible flows Minimal stabilization tecniques for incompressible flows G. Lube 1, L. Röe 1 and T. Knopp 2 1 Numerical and Applied Matematics Georg-August-University of Göttingen D-37083 Göttingen, Germany 2 German Aerospace

More information

Multipole-Based Preconditioners for Sparse Linear Systems.

Multipole-Based Preconditioners for Sparse Linear Systems. Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation. Overview Summary of Contributions Generalized Stokes Problem Solenoidal

More information

FEM solution of the ψ-ω equations with explicit viscous diffusion 1

FEM solution of the ψ-ω equations with explicit viscous diffusion 1 FEM solution of te ψ-ω equations wit explicit viscous diffusion J.-L. Guermond and L. Quartapelle 3 Abstract. Tis paper describes a variational formulation for solving te D time-dependent incompressible

More information

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps A metod of Lagrange Galerkin of second order in time Une métode de Lagrange Galerkin d ordre deux en temps Jocelyn Étienne a a DAMTP, University of Cambridge, Wilberforce Road, Cambridge CB3 0WA, Great-Britain.

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

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

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

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

1. Introduction. We consider the model problem: seeking an unknown function u satisfying

1. Introduction. We consider the model problem: seeking an unknown function u satisfying A DISCONTINUOUS LEAST-SQUARES FINITE ELEMENT METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS XIU YE AND SHANGYOU ZHANG Abstract In tis paper, a discontinuous least-squares (DLS) finite element metod is introduced

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

Fast solvers for steady incompressible flow

Fast solvers for steady incompressible flow ICFD 25 p.1/21 Fast solvers for steady incompressible flow Andy Wathen Oxford University wathen@comlab.ox.ac.uk http://web.comlab.ox.ac.uk/~wathen/ Joint work with: Howard Elman (University of Maryland,

More information

Multigrid Methods for Discretized PDE Problems

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

More information

Spatial discretization scheme for incompressible viscous flows

Spatial discretization scheme for incompressible viscous flows Spatial discretization scheme for incompressible viscous flows N. Kumar Supervisors: J.H.M. ten Thije Boonkkamp and B. Koren CASA-day 2015 1/29 Challenges in CFD Accuracy a primary concern with all CFD

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

Iterative Methods for Incompressible Flow

Iterative Methods for Incompressible Flow Iterative Methods for Incompressible Flow Melanie McKay Thesis submitted to the Faculty of Graduate and Postdoctoral Studies in partial fulfillment of the requirements for the degree of Master s of Science

More information

Numerik 2 Motivation

Numerik 2 Motivation Numerik 2 Motivation P. Bastian Universität Heidelberg Interdisziplinäres Zentrum für Wissenschaftliches Rechnen Im Neuenheimer Feld 368, D-69120 Heidelberg email: Peter.Bastian@iwr.uni-heidelberg.de April

More information

M. Croci (Oxford), M. B. Giles (Oxford), P. E. Farrell (Oxford), M. E. Rognes (Simula) MCQMC July 4, 2018

M. Croci (Oxford), M. B. Giles (Oxford), P. E. Farrell (Oxford), M. E. Rognes (Simula) MCQMC July 4, 2018 Efficient wite noise sampling and coupling for multilevel Monte Carlo M. Croci (Oxford), M. B. Giles (Oxford), P. E. Farrell (Oxford), M. E. Rognes (Simula) MCQMC2018 - July 4, 2018 Overview Introduction

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

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

More information

Jian-Guo Liu 1 and Chi-Wang Shu 2

Jian-Guo Liu 1 and Chi-Wang Shu 2 Journal of Computational Pysics 60, 577 596 (000) doi:0.006/jcp.000.6475, available online at ttp://www.idealibrary.com on Jian-Guo Liu and Ci-Wang Su Institute for Pysical Science and Tecnology and Department

More information

High-Performance Computing for Flows in Porous Media

High-Performance Computing for Flows in Porous Media High-Performance Computing for Flows in Porous Media Peter Bastian 1, Eike Müller 2, Steffen Müthing 1 1 Interdisciplinary Center for Scientific Computing, U Heidelberg, Germany 2 University of Bath, UK

More information

A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows

A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows A Polynomial Adaptive LCP Sceme for Viscous Compressible Flows J.S. Cagnone, B.C. Vermeire, and S.. Nadaraja Department of Mecanical Engineering, McGill University, Montreal, Canada, H3A 2S6 Email: jean-sebastien.cagnone@mail.mcgill.ca

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

Variational Assimilation of Discrete Navier-Stokes Equations

Variational Assimilation of Discrete Navier-Stokes Equations Variational Assimilation of Discrete Navier-Stokes Equations Souleymane.Kadri-Harouna FLUMINANCE, INRIA Rennes-Bretagne Atlantique Campus universitaire de Beaulieu, 35042 Rennes, France Outline Discretization

More information

Space-time XFEM for two-phase mass transport

Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Christoph Lehrenfeld joint work with Arnold Reusken EFEF, Prague, June 5-6th 2015 Christoph Lehrenfeld EFEF, Prague,

More information

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations A. Ouazzi, M. Nickaeen, S. Turek, and M. Waseem Institut für Angewandte Mathematik, LSIII, TU Dortmund, Vogelpothsweg

More information

Divergence-conforming multigrid methods for incompressible flow problems

Divergence-conforming multigrid methods for incompressible flow problems Divergence-conforming multigrid methods for incompressible flow problems Guido Kanschat IWR, Universität Heidelberg Prague-Heidelberg-Workshop April 28th, 2015 G. Kanschat (IWR, Uni HD) Hdiv-DG Práha,

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

(4.2) -Richardson Extrapolation

(4.2) -Richardson Extrapolation (.) -Ricardson Extrapolation. Small-O Notation: Recall tat te big-o notation used to define te rate of convergence in Section.: Suppose tat lim G 0 and lim F L. Te function F is said to converge to L as

More information

A fully-coupled discontinuous Galerkin method for two-phase flow in porous media with discontinuous capillary pressure

A fully-coupled discontinuous Galerkin method for two-phase flow in porous media with discontinuous capillary pressure arxiv:39.7555v [pysics.flu-dyn] 29 Sep 23 A fully-coupled discontinuous Galerkin metod for two-pase flow in porous media wit discontinuous capillary pressure Peter Bastian Heidelberg University, Interdisciplinary

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

arxiv: v1 [math.na] 12 Mar 2018

arxiv: v1 [math.na] 12 Mar 2018 ON PRESSURE ESTIMATES FOR THE NAVIER-STOKES EQUATIONS J A FIORDILINO arxiv:180304366v1 [matna 12 Mar 2018 Abstract Tis paper presents a simple, general tecnique to prove finite element metod (FEM) pressure

More information

Linear Solvers. Andrew Hazel

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

More information

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

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

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Finite Elements (Numerical Solution of Partial Differential Equations)

Finite Elements (Numerical Solution of Partial Differential Equations) Finite Elements (Numerical Solution of Partial Differential Equations) P. Bastian Universität Heidelberg Interdisziplinäres Zentrum für Wissenschaftliches Rechnen Im Neuenheimer Feld 205, D-69120 Heidelberg

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

19 A comparison of some finite element schemes

19 A comparison of some finite element schemes 19 A comparison of some finite element scemes for te incompressible Navier Stokes equations By K. Valen-Sendstad, A. Logg, K.-A. Mardal, H. Narayanan and M. Mortensen Numerical algoritms for te computation

More information

Lagrangian acceleration in confined 2d turbulent flow

Lagrangian acceleration in confined 2d turbulent flow Lagrangian acceleration in confined 2d turbulent flow Kai Schneider 1 1 Benjamin Kadoch, Wouter Bos & Marie Farge 3 1 CMI, Université Aix-Marseille, France 2 LMFA, Ecole Centrale, Lyon, France 3 LMD, Ecole

More information

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801 RESEARCH SUMMARY AND PERSPECTIVES KOFFI B. FADIMBA Department of Matematical Sciences University of Sout Carolina Aiken Aiken, SC 29801 Email: KoffiF@usca.edu 1. Introduction My researc program as focused

More information

Institut für Numerische und Angewandte Mathematik

Institut für Numerische und Angewandte Mathematik Institut für Numerisce und Angewandte Matematik Hybrid discontinuous Galerkin metods wit relaxed H(div-conformity for incompressible flows. Part I Lederer, P. L., Lerenfeld, C., Scöberl, J. Nr. 4 Preprint-Serie

More information

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations Arbitrary order exactly divergence-free central discontinuous Galerkin metods for ideal MHD equations Fengyan Li, Liwei Xu Department of Matematical Sciences, Rensselaer Polytecnic Institute, Troy, NY

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

Computational Linear Algebra

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

More information

PDE Solvers for Fluid Flow

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

More information

arxiv: v1 [physics.flu-dyn] 3 Jun 2015

arxiv: v1 [physics.flu-dyn] 3 Jun 2015 A Convective-like Energy-Stable Open Boundary Condition for Simulations of Incompressible Flows arxiv:156.132v1 [pysics.flu-dyn] 3 Jun 215 S. Dong Center for Computational & Applied Matematics Department

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu Univ. of Texas at Austin January 12, 2007 1 Introduction 2 Weighted Residuals 3 Poisson Equation 4 Other Examples 5 Essential

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

More information

NUMERICAL INVESTIGATION OF BUOY- ANCY DRIVEN FLOWS IN TIGHT LATTICE FUEL BUNDLES

NUMERICAL INVESTIGATION OF BUOY- ANCY DRIVEN FLOWS IN TIGHT LATTICE FUEL BUNDLES Fifth FreeFem workshop on Generic Solver for PDEs: FreeFem++ and its applications NUMERICAL INVESTIGATION OF BUOY- ANCY DRIVEN FLOWS IN TIGHT LATTICE FUEL BUNDLES Paris, December 12 th, 2013 Giuseppe Pitton

More information

Solving Partial Differential Equations Numerically. Miklós Bergou with: Gary Miller, David Cardoze, Todd Phillips, Mark Olah

Solving Partial Differential Equations Numerically. Miklós Bergou with: Gary Miller, David Cardoze, Todd Phillips, Mark Olah Solving Partial Dierential Equations Numerically Miklós Bergou with: Gary Miller, David Cardoze, Todd Phillips, Mark Olah Overview What are partial dierential equations? How do we solve them? (Example)

More information

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990 Computer Methods in Applied Mechanics and Engineering, 94 (1992) 339 351 1 A NEW STRATEGY FOR FINITE ELEMENT COMPUTATIONS INVOLVING MOVING BOUNDARIES AND INTERFACES THE DEFORMING-SPATIAL-DOMAIN/SPACE-TIME

More information

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method WDS'10 Proceedings of Contributed Papers, Part I, 151 156, 2010. ISBN 978-80-7378-139-2 MATFYZPRESS Different Approaces to a Posteriori Error Analysis of te Discontinuous Galerkin Metod I. Šebestová Carles

More information

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

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

More information

Due Tuesday, November 23 nd, 12:00 midnight

Due Tuesday, November 23 nd, 12:00 midnight Due Tuesday, November 23 nd, 12:00 midnight This challenging but very rewarding homework is considering the finite element analysis of advection-diffusion and incompressible fluid flow problems. Problem

More information

Explicit Hyperbolic Reconstructed Discontinuous Galerkin Methods for Time-Dependent Problems

Explicit Hyperbolic Reconstructed Discontinuous Galerkin Methods for Time-Dependent Problems AIAA AVIATION Forum June 25-29 218 Atlanta Georgia 218 Fluid Dynamics Conference 1.2514/6.218-427 Explicit Hyperbolic Reconstructed Discontinuous Galerkin Metods for Time-Dependent Problems Jialin Lou

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

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Mixed Finite Element Methods for Incompressible Flow: Stationary Stokes Equations

Mixed Finite Element Methods for Incompressible Flow: Stationary Stokes Equations Mixed Finite Element Metods for Incompressible Flow: Stationary Stoes Equations Ziqiang Cai, Carles Tong, 2 Panayot S. Vassilevsi, 2 Cunbo Wang Department of Matematics, Purdue University, West Lafayette,

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

More information

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods 1 Introduction Achieving high order time-accuracy in the approximation of the incompressible Navier Stokes equations by means of fractional-step

More information

4.2 - Richardson Extrapolation

4.2 - Richardson Extrapolation . - Ricardson Extrapolation. Small-O Notation: Recall tat te big-o notation used to define te rate of convergence in Section.: Definition Let x n n converge to a number x. Suppose tat n n is a sequence

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

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

Multigrid Methods and their application in CFD

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

More information

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Hybrid Mixed Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

The CG1-DG2 method for conservation laws

The CG1-DG2 method for conservation laws for conservation laws Melanie Bittl 1, Dmitri Kuzmin 1, Roland Becker 2 MoST 2014, Germany 1 Dortmund University of Technology, Germany, 2 University of Pau, France CG1-DG2 Method - Motivation hp-adaptivity

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

NEWTON-GMRES PRECONDITIONING FOR DISCONTINUOUS GALERKIN DISCRETIZATIONS OF THE NAVIER-STOKES EQUATIONS

NEWTON-GMRES PRECONDITIONING FOR DISCONTINUOUS GALERKIN DISCRETIZATIONS OF THE NAVIER-STOKES EQUATIONS NEWTON-GMRES PRECONDITIONING FOR DISCONTINUOUS GALERKIN DISCRETIZATIONS OF THE NAVIER-STOKES EQUATIONS P.-O. PERSSON AND J. PERAIRE Abstract. We study preconditioners for the iterative solution of the

More information

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY (Section 3.2: Derivative Functions and Differentiability) 3.2.1 SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY LEARNING OBJECTIVES Know, understand, and apply te Limit Definition of te Derivative

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

Iterative methods for positive definite linear systems with a complex shift

Iterative methods for positive definite linear systems with a complex shift Iterative methods for positive definite linear systems with a complex shift William McLean, University of New South Wales Vidar Thomée, Chalmers University November 4, 2011 Outline 1. Numerical solution

More information

H(div) conforming and DG methods for incompressible Euler s equations

H(div) conforming and DG methods for incompressible Euler s equations H(div) conforming and DG metods for incompressible Euler s equations Jonny Guzmán Filánder A. Sequeira Ci-Wang Su Abstract H(div) conforming and discontinuous Galerkin (DG) metods are designed for incompressible

More information

Dune. Patrick Leidenberger. 13. May Distributed and Unified Numerics Environment. 13. May 2009

Dune. Patrick Leidenberger. 13. May Distributed and Unified Numerics Environment. 13. May 2009 13. May 2009 leidenberger@ifh.ee.ethz.ch 1 / 25 Dune Distributed and Unified Numerics Environment Patrick Leidenberger 13. May 2009 13. May 2009 leidenberger@ifh.ee.ethz.ch 2 / 25 Table of contents 1 Introduction

More information

Preconditioning in H(div) and Applications

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

More information

Chapter 8. Numerical Solution of Ordinary Differential Equations. Module No. 2. Predictor-Corrector Methods

Chapter 8. Numerical Solution of Ordinary Differential Equations. Module No. 2. Predictor-Corrector Methods Numerical Analysis by Dr. Anita Pal Assistant Professor Department of Matematics National Institute of Tecnology Durgapur Durgapur-7109 email: anita.buie@gmail.com 1 . Capter 8 Numerical Solution of Ordinary

More information

Hybridized Discontinuous Galerkin Methods

Hybridized Discontinuous Galerkin Methods Hybridized Discontinuous Galerkin Methods Theory and Christian Waluga Joint work with Herbert Egger (Uni Graz) 1st DUNE User Meeting, Stuttgart Christian Waluga (AICES) HDG Methods October 6-8, 2010 1

More information

The hybridized DG methods for WS1, WS2, and CS2 test cases

The hybridized DG methods for WS1, WS2, and CS2 test cases The hybridized DG methods for WS1, WS2, and CS2 test cases P. Fernandez, N.C. Nguyen and J. Peraire Aerospace Computational Design Laboratory Department of Aeronautics and Astronautics, MIT 5th High-Order

More information

Numerical Methods for Problems with Moving Fronts Orthogonal Collocation on Finite Elements

Numerical Methods for Problems with Moving Fronts Orthogonal Collocation on Finite Elements Electronic Text Provided with the Book Numerical Methods for Problems with Moving Fronts by Bruce A. Finlayson Ravenna Park Publishing, Inc., 635 22nd Ave. N. E., Seattle, WA 985-699 26-524-3375; ravenna@halcyon.com;www.halcyon.com/ravenna

More information

arxiv: v2 [math.na] 5 Jul 2017

arxiv: v2 [math.na] 5 Jul 2017 Trace Finite Element Metods for PDEs on Surfaces Maxim A. Olsanskii and Arnold Reusken arxiv:1612.00054v2 [mat.na] 5 Jul 2017 Abstract In tis paper we consider a class of unfitted finite element metods

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

The Deflation Accelerated Schwarz Method for CFD

The Deflation Accelerated Schwarz Method for CFD The Deflation Accelerated Schwarz Method for CFD J. Verkaik 1, C. Vuik 2,, B.D. Paarhuis 1, and A. Twerda 1 1 TNO Science and Industry, Stieltjesweg 1, P.O. Box 155, 2600 AD Delft, The Netherlands 2 Delft

More information

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Mixed-Hybrid-Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations Today's Lecture 2D grid colocated arrangement staggered arrangement Exercise: Make a Fortran program which solves a system of linear equations using an iterative method SIMPLE algorithm Pressure-velocity

More information

The solution of the discretized incompressible Navier-Stokes equations with iterative methods

The solution of the discretized incompressible Navier-Stokes equations with iterative methods The solution of the discretized incompressible Navier-Stokes equations with iterative methods Report 93-54 C. Vuik Technische Universiteit Delft Delft University of Technology Faculteit der Technische

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

Elmer. Introduction into Elmer multiphysics. Thomas Zwinger. CSC Tieteen tietotekniikan keskus Oy CSC IT Center for Science Ltd.

Elmer. Introduction into Elmer multiphysics. Thomas Zwinger. CSC Tieteen tietotekniikan keskus Oy CSC IT Center for Science Ltd. Elmer Introduction into Elmer multiphysics FEM package Thomas Zwinger CSC Tieteen tietotekniikan keskus Oy CSC IT Center for Science Ltd. Contents Elmer Background History users, community contacts and

More information

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

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

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

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

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

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

Simulations of the turbulent channel flow at Re τ = 180 with projection-based finite element variational multiscale methods

Simulations of the turbulent channel flow at Re τ = 180 with projection-based finite element variational multiscale methods INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Met. Fluids 7; 55:47 49 Publised online 4 Marc 7 in Wiley InterScience (www.interscience.wiley.com). DOI:./fld.46 Simulations of te

More information

Implementation of the dg method

Implementation of the dg method Implementation of the dg method Matteo Cicuttin CERMICS - École Nationale des Ponts et Chaussées Marne-la-Vallée March 6, 2017 Outline Model problem, fix notation Representing polynomials Computing integrals

More information

Fast Solvers for Unsteady Incompressible Flow

Fast Solvers for Unsteady Incompressible Flow ICFD25 Workshop p. 1/39 Fast Solvers for Unsteady Incompressible Flow David Silvester University of Manchester http://www.maths.manchester.ac.uk/~djs/ ICFD25 Workshop p. 2/39 Outline Semi-Discrete Navier-Stokes

More information

Multigrid Methods for Obstacle Problems

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

More information

Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Methods

Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Methods DOI 0.007/s095-07-048- Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Metods Mengping Zang Jue Yan Received: 7 December 06 / Revised: 7 April 07 / Accepted: April 07 Springer Science+Business

More information