Finite Element Decompositions for Stable Time Integration of Flow Equations

Size: px
Start display at page:

Download "Finite Element Decompositions for Stable Time Integration of Flow Equations"

Transcription

1 MAX PLANCK INSTITUT August 13, 2015 Finite Element Decompositions for Stable Time Integration of Flow Equations Jan Heiland, Robert Altmann (TU Berlin) ICIAM 2015 Beijing DYNAMIK KOMPLEXER TECHNISCHER SYSTEME MAGDEBURG Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 1/31

2 Problem Statement We want to integrate the semi-discrete flow equations, to solve for the velocity v and the pressure p: M v + K(v) + B T p = f Bv = g Why not simply use semi-implicit Euler scheme, which is of first order for v and p? M v+ v c + K(v c ) + B T p c = f c Bv + = g + Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 2/31

3 Numerical Example The error in the pressure variable p for varying p,tol p L Index if we iteratively solve the resulting linear equation systems up to a residual of tol = Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 3/31

4 Introduction Flow equations u + Ku + π = f, u = g, u(0) = u 0. Stokes equation: Ku = ν u Euler equation: Ku = (u )u Navier-Stokes equations: Ku = (u )u ν u Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 4/31

5 Minimal Extension for the PDE u + Ku + π = f u = g We can decompose the solution u = u 1 + u 2 such that u 1 = 0 and u 2 = g. We add the derivative of the constrained u = g to the system u + Ku + π = f, u = g, u = ġ. Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 5/31

6 Minimal Extension for the PDE u + Ku + π = f u = g u = ġ With u = u 1 + u 2, u 1 = 0, and ũ 2 := u 2, one obtains u 1 + ũ 2 + K ( u 1 + u 2 ) π = f ũ 2 u 2 = g = ġ which under reasonable conditions is equivalent to the original system [Altmann 15, Altmann/JH 15] is an index reduced on the PDE level applying Minimal Extension [Kunkel/Mehrmann 04] Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 6/31

7 Spatial Discretization u + Ku + π = f u = g Velocity: u V := [ H 1 0(Ω) ] d v Vh Pressure: π Q := L 2 (Ω)/R p Q h V h and Q h satisfy an inf-sup or the LBB condition like the Taylor-Hood or Crouzeix-Raviart scheme V h Q h Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 7/31

8 Spatial Discretization u + Ku + π = f u = g M v + K(v) + B T p = f Bv = g ( ) Assumptions on the DAE (met by LBB-stable schemes) M R nv,nv, B R np,nv, n v > n p M symmetric positive definite and B is of full rank Proposed reformulation Add the time-derivative of the constraint ( ) Add a variable that makes the system square again Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 8/31

9 Reformulation Find orthogonal matrix Q so that BQ = [ ] B 1 B 2 with invertible B2 [ ] q1 and define := Q T v q 2 M v + K(v) + B T p = f Bv = g ( ) Add constraint B q = ġ and the new variable q 2 := q 2 Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 9/31

10 Reformulation Find orthogonal matrix Q so that BQ = [ ] B 1 B 2 with invertible B2 [ ] q1 and define := Q T v q 2 M v + K(v) + B T p = f Bv = g ( ) Add constraint B q = ġ and the new variable q 2 := q 2 Reformulated index-1 system: [ ] q1 MQ + K(q q 1, q 2 ) + B T p = f 2 B 1 q 1 + B 2 q 2 B 1 q 1 + B 2 q 2 = g = ġ Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 9/31

11 Finite Element Decomposition Problem: how to find Q Computation via QR decomposition is not feasible We propose: decomposition of velocity ansatz space Splitting V h = V h,1 V h,2 Basis functions V h,1 = span{ϕ 1,..., ϕ nv m}, V h,2 = span{ϕ nv m+1,..., ϕ nv } Q = permutation matrix B [ ] B 1 B 2 through column swapping Aim: find a subspace V h,2, or ϕ nv m+1,..., ϕ nv, such that B 2 is invertible Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 10/31

12 Finite Element Decomposition Algorithm to find V h,2 are available for Crouzeix-Raviart elements, Taylor-Hood elements, Rannacher-Turek elements for quads, and their 3D counterparts. see [Altmann/JH 15]. Illustration for the Crouzeix-Raviart scheme The splitting is based on a mapping ι: T \ {T 0 } E Range(ι) = {E 1,..., E m } subset of the set of edges E of the triangulation Edges correspond to ϕ n m+1,..., ϕ n... The algorithm terminates in a triangular B 2 Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 11/31

13 Time Integration Consider the semi-explicit Euler scheme... time-step length v c, v +... current, next time instance of velocity For the index-2 system: M v+ v c + K(v c ) + B T p c = f c Bv + = g + For the index-1 system with (q 1, q 2 ) Q T v: [ 1 ] MQ (q+ 1 q1) c + K(q1, c q2) c + B T p c = f c q c 2 B 1 q B 2 q + 2 = g + B 1 1 (q+ 1 q c 1) + B 2 q c 2 = ġ c Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 12/31

14 What s the Gain Consider the original system M v+ v c The inherent equation for the pressure reads + K(v c ) + B T p c = f c Bv + = g + BM 1 B T p c = Bvc Bv + + BM 1 [f c K(v c )] If we solve the algebraic up to an residual of size ε, then Bv c Bv + = gc g + + εc ε +, i.e. in the pressure, the algebraic error is amplified by 1. Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 13/31

15 What s the Gain While for the index-1 system, BM 1 B T p c = Bvc Bv + + BM 1 [f c K(v c )] Bv c Bv + = gc g + + εc ε + the inherent equation for the pressure reads BM 1 B T p c = 1 [ ] q BQ c 1 q 1 + q 2 c + BM 1 [f c K(q1, c q2)], c which is affected by the algebraic error via [ ] 1 q BQ c 1 q 1 + q 2 c = ġ + + ε c. Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 14/31

16 The Setup Navier-Stokes equations for the cylinder wake at Re = 60 Nonuniform spatial discretization Crouzeix-Raviart finite elements using [FEniCS] about velocity and 5000 pressure nodes Uniform time-discretization Numerically computed reference solution Semi-Explicit Euler scheme GMRes with [KryPy] for the linear systems Fair balancing of the residuals Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 15/31

17 Velocity Approximation q,tol q L 2 Index Index tol = tol = The error in the velocity v versus time step length for varying tolerances tol in the linear solver the + and in the plots denote exact solves (Index-2) and very rough solves (Index-1) Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 16/31

18 Pressure Approximation p,tol p L 2 Index Index tol = tol = The error in the pressure p versus time step length for varying tolerances tol in the linear solver the + and in the plots denote exact solves (Index-2) and very rough solves (Index-1) Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 17/31

19 Residual in the Divergence Constraint Bq,tol g L 2 Index Index tol = tol = The residual in the divergence free constraint versus time step length for varying tolerances tol in the linear solver Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 18/31

20 Conclusion & Outlook Summary: the time integration of semi-discretized flow equations requires some index reduction (well known) Minimal extension can be formulated on the PDE level and numerically realized in FEM by analytical splittings of velocity ansatz spaces (Necessary) future work: Efficiency for the solution of the index-1 systems Formulation for higher order time integration Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 19/31

21 Thank you for your attention Github: github.com/highlando Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 20/31

22 Literature R. Altmann and J. Heiland, Finite element decomposition and minimal extension for flow equations, accepted in M2AN (2015), also available as Preprint from TU Berlin, Germany. A. Gaul, Krypy, Public Git Repository, Commit: 110a1fb756fb, Iterative Solvers for Linear Systems, P. Kunkel and V. Mehrmann, Index reduction for differential-algebraic equations by minimal extension, ZAMM, Z. Angew. Math. Mech. 84 (2004), no. 9, Anders Logg, Kristian B. Ølgaard, Marie E. Rognes, and Garth N. Wells, FFC: the FEniCS form compiler, Automated Solution of Differential Equations by the Finite Element Method, Springer-Verlag, Berlin, Germany, 2012, pp Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 21/31

23 Penalty Method A perturbation in the constraints gives the strangeness-free approximation to the NSEs [ ] [ ] [ ] [ ] [ ] M 0 vε A B T vε f = 0 0 B εi g ṗ ε In Shen 1995 it was shown that in continous space the modelling error behaves like p ε Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 22/31

24 Penalty Method Backdraw Problem: For fixed time step a smaller ε makes the problem ill conditioned: For illustration we observe that with Bv + εp = g the linear case reads M v Av B T p = f or p = 1 [Bv g] ε or M v [A 1 ε BT B]v = f 1 ε Bg and the application of Backward Euler requires solves with the coefficient matrix [ M [A 1 ε BT B] ] which is ill-conditioned if ε. Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 23/31

25 Pressure Poisson Formulations [ ] [ ] [ M 0 v A B T 0 0 ṗ B 0 Differentiation of the constraint, ] [ ] v = p [ ] f g Bv = g becomes B v = ġ, and the application of BM 1 to the differential part leads to the system [ ] [ ] [ ] [ ] [ ] M 0 v A B T v f 0 0 ṗ BM 1 A BM 1 B T = p BM 1, f + ġ which is strangeness-free, since BM 1 B T is invertible. Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 24/31

26 Numerical Treatment of the PPE Formulation [ ] [ M 0 v 0 0 ṗ ] [ A BM 1 A B T BM 1 B T ] [ ] [ ] v f = p BM 1 f + ġ One can use standard time integration methods, e.g. Backward Euler global error is O() in v and p Trapezoidal rule O( 2 ) see Gresho/Sani 2000 for a concise discussion But the solution drifts off the original constraints unless one uses modified discretization schemes Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 25/31

27 Splitting/Projection/PressureCorrection Algorithm Algorithm for one time step according to M un+1 u n Au n B T p n+1 = f n+1 (2) Bu n+1 = g n+1 (3) 1 guess a pressure gradient B T p and solve M ũ un Au n B T p = f n+1 (1 ) 2 Having substracted (1) (1 ) one finds M un+1 ũ B T (p n+1 p) = 0 (4) 3 Use Bu n+1 = g n+1, cf. (2), to solve (3) for (p n+1 p) 4 get u n+1 from (3) and p n+1 = p + (p n+1 p) Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 26/31

28 Splitting/Projection/PressureCorrection Analysis Straight forward implementation for nonlinear formulations but it amplifies the error by 1 correction when solving for the and it also explicitly requires boundary conditions for the pressure It is nothing else than Stabilization by Projection, cf. Hairer/Wanner 2002 for convergence results Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 27/31

29 It is actually a time integration scheme for the strangeness-free system ṽ 0 M 1 A 0 M 1 B T ṽ 0 0 I I M 1 B T 0 v 0 B 0 0 φ = 0 0 BM 1 A 0 BM 1 B T p f 0 g BM 1 f + ġ Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 28/31

30 Divergence Free Bases [ ] [ M 0 v 0 0 ṗ ] [ A BM 1 A B T BM 1 B T ] [ ] [ ] v f = p BM 1 f + ġ Find an orthogonal transformation matrix Q, such that BQ = [R 0] and transform the equations to get [ ] [ ] [ ] R Q T MQ 0 d Q T T [ ] [ ] v QT AQ 0 Q T v Q 0 0 dt p [ ] = T f, p g R 0 0 which can be decomposed into algebraic in differential equations The computation of Q is expensive to unfeasible and if it is done numerically, it may cause instabilities But the system is reduced less computational effort in the time integration Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 29/31

31 Common Solution Approaches M v + K(v) + B T p = f Bv + ɛp = g ( ) (a) Splitting, projection, or pressure correction schemes (b) Pressure penalization scheme (c) Divergence-free methods with common difficulties Need for pressure boundary conditions (a) Parameter dependency (b) Ill-conditioned resulting linear system (b) Instability in the pressure approximation (a-c) Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 30/31

32 References E. Hairer and G. Wanner, Solving ordinary differential equations. II: Stiff and differential-algebraic problems. Springer, R. Rannacher, On the numerical solution of the incompressible Navier-Stokes equations. Z. Angew. Math. Mech. (ZAMM), 73 (1993), no. 9, P. M. Gresho and R. L. Sani, Incompressible flow and the finite element method. Vol. 2: Isothermal laminar flow. Wiley, Max-Planck-Institut Magdeburg J. Heiland, FEM Decomposition for Time Integration for Flows 31/31

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Peter Benner and Jan Heiland November 5, 2015 Seminar Talk at Uni Konstanz Introduction Motivation A controlled physical processes

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

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

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Jie Shen Department of Mathematics, Penn State University University Par, PA 1680, USA Abstract. We present in this

More information

FEM for Stokes Equations

FEM for Stokes Equations FEM for Stokes Equations Kanglin Chen 15. Dezember 2009 Outline 1 Saddle point problem 2 Mixed FEM for Stokes equations 3 Numerical Results 2 / 21 Stokes equations Given (f, g). Find (u, p) s.t. u + p

More information

A Review of Solution Techniques for Unsteady Incompressible Flow

A Review of Solution Techniques for Unsteady Incompressible Flow Zeist 2009 p. 1/57 A Review of Solution Techniques for Unsteady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/57 PDEs Review : 1966 1999 Update : 2000

More information

Vector and scalar penalty-projection methods

Vector and scalar penalty-projection methods Numerical Flow Models for Controlled Fusion - April 2007 Vector and scalar penalty-projection methods for incompressible and variable density flows Philippe Angot Université de Provence, LATP - Marseille

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

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Remark 2.1. Motivation. This chapter deals with the first difficulty inherent to the incompressible Navier Stokes equations, see Remark

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

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

Geometric Numerical Integration

Geometric Numerical Integration Geometric Numerical Integration (Ernst Hairer, TU München, winter 2009/10) Development of numerical ordinary differential equations Nonstiff differential equations (since about 1850), see [4, 2, 1] Adams

More information

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume LIII, Number 1, March 2008 HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS IOAN TELEAGA AND JENS

More information

Time-adaptive methods for the incompressible Navier-Stokes equations

Time-adaptive methods for the incompressible Navier-Stokes equations Time-adaptive methods for the incompressible Navier-Stokes equations Joachim Rang, Thorsten Grahs, Justin Wiegmann, 29.09.2016 Contents Introduction Diagonally implicit Runge Kutta methods Results with

More information

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Sunyoung Bu University of North Carolina Department of Mathematics CB # 325, Chapel Hill USA agatha@email.unc.edu Jingfang

More information

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN Weierstraß-Institut für Angewandte Analysis und Stochastik im Forschungsverbund Berlin e.v. Preprint ISSN 946 8633 Computational comparison between the Taylor Hood and the conforming Crouzeix Raviart element

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

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

More information

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 Jie Shen Department of Mathematics, Penn State University University Park, PA 1682 Abstract. We present some

More information

FETI domain decomposition method to solution of contact problems with large displacements

FETI domain decomposition method to solution of contact problems with large displacements FETI domain decomposition method to solution of contact problems with large displacements Vít Vondrák 1, Zdeněk Dostál 1, Jiří Dobiáš 2, and Svatopluk Pták 2 1 Dept. of Appl. Math., Technical University

More information

Towards pressure-robust mixed methods for the incompressible Navier Stokes equations

Towards pressure-robust mixed methods for the incompressible Navier Stokes equations Mohrenstrasse 39 10117 Berlin Germany Tel. +49 30 20372 0 www.wias-berlin.de 2016-05-05, Pittsburgh Weierstrass Institute for Applied Analysis and Stochastics Towards pressure-robust mixed methods for

More information

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé CMCS/IACS Ecole Polytechnique Federale de Lausanne Erik.Burman@epfl.ch Méthodes Numériques

More information

On finite element methods for 3D time dependent convection diffusion reaction equations with small diffusion

On finite element methods for 3D time dependent convection diffusion reaction equations with small diffusion On finite element methods for 3D time dependent convection diffusion reaction equations with small diffusion Volker John and Ellen Schmeyer FR 6.1 Mathematik, Universität des Saarlandes, Postfach 15 11

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

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

BALANCING-RELATED MODEL REDUCTION FOR DATA-SPARSE SYSTEMS

BALANCING-RELATED MODEL REDUCTION FOR DATA-SPARSE SYSTEMS BALANCING-RELATED Peter Benner Professur Mathematik in Industrie und Technik Fakultät für Mathematik Technische Universität Chemnitz Computational Methods with Applications Harrachov, 19 25 August 2007

More information

WELL POSEDNESS OF PROBLEMS I

WELL POSEDNESS OF PROBLEMS I Finite Element Method 85 WELL POSEDNESS OF PROBLEMS I Consider the following generic problem Lu = f, where L : X Y, u X, f Y and X, Y are two Banach spaces We say that the above problem is well-posed (according

More information

Newton s Method and Efficient, Robust Variants

Newton s Method and Efficient, Robust Variants Newton s Method and Efficient, Robust Variants Philipp Birken University of Kassel (SFB/TRR 30) Soon: University of Lund October 7th 2013 Efficient solution of large systems of non-linear PDEs in science

More information

The antitriangular factorisation of saddle point matrices

The antitriangular factorisation of saddle point matrices The antitriangular factorisation of saddle point matrices J. Pestana and A. J. Wathen August 29, 2013 Abstract Mastronardi and Van Dooren [this journal, 34 (2013) pp. 173 196] recently introduced the block

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

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

Numerical Integration of Equations of Motion

Numerical Integration of Equations of Motion GraSMech course 2009-2010 Computer-aided analysis of rigid and flexible multibody systems Numerical Integration of Equations of Motion Prof. Olivier Verlinden (FPMs) Olivier.Verlinden@fpms.ac.be Prof.

More information

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

More information

NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL

NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL Proceedings of ALGORITMY 212 pp. 29 218 NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL MARTIN HADRAVA, MILOSLAV FEISTAUER, AND PETR SVÁČEK Abstract. The present paper

More information

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller Algebraic flux correction and its application to convection-dominated flow Matthias Möller matthias.moeller@math.uni-dortmund.de Institute of Applied Mathematics (LS III) University of Dortmund, Germany

More information

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems Efficient smoothers for all-at-once multigrid methods for Poisson and Stoes control problems Stefan Taacs stefan.taacs@numa.uni-linz.ac.at, WWW home page: http://www.numa.uni-linz.ac.at/~stefant/j3362/

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

On Multigrid for Phase Field

On Multigrid for Phase Field On Multigrid for Phase Field Carsten Gräser (FU Berlin), Ralf Kornhuber (FU Berlin), Rolf Krause (Uni Bonn), and Vanessa Styles (University of Sussex) Interphase 04 Rome, September, 13-16, 2004 Synopsis

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

NUMERICAL ENCLOSURE OF SOLUTIONS FOR TWO DIMENSIONAL DRIVEN CAVITY PROBLEMS

NUMERICAL ENCLOSURE OF SOLUTIONS FOR TWO DIMENSIONAL DRIVEN CAVITY PROBLEMS European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS 24 P. Neittaanmäki, T. Rossi, K. Majava, and O. Pironneau (eds.) O. Nevanlinna and R. Rannacher (assoc. eds.) Jyväskylä,

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

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

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

Eddy viscosity of cellular flows by upscaling

Eddy viscosity of cellular flows by upscaling Eddy viscosity of cellular flows by upscaling Alexei Novikov a a California Institute of Technology, Applied & Computational Mathematics 1200 E. California Boulevard, MC 217-50, Pasadena, CA 91125, USA

More information

Universität des Saarlandes. Fachrichtung 6.1 Mathematik

Universität des Saarlandes. Fachrichtung 6.1 Mathematik Universität des Saarlandes U N I V E R S I T A S S A R A V I E N I S S Fachrichtung 6.1 Mathematik Preprint Nr. 219 On finite element methods for 3D time dependent convection diffusion reaction equations

More information

Finite Elements for Magnetohydrodynamics and its Optimal Control

Finite Elements for Magnetohydrodynamics and its Optimal Control Finite Elements for Magnetohydrodynamics and its Karl Kunisch Marco Discacciati (RICAM) FEM Symposium Chemnitz September 25 27, 2006 Overview 1 2 3 What is Magnetohydrodynamics? Magnetohydrodynamics (MHD)

More information

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev Implementation of 3D Incompressible N-S Equations Mikhail Sekachev Navier-Stokes Equations The motion of a viscous incompressible fluid is governed by the Navier-Stokes equations u + t u = ( u ) 0 Quick

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

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

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

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations Fourteenth International Conference on Domain Decomposition Methods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 23 DDM.org 2. A Dual-Primal FEI Method for solving Stokes/Navier-Stokes

More information

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Mohamed S. Ebeida Carnegie Mellon University, Pittsburgh, PA 15213 Roger L. Davis and Roland W. Freund

More information

Parallel-in-time integrators for Hamiltonian systems

Parallel-in-time integrators for Hamiltonian systems Parallel-in-time integrators for Hamiltonian systems Claude Le Bris ENPC and INRIA Visiting Professor, The University of Chicago joint work with X. Dai (Paris 6 and Chinese Academy of Sciences), F. Legoll

More information

FINITE ELEMENT APPROXIMATION OF ELLIPTIC DIRICHLET OPTIMAL CONTROL PROBLEMS

FINITE ELEMENT APPROXIMATION OF ELLIPTIC DIRICHLET OPTIMAL CONTROL PROBLEMS Numerical Functional Analysis and Optimization, 28(7 8):957 973, 2007 Copyright Taylor & Francis Group, LLC ISSN: 0163-0563 print/1532-2467 online DOI: 10.1080/01630560701493305 FINITE ELEMENT APPROXIMATION

More information

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

Multi-Factor Finite Differences

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

More information

A Posteriori Estimates for Cost Functionals of Optimal Control Problems

A Posteriori Estimates for Cost Functionals of Optimal Control Problems A Posteriori Estimates for Cost Functionals of Optimal Control Problems Alexandra Gaevskaya, Ronald H.W. Hoppe,2 and Sergey Repin 3 Institute of Mathematics, Universität Augsburg, D-8659 Augsburg, Germany

More information

Reducing round-off errors in symmetric multistep methods

Reducing round-off errors in symmetric multistep methods Reducing round-off errors in symmetric multistep methods Paola Console a, Ernst Hairer a a Section de Mathématiques, Université de Genève, 2-4 rue du Lièvre, CH-1211 Genève 4, Switzerland. (Paola.Console@unige.ch,

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

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

From Completing the Squares and Orthogonal Projection to Finite Element Methods

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

More information

NUMERICAL STUDIES OF VARIATIONAL-TYPE TIME-DISCRETIZATION TECHNIQUES FOR TRANSIENT OSEEN PROBLEM

NUMERICAL STUDIES OF VARIATIONAL-TYPE TIME-DISCRETIZATION TECHNIQUES FOR TRANSIENT OSEEN PROBLEM Proceedings of ALGORITMY 212 pp. 44 415 NUMERICAL STUDIES OF VARIATIONAL-TYPE TIME-DISCRETIZATION TECHNIQUES FOR TRANSIENT OSEEN PROBLEM NAVEED AHMED AND GUNAR MATTHIES Abstract. In this paper, we combine

More information

NUMERICAL METHODS. lor CHEMICAL ENGINEERS. Using Excel', VBA, and MATLAB* VICTOR J. LAW. CRC Press. Taylor & Francis Group

NUMERICAL METHODS. lor CHEMICAL ENGINEERS. Using Excel', VBA, and MATLAB* VICTOR J. LAW. CRC Press. Taylor & Francis Group NUMERICAL METHODS lor CHEMICAL ENGINEERS Using Excel', VBA, and MATLAB* VICTOR J. LAW CRC Press Taylor & Francis Group Boca Raton London New York CRC Press is an imprint of the Taylor & Francis Croup,

More information

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations 2013 SIAM Conference On Computational Science and Engineering Boston, 27 th February 2013 PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations U. Villa,

More information

Termination criteria for inexact fixed point methods

Termination criteria for inexact fixed point methods Termination criteria for inexact fixed point methods Philipp Birken 1 October 1, 2013 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany Department of Mathematics/Computer

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

Chapter 9 Implicit integration, incompressible flows

Chapter 9 Implicit integration, incompressible flows Chapter 9 Implicit integration, incompressible flows The methods we discussed so far work well for problems of hydrodynamics in which the flow speeds of interest are not orders of magnitude smaller than

More information

Finite difference methods for the diffusion equation

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

More information

On Linear-Quadratic Control Theory of Implicit Difference Equations

On Linear-Quadratic Control Theory of Implicit Difference Equations On Linear-Quadratic Control Theory of Implicit Difference Equations Daniel Bankmann Technische Universität Berlin 10. Elgersburg Workshop 2016 February 9, 2016 D. Bankmann (TU Berlin) Control of IDEs February

More information

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Johan Hoffman May 14, 2006 Abstract In this paper we use a General Galerkin (G2) method to simulate drag crisis for a sphere,

More information

A posteriori error estimates applied to flow in a channel with corners

A posteriori error estimates applied to flow in a channel with corners Mathematics and Computers in Simulation 61 (2003) 375 383 A posteriori error estimates applied to flow in a channel with corners Pavel Burda a,, Jaroslav Novotný b, Bedřich Sousedík a a Department of Mathematics,

More information

A connection between grad-div stabilized FE solutions and pointwise divergence-free FE solutions on general meshes

A connection between grad-div stabilized FE solutions and pointwise divergence-free FE solutions on general meshes A connection between grad-div stabilized FE solutions and pointwise divergence-free FE solutions on general meshes Sarah E. Malick Sponsor: Leo G. Rebholz Abstract We prove, for Stokes, Oseen, and Boussinesq

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (1999) 82: 179 191 Numerische Mathematik c Springer-Verlag 1999 Electronic Edition A cascadic multigrid algorithm for the Stokes equations Dietrich Braess 1, Wolfgang Dahmen 2 1 Fakultät für

More information

1. Introduction. Consider nonstationary Navier Stokes equations with a nonslip boundary condition

1. Introduction. Consider nonstationary Navier Stokes equations with a nonslip boundary condition SIAM J. SCI. COMPUT. Vol. 3, No., pp. 398 49 c 8 Society for Industrial and Applied Mathematics LONG TIME NUMERICAL SOLUTION OF THE NAVIER STOKES EQUATIONS BASED ON A SEQUENTIAL REGULARIZATION FORMULATION

More information

Preconditioning for Nonsymmetry and Time-dependence

Preconditioning for Nonsymmetry and Time-dependence Preconditioning for Nonsymmetry and Time-dependence Andy Wathen Oxford University, UK joint work with Jen Pestana and Elle McDonald Jeju, Korea, 2015 p.1/24 Iterative methods For self-adjoint problems/symmetric

More information

Stability of the Parareal Algorithm

Stability of the Parareal Algorithm Stability of the Parareal Algorithm Gunnar Andreas Staff and Einar M. Rønquist Norwegian University of Science and Technology Department of Mathematical Sciences Summary. We discuss the stability of the

More information

Automating the Finite Element Method

Automating the Finite Element Method Automating the Finite Element Method Anders Logg logg@tti-c.org Toyota Technological Institute at Chicago Johan Hoffman, Johan Jansson, Claes Johnson, Robert C. Kirby, Matthew Knepley, Ridgway Scott Simula

More information

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION Proceedings of ALGORITMY pp. 9 3 FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION JAN STEBEL Abstract. The paper deals with the numerical simulations of steady flows

More information

FEniCS Course. Lecture 8: A posteriori error estimates and adaptivity. Contributors André Massing Marie Rognes

FEniCS Course. Lecture 8: A posteriori error estimates and adaptivity. Contributors André Massing Marie Rognes FEniCS Course Lecture 8: A posteriori error estimates and adaptivity Contributors André Massing Marie Rognes 1 / 24 A priori estimates If u H k+1 (Ω) and V h = P k (T h ) then u u h Ch k u Ω,k+1 u u h

More information

On Friedrichs inequality, Helmholtz decomposition, vector potentials, and the div-curl lemma. Ben Schweizer 1

On Friedrichs inequality, Helmholtz decomposition, vector potentials, and the div-curl lemma. Ben Schweizer 1 On Friedrichs inequality, Helmholtz decomposition, vector potentials, and the div-curl lemma Ben Schweizer 1 January 16, 2017 Abstract: We study connections between four different types of results that

More information

Mixed Finite Element Methods. Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016

Mixed Finite Element Methods. Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016 Mixed Finite Element Methods Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016 Linear elasticity Given the load f : Ω R n, find the displacement u : Ω R n and the

More information

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows Author manuscript, published in "5th International Symposium on Finite Volumes for Complex Applications, Aussois : France 2008)" Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible

More information

ITERATIVE METHODS BASED ON KRYLOV SUBSPACES

ITERATIVE METHODS BASED ON KRYLOV SUBSPACES ITERATIVE METHODS BASED ON KRYLOV SUBSPACES LONG CHEN We shall present iterative methods for solving linear algebraic equation Au = b based on Krylov subspaces We derive conjugate gradient (CG) method

More information

A Review of Preconditioning Techniques for Steady Incompressible Flow

A Review of Preconditioning Techniques for Steady Incompressible Flow Zeist 2009 p. 1/43 A Review of Preconditioning Techniques for Steady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/43 PDEs Review : 1984 2005 Update

More information

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations A Least-Squares Finite Element Approximation for the Compressible Stokes Equations Zhiqiang Cai, 1 Xiu Ye 1 Department of Mathematics, Purdue University, 1395 Mathematical Science Building, West Lafayette,

More information

Numerical Methods for Incompressible Viscous Flow

Numerical Methods for Incompressible Viscous Flow Numerical Methods for Incompressible Viscous Flow Hans Petter Langtangen Kent-Andre Mardal Dept. of Scientific Computing, Simula Research Laboratory and Dept. of Informatics, University of Oslo Ragnar

More information

Eddy viscosity of cellular flows by upscaling

Eddy viscosity of cellular flows by upscaling Eddy viscosity of cellular flows by upscaling Alexei Novikov a a California Institute of Technology, Applied & Computational Mathematics 200 E. California Boulevard, MC 27-50, Pasadena, CA 925, USA E-mail:

More information

Initial Temperature Reconstruction for a Nonlinear Heat Equation: Application to Radiative Heat Transfer.

Initial Temperature Reconstruction for a Nonlinear Heat Equation: Application to Radiative Heat Transfer. Proceedings of the 5th International Conference on Inverse Problems in Engineering: Theory and Practice, Cambridge, UK, 11-15th July 2005 Initial Temperature Reconstruction for a Nonlinear Heat Equation:

More information

A note on the uniform perturbation index 1

A note on the uniform perturbation index 1 Rostock. Math. Kolloq. 52, 33 46 (998) Subject Classification (AMS) 65L5 M. Arnold A note on the uniform perturbation index ABSTRACT. For a given differential-algebraic equation (DAE) the perturbation

More information

Stability of Krylov Subspace Spectral Methods

Stability of Krylov Subspace Spectral Methods Stability of Krylov Subspace Spectral Methods James V. Lambers Department of Energy Resources Engineering Stanford University includes joint work with Patrick Guidotti and Knut Sølna, UC Irvine Margot

More information

ON SINGULAR PERTURBATION OF THE STOKES PROBLEM

ON SINGULAR PERTURBATION OF THE STOKES PROBLEM NUMERICAL ANALYSIS AND MATHEMATICAL MODELLING BANACH CENTER PUBLICATIONS, VOLUME 9 INSTITUTE OF MATHEMATICS POLISH ACADEMY OF SCIENCES WARSZAWA 994 ON SINGULAR PERTURBATION OF THE STOKES PROBLEM G. M.

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

A Finite Element Method for the Surface Stokes Problem

A Finite Element Method for the Surface Stokes Problem J A N U A R Y 2 0 1 8 P R E P R I N T 4 7 5 A Finite Element Method for the Surface Stokes Problem Maxim A. Olshanskii *, Annalisa Quaini, Arnold Reusken and Vladimir Yushutin Institut für Geometrie und

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

Efficient FEM-multigrid solver for granular material

Efficient FEM-multigrid solver for granular material Efficient FEM-multigrid solver for granular material S. Mandal, A. Ouazzi, S. Turek Chair for Applied Mathematics and Numerics (LSIII), TU Dortmund STW user committee meeting Enschede, 25th September,

More information

Glowinski Pironneau method for the 3D ω-ψ equations

Glowinski Pironneau method for the 3D ω-ψ equations 280 GUERMOND AND QUARTAPELLE Glowinski Pironneau method for the 3D ω-ψ equations Jean-Luc Guermond and Luigi Quartapelle 1 LIMSI CNRS, Orsay, France, and Dipartimento di Fisica, Politecnico di Milano,

More information

Pressure Poisson Method for the Incompressible Navier-Stokes Equations Using Galerkin Finite Elements

Pressure Poisson Method for the Incompressible Navier-Stokes Equations Using Galerkin Finite Elements Georgia Southern University Digital Commons@Georgia Southern Electronic Theses & Dissertations Graduate Studies, Jack N. Averitt College of Summer 2013 Pressure Poisson Method for the Incompressible Navier-Stokes

More information