Partitioned Methods for Multifield Problems

Size: px
Start display at page:

Download "Partitioned Methods for Multifield Problems"

Transcription

1 C Partitioned Methods for Multifield Problems Joachim Rang, Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C

2 One-dimensional piston problem fixed wall Fluid flexible piston piston s motion pressure p 0 equilibrium length of the chamber 0 l Joachim Rang Partitioned Methods for Multifield Problems Seite 2 C

3 The one-dimensional piston problem Fluid equations: mass and momentum conservation equations: { ρ t + (ρu) x = 0 (ρu) t + (ρu 2 + p) x = 0 system of conservation laws i. e. hyperbolic system linear dynamic equilibrium of the piston: mq tt + dq t + Kq = p(l 0 + q) p Joachim Rang Partitioned Methods for Multifield Problems Seite 3 C

4 Systems of conservation laws linear advection problem: Burgers equation u t + au x = 0, ( ) u 2 u t + 2 x a R = Joachim Rang Partitioned Methods for Multifield Problems Seite 4 C

5 Linear advection problem initial condition: xxxx u 0 (x) = exp( 10(4x 1) 2 ) periodic boundary condition, a = Joachim Rang Partitioned Methods for Multifield Problems Seite 5 C

6 Linear advection problem initial condition: { 1, 0.2 x 0.3 u 0 (x) = 0, else periodic boundary condition, a = Joachim Rang Partitioned Methods for Multifield Problems Seite 6 C

7 One-dimensional piston problem Fluid (mass and momentum equation conservation equations): ρ t + x (ρu) = 0 t (ρu) + x (ρu2 + p) = 0 ρ... gas density u... flow velocity p... pressure Moreover p ρ = c2 c... sound speed Joachim Rang Partitioned Methods for Multifield Problems Seite 7 C

8 One-dimensional piston problem linear dynamic equilibrium of the piston: mq tt + dq t + Kq = p(l 0 + q) p 0 m... mass d... damping K... stiffness q... displacement q t... velocity q tt... accelaration Joachim Rang Partitioned Methods for Multifield Problems Seite 8 C

9 One-dimensional piston problem equilibrium state: uniform pressure p 0, inside and outside the piston chamber, a uniform gas density ρ 0, a zero flow velocity u 0 = 0 and a chamber length equal to l 0 boundary conditions: ρ(t, 0)u(t, 0) = 0, u(t, l 0 + q) = q t initial conditions: u(0, x) = u 0 (x), ρ(0, x) = ρ 0 (x), q(0, x) = q 0 (x), q t (0, x) = r 0 (x) Joachim Rang Partitioned Methods for Multifield Problems Seite 9 C

10 Discretisation discretisation in space: finite difference scheme with upwinding δẇ j + 1 [ J + 0 h δw j 1 + (J + 0 J 0 )δw j + J 0 δw j+1] = 0. For j = N (interface condition): δẇ N + 1 h [ J + 0 δw N 1 + (J + 0 J 0 )δw ] 1 N h ( ρqt 0 structural equations define Q = (q, q t ). Then ( ) Q = Q + p(l k/m d/m 0 + q) p 0 }{{} m =:D Moreover we have p(l 0 + q) p 0 = c 2 0 δρ N ) = Joachim Rang Partitioned Methods for Multifield Problems Seite 10 C

11 Implementation consider the undamped case, i. e. d = 0. non-dimensional variables: t := c 0 l 0 t, x := x l 0, h := h l 0, q := q l 0, ρ := ρ ρ 0, ρut := ρu ρ 0 c 0, δw := (δρ, δρu) Joachim Rang Partitioned Methods for Multifield Problems Seite 11 C

12 Implementation Then it follows δw j + 1 [ J + 0 h δw j 1 + (J + 0 J 0 )δw j + J 0 δw j+1] = 0, j N, δw N + 1 [ J + 0 h δw N 1 + (J + 0 J 0 )δw N 1 ( q )] = 0, j = N, k 0 q + ω 2 s q = 1 m (δρ N 1) where f = df dt, J+ 0 = 1 ( ω 2 s = kl2 0 mc 2 0 m = m ρ 0 l 0. ) J 0 = 1 2 ( ) Joachim Rang Partitioned Methods for Multifield Problems Seite 12 C

13 Implementation The system can be written as ( δw Q ) ( A B = C D ) ( δw Q ), ( δw(0) Q(0) ) = (0,..., 0, 1), where A = 1 h J + 0 J 0 J 0 J + 0 J + 0 J 0 J 0 ( ) C = m J + 0 J + 0 J 0 J 0 J + 0 J + 0 J 0 ( R 2,2m, D = For the simulation we set m = and ω 2 s = 3.03e ω 2 s 0 0 0, B = 1 h R2m,2 1 0 ) R 2, Joachim Rang Partitioned Methods for Multifield Problems Seite 13 C

14 Implementation spatial discretisation: h = 1/80 time discretisation: implicit Euler method with τ = 1/20 and τ = 1/10 partitioned approach: Block-Jacobi method Joachim Rang Partitioned Methods for Multifield Problems Seite 14 C

15 Numerical result: τ = 2/ Joachim Rang Partitioned Methods for Multifield Problems Seite 15 C

16 Numerical result: τ = 1/ Joachim Rang Partitioned Methods for Multifield Problems Seite 16 C

17 Differential-algebraic equations Differential algebraic equations consists of ordinary differential equations (ODEs) and algebraic constraints. example in a semi-explicit form: u = f(t, u, v) 0 = g(t, u, v) Joachim Rang Partitioned Methods for Multifield Problems Seite 17 C

18 Movement of a pendulum Movement of a pendulum: q 1 = v 1 q 2 = v 2 v 1 = λq 1 v 2 = λq 2 g 0 = q1 2 + q q 1, q 2... coordinates of the pendulum v 1, v 2... velocity λ... unknown Lagrangian multiplier g... gravity last equation: length of pendulum should be constant (algebraic constraint) Joachim Rang Partitioned Methods for Multifield Problems Seite 18 C

19 Heat equation one-dimensional heat equation: u u = f in J Ω with u = g(t) on the boundary Ω and initial condition. semi-discretisation in space: u(t, x i )+ 1 h 2 (2u(t, x i) u(t, x i+1 ) u(t, x i+1 )) = f(t, x i ), i = 1,..., N 1, where x 0 and x N are the nodes on the boundary Joachim Rang Partitioned Methods for Multifield Problems Seite 19 C

20 Heat equation Let u h (t) := (u(t, x 1 ),..., u(t, x N 1 )), f h (t) := (f(t, x 1 ),..., f(t, x N 1 )), A h := h RN 1,N Joachim Rang Partitioned Methods for Multifield Problems Seite 20 C

21 Heat equation The Dirichlet boundary condition can be satisfied by adding two algebraic equations. Then u(t, x 0 ) 0 I 0 u h u(t, x N ) where v 1 A h v v 1 = ( 1/h 2, 0,..., 0), v 2 = (0,..., 0, 1/h 2 ). u(t, x 0 ) u h u(t, x N ) = g(t, x 0 ) f h g(t, x N ), Joachim Rang Partitioned Methods for Multifield Problems Seite 21 C

22 Incompressible Navier Stokes equations incompressible Navier Stokes equations: u Re 1 u + (u )u + p = f in (0, T] Ω, u = 0 in [0, T] Ω, u = g on [0, T] Ω, u(0, ) = u 0 in Ω, p dx = 0 in [0, T], u... velocity u 0... initial velocity p... pressure f... body forces on the right-hand side g... Dirichlet boundary conditions Ω R d, d {2, 3}... a domain Re... Reynolds number Ω Joachim Rang Partitioned Methods for Multifield Problems Seite 22 C

23 Incompressible Navier Stokes equations Assume: homogenous Dirichlet boundary conditions semi-discretisation in space: finite elements. write Navier Stokes equations component-wise: u 1 Re 1 u 1 + u 1 x u 1 + u 2 y u 1 + x p = f 1, u 2 Re 1 u 2 + u 1 x u 2 + u 2 y u 2 + y p = f 2, x u 1 + y u 2 = Joachim Rang Partitioned Methods for Multifield Problems Seite 23 C

24 Incompressible Navier Stokes equations Multiply each equation with a test function v and integrate over domain. Find (u, p) L 2 (0, T; V) L 2 (0, T; Q) with u = (u 1, u 2 ) such that a.e. in (0, T) ( u 1, v 1 ) + Re 1 ( u 1, v 1 ) + (u 1 x u 1 + u 2 y u 1, v 1 ) + ( x p, v 1 ) = (f 1, v 1 ), ( u 2, v 2 ) + Re 1 ( u 2, v 2 ) + (u 1 x u 2 + u 2 y u 2, v 2 ) + ( y p, v 2 ) = (f 2, v 2 ), for all (v, q) V Q holds. (u 1, x q) + (u 2, y q) = Joachim Rang Partitioned Methods for Multifield Problems Seite 24 C

25 Incompressible Navier Stokes equations The Finite Element method approximates the solution of the weak problem in a Finte-Element space V h V and Q h Q. Let V h = W h W h, {ϕ 1,..., ϕ Nu } be a basis of W h and {ψ 1,..., ψ Np } be a basis of Q h. We define the following matrices and vectors (M) ij = (ϕ j, ϕ i ), i, j = 1,..., N u, (A(u)) ij = Re 1 ( ϕ j, ϕ i ) + (u 1 x ϕ j + u 2 y ϕ j, ϕ i ), i, j = 1,..., N u, (B 1 ) ij = ( x ψ j, ϕ i ), i = 1,..., N u, j = 1,..., N p, (B 2 ) ij = ( y ψ j, ϕ i ), i = 1,..., N u, j = 1,..., N p, (f k ) i = (f k, ϕ i ), i = 1,..., N u, k = 1, Joachim Rang Partitioned Methods for Multifield Problems Seite 25 C

26 Incompressible Navier Stokes equations Then M M u 1 u 2 ṗ f 1 = f 2 0 A(u) 0 B 1 0 A(u) B 2 B1 T B2 T 0 u 1 u 2 p or shorter ( M ) ( uṗ ) = ( f 0 ) ( A(u) B B T 0 ) ( u p ). (1) Joachim Rang Partitioned Methods for Multifield Problems Seite 26 C

27 Solution of a linear ODE Let f : J R n be a given continuous function and C R n,n. Consider the linear ODE { u + Cu = f(t). (2) u(0) = u 0 The unique solution is given by t u(t) = e C(t t0) u 0 + e C(t τ) f(τ) dτ. t Joachim Rang Partitioned Methods for Multifield Problems Seite 27 C

28 DAEs are not ODEs Consider the DAE u 1 + u 2 = f 1, u 2 + u 3 = f 2, u 1 = f 3. solution depends on derivatives of the right-hand side numerical problems since differentiating is an ill-posed problem. need no initial conditions. DAE has hidden constraints. If we prescribe some initial conditions we may have the problem that they do not fit with our DAE. If the initial conditions satisfy the DAE then the initial conditions are consistent Joachim Rang Partitioned Methods for Multifield Problems Seite 28 C

29 Differentiation index Let the DAE F(t, u, u) = 0, be uniquely solvable. If v := u is uniquely determined by (t, u) and F(t, u, v) F t (t, u, v) + F u (t, u, v)v + F v (t, u, v) v F k (t, u, v, w) :=. = 0 d k F(t, u, v) dtk with w = (u (2),..., u (k) ) for all consistent initial values and i d is the least such integer that this holds for, we call i d the differentiation index Joachim Rang Partitioned Methods for Multifield Problems Seite 29 C

30 Maximal differentation index Let F be a family of right-hand sides such that, for any δ F, the DAE F(t, û, û) = δ. has only one solution. Then the maximum differentiation index is { i md := max i d is the differentiation index of F(t, û, û) } = δ. δ F Joachim Rang Partitioned Methods for Multifield Problems Seite 30 C

31 Index-1 systems Consider the semi-explicit DAE u 1 = f(u 1, u 2 ), u 1 (0) = u 10, 0 = g(u 1, u 2 ). Let the function f be Lipschitz continuous Let the Jacobian g u 2 be regular Then the DAE has differentiation index Joachim Rang Partitioned Methods for Multifield Problems Seite 31 C

32 Index-2 systems Consider the semi-explicit DAE u 1 = f(u 1, u 2 ), u 1 (0) = u 10, 0 = g(u 1 ), Let the functions f and g be Lipschitz continuous Let the matrix product g f u 1 u 2 be regular Then the DAE has differentiation index two Joachim Rang Partitioned Methods for Multifield Problems Seite 32 C

33 Dynamic iteration scheme Consider the system ẏ 1 = f 1 (y 1, y 2, z 1 ), y 1 (0) = y 10, 0 = h1 (y 1, y 2, z 1, u) 0 = g(y 1, y 2, z 1, z 2 ) ẏ 2 = f 2 (y 1, y 2, z 2 ), y 2 (0) = y 20, 0 = h2 (y 1, y 2, z 2, u) Assumptions: The system is uniquely solvable. Jacobians h h z u g and 0 z are regular differentiation index 1, hi z i, i = 1, Joachim Rang Partitioned Methods for Multifield Problems Seite 33 C

34 Example Let α > 0 and consider the DAE ẏ 1 = 1, y 1 (0) = 0 0 = (α 1)y 1 + αz 1 αu 0 = z 1 z 2 ẏ 2 = 0, y 2 (0) = 0 0 = αz 2 u Then we have h z = ( α 0 0 α ), ( h α u = 1 ), g z = (1, 1) Joachim Rang Partitioned Methods for Multifield Problems Seite 34 C

35 Example It follows h z g z h u 0 = α 0 α 0 α This matrix is regular, if α 0. Moreover we have i. e. the DAE has index 1. h z i = α, Joachim Rang Partitioned Methods for Multifield Problems Seite 35 C

36 A dynamic iteration scheme Gauß Seidel iteration: ( ) ẏ (k+1) 1 = f 1 y (k+1) 1, y (k) 2, z(k+1) 1 ( ) 0 = h1 y (k+1) 1, y (k) 2, (3) z(k+1) 1, u (k) and ( ) ẏ (k+1) 2 = f 2 y (k+1) 1, y (k+1) 2, z (k+1) 2 ( ) 0 = h2 y (k+1) 1, y (k+1) 2, z (k+1) 2, u (k+1) ( ) 0 = g y (k+1) 1, y (k+1) 2, z (k+1) 1, z (k+1) 2. (4) Joachim Rang Partitioned Methods for Multifield Problems Seite 36 C

37 Remarks The initial values y (k+1) 1 (t m ) = y 1 (t m ) and y (k+1) 2 (t m ) = y 2 (t m ) guarantee that y 1 and y 2 are continuous numerical solutions. The algebraic components are in general only piecewise continuous. The dynamic iteration scheme (3) forms an index-1 system since the Jacobian h1 is non-singular. Therefore (3) is uniquely z 1 solvable, if y 1 (t m ) is accurate enough. The initial value z (k+1) 1 is determined by h1 = 0 (as usual). The same argumentation is true for system (4) Joachim Rang Partitioned Methods for Multifield Problems Seite 37 C

38 Remarks The Gauß Seidel iteration is constructed in such a way that z (k) 1 and z (k) 2 do not enter the (k + 1)-st step of the iteration. Therefore only local errors in u and y are propagated during the iteration process. Alternative methods are the Jacobi, the Picard, the SOR iteration and many more Joachim Rang Partitioned Methods for Multifield Problems Seite 38 C

39 Convergence Remember, in the case of linear ODEs convergence may always be archieved, if a sufficiently small τ is used. Let with R i (t) := α := max R 1 2 (t)r 1(t) t J [ g z i ( hi z i ) 1 h i u ], i = 1, 2. The contractivity constant α α < 1 guarantees the convergence of the dynamic iteration scheme for k. Proof: see Arnold/Günther (2001) Joachim Rang Partitioned Methods for Multifield Problems Seite 39 C

40 Example Let α > 0 and consider the DAE ẏ 1 = 1, y 1 (0) = 0 0 = (α 1)y 1 + αz 1 αu 0 = z 1 z 2 ẏ 2 = 0, y 2 (0) = 0 0 = αz 2 u contractivity constant: α time discretisation: implicit Euler method Comparison: monolithical approach and BGS method with 10 and 20 inner iterations Joachim Rang Partitioned Methods for Multifield Problems Seite 40 C

41 Numerical result Joachim Rang Partitioned Methods for Multifield Problems Seite 41 C

42 Convergence Remember: The contractivity constant α α < 1 with α < 1 guarantees the convergence of the dynamic iteration scheme for k. The numbering of the subsystems is significant since it determines their order in the Gauß Seidel method and therefore the contractivity constant. Example: ẏ 1 = 0, y 1 (0) = 0 0 = αz 1 u 0 = z 1 z 2 ẏ 2 = 1, y 2 (0) = 0 0 = (α 1)y 2 + αz 2 αu with the contractivity constant 1/α Joachim Rang Partitioned Methods for Multifield Problems Seite 42 C

43 Numerical result Joachim Rang Partitioned Methods for Multifield Problems Seite 43 C

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems Partitioned Methods for Multifield Problems Joachim Rang, 10.5.2017 10.5.2017 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 Contents Blockform of linear iteration schemes Examples 10.5.2017

More information

The incompressible Navier-Stokes equations in vacuum

The incompressible Navier-Stokes equations in vacuum The incompressible, Université Paris-Est Créteil Piotr Bogus law Mucha, Warsaw University Journées Jeunes EDPistes 218, Institut Elie Cartan, Université de Lorraine March 23th, 218 Incompressible Navier-Stokes

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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

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

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

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

Partial Differential Equations II

Partial Differential Equations II Partial Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Partial Differential Equations II 1 / 28 Almost Done! Homework

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

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

Partititioned Methods for Multifield Problems

Partititioned Methods for Multifield Problems Partititioned Methods for Multifield Problems Joachim Rang, 22.7.215 22.7.215 Joachim Rang Partititioned Methods for Multifield Problems Seite 1 Non-matching matches usually the fluid and the structure

More information

TAU Solver Improvement [Implicit methods]

TAU Solver Improvement [Implicit methods] TAU Solver Improvement [Implicit methods] Richard Dwight Megadesign 23-24 May 2007 Folie 1 > Vortrag > Autor Outline Motivation (convergence acceleration to steady state, fast unsteady) Implicit methods

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

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 10 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Pseudo-Time Integration 1 / 10 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 10 Outline 1

More information

Ordinary Differential Equation Theory

Ordinary Differential Equation Theory Part I Ordinary Differential Equation Theory 1 Introductory Theory An n th order ODE for y = y(t) has the form Usually it can be written F (t, y, y,.., y (n) ) = y (n) = f(t, y, y,.., y (n 1) ) (Implicit

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

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

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

A Finite-Element based Navier-Stokes Solver for LES

A Finite-Element based Navier-Stokes Solver for LES A Finite-Element based Navier-Stokes Solver for LES W. Wienken a, J. Stiller b and U. Fladrich c. a Technische Universität Dresden, Institute of Fluid Mechanics (ISM) b Technische Universität Dresden,

More information

X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow.

X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow. Physical processes by characteristic timescale Diffusive timescale t diff ~ L2 D largest Sound crossing timescale t sound ~ L a Flow timescale t flow ~ L u Free fall timescale Cooling timescale Reaction

More information

On the local well-posedness of compressible viscous flows with bounded density

On the local well-posedness of compressible viscous flows with bounded density On the local well-posedness of compressible viscous flows with bounded density Marius Paicu University of Bordeaux joint work with Raphaël Danchin and Francesco Fanelli Mathflows 2018, Porquerolles September

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

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

7 Hyperbolic Differential Equations

7 Hyperbolic Differential Equations Numerical Analysis of Differential Equations 243 7 Hyperbolic Differential Equations While parabolic equations model diffusion processes, hyperbolic equations model wave propagation and transport phenomena.

More information

Introduction to Hamiltonian systems

Introduction to Hamiltonian systems Introduction to Hamiltonian systems Marlis Hochbruck Heinrich-Heine Universität Düsseldorf Oberwolfach Seminar, November 2008 Examples Mathematical biology: Lotka-Volterra model First numerical methods

More information

Webster s horn model on Bernoulli flow

Webster s horn model on Bernoulli flow Webster s horn model on Bernoulli flow Aalto University, Dept. Mathematics and Systems Analysis January 5th, 2018 Incompressible, steady Bernoulli principle Consider a straight tube Ω R 3 havin circular

More information

Hyperbolic Systems of Conservation Laws. in One Space Dimension. I - Basic concepts. Alberto Bressan. Department of Mathematics, Penn State University

Hyperbolic Systems of Conservation Laws. in One Space Dimension. I - Basic concepts. Alberto Bressan. Department of Mathematics, Penn State University Hyperbolic Systems of Conservation Laws in One Space Dimension I - Basic concepts Alberto Bressan Department of Mathematics, Penn State University http://www.math.psu.edu/bressan/ 1 The Scalar Conservation

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 unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Getting started: CFD notation

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

More information

Block-Structured Adaptive Mesh Refinement

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

More information

Shooting methods for numerical solutions of control problems constrained. by linear and nonlinear hyperbolic partial differential equations

Shooting methods for numerical solutions of control problems constrained. by linear and nonlinear hyperbolic partial differential equations Shooting methods for numerical solutions of control problems constrained by linear and nonlinear hyperbolic partial differential equations by Sung-Dae Yang A dissertation submitted to the graduate faculty

More information

Numerical Methods for Differential Equations Mathematical and Computational Tools

Numerical Methods for Differential Equations Mathematical and Computational Tools Numerical Methods for Differential Equations Mathematical and Computational Tools Gustaf Söderlind Numerical Analysis, Lund University Contents V4.16 Part 1. Vector norms, matrix norms and logarithmic

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

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

IMPACTS OF SIGMA COORDINATES ON THE EULER AND NAVIER-STOKES EQUATIONS USING CONTINUOUS/DISCONTINUOUS GALERKIN METHODS

IMPACTS OF SIGMA COORDINATES ON THE EULER AND NAVIER-STOKES EQUATIONS USING CONTINUOUS/DISCONTINUOUS GALERKIN METHODS Approved for public release; distribution is unlimited IMPACTS OF SIGMA COORDINATES ON THE EULER AND NAVIER-STOKES EQUATIONS USING CONTINUOUS/DISCONTINUOUS GALERKIN METHODS Sean L. Gibbons Captain, United

More information

MATH 23 Exam 2 Review Solutions

MATH 23 Exam 2 Review Solutions MATH 23 Exam 2 Review Solutions Problem 1. Use the method of reduction of order to find a second solution of the given differential equation x 2 y (x 0.1875)y = 0, x > 0, y 1 (x) = x 1/4 e 2 x Solution

More information

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

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

More information

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

Differential equations, comprehensive exam topics and sample questions

Differential equations, comprehensive exam topics and sample questions Differential equations, comprehensive exam topics and sample questions Topics covered ODE s: Chapters -5, 7, from Elementary Differential Equations by Edwards and Penney, 6th edition.. Exact solutions

More information

Igor Cialenco. Department of Applied Mathematics Illinois Institute of Technology, USA joint with N.

Igor Cialenco. Department of Applied Mathematics Illinois Institute of Technology, USA joint with N. Parameter Estimation for Stochastic Navier-Stokes Equations Igor Cialenco Department of Applied Mathematics Illinois Institute of Technology, USA igor@math.iit.edu joint with N. Glatt-Holtz (IU) Asymptotical

More information

On two fractional step finite volume and finite element schemes for reactive low Mach number flows

On two fractional step finite volume and finite element schemes for reactive low Mach number flows Fourth International Symposium on Finite Volumes for Complex Applications - Problems and Perspectives - July 4-8, 2005 / Marrakech, Morocco On two fractional step finite volume and finite element schemes

More information

C.-H. Lamarque. University of Lyon/ENTPE/LGCB & LTDS UMR CNRS 5513

C.-H. Lamarque. University of Lyon/ENTPE/LGCB & LTDS UMR CNRS 5513 Nonlinear Dynamics of Smooth and Non-Smooth Systems with Application to Passive Controls 3rd Sperlonga Summer School on Mechanics and Engineering Sciences on Dynamics, Stability and Control of Flexible

More information

Boundary layer flows The logarithmic law of the wall Mixing length model for turbulent viscosity

Boundary layer flows The logarithmic law of the wall Mixing length model for turbulent viscosity Boundary layer flows The logarithmic law of the wall Mixing length model for turbulent viscosity Tobias Knopp D 23. November 28 Reynolds averaged Navier-Stokes equations Consider the RANS equations with

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

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

Partial Differential Equations

Partial Differential Equations Part II Partial Differential Equations Year 2015 2014 2013 2012 2011 2010 2009 2008 2007 2006 2005 2015 Paper 4, Section II 29E Partial Differential Equations 72 (a) Show that the Cauchy problem for u(x,

More information

Multiple integrals: Sufficient conditions for a local minimum, Jacobi and Weierstrass-type conditions

Multiple integrals: Sufficient conditions for a local minimum, Jacobi and Weierstrass-type conditions Multiple integrals: Sufficient conditions for a local minimum, Jacobi and Weierstrass-type conditions March 6, 2013 Contents 1 Wea second variation 2 1.1 Formulas for variation........................

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Splitting based Implicit solvers for compressible fluid models

Splitting based Implicit solvers for compressible fluid models Splitting based Implicit solvers for compressible fluid models D. Coulette 3, E. Franck 1, M. Gaja 2, P. Helluy 3, J. Lakhlili 2, M. Mazza 2, M. Mehrenberger 3, A. Ratnani 2, S. Serra-Capizzano 4, E. Sonnendrücker

More information

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Numerical Methods - Initial Value Problems for ODEs

Numerical Methods - Initial Value Problems for ODEs Numerical Methods - Initial Value Problems for ODEs Y. K. Goh Universiti Tunku Abdul Rahman 2013 Y. K. Goh (UTAR) Numerical Methods - Initial Value Problems for ODEs 2013 1 / 43 Outline 1 Initial Value

More information

Chapter 3 Burgers Equation

Chapter 3 Burgers Equation Chapter 3 Burgers Equation One of the major challenges in the field of comple systems is a thorough understanding of the phenomenon of turbulence. Direct numerical simulations (DNS) have substantially

More information

Relativistic Hydrodynamics L3&4/SS14/ZAH

Relativistic Hydrodynamics L3&4/SS14/ZAH Conservation form: Remember: [ q] 0 conservative div Flux t f non-conservative 1. Euler equations: are the hydrodynamical equations describing the time-evolution of ideal fluids/plasmas, i.e., frictionless

More information

Skew-Symmetric Schemes for compressible and incompressible flows

Skew-Symmetric Schemes for compressible and incompressible flows Skew-Symmetric Schemes for compressible and incompressible flows Julius Reiss Fachgebiet für Numerische Fluiddynamik TU Berlin CEMRACS J. Reiss (TU Berlin) Skew-Symmetric Schemes August 8 th, 202 / 46

More information

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

Numerik 2 Motivation

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

More information

Relaxation methods and finite element schemes for the equations of visco-elastodynamics. Chiara Simeoni

Relaxation methods and finite element schemes for the equations of visco-elastodynamics. Chiara Simeoni Relaxation methods and finite element schemes for the equations of visco-elastodynamics Chiara Simeoni Department of Information Engineering, Computer Science and Mathematics University of L Aquila (Italy)

More information

Math 266 Midterm Exam 2

Math 266 Midterm Exam 2 Math 266 Midterm Exam 2 March 2st 26 Name: Ground Rules. Calculator is NOT allowed. 2. Show your work for every problem unless otherwise stated (partial credits are available). 3. You may use one 4-by-6

More information

FVM for Fluid-Structure Interaction with Large Structural Displacements

FVM for Fluid-Structure Interaction with Large Structural Displacements FVM for Fluid-Structure Interaction with Large Structural Displacements Željko Tuković and Hrvoje Jasak Zeljko.Tukovic@fsb.hr, h.jasak@wikki.co.uk Faculty of Mechanical Engineering and Naval Architecture

More information

arxiv: v2 [math.na] 1 Sep 2018

arxiv: v2 [math.na] 1 Sep 2018 High-order, linearly stable, partitioned solvers for general multiphysics problems based on implicit-explicit Runge-Kutta schemes D. Z. Huang a,,, P.-O. Persson b,c,, M. J. Zahr b,d,3,4, a Institute for

More information

To study the motion of a perfect gas, the conservation equations of continuity

To study the motion of a perfect gas, the conservation equations of continuity Chapter 1 Ideal Gas Flow The Navier-Stokes equations To study the motion of a perfect gas, the conservation equations of continuity ρ + (ρ v = 0, (1.1 momentum ρ D v Dt = p+ τ +ρ f m, (1.2 and energy ρ

More information

Conservation laws and some applications to traffic flows

Conservation laws and some applications to traffic flows Conservation laws and some applications to traffic flows Khai T. Nguyen Department of Mathematics, Penn State University ktn2@psu.edu 46th Annual John H. Barrett Memorial Lectures May 16 18, 2016 Khai

More information

arxiv: v3 [math.na] 18 Feb 2019

arxiv: v3 [math.na] 18 Feb 2019 Constraint-consistent Runge-Kutta methods for one-dimensional incompressible multiphase flow B. Sanderse a, A.E.P. Veldman b a Centrum Wiskunde & Informatica (CWI), Amsterdam, The Netherlands b Bernoulli

More information

(1) u (t) = f(t, u(t)), 0 t a.

(1) u (t) = f(t, u(t)), 0 t a. I. Introduction 1. Ordinary Differential Equations. In most introductions to ordinary differential equations one learns a variety of methods for certain classes of equations, but the issues of existence

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

Finite Element Decompositions for Stable Time Integration of Flow Equations

Finite Element Decompositions for Stable Time Integration of Flow Equations 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

More information

The Hopf equation. The Hopf equation A toy model of fluid mechanics

The Hopf equation. The Hopf equation A toy model of fluid mechanics The Hopf equation A toy model of fluid mechanics 1. Main physical features Mathematical description of a continuous medium At the microscopic level, a fluid is a collection of interacting particles (Van

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

The Implicit and Inverse Function Theorems Notes to supplement Chapter 13.

The Implicit and Inverse Function Theorems Notes to supplement Chapter 13. The Implicit and Inverse Function Theorems Notes to supplement Chapter 13. Remark: These notes are still in draft form. Examples will be added to Section 5. If you see any errors, please let me know. 1.

More information

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16.

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16. CAVITY INSPECTION NDT&E Methods: UT VJ Technologies NDT&E Methods: UT 6. NDT&E: Introduction to Methods 6.1. Ultrasonic Testing: Basics of Elasto-Dynamics 6.2. Principles of Measurement 6.3. The Pulse-Echo

More information

1 2 predators competing for 1 prey

1 2 predators competing for 1 prey 1 2 predators competing for 1 prey I consider here the equations for two predator species competing for 1 prey species The equations of the system are H (t) = rh(1 H K ) a1hp1 1+a a 2HP 2 1T 1H 1 + a 2

More information

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand Institute of Aerospace Thermodynamics Numerical modelling of phase change processes in clouds Challenges and Approaches Martin Reitzle Bernard Weigand Introduction Institute of Aerospace Thermodynamics

More information

Computational Fluid Dynamics I + II. Mathematische Strömungslehre I + II

Computational Fluid Dynamics I + II. Mathematische Strömungslehre I + II Computational Fluid Dynamics I + II Mathematische Strömungslehre I + II Prof. Dr.-Ing. D. Hänel Aerodynamisches Institut RWTH Aachen Contents 1 Governing equations of fluid dynamics 1 1.1 General formulation

More information

Practice Problems For Test 3

Practice Problems For Test 3 Practice Problems For Test 3 Power Series Preliminary Material. Find the interval of convergence of the following. Be sure to determine the convergence at the endpoints. (a) ( ) k (x ) k (x 3) k= k (b)

More information

A Hybrid Method for the Wave Equation. beilina

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

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations Professor Dr. E F Toro Laboratory of Applied Mathematics University of Trento, Italy eleuterio.toro@unitn.it http://www.ing.unitn.it/toro September 19, 2014 1 / 55 Motivation

More information

Advanced methods for ODEs and DAEs. Lecture 9: Multistep methods/ Differential algebraic equations

Advanced methods for ODEs and DAEs. Lecture 9: Multistep methods/ Differential algebraic equations Advanced methods for ODEs and DAEs Lecture 9: Multistep methods/ Differential algebraic equations Bojana Rosic, 22. Juni 2016 PART I: MULTISTEP METHODS 22. Juni 2016 Bojana Rosić Advanced methods for ODEs

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

Solvability of the Incompressible Navier-Stokes Equations on a Moving Domain with Surface Tension. 1. Introduction

Solvability of the Incompressible Navier-Stokes Equations on a Moving Domain with Surface Tension. 1. Introduction Solvability of the Incompressible Navier-Stokes Equations on a Moving Domain with Surface Tension Hantaek Bae Courant Institute of Mathematical Sciences, New York University 251 Mercer Street, New York,

More information

Computational Fluid Dynamics 2

Computational Fluid Dynamics 2 Seite 1 Introduction Computational Fluid Dynamics 11.07.2016 Computational Fluid Dynamics 2 Turbulence effects and Particle transport Martin Pietsch Computational Biomechanics Summer Term 2016 Seite 2

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Linearization and Characteristic Relations 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

More information

ORDINARY DIFFERENTIAL EQUATIONS

ORDINARY DIFFERENTIAL EQUATIONS ORDINARY DIFFERENTIAL EQUATIONS GABRIEL NAGY Mathematics Department, Michigan State University, East Lansing, MI, 4884 NOVEMBER 9, 7 Summary This is an introduction to ordinary differential equations We

More information

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013 ADI iterations for general elliptic problems John Strain Mathematics Department UC Berkeley July 2013 1 OVERVIEW Classical alternating direction implicit (ADI) iteration Essentially optimal in simple domains

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

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

PDEs, part 3: Hyperbolic PDEs

PDEs, part 3: Hyperbolic PDEs PDEs, part 3: Hyperbolic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2011 Hyperbolic equations (Sections 6.4 and 6.5 of Strang). Consider the model problem (the

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

Differential Equations and Modeling

Differential Equations and Modeling Differential Equations and Modeling Preliminary Lecture Notes Adolfo J. Rumbos c Draft date: March 22, 2018 March 22, 2018 2 Contents 1 Preface 5 2 Introduction to Modeling 7 2.1 Constructing Models.........................

More information

Mathematics for Engineers II. lectures. Differential Equations

Mathematics for Engineers II. lectures. Differential Equations Differential Equations Examples for differential equations Newton s second law for a point mass Consider a particle of mass m subject to net force a F. Newton s second law states that the vector acceleration

More information

Divergence Theorem and Its Application in Characterizing

Divergence Theorem and Its Application in Characterizing Divergence Theorem and Its Application in Characterizing Fluid Flow Let v be the velocity of flow of a fluid element and ρ(x, y, z, t) be the mass density of fluid at a point (x, y, z) at time t. Thus,

More information

Alberto Bressan. Department of Mathematics, Penn State University

Alberto Bressan. Department of Mathematics, Penn State University Non-cooperative Differential Games A Homotopy Approach Alberto Bressan Department of Mathematics, Penn State University 1 Differential Games d dt x(t) = G(x(t), u 1(t), u 2 (t)), x(0) = y, u i (t) U i

More information

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8)

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8) Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8) Contents Important concepts, definitions, etc...2 Exact solutions of some differential equations...3 Estimates of solutions to differential

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

Optimal control problems with PDE constraints

Optimal control problems with PDE constraints Optimal control problems with PDE constraints Maya Neytcheva CIM, October 2017 General framework Unconstrained optimization problems min f (q) q x R n (real vector) and f : R n R is a smooth function.

More information

Quasi-potential for Burgers equation

Quasi-potential for Burgers equation Quasi-potential for Burgers equation Open Systems, Zurich, June 1, 29 L. Bertini, A. De Sole, D. Gabrielli, G. Jona-Lasinio, C. Landim Boundary Driven WASEP State Space: Fix N 1. {, 1} {1,...,N 1} η =

More information

Moving interface problems. for elliptic systems. John Strain Mathematics Department UC Berkeley June 2010

Moving interface problems. for elliptic systems. John Strain Mathematics Department UC Berkeley June 2010 Moving interface problems for elliptic systems John Strain Mathematics Department UC Berkeley June 2010 1 ALGORITHMS Implicit semi-lagrangian contouring moves interfaces with arbitrary topology subject

More information

Optimal control of nonstructured nonlinear descriptor systems

Optimal control of nonstructured nonlinear descriptor systems Optimal control of nonstructured nonlinear descriptor systems TU Berlin DFG Research Center Institut für Mathematik MATHEON Workshop Elgersburg 19.02.07 joint work with Peter Kunkel Overview Applications

More information

Introduction of Partial Differential Equations and Boundary Value Problems

Introduction of Partial Differential Equations and Boundary Value Problems Introduction of Partial Differential Equations and Boundary Value Problems 2009 Outline Definition Classification Where PDEs come from? Well-posed problem, solutions Initial Conditions and Boundary Conditions

More information