Méthode de quasi-newton en interaction fluide-structure. J.-F. Gerbeau & M. Vidrascu

Size: px
Start display at page:

Download "Méthode de quasi-newton en interaction fluide-structure. J.-F. Gerbeau & M. Vidrascu"

Transcription

1 Méthode de quasi-newton en interaction fluide-structure J.-F. Gerbeau & M. Vidrascu

2 Motivations médicales Athérosclérose :

3 Sistole Diastole La formation des plaques est liée, entre autre, la dynamique du sang et aux contraintes exercées sur la paroi. S S Recirculation Zone Ce que pourrait permettre la simulation : mieux comprendre le phénomène prévoir les conséquences d opérations chirurgicales améliorer les prothèses

4 1. Problem statement Purpose : simulate the mechanical interaction between the wall and the blood in a portion of large vessels

5 1.1. General equations Fluid models : Navier-Stokes 2D or 3D (u, p) in Arbitrary Lagrange Euler formulation (w) Structure models : Structure 1D (d = d r e r ) : cylindrical geometry, linear elasticity ρ w h 2 d r t 2 kgh 2 d r z 2 + Eh 1 ν 2 d r R 2 0 γ 3 d r z 2 t = f Σ Structure 2D (d). Shell model in large displacements (MITC) Coupling Fluid-Structure interface Σ t (reference configuration ˆΣ) : < f Σ, ϕ >= u Σt = d t ˆΣ Σ t (pn 2µɛ(u) n) ϕ dσ

6 1.2. Variational formulation Let ˆv and ϕ test fonctions independent of t on ˆΩ, with v = 0 on Σ t. Ω F (t) d dt ρ F u v div w dx Ω F (t) ρ F u v dx + Ω F (t) p div v dx + Ω F (t) ρ F (u w) u v dx Ω F (t) 2µɛ(u) ɛ(v) dx = 0 Ω F (t) Ω F (t) q div u = 0 w v = 0 ˆΩ S ρ S 2 d t 2 ϕ dˆx + a(d, ϕ) = < f Σ t, ϕ >

7 1.3. Time discretization. Fluid. (implicit Euler) Ω n+1 F 1 δt ρ F u n+1 v + Ω n+1 F ρ F u n+1 v div w n+1 ρ F (u n+1 w n+1 ) u n+1 v Ω n+1 F p div v + Ω n+1 F 2µɛ(u n+1 ) ɛ(v) = 1 δt Ω n+1 F Ω n+1 F q div u n+1 = 0 ρ F u n v Ω n F u n+1 Σ n+1 = dn+1 d n Ω n+1 w n+1 v = 0 δt w n+1 Σ n+1 = u n+1 Σ n+1 f Σ n+1 = F(d n+1 )

8 1.4. Time discretization. Structure. (mid-point) v ρ S ˆΩS n+1 S v n S δt ϕ dˆx a(dn, ϕ) a(dn+1, ϕ) = < f Σ n+1, ϕ > d n+1 d n δt = vn+1 S + v n S 2 where < f Σ n+1, ϕ > is the residual of the fluid problem d n+1 = S(f Σ n+1)

9 1.5. Fluid/structure coupling. Two main approaches : (i) Staggered schemes (Piperno, Fahrat, Larrouturou,...) At each time step : basically one resolution of F and one resolution of S. this seems to be unsuitable for blood flows (ii) Implicit schemes (Le Tallec & Mouro) At each time step a nonlinear problem to be solved : d n+1 = S F(d n+1 ) Advantages : stability (energy balance) Drawback : expensive!

10 2.1. Fixed point algorithms Naive fixed point algorithm (i) d 0 = d n (ii) d k+1 = S F(d k ) does not converge! 2. Numerical algorithms

11 Relaxed fixed point algorithm with prediction (i) d 0 = d n + 3δt 2 vn S δt 2 vn 1 S (ii) d k+1 = S F(d k ) (iii) d k+1 = ω k dk+1 + (1 ω k )d k

12 How to choose ω k? : (i) by hand : ω k = ω (ii) Domain decomposition (Le Tallec - Mouro) : reformulate the fixed point algorithm as a preconditioned gradient method applied to an interface problem (iii) Aitken-like acceleration formula (Mok - Wall - Ramm) : heuristic generalization in n dimensions, of the formula that gives the exact solution for affine functions in 1D : ω k = (d k d k 1 ) (d k S F(d k ) d k 1 + S F(d k 1 )) d k S F(d k ) d k 1 + S F(d k 1 ) 2 Mok & co. concluded that (iii) gave slightly better results compared to (ii).

13 Domain decomposition method (formal) A F II A F IΣ 0 A F ΣI A F ΣΣ + AS ΣΣ AS ΣI 0 A S IΣ A S II df I d Σ d S I = bf I b Σ b S I (d F I = δt u F I ) (i) Fluid solver with Dirichlet boundary conditions : A F II df I,k+1 = bf I AF IΣ d Σ,k (ii) Residual (force) computation : F Σ,k+1 = A F ΣI df I,k+1 + AF ΣΣ d Σ,k (iii) Structure solver with Neumann boundary conditions : [ A S ΣΣ A S ΣI A S IΣ A S II ] [ dσ,k+1 d S I,k+1 ] = [ bσ F Σ,k+1 b S I ] (iv) d Σ,k+1 = ω k dσ,k+1 + (1 ω k )d Σ,k

14 Eliminate d F I,k+1 in (i) and (ii) (SF = A F ΣΣ AF ΣI (AF II ) 1 A F IΣ ) F Σ,k+1 = S F d F Σ,k + A F ΣI(A F II) 1 b F I Eliminate d S I,k+1 in (iii) (SS = A S ΣΣ AS ΣI (A II) 1 A S IΣ ) S S dσ,k+1 = b Σ A S ΣI(A S II) 1 b S I F Σ,k+1 S S dσ,k+1 = S F d Σ,k + b Σ A S ΣI(A S II) 1 b S I A F ΣI(A F II) 1 b F I d Σ,k+1 = (S S ) 1 ( b S F d Σ,k )

15 Relaxation : d Σ,k+1 = ω k dσ,k+1 + (1 ω k )d Σ,k = = d Σ,k + ω k ([ d Σ,k+1 d Σ,k ) ] d Σ,k + ω k (S S ) 1 ( b S F d Σ,k ) + d Σ,k = d Σ,k + ω k (S S ) 1 [ b (S F + S S )d Σ,k ] We recognize a gradient method for the solution of (S F + S S )d Σ = b preconditionned by S S. this gives a way to design ω k (e.g. steepest descent)

16 Benchmark test ( Mok, Wall, Ramm in 2D) Fluid : ρ F = 1, µ = 0.01 Structure : ρ S = 500, E = 250, h = u(t) = 1 cos ( ω t ) rigid wall rigid wall flexible bottom

17 MODULEF : vidrascu 03/09/02 tracou.data NOMBRE DE COURBES : 3 EXTREMA EN X : E+03 EXTREMA EN Y : -0.68E : B : A : C TRACE DE COURBES

18 Pressure wave in artery Fluid blood Structure artery Po P in Pout t = 0 : u = 0, P = P 0 = 0. { 0 < t < 5 ms : Pin = 10 mmhg t > 5 ms : P in = 0

19 160 Aitken constant relaxation number of iterations time

20 2.2. Quasi-Newton algorithms (i) d 0 = d n + 3δt 2 vn S δt 2 vn 1 S (ii) R (d k )δd k = R(d k ) (iii) d k+1 = d k + λ k δd k R is a suitable approximation of R R = I S F Rd = 0 λ k is determined via a linesearch strategy.

21 First possibility : automatic differentiation... Second possibility : (Brown & Saad) The linear system at step (ii) is solved approximatively with a few iterations of GMRES. The matrix/vector products R (d k )z are evaluated by computing : R(d k + hz) R(d k ) h or (better) R(d k + hz) R(d k hz) 2h It works, but it s expensive and it s difficult to choose h. Third possibility : evaluate the continuous Jacobian of the fluid structure problem (Fernandez & Moubachir). To be tested! Fourth possibility : use a reduced model.

22 3.1. Classical 1D model : 3. Reduced FSI models cylinder axial symmetry no radial velocity z ex ez e y z z=z - A = S (area of S) - Q = - p = 1 A(z) S u z dσ (flux through S) ou u = Q A S p dσ (mean pressure moyenne)

23 mass conservation : div u = 0 = A t + Q z = 0 momentum along z : u z t +div (u zu)+ 1 ρ F p z ν u z = 0 = Q t + z (α Q2 A ) + A p ρ F z + K Q R A = 0 wall law : relation between p and A e.g. : Φ(A) = p 0 + πh0 E (1 ν 2 )A 0 ( A A0 ) = p = β 0 + β A Main difficulties : geometry : cylinder mean value variables : 3D 1D 3D

24 3.2. A new reduced model An important feature in fluid structure interaction problems in blood flow is the so-called mass added effect. This effect can be captured with a non-viscous linear fluid model : ρ F t u + p = 0 on Ω F div u = 0 on Ω F u n = t d n on Σ or, p = 0 on Ω F p n = ρ u F t n on Σ

25 3.3. The special case of the generalized wave equation Notation : p = 0 on Ω F p n = g on Σ p = p d on Γ Generalized wave equation for the structure : p Σ = M A g ρ S 2 d r t 2 a 2 d r z 2 + bd r c 3 d r z 2 t = p Σ u Simplified fluid model : p Σ = ρ F M A t n = ρ 2 d r F M A t 2 Simplified fluid-structure problem : (ρ S + ρ F M A ) 2 d r t 2 a 2 d r z 2 + bd r c 3 d r z 2 t = 0

26 3.4. Three possible applications of the reduced model With 1D model structure (wave equation) : (i) A good candidate for studying fluid-structure algorithms (ii) A possible alternative for classical FSI 1D models With general structure models : (iii) A good candidate for approximating the jacobian in Quasi-Newton algorithms

27 (i) A good candidate for studying fluid-structure algorithms it is rather simple (linear) it shares two important features with the real model : lots of sub-structuring iterations are needed to converge analogous property of propagation

28 35 Simplified model Complete model number of iterations time

29 Why staggered algorithm does not work in blood flows? Implicit algorithm : (ρ S + ρ F M A ) vn+1 S v n S δt Staggered algorithm : u n+1 n = v n+1 S a 2 d n+1/2 r z 2 n + bd n+1/2 r c 3 d n+1/2 r z 2 t = 0 u n+1 n = v n S n v n+1 S v n S ρ S δt v n S + ρ F M vn 1 S A δt a 2 d n+1/2 r z 2 + bd n+1/2 r c 3 d n+1/2 r z 2 t = 0

30 D n+1 V n+1 W n+1 = P D n V n W n Spectral property of the iteration matrix P : For ρ F /ρ S > (roughly) : λ k >> 1 λ k increases when δt decreases

31 (ii) A possible alternative for classical FSI 1D models versus [ ] A t Q + Q Q z 2 A + β = 0 3 A3/2 K Q A (ρ S + ρ F M A ) 2 d t 2 a 2 d z 2 + bd c 3 d z 2 t = 0 What has been lost? nonlinearity viscous effect What has been gained? same variables as the complete model (3D-3D) realistic structure response

32 (iii) Approximate the tangent operator of the real problem (i) Prediction : d 0 = d n + 3δt 2 vn S δt 2 vn 1 S (ii) Resolution of R (d k )δd k = R(d k ) evaluate R(d k ) (with R = I S F) Solve the linear system with GMRES (tolerance 10 3, about 8 iterations). The matrix/vector products being evaluated by : R (d k )z = z S (F(d k )) F (d k )z one resolution of a scalar Poisson problem (instead of Navier-Stokes) one resolution of the linearized structure (already computed and factorized during the structure solution) (iii) d k+1 = d k + λ k δd k In practice the linesearch procedure is never activated (λ k = 1) : the approximated jacobian is not so bad!

33 35 Quasi-Newton Aitken number of iterations time

34 50 45 Quasi-Newton Aitken number of iterations time

35 Mean number of fluid-structure evaluations : Computational time : Aitken Quasi-Newton Speed up 2D D Aitken Quasi-Newton Speed up 2D 43 min 16 min 2.7 3D 12 h 16 5 h

A domain decomposition framework for fluid-structure interaction problems

A domain decomposition framework for fluid-structure interaction problems A domain decomposition framework for fluid-structure interaction problems Simone Deparis 1, Marco Discacciati 1, and Alfio Quarteroni 1,2 1 Institute of Analysis and Scientific Computing, CMCS-IACS, EPF

More information

Numerical Simulations of the Fluid-Structure Coupling in Physiological Vessels Mini-Workshop I

Numerical Simulations of the Fluid-Structure Coupling in Physiological Vessels Mini-Workshop I Numerical Simulations of the Fluid-Structure Coupling in Physiological Vessels INRIA Rocquencourt, projet REO miguel.fernandez@inria.fr CRM Spring School, Montréal May 16, 2005 Motivations It is generally

More information

A QUASI-NEWTON ALGORITHM BASED ON A REDUCED MODEL FOR FLUID-STRUCTURE INTERACTION PROBLEMS IN BLOOD FLOWS

A QUASI-NEWTON ALGORITHM BASED ON A REDUCED MODEL FOR FLUID-STRUCTURE INTERACTION PROBLEMS IN BLOOD FLOWS ESAIM: M2AN Vol. 37, N o 4, 2003, pp. 631 647 DOI: 10.1051/m2an:2003049 ESAIM: Mathematical Modelling and Numerical Analysis A QUASI-NEWTON ALGORITHM BASED ON A REDUCED MODEL OR LUID-STRUCTURE INTERACTION

More information

Coupling techniques for partitioned fluid structure interaction simulations with black box solvers

Coupling techniques for partitioned fluid structure interaction simulations with black box solvers Coupling techniques for partitioned fluid structure interaction simulations with black box solvers Joris Degroote 1, Robby Haelterman 2, Sebastiaan Annerel 1, Jan Vierendeels 1 1 Ghent University, Department

More information

Fluid-structure algorithms based on Steklov-Poincaré operators

Fluid-structure algorithms based on Steklov-Poincaré operators Fluid-structure algorithms based on Steklov-Poincaré operators S. Deparis, M. Discacciati, G. Fourestey, A. Quarteroni April 25, 2005 Abstract In this paper we review some classical algorithms for fluid-structure

More information

A multi-solver quasi-newton method for the partitioned simulation of fluid-structure interaction

A multi-solver quasi-newton method for the partitioned simulation of fluid-structure interaction A multi-solver quasi-newton method for the partitioned simulation of fluid-structure interaction J Degroote, S Annerel and J Vierendeels Department of Flow, Heat and Combustion Mechanics, Ghent University,

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

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

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Modeling, Simulating and Rendering Fluids Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Applications Mostly Hollywood Shrek Antz Terminator 3 Many others Games Engineering Animating Fluids is

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

A modular, operator splitting scheme for fluid-structure interaction problems with thick structures

A modular, operator splitting scheme for fluid-structure interaction problems with thick structures Numerical Analysis and Scientific Computing Preprint Seria A modular, operator splitting scheme for fluid-structure interaction problems with thick structures M. Bukač S. Čanić R. Glowinski B. Muha A.

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

Fourier Series Development for Solving a Steady Fluid Structure Interaction Problem

Fourier Series Development for Solving a Steady Fluid Structure Interaction Problem Int. J. Contemp. Math. Sciences, Vol. 8, 203, no. 2, 75-84 HIKARI Ltd, www.m-hikari.com Fourier Series Development for Solving a Steady Fluid Structure Interaction Problem Ibrahima Mbaye University of

More information

A monolithic approach to fluid-composite structure interaction

A monolithic approach to fluid-composite structure interaction Noname manuscript No. (will be inserted by the editor) A monolithic approach to fluid-composite structure interaction Davide Forti Martina Buac Annalisa Quaini Suncica Canic Simone Deparis Received: date

More information

A monolithic FEM solver for fluid structure

A monolithic FEM solver for fluid structure A monolithic FEM solver for fluid structure interaction p. 1/1 A monolithic FEM solver for fluid structure interaction Stefan Turek, Jaroslav Hron jaroslav.hron@mathematik.uni-dortmund.de Department of

More information

PROBLEM SET 6. SOLUTIONS April 1, 2004

PROBLEM SET 6. SOLUTIONS April 1, 2004 Harvard-MIT Division of Health Sciences and Technology HST.54J: Quantitative Physiology: Organ Transport Systems Instructors: Roger Mark and Jose Venegas MASSACHUSETTS INSTITUTE OF TECHNOLOGY Departments

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

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint. " = " x,t,#, #

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint.  =  x,t,#, # Notes Assignment 4 due today (when I check email tomorrow morning) Don t be afraid to make assumptions, approximate quantities, In particular, method for computing time step bound (look at max eigenvalue

More information

A monolithic fluid structure interaction solver Verification and Validation Application: venous valve motion

A monolithic fluid structure interaction solver Verification and Validation Application: venous valve motion 1 / 41 A monolithic fluid structure interaction solver Verification and Validation Application: venous valve motion Chen-Yu CHIANG O. Pironneau, T.W.H. Sheu, M. Thiriet Laboratoire Jacques-Louis Lions

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

Large Scale Fluid-Structure Interaction by coupling OpenFOAM with external codes

Large Scale Fluid-Structure Interaction by coupling OpenFOAM with external codes Large Scale Fluid-Structure Interaction by coupling OpenFOAM with external codes Thomas Gallinger * Alexander Kupzok Roland Wüchner Kai-Uwe Bletzinger Lehrstuhl für Statik Technische Universität München

More information

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

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

More information

An Operator Splitting Approach to the Solution of Fluid-Structure Interaction Problems in Hemodynamics

An Operator Splitting Approach to the Solution of Fluid-Structure Interaction Problems in Hemodynamics An Operator Splitting Approach to the Solution of Fluid-Structure Interaction Problems in Hemodynamics Martina Bukač, Sunčica Čanić, Boris Muha, and Roland Glowinski Abstract We present a loosely coupled

More information

Course Outline. 2. Vectors in V 3.

Course Outline. 2. Vectors in V 3. 1. Vectors in V 2. Course Outline a. Vectors and scalars. The magnitude and direction of a vector. The zero vector. b. Graphical vector algebra. c. Vectors in component form. Vector algebra with components.

More information

An arbitrary lagrangian eulerian discontinuous galerkin approach to fluid-structure interaction and its application to cardiovascular problem

An arbitrary lagrangian eulerian discontinuous galerkin approach to fluid-structure interaction and its application to cardiovascular problem An arbitrary lagrangian eulerian discontinuous galerkin approach to fluid-structure interaction and its application to cardiovascular problem Yifan Wang University of Houston, Department of Mathematics

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

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

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

Spatial discretization scheme for incompressible viscous flows

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

More information

A semi-implicit approach for fluid-structure interaction based on an algebraic fractional step method

A semi-implicit approach for fluid-structure interaction based on an algebraic fractional step method A semi-implicit approach for fluid-structure interaction based on an algebraic fractional step method Annalisa Quaini, Alfio Quarteroni 3rd October 6 Chair of Modelling and Scientific Computing (CMCS),

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

Navier-Stokes Flow in Cylindrical Elastic Tubes

Navier-Stokes Flow in Cylindrical Elastic Tubes Navier-Stokes Flow in Cylindrical Elastic Tubes Taha Sochi University College London, Department of Physics & stronomy, Gower Street, London, WC1E 6BT Email: t.sochi@ucl.ac.uk. bstract nalytical expressions

More information

Extrapolation methods for accelerating unsteady partitioned fluid-structure interaction simulations

Extrapolation methods for accelerating unsteady partitioned fluid-structure interaction simulations Int. Jnl. of Multiphysics Volume 5 Number 4 211 287 Extrapolation methods for accelerating unsteady partitioned fluid-structure interaction simulations Stephen Sachs*, Marcel Streitenberger, Dörte C. Sternel**,

More information

arxiv: v2 [math.ap] 4 Mar 2016

arxiv: v2 [math.ap] 4 Mar 2016 Existence of a weak solution to a fluid-elastic structure interaction problem with the Navier slip boundary condition Boris Muha Sunčica Čanić arxiv:155.446v [math.ap] 4 Mar 16 Abstract We study a nonlinear,

More information

Numerical Analysis of Electromagnetic Fields

Numerical Analysis of Electromagnetic Fields Pei-bai Zhou Numerical Analysis of Electromagnetic Fields With 157 Figures Springer-Verlag Berlin Heidelberg New York London Paris Tokyo Hong Kong Barcelona Budapest Contents Part 1 Universal Concepts

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

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

Implementing a Partitioned Algorithm for Fluid-Structure Interaction of Flexible Flapping Wings within Overture

Implementing a Partitioned Algorithm for Fluid-Structure Interaction of Flexible Flapping Wings within Overture 10 th Symposimum on Overset Composite Grids and Solution Technology, NASA Ames Research Center Moffett Field, California, USA 1 Implementing a Partitioned Algorithm for Fluid-Structure Interaction of Flexible

More information

Least-Squares Finite Element Methods

Least-Squares Finite Element Methods Pavel В. Bochev Max D. Gunzburger Least-Squares Finite Element Methods Spri ringer Contents Part I Survey of Variational Principles and Associated Finite Element Methods 1 Classical Variational Methods

More information

Coupling Stokes and Darcy equations: modeling and numerical methods

Coupling Stokes and Darcy equations: modeling and numerical methods Coupling Stokes and Darcy equations: modeling and numerical methods Marco Discacciati NM2PorousMedia 24 Dubrovnik, September 29, 24 Acknowledgment: European Union Seventh Framework Programme (FP7/27-23),

More information

Stability of the kinematically coupled β-scheme for fluid-structure interaction problems in hemodynamics

Stability of the kinematically coupled β-scheme for fluid-structure interaction problems in hemodynamics Numerical Analysis and Scientific Computing Preprint Seria Stability of the kinematically coupled β-scheme for fluid-structure interaction problems in hemodynamics S. Čanić B. Muha M. Bukač Preprint #13

More information

A Fully Implicit Domain Decomposition Based ALE Framework for Three-dimensional Fluid-structure Interaction with Application in Blood Flow Computation

A Fully Implicit Domain Decomposition Based ALE Framework for Three-dimensional Fluid-structure Interaction with Application in Blood Flow Computation A Fully Implicit Domain Decomposition Based ALE Framework for Three-dimensional Fluid-structure Interaction with Application in Blood Flow Computation Yuqi Wu a, Xiao-Chuan Cai b a Department of Applied

More information

Efficient Solvers for the Navier Stokes Equations in Rotation Form

Efficient Solvers for the Navier Stokes Equations in Rotation Form Efficient Solvers for the Navier Stokes Equations in Rotation Form Computer Research Institute Seminar Purdue University March 4, 2005 Michele Benzi Emory University Atlanta, GA Thanks to: NSF (MPS/Computational

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Fundamentals of Linear Elasticity

Fundamentals of Linear Elasticity Fundamentals of Linear Elasticity Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research of the Polish Academy

More information

Approximate- vs. full-hessian in FWI: 1D analytical and numerical experiments

Approximate- vs. full-hessian in FWI: 1D analytical and numerical experiments Approximate- vs. full-hessian in FWI: 1D analytical and numerical experiments Raul Cova and Kris Innanen ABSTRACT Feasibility of using Full Waveform Inversion (FWI) to build velocity models has been increasing

More information

Adjoint code development and optimization using automatic differentiation (AD)

Adjoint code development and optimization using automatic differentiation (AD) Adjoint code development and optimization using automatic differentiation (AD) Praveen. C Computational and Theoretical Fluid Dynamics Division National Aerospace Laboratories Bangalore - 560 037 CTFD

More information

Quick Recapitulation of Fluid Mechanics

Quick Recapitulation of Fluid Mechanics Quick Recapitulation of Fluid Mechanics Amey Joshi 07-Feb-018 1 Equations of ideal fluids onsider a volume element of a fluid of density ρ. If there are no sources or sinks in, the mass in it will change

More information

arxiv: v1 [math.na] 3 May 2018

arxiv: v1 [math.na] 3 May 2018 ; :1 25 Fluid-structure interaction simulations of venous valves: a monolithic ALE method for large structural displacements arxiv:1805.01321v1 [math.na] 3 May 2018 S. Calandrini 1 *, E. Aulisa 1 1 Department

More information

Natural States and Symmetry Properties of. Two-Dimensional Ciarlet-Mooney-Rivlin. Nonlinear Constitutive Models

Natural States and Symmetry Properties of. Two-Dimensional Ciarlet-Mooney-Rivlin. Nonlinear Constitutive Models Natural States and Symmetry Properties of Two-Dimensional Ciarlet-Mooney-Rivlin Nonlinear Constitutive Models Alexei Cheviakov, Department of Mathematics and Statistics, Univ. Saskatchewan, Canada Jean-François

More information

SF2822 Applied Nonlinear Optimization. Preparatory question. Lecture 9: Sequential quadratic programming. Anders Forsgren

SF2822 Applied Nonlinear Optimization. Preparatory question. Lecture 9: Sequential quadratic programming. Anders Forsgren SF2822 Applied Nonlinear Optimization Lecture 9: Sequential quadratic programming Anders Forsgren SF2822 Applied Nonlinear Optimization, KTH / 24 Lecture 9, 207/208 Preparatory question. Try to solve theory

More information

A Harmonic Balance Approach for Large-Scale Problems in Nonlinear Structural Dynamics

A Harmonic Balance Approach for Large-Scale Problems in Nonlinear Structural Dynamics A Harmonic Balance Approach for Large-Scale Problems in Nonlinear Structural Dynamics Allen R, PhD Candidate Peter J Attar, Assistant Professor University of Oklahoma Aerospace and Mechanical Engineering

More information

Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence

Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence Rohit Dhariwal and Vijaya Rani PI: Sarma L. Rani Department of Mechanical and Aerospace

More information

examples of equations: what and why intrinsic view, physical origin, probability, geometry

examples of equations: what and why intrinsic view, physical origin, probability, geometry Lecture 1 Introduction examples of equations: what and why intrinsic view, physical origin, probability, geometry Intrinsic/abstract F ( x, Du, D u, D 3 u, = 0 Recall algebraic equations such as linear

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

Review for Exam 2 Ben Wang and Mark Styczynski

Review for Exam 2 Ben Wang and Mark Styczynski Review for Exam Ben Wang and Mark Styczynski This is a rough approximation of what we went over in the review session. This is actually more detailed in portions than what we went over. Also, please note

More information

Linear Solvers. Andrew Hazel

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

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

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

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

Math and Numerical Methods Review

Math and Numerical Methods Review Math and Numerical Methods Review Michael Caracotsios, Ph.D. Clinical Associate Professor Chemical Engineering Department University of Illinois at Chicago Introduction In the study of chemical engineering

More information

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

A numerical study of vortex-induced vibrations (viv) in an elastic cantilever

A numerical study of vortex-induced vibrations (viv) in an elastic cantilever A numerical study of vortex-induced vibrations (viv) in an elastic cantilever Lorentzon, Johan; Austrell, Per Erik; Szász, Robert-Zoltán; Revstedt, Johan 2009 Link to publication Citation for published

More information

Preprint Alexander Heinlein, Axel Klawonn, and Oliver Rheinbach Parallel Two-Level Overlapping Schwarz Methods in Fluid-Structure Interaction

Preprint Alexander Heinlein, Axel Klawonn, and Oliver Rheinbach Parallel Two-Level Overlapping Schwarz Methods in Fluid-Structure Interaction Fakultät für Mathematik und Informatik Preprint 2015-15 Alexander Heinlein, Axel Klawonn, and Oliver Rheinbach Parallel Two-Level Overlapping Schwarz Methods in Fluid-Structure Interaction ISSN 1433-9307

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

Numerical Optimization Algorithms

Numerical Optimization Algorithms Numerical Optimization Algorithms 1. Overview. Calculus of Variations 3. Linearized Supersonic Flow 4. Steepest Descent 5. Smoothed Steepest Descent Overview 1 Two Main Categories of Optimization Algorithms

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

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

Iterative Solvers in the Finite Element Solution of Transient Heat Conduction

Iterative Solvers in the Finite Element Solution of Transient Heat Conduction Iterative Solvers in the Finite Element Solution of Transient Heat Conduction Mile R. Vuji~i} PhD student Steve G.R. Brown Senior Lecturer Materials Research Centre School of Engineering University of

More information

Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems

Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems Martin Engel and Michael Griebel Institute of Numerical Simulation, University of Bonn, Wegelerstr.

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

Partitioned Methods for Multifield Problems

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

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

fluid mechanics as a prominent discipline of application for numerical

fluid mechanics as a prominent discipline of application for numerical 1. fluid mechanics as a prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid

More information

A Multigrid LCR-FEM solver for viscoelastic fluids with application to problems with free surface

A Multigrid LCR-FEM solver for viscoelastic fluids with application to problems with free surface A Multigrid LCR-FEM solver for viscoelastic fluids with application to problems with free surface Damanik, H., Mierka, O., Ouazzi, A., Turek, S. (Lausanne, August 2013) Page 1 Motivation Polymer melts:

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling

Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling Brian A. Lockwood, Markus P. Rumpfkeil, Wataru Yamazaki and Dimitri J. Mavriplis Mechanical Engineering

More information

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

More information

University of Washington Department of Chemistry Chemistry 453 Winter Quarter 2013

University of Washington Department of Chemistry Chemistry 453 Winter Quarter 2013 Lecture 1 3/13/13 University of Washington Department of Chemistry Chemistry 53 Winter Quarter 013 A. Definition of Viscosity Viscosity refers to the resistance of fluids to flow. Consider a flowing liquid

More information

Numerical Simulation of Newtonian and Non-Newtonian Flows in Bypass

Numerical Simulation of Newtonian and Non-Newtonian Flows in Bypass Numerical Simulation of Newtonian and Non-Newtonian Flows in Bypass Vladimír Prokop, Karel Kozel Czech Technical University Faculty of Mechanical Engineering Department of Technical Mathematics Vladimír

More information

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

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

More information

7.4 The Saddle Point Stokes Problem

7.4 The Saddle Point Stokes Problem 346 CHAPTER 7. APPLIED FOURIER ANALYSIS 7.4 The Saddle Point Stokes Problem So far the matrix C has been diagonal no trouble to invert. This section jumps to a fluid flow problem that is still linear (simpler

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

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

The Shallow Water Equations

The Shallow Water Equations If you have not already done so, you are strongly encouraged to read the companion file on the non-divergent barotropic vorticity equation, before proceeding to this shallow water case. We do not repeat

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

Solving PDEs with freefem++

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

More information

MAE210C: Fluid Mechanics III Spring Quarter sgls/mae210c 2013/ Solution II

MAE210C: Fluid Mechanics III Spring Quarter sgls/mae210c 2013/ Solution II MAE210C: Fluid Mechanics III Spring Quarter 2013 http://web.eng.ucsd.edu/ sgls/mae210c 2013/ Solution II D 4.1 The equations are exactly the same as before, with the difference that the pressure in the

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

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

More information

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy Antony Jameson 1 1 Thomas V. Jones Professor of Engineering Department of Aeronautics and Astronautics Stanford University

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Modeling using conservation laws. Let u(x, t) = density (heat, momentum, probability,...) so that. u dx = amount in region R Ω. R

Modeling using conservation laws. Let u(x, t) = density (heat, momentum, probability,...) so that. u dx = amount in region R Ω. R Modeling using conservation laws Let u(x, t) = density (heat, momentum, probability,...) so that u dx = amount in region R Ω. R Modeling using conservation laws Let u(x, t) = density (heat, momentum, probability,...)

More information

CURRENT MATERIAL: Vector Calculus.

CURRENT MATERIAL: Vector Calculus. Math 275, section 002 (Ultman) Fall 2011 FINAL EXAM REVIEW The final exam will be held on Wednesday 14 December from 10:30am 12:30pm in our regular classroom. You will be allowed both sides of an 8.5 11

More information

Application of Chimera Grids in Rotational Flow

Application of Chimera Grids in Rotational Flow CES Seminar Write-up Application of Chimera Grids in Rotational Flow Marc Schwalbach 292414 marc.schwalbach@rwth-aachen.de Supervisors: Dr. Anil Nemili & Emre Özkaya, M.Sc. MATHCCES RWTH Aachen University

More information

Chapter 1 Mathematical Foundations

Chapter 1 Mathematical Foundations Computational Electromagnetics; Chapter 1 1 Chapter 1 Mathematical Foundations 1.1 Maxwell s Equations Electromagnetic phenomena can be described by the electric field E, the electric induction D, the

More information

Physic-based Preconditioning and B-Splines finite elements method for Tokamak MHD

Physic-based Preconditioning and B-Splines finite elements method for Tokamak MHD Physic-based Preconditioning and B-Splines finite elements method for Tokamak MHD E. Franck 1, M. Gaja 2, M. Mazza 2, A. Ratnani 2, S. Serra Capizzano 3, E. Sonnendrücker 2 ECCOMAS Congress 2016, 5-10

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

Lecture No 1 Introduction to Diffusion equations The heat equat

Lecture No 1 Introduction to Diffusion equations The heat equat Lecture No 1 Introduction to Diffusion equations The heat equation Columbia University IAS summer program June, 2009 Outline of the lectures We will discuss some basic models of diffusion equations and

More information