Solving PDEs with freefem++

Size: px
Start display at page:

Download "Solving PDEs with freefem++"

Transcription

1 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 Check for new release every month Now in 3D and in MPI OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

2 Outline I 1 Part I: Algorithms Introduction Blocks Rannacher s Projection Scheme for Navier-Stokes eqs Floating Object Fluids and Temperature A Large Example 2 Part II: Playing with Meshes Mesh Adaptivity Domain Decomposition and zoom Application to Hydrology Discontinuous Galerkin freefem++ and Option Pricing OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

3 Introduction freefem++ has two building blocks An elliptic PDE system solver problem, solve A convection module convect Most complex nonlinear problems can be solved by appropriate algorithmic combination of both Except hyperbolic problems with shocks The power of freefem++ is also due to the capacity to handle multiple meshes in one script freefem++ has an advanced mesh adaptivity module OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

4 A simple elliptic problem u = f in Ω, u Ω = u Γ Ω u û f û = 0, Ω û H 1 0 (Ω) Take Ω the unit circle, f a Dirac at x 0, y 0 and u Γ = 0. The problems is solved in variational form approximated by a finite element method : u H 1 0 (Ω) V h = {û C 0 (Ω h ) : u h Tk P 2 triangle in the mesh} Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

5 A simple convection problem Let u be solution of D t u := t u + a u = 0, u(0) = u 0 in Ω, t < T One has D t u(x 0, t 0 ) := lim δt [u(χ(t 0), t 0 ) u(χ(t 0 δt), t 0 δt)] where χ(t) = a(χ(t), t), χ(t 0 ) = x 0 δt 0 1 Hence D t u(x 0 ) 1 δt (um+1 (x 0 ) u m (X m (x 0 ))) with X m (x 0 ) := χ(t δt) x 0 a(x 0 )δt (1) A possible scheme is u m+1 (x) = u m (X m (x)) Π h u m (x a(x)δt) The keyword convect([a1,a2],-dt,u) returns uoχ. Note that the result is not a piecewise polynomial function even when u is. The difference with u(x adt) is a that x adt is not a precise computation of χ(t dt), especially near boundaries. OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

6 A simple convection problem (II) Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

7 A convection diffusion problem Let u be solution of the convection-diffusion-dissipation equation t u + a u (µ u) + bu = 0, u(0) = u 0 in Ω, t < T It can be rewritten as D t u (µ u) + bu = f, u(0) = u 0 where D t u is the convective derivative. Let us use an implicit Euler scheme in time combined with the previous methods [ u m+1 u m ox m ] û + µ u m+1 û + bu m+1 û = 0, û H0 1 (Ω) δt Ω OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

8 Convection Diffusion problem (II) Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

9 Publish the results. e.g. Evolution of u and u 2 This exercise will show how to communicate with the outside world Execute Use gnuplot to create a one dimensional graph >cd /Users/pironneau/Desktop/bilbaoFreefem/edp >gnuplot plot "norms.txt"using 1:2 w l, "norms.txt"using 1:3 w l OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

10 Rannacher s Projection Scheme Her we used Neumann bdy conditions for the PDE instead of Dirichlet to illustrate the fact that u remains constant and u 2 decays exponentially OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

11 Rannacher s Projection Scheme Consider t u + u u + p ν u = 0, u = 0 with u(0) = u 0 and u Γ = u Γ. With X (x) = x u m (x)δt, the following is first order in time: 1 δt (um+1/2 u m ox ) + p m ν u m+1/2 = 0 q = u m+1/2 u m+1/2 u m+1 = u m+1/2 + qδt, p m+1 = p m q p m q Exercise Compare this scheme with a fully coupled scheme like 1 δt (um+1 u m ox ) + p m+1 ν u m+1 = 0, u m+1 = 0 on the driven cavity problem. OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

12 Freefem Script for Fully Implicit and Rannacher s OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

13 Floating Object Consider a cylinder C of radius R and mass µ and center q 0 := x 0 (t), y 0 (t) floating in the flow of a driven cavity with viscosity ν. To find its motion q 0 and its angular velocity ω we must apply Newtons law: µ d2 q 0 dt 2 = d ω dt = q C [ν( u + u T ) p)] n [ ] [ν( u + u T ) p] n q C The no-slip boundary condition on C requires to impose on C a velocity for the fluid equal to q 0 + ω (q q 0 ). The mesh must be rebuilt at each time step because C moves. we shall use the trick u=u to project u defined on the old triangulation onto a u defined on the new one. OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

14 Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

15 Fluids at Varying Temperature The Boussinesq approximation assumes that the density changes slightly with the temperature θ and the buyancy is a force in the fluid: t u + u u + p ν u = aθ e y, u = 0 t θ + u θ κ θ = 0 with u(0) = u 0, θ(0) = θ 0 and u Γ = u Γ, θ Γ = θ Γ. Let us study the case of a box with a hot (θ Γ = 1) and a cold wall (θ Γ = 0) t=0.107 IsoValue t=0.13 IsoValue Vec Value Vec Value OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

16 Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

17 Fluids, Temperature and Turbulence t θ + u θ (κ m T θ) = 0 t u + u u (µ T u) + p + e(θ θ 0 ) e 2, u = 0 k 2 µ T = c µ ɛ, κ T = κµ T t k + u k + ɛ (µ T k) = µ T 2 u + ut 2 ɛ 2 t ɛ + u ɛ + c 2 k c ɛ (µ T ɛ) = c 1 c µ 2 k u + ut 2 = 0 1 δt (θm+1 θ m X m ) (κ m T θ m+1 ) = 0 1 δt (um+1 u m X m ) (µ m T u m+1 ) + p m+1 + e(θ m+1 θ 0 ) e 2, u m+1 1 δt (km+1 k m X m ) + k 1 δt (ɛm+1 ɛ m X m ) + c 2 ɛ µ m+1 T = c µ k m+12 ɛ m+1, m+1 ɛm k m (µm T k m+1 ) = µm T 2 um + u mt 2 m+1 ɛm κm+1 T = κµ m+1 T k m c ɛ (µ m T ɛ m+1 ) = c 1 c µ 2 km u m + u mt 2 OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

18 Fluids, Temperature and Turbulence (II) IsoValue Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

19 Conclusion of Part I 1 Learn Variational Formulations 2 Learn how to devise Algorithms 3 Choose your finite element spaces Thank you for your attention OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

20 Outline I 1 Part I: Algorithms Introduction Blocks Rannacher s Projection Scheme for Navier-Stokes eqs Floating Object Fluids and Temperature A Large Example 2 Part II: Playing with Meshes Mesh Adaptivity Domain Decomposition and zoom Application to Hydrology Discontinuous Galerkin freefem++ and Option Pricing OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

21 Local Error Minimized: Estimated Results OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

22 Mesh Refinement OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

23 Local Error and Adaptivity OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

24 Mesh Refinement OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

25 Domain Decomposition with Overlapping Schwarz Algoritm To Solve u = f in Ω, u Γ = 0 in a domain Ω = Ω 1 Ω 2, on computes u as the limit of u k = f in Ω 1, u k Γ1 = u k 1 u k = f in Ω 2, u k Γ2 = u k 1 OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

26 file ddm.edp Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

27 The Schwarz-Zoom Method γ H (resp γ h ) is the interpolation operator on V H (resp V h ) Find u m+1 H V H, u m+1 h V h, such that w H V 0H, w h V 0h a H (u m+1 H, w H ) = (f, w H ), u m+1 H SH = γ H uh m, um+1 H ΓH = g H, a h (u m+1 h, w h ) = (f, w h ), u m+1 h Sh = γ h uh m, um+1 Γh = g h h OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

28 Hilbert Space Decomposition Method (JL. Lions) Model problem (for instance K = I, f = 1 + δ( x x 0 )): (K v) = f in Ω, u Γ = 0 v = U + u, U H 1 0 (Ω), u Λ H 1 0 (Λ) β(u n+1 U n ) (U n+1 + u n ) = f in Ω β(u n+1 u n ) (U n + u n+1 ) = f in Λ "usmall.gnu" using 1:3 "ularge.gnu" using 1:3 "u.gnu" using 1:3 "log.gnu" using 1: OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

29 The COUPLEX I Test Case Figure: A 2D multilayered geometry 20km long, 500m high with permeability variations K + K = O(10 9 ). Hydrostatic pressure by a FEM. (K H) = 0, H or H given on Γ n OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

30 COUPLEX I : Concentration of Radio-Nucleides Figure: Concentration at 4 times with Discontinuous Galerkin FEM (Apoung-Despré). r t c + λc + u c (K c) = q(t)δ(x x R ) OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

31 Solution by Zoom Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

32 Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

33 Discontinuous Galerkin (II) Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

34 Pricing a Basket Option Find Given U h (T ) = (K S 1 S 2 ) + find U h H h such that V h H h ( t U h )V h [ [ 1 2 S i (σi 2 Si 2 V h ) Si U h µ i S i ( Si U h )V h ] Ω Ω i=1,2 S1 (ρσ 1 σ 2 S 1 S 2 V ) h S2 U h ] Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

35 Heston Model t P (yx)2 2 xxp (yµ)2 yy P ρy 2 xµ xy P r x P + rp = 0 2 P(x, y, T ) = (K x y) + P(0, y, t) = Ke rt P(+, y, t) = 0 y P(x, 0, t) = y P(x, +, t) = 0 Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

36 American Options u t σ2 x 2 2 u 2 x 2 rx u x + ru 0 u u, one is = with u(t, 0) = Ke rt, u(0, x) = u (x) := (K x) + { V = v L 2 (R + ), x v } x L2 (R + ), K = {v L 2 (0, T; V), v u }. Find u K C 0 ([0, T ]; L 2 (R + u )), t L2 (0, T ; V ), s.t. ( u t, v u) + a(u, v u) 0, v K, u(t = 0) = u, with ( σ 2 v w a(v, w) = x2 2 x x + (σ2 + x σ ) x r)x v x w + rvw dx. R + Assume σ [σ, σ] and x x σ 2 < M, then the solution exists and is unique. OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

37 Semi-Smooth Newton Method Kunisch et al suggested to reformulate the problem as a(u, v) (λ, v) = (f, v) v H 1 (R + ), λ min{0, λ + c(u φ)} = 0, i.e.au λ = f The last eq. is equivalent to λ 0, λ λ + c(u φ) i.e. u φ, λ 0, with equality on one of them for each S. This problem is equivalent for any real constant c > 0 because λ is the Lagrange multiplier of the constraint. Newton s algorithm applied to (3) gives Choose c > 0,, u 0, λ 0, set k = 0. Determine A k := {S : λ k (S) + c(u k (S) φ(s)) < 0} Set u k+1 = arg min u H 1 (R + ){ 1 2 a(u, u) (f, u) : u = φ on A k} Set λ k+1 = f Au k+1 OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

38 Results "exercise_250" Best of put basket option, σ 1 = 0.2, σ 2 = 0.1, ρ = 0.8 Execute OP ( www/ann.jussieu.fr/pironneau) Solving PDEs with freefem++ March 13, / 38

A short introduction to FreeFem++

A short introduction to FreeFem++ A short introduction to FreeFem++ M. Ersoy Basque Center for Applied Mathematics 12 November 2010 Outline of the talk Outline of the talk 1 Introduction 2 HOW TO solve steady pdes : e.g. Laplace equation

More information

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

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

More information

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

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems Institute for Mathematics and Scientific Computing, Austria DISC Summerschool 5 Outline of the talk POD and singular value decomposition

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

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

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

Part IV: Numerical schemes for the phase-filed model

Part IV: Numerical schemes for the phase-filed model Part IV: Numerical schemes for the phase-filed model Jie Shen Department of Mathematics Purdue University IMS, Singapore July 29-3, 29 The complete set of governing equations Find u, p, (φ, ξ) such that

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

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

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

More information

Solving Distributed Optimal Control Problems for the Unsteady Burgers Equation in COMSOL Multiphysics

Solving Distributed Optimal Control Problems for the Unsteady Burgers Equation in COMSOL Multiphysics Excerpt from the Proceedings of the COMSOL Conference 2009 Milan Solving Distributed Optimal Control Problems for the Unsteady Burgers Equation in COMSOL Multiphysics Fikriye Yılmaz 1, Bülent Karasözen

More information

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

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

More information

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

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

The Lattice Boltzmann method for hyperbolic systems. Benjamin Graille. October 19, 2016

The Lattice Boltzmann method for hyperbolic systems. Benjamin Graille. October 19, 2016 The Lattice Boltzmann method for hyperbolic systems Benjamin Graille October 19, 2016 Framework The Lattice Boltzmann method 1 Description of the lattice Boltzmann method Link with the kinetic theory Classical

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

Some examples in domain decomposition

Some examples in domain decomposition Some examples in domain decomposition Frédéric Nataf nataf@ann.jussieu.fr, www.ann.jussieu.fr/ nataf Laboratoire J.L. Lions, CNRS UMR7598. Université Pierre et Marie Curie, France Joint work with V. Dolean

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

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations Songul Kaya and Béatrice Rivière Abstract We formulate a subgrid eddy viscosity method for solving the steady-state

More information

Numerical simulations and mesh adaptation : exercise sessions Charles Dapogny 1, Pascal Frey 2, Yannick Privat 2

Numerical simulations and mesh adaptation : exercise sessions Charles Dapogny 1, Pascal Frey 2, Yannick Privat 2 Numerical simulations and mesh adaptation : exercise sessions Charles Dapogny Pascal Frey 2 Yannick Privat 2 The purpose of this exercise session is to give an overview of several aspects of scientific

More information

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

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

More information

CIMPA Summer School on Current Research in Finite Element Methods

CIMPA Summer School on Current Research in Finite Element Methods CIMPA Summer School on Current Research in Finite Element Methods Local zooming techniques for the finite element method Alexei Lozinski Laboratoire de mathématiques de Besançon Université de Franche-Comté,

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 Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Partial Differential Equations (Lecture 1, Week 1) Markus Schmuck Department of Mathematics and Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh

More information

Introduction into Implementation of Optimization problems with PDEs: Sheet 3

Introduction into Implementation of Optimization problems with PDEs: Sheet 3 Technische Universität München Center for Mathematical Sciences, M17 Lucas Bonifacius, Korbinian Singhammer www-m17.ma.tum.de/lehrstuhl/lehresose16labcourseoptpde Summer 216 Introduction into Implementation

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

Past, present and space-time

Past, present and space-time Past, present and space-time Arnold Reusken Chair for Numerical Mathematics RWTH Aachen Utrecht, 12.11.2015 Reusken (RWTH Aachen) Past, present and space-time Utrecht, 12.11.2015 1 / 20 Outline Past. Past

More information

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

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

More information

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

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

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

From Boltzmann Equations to Gas Dynamics: From DiPerna-Lions to Leray

From Boltzmann Equations to Gas Dynamics: From DiPerna-Lions to Leray From Boltzmann Equations to Gas Dynamics: From DiPerna-Lions to Leray C. David Levermore Department of Mathematics and Institute for Physical Science and Technology University of Maryland, College Park

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

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

More information

Vorticity and Dynamics

Vorticity and Dynamics Vorticity and Dynamics In Navier-Stokes equation Nonlinear term ω u the Lamb vector is related to the nonlinear term u 2 (u ) u = + ω u 2 Sort of Coriolis force in a rotation frame Viscous term ν u = ν

More information

Modelling of interfaces and free boundaries

Modelling of interfaces and free boundaries University of Regensburg Regensburg, March 2009 Outline 1 Introduction 2 Obstacle problems 3 Stefan problem 4 Shape optimization Introduction What is a free boundary problem? Solve a partial differential

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

6.2 Governing Equations for Natural Convection

6.2 Governing Equations for Natural Convection 6. Governing Equations for Natural Convection 6..1 Generalized Governing Equations The governing equations for natural convection are special cases of the generalized governing equations that were discussed

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

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

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

More information

Équation de Burgers avec particule ponctuelle

Équation de Burgers avec particule ponctuelle Équation de Burgers avec particule ponctuelle Nicolas Seguin Laboratoire J.-L. Lions, UPMC Paris 6, France 7 juin 2010 En collaboration avec B. Andreianov, F. Lagoutière et T. Takahashi Nicolas Seguin

More information

Preconditioned space-time boundary element methods for the heat equation

Preconditioned space-time boundary element methods for the heat equation W I S S E N T E C H N I K L E I D E N S C H A F T Preconditioned space-time boundary element methods for the heat equation S. Dohr and O. Steinbach Institut für Numerische Mathematik Space-Time Methods

More information

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements W I S S E N T E C H N I K L E I D E N S C H A F T A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements Matthias Gsell and Olaf Steinbach Institute of Computational Mathematics

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

Marching on the BL equations

Marching on the BL equations Marching on the BL equations Harvey S. H. Lam February 10, 2004 Abstract The assumption is that you are competent in Matlab or Mathematica. White s 4-7 starting on page 275 shows us that all generic boundary

More information

Numerical control and inverse problems and Carleman estimates

Numerical control and inverse problems and Carleman estimates Numerical control and inverse problems and Carleman estimates Enrique FERNÁNDEZ-CARA Dpto. E.D.A.N. - Univ. of Sevilla from some joint works with A. MÜNCH Lab. Mathématiques, Univ. Blaise Pascal, C-F 2,

More information

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla Doc-Course: Partial Differential Equations: Analysis, Numerics and Control Research Unit 3: Numerical Methods for PDEs Part I: Finite Element Method: Elliptic and Parabolic Equations Juan Vicente Gutiérrez

More information

Xingye Yue. Soochow University, Suzhou, China.

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

More information

A Stable Spectral Difference Method for Triangles

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

More information

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

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Philippe B. Laval KSU Current Semester Philippe B. Laval (KSU) Key Concepts Current Semester 1 / 25 Introduction The purpose of this section is to define

More information

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS Proceedings of ALGORITMY 2009 pp. 1 10 SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS MILOSLAV VLASÁK Abstract. We deal with a numerical solution of a scalar

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

More information

A posteriori error estimates for the adaptivity technique for the Tikhonov functional and global convergence for a coefficient inverse problem

A posteriori error estimates for the adaptivity technique for the Tikhonov functional and global convergence for a coefficient inverse problem A posteriori error estimates for the adaptivity technique for the Tikhonov functional and global convergence for a coefficient inverse problem Larisa Beilina Michael V. Klibanov December 18, 29 Abstract

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

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

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Global Carleman inequalities and theoretical and numerical control results for systems governed by PDEs

Global Carleman inequalities and theoretical and numerical control results for systems governed by PDEs Global Carleman inequalities and theoretical and numerical control results for systems governed by PDEs Enrique FERNÁNDEZ-CARA Dpto. E.D.A.N. - Univ. of Sevilla joint work with A. MÜNCH Lab. Mathématiques,

More information

u(0) = u 0, u(1) = u 1. To prove what we want we introduce a new function, where c = sup x [0,1] a(x) and ɛ 0:

u(0) = u 0, u(1) = u 1. To prove what we want we introduce a new function, where c = sup x [0,1] a(x) and ɛ 0: 6. Maximum Principles Goal: gives properties of a solution of a PDE without solving it. For the two-point boundary problem we shall show that the extreme values of the solution are attained on the boundary.

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

Interaction of Incompressible Fluid and Moving Bodies

Interaction of Incompressible Fluid and Moving Bodies WDS'06 Proceedings of Contributed Papers, Part I, 53 58, 2006. ISBN 80-86732-84-3 MATFYZPRESS Interaction of Incompressible Fluid and Moving Bodies M. Růžička Charles University, Faculty of Mathematics

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

Basic Aspects of Discretization

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

More information

Chapter 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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Xu Chen Assistant Professor United Technologies Engineering Build, Rm. 382 Department of Mechanical Engineering University of Connecticut xchen@engr.uconn.edu Contents 1

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

Spectral element schemes for the. Korteweg-de Vries and Saint-Venant equations

Spectral element schemes for the. Korteweg-de Vries and Saint-Venant equations Spectral element schemes for the Korteweg-de Vries and Saint-Venant equations R. PASQUETTI a a. Université Côte d Azur, CNRS, Inria, LJAD, France, richard.pasquetti@unice.fr... Résumé : Les sytèmes hyperboliques

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

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

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

An Introduction to Numerical Methods for Differential Equations. Janet Peterson An Introduction to Numerical Methods for Differential Equations Janet Peterson Fall 2015 2 Chapter 1 Introduction Differential equations arise in many disciplines such as engineering, mathematics, sciences

More information

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

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

More information

FEM Convergence for PDEs with Point Sources in 2-D and 3-D

FEM Convergence for PDEs with Point Sources in 2-D and 3-D FEM Convergence for PDEs with Point Sources in 2-D and 3-D Kourosh M. Kalayeh 1, Jonathan S. Graf 2 Matthias K. Gobbert 2 1 Department of Mechanical Engineering 2 Department of Mathematics and Statistics

More information

Approximation of fluid-structure interaction problems with Lagrange multiplier

Approximation of fluid-structure interaction problems with Lagrange multiplier Approximation of fluid-structure interaction problems with Lagrange multiplier Daniele Boffi Dipartimento di Matematica F. Casorati, Università di Pavia http://www-dimat.unipv.it/boffi May 30, 2016 Outline

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

Non-Differentiable Embedding of Lagrangian structures

Non-Differentiable Embedding of Lagrangian structures Non-Differentiable Embedding of Lagrangian structures Isabelle Greff Joint work with J. Cresson Université de Pau et des Pays de l Adour CNAM, Paris, April, 22nd 2010 Position of the problem 1. Example

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Steffen Börm Compiled July 12, 2018, 12:01 All rights reserved. Contents 1. Introduction 5 2. Finite difference methods 7 2.1. Potential equation.............................

More information

Salmon: Lectures on partial differential equations

Salmon: Lectures on partial differential equations 6. The wave equation Of the 3 basic equations derived in the previous section, we have already discussed the heat equation, (1) θ t = κθ xx + Q( x,t). In this section we discuss the wave equation, () θ

More information

POD for Parametric PDEs and for Optimality Systems

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

More information

Proper Orthogonal Decomposition. POD for PDE Constrained Optimization. Stefan Volkwein

Proper Orthogonal Decomposition. POD for PDE Constrained Optimization. Stefan Volkwein Proper Orthogonal Decomposition for PDE Constrained Optimization Institute of Mathematics and Statistics, University of Constance Joined work with F. Diwoky, M. Hinze, D. Hömberg, M. Kahlbacher, E. Kammann,

More information

R T (u H )v + (2.1) J S (u H )v v V, T (2.2) (2.3) H S J S (u H ) 2 L 2 (S). S T

R T (u H )v + (2.1) J S (u H )v v V, T (2.2) (2.3) H S J S (u H ) 2 L 2 (S). S T 2 R.H. NOCHETTO 2. Lecture 2. Adaptivity I: Design and Convergence of AFEM tarting with a conforming mesh T H, the adaptive procedure AFEM consists of loops of the form OLVE ETIMATE MARK REFINE to produce

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

Length Learning Objectives Learning Objectives Assessment

Length Learning Objectives Learning Objectives Assessment Universidade Federal Fluminense PGMEC Course: Advanced Computational Fluid Dynamics Coordinator: Vassilis Theofilis Academic Year: 2018, 2 nd Semester Length: 60hrs (48hrs classroom and 12hrs tutorials)

More information

LECTURE 3: DISCRETE GRADIENT FLOWS

LECTURE 3: DISCRETE GRADIENT FLOWS LECTURE 3: DISCRETE GRADIENT FLOWS Department of Mathematics and Institute for Physical Science and Technology University of Maryland, USA Tutorial: Numerical Methods for FBPs Free Boundary Problems and

More information

Lecture 10. (2) Functions of two variables. Partial derivatives. Dan Nichols February 27, 2018

Lecture 10. (2) Functions of two variables. Partial derivatives. Dan Nichols February 27, 2018 Lecture 10 Partial derivatives Dan Nichols nichols@math.umass.edu MATH 233, Spring 2018 University of Massachusetts February 27, 2018 Last time: functions of two variables f(x, y) x and y are the independent

More information

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

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

More information

Computer simulation of multiscale problems

Computer simulation of multiscale problems Progress in the SSF project CutFEM, Geometry, and Optimal design Computer simulation of multiscale problems Axel Målqvist and Daniel Elfverson University of Gothenburg and Uppsala University Umeå 2015-05-20

More information

Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme

Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme Aravind Balan, Michael Woopen and Georg May AICES Graduate School, RWTH Aachen University, Germany 22nd AIAA Computational

More information

Notes: Outline. Diffusive flux. Notes: Notes: Advection-diffusion

Notes: Outline. Diffusive flux. Notes: Notes: Advection-diffusion Outline This lecture Diffusion and advection-diffusion Riemann problem for advection Diagonalization of hyperbolic system, reduction to advection equations Characteristics and Riemann problem for acoustics

More information

Control of Interface Evolution in Multi-Phase Fluid Flows

Control of Interface Evolution in Multi-Phase Fluid Flows Control of Interface Evolution in Multi-Phase Fluid Flows Markus Klein Department of Mathematics University of Tübingen Workshop on Numerical Methods for Optimal Control and Inverse Problems Garching,

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

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

FEM-Level Set Techniques for Multiphase Flow --- Some recent results

FEM-Level Set Techniques for Multiphase Flow --- Some recent results FEM-Level Set Techniques for Multiphase Flow --- Some recent results ENUMATH09, Uppsala Stefan Turek, Otto Mierka, Dmitri Kuzmin, Shuren Hysing Institut für Angewandte Mathematik, TU Dortmund http://www.mathematik.tu-dortmund.de/ls3

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

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v

More information

10. Buoyancy-driven flow

10. Buoyancy-driven flow 10. Buoyancy-driven flow For such flows to occur, need: Gravity field Variation of density (note: not the same as variable density!) Simplest case: Viscous flow, incompressible fluid, density-variation

More information

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik Numerical analysis of a control and state constrained elliptic control problem with piecewise constant control approximations Klaus Deckelnick and Michael

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