A monolithic FEM solver for fluid structure

Size: px
Start display at page:

Download "A monolithic FEM solver for fluid structure"

Transcription

1 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 Applied Mathematics, LS III, University of Dortmund

2 A monolithic FEM solver for fluid structure interaction p. 2/1 Fluid structure interaction large deformation structure in internal/external flow (bioengineering) pulsative flow in large blood vessel with obstacles flow through heart flaps flow in a heart ventricle... physical model parts to deal with viscous fluid flow elastic body undergoing large deformations numerical tasks involved space and time discretization nonlinear system solution solution of large linear system the interaction between the two parts

3 A monolithic FEM solver for fluid structure interaction p. 3/1 Problem description Γ 2 Γ 1 Γ3 Ω s Ω f Γ 0 χ s χ f Γ 2 t Γ 1 t Γ 0 t Γ 3 t Ω s t Ω f t reference configuration current configuration structure part fluid part χ s : Ω s [0, T ] Ω s t u s = χ s (X, t) X, v s = us t F = I + Grad u s, J = det F χ f : Ω f [0, T ] Ω f t u f = χ f (X, t) X v f : Ω f t [0, T ] Rn

4 A monolithic FEM solver for fluid structure interaction p. 4/1 Governing equations structure part fluid part v s t = div(jσ s F T ) + f in Ω s det(i + u s ) = 1 in Ω s u s = 0 on Γ 2 σ s n = 0 on Γ 3 v f t + ( v f )v f = div σ f + f in Ω f t div v f = 0 in Ω f t v f = v 0 on Γ 1 t or σ f n = 0 on Γ 1 t interface conditions v f = v s σ f n = σ s n on Γ 0 t on Γ 0 t

5 A monolithic FEM solver for fluid structure interaction p. 5/1 Arbitrary Lagrangian-Eulerian Formulation χ : Ω [0, T ] Ω t, v = χ t, F = χ X, J = det F ζ R : R [0, T ] R t, R t Ω t t [0, T ], v R = ζ R t, F R = ζ R X, J R = det F R t Z Z ϱdv + ϱ(v v R ) n Rt da = 0 R t R t t (ϱj R) + div ϱj R (v v R )F T R = 0 Lagrangian description: ζ R = χ F R = F, J R = J, v R = v t (ϱj) = 0 Eulerian description: ζ R = Id F R = I, J R = 1, v R = 0 ϱ t + div(ϱv) = 0

6 A monolithic FEM solver for fluid structure interaction p. 6/1 Governing equations structure part v s t = div(jσ s F T ) + f in Ω s det(i + u s ) = 1 in Ω s u s = 0 on Γ 2 σ s n = 0 on Γ 3 fluid part v f t + ( v f )F 1 v f = div div Jv f F T = 0 Jσ f F T + f in Ω f in Ω f v f = v 0 or σ f n = 0 on Γ 1

7 A monolithic FEM solver for fluid structure interaction p. 7/1 Coupling strategies separated, weak coupling t n fluid t n solid t n+1 fluid t n+1 solid... separated, strong coupling t n fluid t n solid t n+1 fluid t n+1 solid... monolithic t n fluid & solid t n+1 fluid & solid...

8 A monolithic FEM solver for fluid structure interaction p. 8/1 Uniform formulation Ω = Ω f Ω s, u : Ω [0, T ] R 3, v : Ω [0, T ] R 3, 8 < v in Ω s : u ( mesh deformation operator ) in Ω f 8 < div `Jσ s F T in Ω s : β( v)f 1 (v u t ) + div `Jσ f F T in Ω f 8 < J 1 in Ω s 0 = : div(jvf T ) in Ω f u t = β v t = σ f n = σ s n on Γ 0 t v = v B u = 0 σ s n = 0 on Γ 1 t on Γ 2 t on Γ 3 t

9 A monolithic FEM solver for fluid structure interaction p. 9/1 Constitutive equations incompressible Newtonian fluid σ f = pi + ν( v + v T ) ν = ν( D ), D = v + v T hyperelastic material σ s = pi + 2F Ψ F FT where C = FF T and I C = tr C, I C = 1 2 neo-hookean compressible material Ψ(F) =α(i C 3) Ψ(F) =α 1 (I C 3) + α 2 (I C 3) + α 3 ( Fe 1) 2 `tr C 2 (tr C) 2 neo-hookean incompressible material σ s = p s I + µ(ff T I) p s =λ(det F det F 1 ) σ s = p s I + µ(ff T I) det F =I (λ )

10 A monolithic FEM solver for fluid structure interaction p. 10/1 Energy estimate for the system Z c T 2 v(t ) 2 L 2 (Ω T ) + 0 µ v 2 L 2 (Ω f t ) dt + a u(t ) 2 L 2 (Ω s ) b L 1 (Ω s ) v 0 2 L 2 (Ω f ) + β 2 v 0 2 L 2 (Ω s ) U = {u L (I, [W 1,2 (Ω)] 3 ), u = 0 on Γ 2 } V = {v L 2 (I, [W 1,2 (Ω t )] 3 ) L (I, [L 2 (Ω t )] 3 ), v = 0 on Γ 1 } P = {p L 2 (I, L 2 (Ω))}

11 A monolithic FEM solver for fluid structure interaction p. 11/1 Discretization in space and time Discretization in space: FEM Q 2 /Q 2 /P disc 1 y x v h, u h p h, p h x, p h y U h = {u h [C(Ω h )] 2, u h T [Q 2 (T )] 2 T T h, u h = 0 on Γ 1 }, V h = {v h [C(Ω h )] 2, v h T [Q 2 (T )] 2 T T h, v h = 0 on Γ 2 }, P h = {p h L 2 (Ω h ), p h T P 1 (T ) T T h }. Discretization in time: Crank-Nicholson scheme with adaptive time-step selection

12 A monolithic FEM solver for fluid structure interaction p. 12/1 Discrete nonlinear system R(X) =0, X = (u h, v h, p h ) U h V h P h Mu h k 2 (M s v h + L f u h ) = rhs(u n h, vn h ) (M f + βm s )v h + k 2 N 1(v h, v h ) N 2(v h, u h ) + k 2 (Ss (u h ) + S f (v h )) kbp h = rhs(u n h, vn h, pn h ) R X (X) = N 2 u h + k 2 C(u h ) + B f T vh = 1 M k 2 Lf k 2 M 1 s 0 (N 1 +S s +S f ) u + k B h u p h M s + βm f + 1 N 2 h 2 v + k (N 1 +S 2 f ) h 2 v kbc h A B st + Bf T u v h B f T 0 h

13 A monolithic FEM solver for fluid structure interaction p. 12/1 Discrete nonlinear system R(X) =0, X = (u h, v h, p h ) U h V h P h Mu h k 2 (M s v h + L f u h ) = rhs(u n h, vn h ) (M f + βm s )v h + k 2 N 1(v h, v h ) N 2(v h, u h ) + k 2 (Ss (u h ) + S f (v h )) kbp h = rhs(u n h, vn h, pn h ) C(u h ) + B f T vh = S uu S uv 0 S vu S vv kb c u B T s c v B T f u v p = Typical discrete saddle-point problem f u f v f p 3 7 5

14 A monolithic FEM solver for fluid structure interaction p. 13/1 Solution of the nonlinear problem compute the Jacobian matrix (analytic, automatic differentiation or divided differences)» R (X n ) [R] i(x n + εe j ) [R] i (X n εe j ), X 2ε ij solve for δx» R X (Xn ) δx = R(X n ) adaptive line search strategy X n+1 =X n + ωδx ω such that f(ω) = R(X + ωδx) X MG, BiCGStab or GMRes(m) with ILU(k) preconditioner to solve the linear problems

15 A monolithic FEM solver for fluid structure interaction p. 14/1 Jacobian approximation» R X ij (X n ) [R] i(x n + εe j ) [R] i (X n εe j ) 2ε, ε/t OL / [21.52] 12 /57.08 [26.52] 12 /47.00 [23.75] 17 /33.06 [27.38] / [24.57] 8 /62.75 [17.77] 10 /42.20 [18.95] 18 /31.33 [29.05] / [51.65] 20 /47.35 [38.28] 25 /29.80 [38.58] 56 /16.98 [73.83] / [141.30] 48 /35.79 [81.72] 49 /17.92 [65.77] nonlinear solver it. / avg. linear solver it. [CPU time] for BiCGStab(ILU(0))

16 A monolithic FEM solver for fluid structure interaction p. 15/1 Multigrid solver standard geometric multigrid approach smoother by local MPSC-Ansatz (Vanka-like smoother) u l+1 u l 6 4v l = 6 4v l 7 5 ω X S uu Ωi S uv Ωi S vu Ωi S vv Ωi kb 7 Ωi 5 Patch Ω i c u Bs Ω T c v B T 0 i f Ω i p l+1 p l def l u 6 4def l 7 v 5 def l p full inverse of the local problems by standard LAPACK (39 39 systems) alternatives: simplified local problems (3 3 systems) or ILU(k) combination with GMRES/BiCGStab methods possible full Q 2 and P disc 1 prolongation P, restriction by R = P T

17 A monolithic FEM solver for fluid structure interaction p. 16/1 Boundary and initial conditions v f = 0 inflow Γ 0 t outflow v f = 0 inflow parabolic velocity profile is prescribed at the left end of the channel v f (0, y) = 1.5 y(h y) 2 = y(0.41 y), H outflow condition can be chosen by the user (stress free or do nothing) interface condition on Γ 0 t is vf = v s and σ f n = σ s n otherwise the no-slip condition is prescribed for the fluid on the other boundary parts. i.e. top and bottom wall and cylinder

18 A monolithic FEM solver for fluid structure interaction p. 17/1 Examples β = 1 α = ν P = 0.5 ν = (Re = 200) A, y coord A, y coord t t

19 A monolithic FEM solver for fluid structure interaction p. 18/1 Multigrid solver 1 timestep started with fully developed solution standard streamline diffusion, CN time step, each linear step solved to relative prec shown: number of nonlinear steps/avg. number of linear steps [CPU time] timestep 10 2 Level ndof MG(2) MG(4) MG(8) BiCGStab(ILU(1)) GMRES(ILU(1),200) /8 [66] 2/8 [92] 2/7 [112] 2/51 [32] 2/50 [27] /8 [190] 2/5 [198] 2/4 [302] 2/120 [200] 2/117 [151] /9 [744] 2/6 [852] 2/4 [1185] 2/311 [1646] 2/358 [1432] /13 [3803] 2/7 [3924] 2/6 [6241] MEM. MEM. timestep 10 0 Level ndof MG(2) MG(4) MG(8) BiCGStab(ILU(1)) GMRES(ILU(1),200) /12 [118] 4/11 [177] 4/10 [262] 20/160 [631] 20/801 [1579] /12 [466] 4/7 [470] 4/5 [681] 2/800 [] diverg. 13/801 [] diverg /13 [1898] 4/7 [2057] 4/5 [2874] 2/800 [] diverg. 4/801 [] diverg /15 [8678] 4/8 [9069] 4/6 [13808] MEM. MEM. robust and efficient Newton-MG scheme

20 A monolithic FEM solver for fluid structure interaction p. 19/1 Summary monolithic, fully coupled FEM (Q 2 /P 1 ) for viscous incompressible fluid and incompressible hyperelastic structure fully implicit 2nd order discretization in time (Crank-Nicholson) Newton-like method for the coupled system (Jacobian matrix via divided differences) preconditioned Krylov space linear solver (ILU(k)/GMRES(m)) adaptive time step control a priori space-adapted mesh

Proposal for numerical benchmarking of fluid-structure interaction between an elastic object and laminar incompressible flow

Proposal for numerical benchmarking of fluid-structure interaction between an elastic object and laminar incompressible flow Proposal for numerical benchmarking of fluid-structure interaction between an elastic object and laminar incompressible flow Stefan Turek and Jaroslav Hron Institute for Applied Mathematics and Numerics,

More information

Numerical simulation of laminar incompressible fluid-structure interaction for elastic material with point constraints

Numerical simulation of laminar incompressible fluid-structure interaction for elastic material with point constraints Numerical simulation of laminar incompressible fluid-structure interaction for elastic material with point constraints M. Razzaq 1, J. Hron 2 and S. Turek 3 1 Institute of Applied Mathematics, TU Dortmund,

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

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

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

Finite element simulation techniques for incompressible fluid-structure interaction with applications to bio-engineering and optimization

Finite element simulation techniques for incompressible fluid-structure interaction with applications to bio-engineering and optimization Finite element simulation techniques for incompressible fluid-structure interaction with applications to bio-engineering and optimization Dissertation zur Erlangung des Grades eines Doktors der Naturwissenschaften

More information

Monolithic FEM multigrid techniques for the simulation of viscoelastic flow

Monolithic FEM multigrid techniques for the simulation of viscoelastic flow Monolithic FEM multigrid techniques for the simulation of viscoelastic flow A. Ouazzi, H. Damanik, S. Turek, J. Hron Institute of Applied Mathematics, LS III, TU Dortmund http://www.featflow.de European

More information

Deformation of bovine eye fluid structure interaction between viscoelastic vitreous, non-linear elastic lens and sclera

Deformation of bovine eye fluid structure interaction between viscoelastic vitreous, non-linear elastic lens and sclera Karel October Tůma 24, Simulation 2018 of a bovine eye 1/19 Deformation of bovine eye fluid structure interaction between viscoelastic vitreous, non-linear elastic lens and sclera Karel Tůma 1 joint work

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

Numerical simulation of fluid-structure interaction with application to aneurysm hemodynamics

Numerical simulation of fluid-structure interaction with application to aneurysm hemodynamics Fluid-Structure Interaction. Theory, Numerics and Applications pp. 283 294 Herrsching am Ammersee, 29.9.-1.10.2008 Numerical simulation of fluid-structure interaction with application to aneurysm hemodynamics

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

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

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

More information

Numerical Benchmarking of Fluid-Structure Interaction: A comparison of different discretization and solution approaches

Numerical Benchmarking of Fluid-Structure Interaction: A comparison of different discretization and solution approaches Numerical Benchmarking of Fluid-Structure Interaction: A comparison of different discretization and solution approaches Stefan Turek, Jaroslav Hron, Mudassar Razzaq, Hilmar Wobker, and Michael Schäfer

More information

FEM techniques for nonlinear fluids

FEM techniques for nonlinear fluids FEM techniques for nonlinear fluids From non-isothermal, pressure and shear dependent viscosity models to viscoelastic flow A. Ouazzi, H. Damanik, S. Turek Institute of Applied Mathematics, LS III, TU

More information

A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow

A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow Michael Köster, Michael Hinze, Stefan Turek Michael Köster Institute for Applied Mathematics TU Dortmund Trier,

More information

Constitutive models. Constitutive model: determines P in terms of deformation

Constitutive models. Constitutive model: determines P in terms of deformation Constitutive models Constitutive model: determines P in terms of deformation Elastic material: P depends only on current F Hyperelastic material: work is independent of path strain energy density function

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

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

Numerical simulation and benchmarking of fluid-structure interaction with application to hemodynamics

Numerical simulation and benchmarking of fluid-structure interaction with application to hemodynamics Numerical simulation and benchmarking of fluid-structure interaction with application to hemodynamics M. Razzaq a,, S. Turek a J. Hron a,b, J. F. Acker a with support by F. Weichert c, I. Q. Grunwald,

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

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

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

More information

LEAST-SQUARES FINITE ELEMENT MODELS

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

More information

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Computational Design Forward design: direct manipulation of design parameters Level of abstraction Exploration

More information

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

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

More information

Algebraic Flux Correction III

Algebraic Flux Correction III Algebraic Flux Correction III Incompressible Flow Problems Stefan Turek and Dmitri Kuzmin Abstract This chapter illustrates the use of algebraic flux correction in the context of finite element methods

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 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

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

FSI with Application in Hemodynamics Analysis and Simulation

FSI with Application in Hemodynamics Analysis and Simulation FSI with Application in Hemodynamics Analysis and Simulation Mária Lukáčová Institute of Mathematics, University of Mainz A. Hundertmark (Uni-Mainz) Š. Nečasová (Academy of Sciences, Prague) G. Rusnáková

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

Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models

Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models H. Damanik a,, J. Hron b, A. Ouazzi a, S. Turek a a Institut für Angewante Mathematik, TU Dortmund, Germany b Institute

More information

Basic hydrodynamics. David Gurarie. 1 Newtonian fluids: Euler and Navier-Stokes equations

Basic hydrodynamics. David Gurarie. 1 Newtonian fluids: Euler and Navier-Stokes equations Basic hydrodynamics David Gurarie 1 Newtonian fluids: Euler and Navier-Stokes equations The basic hydrodynamic equations in the Eulerian form consist of conservation of mass, momentum and energy. We denote

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

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

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

More information

Some remarks on grad-div stabilization of incompressible flow simulations

Some remarks on grad-div stabilization of incompressible flow simulations Some remarks on grad-div stabilization of incompressible flow simulations Gert Lube Institute for Numerical and Applied Mathematics Georg-August-University Göttingen M. Stynes Workshop Numerical Analysis

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

Numerical Simulation of Powder Flow

Numerical Simulation of Powder Flow Numerical Simulation of Powder Flow Stefan Turek, Abderrahim Ouazzi Institut für Angewandte Mathematik, Univ. Dortmund http://www.mathematik.uni-dortmund.de/ls3 http://www.featflow.de Models for granular

More information

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

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

More information

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

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

More information

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

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

More information

FAST SOLVERS AND EFFICIENT NUMERICAL CFD TECHNIQUES FOR DYNAMIC POROUS MEDIA PROBLEMS

FAST SOLVERS AND EFFICIENT NUMERICAL CFD TECHNIQUES FOR DYNAMIC POROUS MEDIA PROBLEMS V International Conference on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 23 S. Idelsohn, M. Papadrakakis and B. Schrefler (Eds) FAST SOLVERS AND EFFICIENT NUMERICAL

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

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

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

More information

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

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

A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE

A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE ANDRIY SOKOLOV, MAXIM A. OLSHANSKII, AND STEFAN TUREK Abstract. The paper presents a new discrete projection method (DPM)

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

Continuum Mechanics and the Finite Element Method

Continuum Mechanics and the Finite Element Method Continuum Mechanics and the Finite Element Method 1 Assignment 2 Due on March 2 nd @ midnight 2 Suppose you want to simulate this The familiar mass-spring system l 0 l y i X y i x Spring length before/after

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

Fast solvers for steady incompressible flow

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

More information

You may not start to read the questions printed on the subsequent pages until instructed to do so by the Invigilator.

You may not start to read the questions printed on the subsequent pages until instructed to do so by the Invigilator. MATHEMATICAL TRIPOS Part III Thursday 1 June 2006 1.30 to 4.30 PAPER 76 NONLINEAR CONTINUUM MECHANICS Attempt FOUR questions. There are SIX questions in total. The questions carry equal weight. STATIONERY

More information

Nonlinear Equations for Finite-Amplitude Wave Propagation in Fiber-Reinforced Hyperelastic Media

Nonlinear Equations for Finite-Amplitude Wave Propagation in Fiber-Reinforced Hyperelastic Media Nonlinear Equations for Finite-Amplitude Wave Propagation in Fiber-Reinforced Hyperelastic Media Alexei F. Cheviakov Department of Mathematics and Statistics, University of Saskatchewan, Saskatoon, Canada

More information

Nonlinear elasticity and gels

Nonlinear elasticity and gels Nonlinear elasticity and gels M. Carme Calderer School of Mathematics University of Minnesota New Mexico Analysis Seminar New Mexico State University April 4-6, 2008 1 / 23 Outline Balance laws for gels

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

NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH DYNAMIC FRACTURE

NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH DYNAMIC FRACTURE NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH DYNAMIC FRACTURE Kevin G. Wang (1), Patrick Lea (2), and Charbel Farhat (3) (1) Department of Aerospace, California Institute of Technology

More information

On Multigrid for Phase Field

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

More information

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

Méthode de quasi-newton en interaction fluide-structure. J.-F. Gerbeau & M. Vidrascu Méthode de quasi-newton en interaction fluide-structure J.-F. Gerbeau & M. Vidrascu Motivations médicales Athérosclérose : Sistole Diastole La formation des plaques est liée, entre autre, la dynamique

More information

A SHORT INTRODUCTION TO TWO-PHASE FLOWS Two-phase flows balance equations

A SHORT INTRODUCTION TO TWO-PHASE FLOWS Two-phase flows balance equations A SHORT INTRODUCTION TO TWO-PHASE FLOWS Two-phase flows balance equations Hervé Lemonnier DM2S/STMF/LIEFT, CEA/Grenoble, 38054 Grenoble Cedex 9 Ph. +33(0)4 38 78 45 40 herve.lemonnier@cea.fr, herve.lemonnier.sci.free.fr/tpf/tpf.htm

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

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

Robust Monolithic - Multigrid FEM Solver for Three Fields Formulation Rising from non-newtonian Flow Problems

Robust Monolithic - Multigrid FEM Solver for Three Fields Formulation Rising from non-newtonian Flow Problems Robust Monolithic - Multigrid FEM Solver for Three Fields Formulation Rising from non-newtonian Flow Problems M. Aaqib Afaq Institute for Applied Mathematics and Numerics (LSIII) TU Dortmund 13 July 2017

More information

Hybrid Discontinuous Galerkin methods for incompressible flow problems

Hybrid Discontinuous Galerkin methods for incompressible flow problems Hybrid Discontinuous Galerkin methods incompressible flow problems Christoph Lehrenfeld, Joachim Schöberl MathCCES Computational Mathematics in Engineering Workshop Linz, May 31 - June 1, 2010 Contents

More information

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

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

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

More information

Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows

Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows Alexander Chesnokov Lavrentyev Institute of Hydrodynamics Novosibirsk, Russia chesnokov@hydro.nsc.ru July 14,

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

CVEN 7511 Computational Mechanics of Solids and Structures

CVEN 7511 Computational Mechanics of Solids and Structures CVEN 7511 Computational Mechanics of Solids and Structures Instructor: Kaspar J. Willam Original Version of Class Notes Chishen T. Lin Fall 1990 Chapter 1 Fundamentals of Continuum Mechanics Abstract In

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

Fast Iterative Solution of Saddle Point Problems

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

More information

Nonlinear stability of steady flow of Giesekus viscoelastic fluid

Nonlinear stability of steady flow of Giesekus viscoelastic fluid Nonlinear stability of steady flow of Giesekus viscoelastic fluid Mark Dostalík, V. Průša, K. Tůma August 9, 2018 Faculty of Mathematics and Physics, Charles University Table of contents 1. Introduction

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

Exercise 5: Exact Solutions to the Navier-Stokes Equations I

Exercise 5: Exact Solutions to the Navier-Stokes Equations I Fluid Mechanics, SG4, HT009 September 5, 009 Exercise 5: Exact Solutions to the Navier-Stokes Equations I Example : Plane Couette Flow Consider the flow of a viscous Newtonian fluid between two parallel

More information

Vít Průša (joint work with K.R. Rajagopal) 30 October Mathematical Institute, Charles University

Vít Průša (joint work with K.R. Rajagopal) 30 October Mathematical Institute, Charles University On models for viscoelastic fluid-like materials that are mechanically incompressible and thermally compressible or expansible and their Oberbeck Boussinesq type approximations Vít Průša (joint work with

More information

Mathematical Modeling and Simulation of Flow in Domains Separated by Leaky Semipermeable Membrane Including Osmotic Effect

Mathematical Modeling and Simulation of Flow in Domains Separated by Leaky Semipermeable Membrane Including Osmotic Effect Nečas Center for Mathematical Modeling Mathematical Modeling and Simulation of Flow in Domains Separated by Leaky Semipermeable Membrane Including Osmotic Effect J. Hron, M. Neuss-Radu and P. Pustějovská

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

2. FLUID-FLOW EQUATIONS SPRING 2019 2. FLUID-FLOW EQUATIONS SPRING 2019 2.1 Introduction 2.2 Conservative differential equations 2.3 Non-conservative differential equations 2.4 Non-dimensionalisation Summary Examples 2.1 Introduction Fluid

More information

Diese Arbeit wurde vorgelegt am Lehrstuhl für computergestützte Analyse technischer Systeme

Diese Arbeit wurde vorgelegt am Lehrstuhl für computergestützte Analyse technischer Systeme Diese Arbeit wurde vorgelegt am Lehrstuhl für computergestützte Analyse technischer Systeme Dreidimensionale Isogeometrische Elastische Festkörper für Fluid-Struktur Interaktionen Three-Dimensional Isogeometric

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

Determination of pressure data in aortic valves

Determination of pressure data in aortic valves Determination of pressure data in aortic valves Helena Švihlová a, Jaroslav Hron a, Josef Málek a, K.R.Rajagopal b and Keshava Rajagopal c a, Mathematical Institute, Charles University, Czech Republic

More information

Sebastian Gjertsen Master s Thesis, Spring 2017

Sebastian Gjertsen Master s Thesis, Spring 2017 Development of a Verified and Validated Computational Framework for Fluid-Structure Interaction: Investigating Lifting Operators and Numerical Stability Sebastian Gjertsen Master s Thesis, Spring 2017

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

A Review of Solution Techniques for Unsteady Incompressible Flow

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

More information

Numerical simulation of powder flow by Finite Element methods

Numerical simulation of powder flow by Finite Element methods Numerical simulation of powder flow by Finite Element methods S. Turek and A. Ouazzi Institute of Applied Mathematics, University of Dortmund, 44227 Dortmund, Germany Abstract In contrast to most fluids,

More information

Modeling Interface Response in Cellular Adhesion

Modeling Interface Response in Cellular Adhesion Excerpt from the Proceedings of the COMSOL Conference 009 Milan Modeling Interface Response in Cellular Adhesion G. Megali *,1, D. Pellicanò 1, M. Cacciola 1, F. Calarco 1, D. De Carlo 1, F. Laganà 1 and

More information

Modeling and numerical simulations of swimmers

Modeling and numerical simulations of swimmers Plafrim, may 31, 2011 p. 1 Modeling and numerical simulations of swimmers Michel Bergmann INRIA Bordeaux Sud-Ouest, project-team MC2 Institut de Mathématiques Appliquées de Bordeaux 33405 TALENCE cedex,

More information

Interaction of Incompressible Fluid and Moving Bodies

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

More information

Mass of fluid leaving per unit time

Mass of fluid leaving per unit time 5 ENERGY EQUATION OF FLUID MOTION 5.1 Eulerian Approach & Control Volume In order to develop the equations that describe a flow, it is assumed that fluids are subject to certain fundamental laws of physics.

More information

Preconditioners for the incompressible Navier Stokes equations

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

More information

Algebraic Multigrid Methods for the Oseen Problem

Algebraic Multigrid Methods for the Oseen Problem Algebraic Multigrid Methods for the Oseen Problem Markus Wabro Joint work with: Walter Zulehner, Linz www.numa.uni-linz.ac.at This work has been supported by the Austrian Science Foundation Fonds zur Förderung

More information

Advances in the mathematical theory of the finite element immersed boundary method

Advances in the mathematical theory of the finite element immersed boundary method Advances in the mathematical theory of the finite element immersed boundary method Daniele Boffi Dipartimento di Matematica F. Casorati, Università di Pavia http://www-dimat.unipv.it/boffi May 12, 2014

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

A CONTINUUM MECHANICS PRIMER

A CONTINUUM MECHANICS PRIMER A CONTINUUM MECHANICS PRIMER On Constitutive Theories of Materials I-SHIH LIU Rio de Janeiro Preface In this note, we concern only fundamental concepts of continuum mechanics for the formulation of basic

More information

A nonlinear cross-diffusion system for contact inhibition of cell growth

A nonlinear cross-diffusion system for contact inhibition of cell growth A nonlinear cross-diffusion system for contact inhibition of cell growth M. Bertsch 1, D. Hilhorst 2, H. Izuhara 3, M. Mimura 3 1 IAC, CNR, Rome 2 University of Paris-Sud 11 3 Meiji University FBP 2012

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

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

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 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

Fast Solvers for Unsteady Incompressible Flow

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

More information

The Navier-Stokes Equations

The Navier-Stokes Equations s University of New Hampshire February 22, 202 and equations describe the non-relativistic time evolution of mass and momentum in fluid substances. mass density field: ρ = ρ(t, x, y, z) velocity field:

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

arxiv: v1 [math.na] 19 Dec 2013

arxiv: v1 [math.na] 19 Dec 2013 NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH HYPERELASTIC MODELS I: A PARTITIONED APPROACH arxiv:1312.5561v1 [math.na] 19 Dec 2013 ULRICH LANGER AND HUIDONG YANG Abstract. In this

More information