Efficient BDF time discretization of the Navier Stokes equations with VMS LES modeling in a High Performance Computing framework

Size: px
Start display at page:

Download "Efficient BDF time discretization of the Navier Stokes equations with VMS LES modeling in a High Performance Computing framework"

Transcription

1 Introduction VS LES/BDF Implementation Results Conclusions Swiss Numerical Analysis Day 2015, Geneva, Switzerland, 17 April Efficient BDF time discretization of the Navier Stokes equations with VS LES modeling in a High Performance Computing framework L. Dede, D. Forti, S. Deparis, and A. Quarteroni CCS Chair of odelling and Scientific Computing ATHICSE athematics Institute of Computational Science and Engineering EPFL E cole Polytechnique Fe de rale de Lausanne Switzerland

2 Introduction VS LES/BDF Implementation Results Conclusions Introduction Applications Turbulent or transitional flows occur in many physical contexts: External flows (civil Engineering, Hydrodynamics, or Aeronautical applications); Internal flows (e.g. Haemodynamics). DNS vs. LES The Direct Numerical Simulation (DNS) is generally computationally challenging or not affordable, for which Large Eddy Simulations (LES) models can instead be used. Numerical Approximation (LES) Even with LES modeling, efficient and flexible solvers for the incompressible Navier Stokes equations, e.g. based on the Finite Elements method, are required to make feasible the numerical simulation, also in a High Performance Computing HPC setting.

3 Introduction VS LES/BDF Implementation Results Conclusions otivations Goals Develop an efficient solver for LES modeling of the incompressible Navier Stokes equations. Use the Finite Elements method for the spatial approximation. Use efficient time discretization schemes. Use a scalable solver for parallel computing (HPC). Solve large scale problems at high Reynolds (Re) numbers. ethodology Variational ultiscale (VS) approach with LES modeling (VS LES) [Bazilevs et al., CAE, 2007], [Codina et al., CAE, 2007], [Wall et al, CAE 2010]. Backward Differentiation Formulas (BDF) for the time discretization to define a semi implicit scheme (VS LES/BDF). Scalable solver for HPC with ultigrid (L) preconditioner.

4 Introduction VS LES/BDF Implementation Results Conclusions The incompressible Navier Stokes equations Navier Stokes equations for incompressible flows (Newtonian) ρ u t + ρ(u )u f σ(u, p) = 0 in Ω (0, T ), u = 0 in Ω (0, T ), with suitable initial and boundary conditions on Γ D Ω; u and p are the velocity and the pressure, ρ the density, f the external forces, σ(u, p) = pi + 2µɛ(u) the stress tensor, µ the dynamic viscosity, and ɛ(u) = 1 2 ( u + ( u)t ) the strain tensor. Weak formulation The weak formulation of the Navier Stokes equations reads: find U = {u, p} V g : ( ) w, ρ u t + (w, ρ(u )u) + ( w, µ( u + u T )) ( w, p) + (q, u) = (w, f ) for all W = {w, q} V 0, t (0, T ), (1) with the function spaces V g = {u [ H 1 (Ω) ] d : u ΓD = g}, V 0 = {u [ H 1 (Ω) ] d : u ΓD = 0}, Q = L 2 (Ω), V g = V g Q, and V 0 = V 0 Q.

5 Introduction VS LES/BDF Implementation Results Conclusions Spatial approximation: Finite Elements and VS LES modelling Finite Elements discretization We define X h r := { v h C 0 (Ω) : v h K P r, for all K T h } as the Finite Elements function space of degree r 1 over Ω triangulated with a mesh T h of tetrahedrons; h K is the diameter of the element K T h. ultiscale direct sum decomposition The space V (V g or V 0 ) is decomposed into the coarse and fine scales subspaces: V = V h V, V h is the coarse scale function space associated to the Finite Elements discretization Xr h and V is an infinite dimensional function space representing the fine scales. For the weak formulation (1), we apply the decomposition to the trial and test functions: w = w h + w, q = q h + q, u = u h + u, p = p h + p.

6 Introduction VS LES/BDF Implementation Results Conclusions Spatial approximation: Finite Elements and VS LES modelling VS LES modeling [Bazilevs et al., CAE, 2007] The fine scale velocity and pressure components are chosen as: u τ (u h ) r (u h, p h ), p τ C (u h ) r C (u h ); r (u h, p h ) and r C (u h ) are the residuals of the momentum and continuity equations: r (u h, p h ) = ρ uh t + ρuh u h + p h µ u h f, r C (u h ) = u h. The stabilization parameters τ and τ C are set as: τ = τ (u h ) = ( σ 2 ρ 2 t 2 + ρ2 h 2 K ) 1/2 u h 2 + µ2 C hk 4 p, (2) τ C = τ C (u h ) = h 2 K τ (u h ), (3) with σ a constant equal to the order of the time discretization chosen with time step t and C p = 60 2 r 2 a constant related to an inverse inequality.

7 Introduction VS LES/BDF Implementation Results Conclusions Spatial approximation: Finite Elements and VS LES modelling Semi discrete VS LES formulation (weak residual) find U h = {u h, p h } V h g : A(W h, U h ) F (W h ) = 0 where: for all W h = {w h, q h } V h 0, t (0, T ), A(W h, U h ) := A NS (W h, U h ) + A VS (W h, U h ) F (W h ) := (w h, f ), ( ) A NS (W h, U h ) := w h, ρ uh + ( w h, ρ(u h )u h) t + ( w h, µ( u h + ( u h ) T ) ) ( w h, p h) + ( q h, u h), A VS (W h, U h ) := ( ρu h w h + q h, τ (u h ) r (u h, p h ) ) ( w h, τ C (u h ) r C (u h ) ) + ( ρu h ( u h ) T, τ (u h ) r (u h, p h ) ) VS SUPG and VS LES terms ( w h, τ (u h ) r (u h, p h ) τ (u h ) r (u h, p h ) ).

8 Introduction VS LES/BDF Implementation Results Conclusions Time discretization: implicit BDF schemes Backward Differentiation Formulas (BDF) We partition [0, T ] into N t subintervals of size t = T N t with t n = n t for n = 0,..., N t; u h n u h (t n) and pn h p h (t n). Depending the order σ of the BDF scheme, the approximation of the time derivative of the velocity reads: u h ασuh n+1 u h n,bdfσ, t t where for BDF schemes of orders σ = 1, 2, 3 we have: u h n if n 1, for σ = 1 (BDF1), u h n,bdfσ = 2u h n 1 2 uh n 1 if n 2, for σ = 2 (BDF2), 3u h n 3 2 uh n uh n 2 if n 3, for σ = 3 (BDF3), 1, for σ = 1 (BDF1), 3 α σ =, for σ = 2 (BDF2), 2 11, for σ = 3 (BDF3). 6

9 Introduction VS LES/BDF Implementation Results Conclusions Time discretization: implicit BDF schemes The fully implicit BDF scheme for VS LES modeling For a BDF scheme of order σ: find u h n+1 Vg h and pn+1 h Q h : ( ) w h, ρ ασuh n+1 uh n,bdfσ + ( ) w h, ρ (u h t n+1 )u h n+1 + ( w h, µ ( u h n+1 + ( u h n+1) )) T ( ( ) w h, pn+1) h + q h, u h n+1 + ( ρ u h n+1 w h + q h, τ (u h n+1) r (u h n+1, pn+1) ) h ( w h, τ C (u h n+1) r C (u h n+1) ) + ( ρ u h n+1 ( w h ) T, τ (u h n+1) r (u h n+1, p h n+1) ) ( w h, τ (u h n+1) r (u h n+1, p h n+1) τ (u h n+1) r (u h n+1, p h n+1) ) = ( w h, f n+1 ), given u h n,..., u h n+1 σ, with f n+1 = f (t n+1). The problem is nonlinear both in u h n+1 and p h n+1. for all w h V h 0 and q h Q h, n σ 1,

10 Introduction VS LES/BDF Implementation Results Conclusions Time discretization: the semi implicit BDF scheme (VS LES/BDF) Extrapolation with Newton Gregory backward polynomials The variables u h n+1 and p h n+1 are linearized by means of extrapolation with Newton Gregory backward polynomials. We consider the following extrapolations of orders σ= 1, 2, 3 for the velocity and pressure variables at the discrete time t n+1: u h n if n 0, for σ = 1 (BDF1), u h n+1,σ = 2 u h n u h n 1 if n 1, for σ = 2 (BDF2), 3 u h n 3 u h n 1 + u h n 2 if n 2, for σ = 3 (BDF3) pn h if n 0, for σ = 1 (BDF1), pn+1,σ h = 2 pn h pn 1 h if n 1, for σ = 2 (BDF2), 3 pn h 3 pn 1 h + pn 2 h if n 2, for σ = 3 (BDF3). The extrapolations of u h n+1 and p h n+1 induce similar extrapolations on the residuals and stabilization parameters.

11 Introduction VS LES/BDF Implementation Results Conclusions Time discretization: the semi implicit BDF scheme The semi implicit BDF scheme for VS LES modeling (VS LES/BDF) For a BDF scheme of order σ: find u h n+1 Vg h and pn+1 h Q h : ( w h, ρ ασuh n+1 uh n,bdfσ t ( w h, p h n+1 ( w h, τ n+1,σ C ( + ) + (w h, ρ ( ) ( u h n+1,σ )u h n+1 + w h, µ ( u h n+1 + ( u h n+1) T ) ) ) ( + q h, u h n+1) + (ρ u h n+1,σ w h + q h, τ n+1,σ r n+1,σ (u h n+1, pn+1) ) h r C (u h n+1) ) + ( ρ u h n+1,σ ( w h ) T, τ n+1,σ r n+1,σ (u h n+1, pn+1) ) h ( w h, τ n+1,σ r n+1,σ τ n+1,σ r n+1,σ (u h n+1, pn+1) ) h ( ) w h, τ n+1,σ given u h n,..., u h n+1 σ. w h, τ n+1,σ r n+1,σ r n+1,σ The problem is linear both in u h n+1 and p h n+1. τ n+1,σ u ρ α h n+1 σ t ) (u h n+1, pn+1) h τ n+1,σ ρ uh n,bdf t = ( w h, f n+1 ), for all w h V h 0 and q h Q h, n σ 1,

12 Introduction VS LES/BDF Implementation Results Conclusions Time discretization: the semi implicit BDF scheme Extrapolated stabilization parameters τ n+1,σ := τ n+1,σ C = ( σ 2 ρ 2 t 2 hk 2 τ n+1,σ + ρ2 hk 2. u h n+1,σ ) 1/2 2 + µ2 C p, h 4 K Extrapolated residuals r n+1,σ (u h n+1, p h n+1) := ρ r n+1,σ ( α σu h n+1 uh n,bdfσ t + p h n+1 µ u h n+1 f n+1, := r n+1,σ (u h n+1,σ, pn+1,σ), h ) + ρ u h n+1,σ u h n+1 r n+1,σ (u h n+1, p h n+1) := ρu h n+1,σ u h n+1 + p h n+1 µ u h n+1 f n+1. The extrapolation of the stabilization parameters and residuals is based on the extrapolated variables u h n+1,σ and p h n+1,σ.

13 Introduction VS LES/BDF Implementation Results Conclusions Time discretization: the semi implicit BDF scheme Remarks The fully discrete semi implicit formulation (VS LES/BDF) yields a linear problem in the variables u h n+1 and p h n+1 to be solved only once at each time step t n. At the discrete level, assembling and solving the linear system is done only once for each time step t n (fewer terms than with Newton linearization). BDF schemes with extrapolation yields stable time discretizations of the Navier Stokes equations at the continuous level (under suitable boundary conditions). The stability in respect of the time discretization for the VS LES/BDF scheme is not guaranteed a priori (for all t). In practice, stability in respect of the time discretization is also obtained for relatively large time steps t.

14 Introduction VS LES/BDF Implementation Results Conclusions Finite Elements library LifeV Numerical implementation The implementation of the VS LES/BDF mehod for the incompressible Navier Stokes equations is carried out in the Finite Elements Library LifeV. LifeV Finite Elements Library for the numerical approximation of PDEs Research code oriented to the development and test of new numerical methods and algorithms C++, object oriented, parallel LifeV relies on Trilinos Library/packages odular design; use of the Expression Template Assembly (ETA) package Developers: CCS EPFL, E(C)2 Emory, OX Polimi, REO, ESTIE INRIA Distributed under LGPL,

15 Introduction VS LES/BDF Implementation Results Conclusions ultigrid (L) preconditioner Solver We use the GRES method through the Belos package of Trilinos to solve the linear system. The stopping criterion is based on the relative residual, with tolerance tol = The right preconditioning strategy is used. L Preconditioner We use the ultigrid preconditioners available from the L package of Trilinos. The preconditioner is built on the system matrix [Gee et. al, Sandia National Labs., 2006]. Default parameters setting: NSSA, nonsymmetric smoothed aggregation variant for highly nonsymmetric operators; max levels = 3, cycle applications = 3, pde equations = 4; smoother: Gauss-Seidel, 3 sweeps; aggregation: type = Uncoupled-IS.

16 Introduction VS LES/BDF Implementation Results Flow past a squared cylinder Benchmark problem Flow past a squared cylinder at Re = 22,000 [Koobus and Farhat, 2004] (experimental data available). Γout Γin Lout 2H D y z Lin x Ls Space and time discretizations FE: P1 P1 1,323,056 DOFs; P2 P2 9,209,040 DOFs. Different choices of BDF order (σ = 1 or 2) and t. Conclusions

17 Introduction VS LES/BDF Implementation Flow past a squared cylinder Vortex structures Lambda 2 criterion Results Conclusions

18 Introduction VS LES/BDF Implementation Results Conclusions Flow past a squared cylinder Comparison of drag coefficient C D vs. time t for different discretizations FE P1 P1 and P2 P2; BDF orders σ = 1 and 2. 3 t = s 3 t = s t = s 3.2 t = s CD [-] CD [-] CD [-] CD [-] Time [s] 3 t = s CD [-] Time [s] t = s 3 t = s CD [-] Time [s] 3.2 t = s Time [s] Time [s] Time [s] P1 P1, BDF 1 P1 P1, BDF 2 P2 P2, BDF 2

19 Introduction VS LES/BDF Implementation Results Conclusions Flow past a squared cylinder Comparison of results for different discretizations and literature FE P1 P1 and P2 P2; BDF orders σ = 1 and 2. Numerical Results FE t BDF σ C D rms(c D ) rms(c L ) Strouhal s s P1 P s s s s s P2 P s s Literature (LES) LES method C D rms(c D ) rms(c L ) Strouhal VS F.V. [Koobus., 2004] Smagorinsky [Rodi, 1997] Dynamic LES [Sohankar, 2000]

20 Introduction VS LES/BDF Implementation Results Conclusions Flow past a squared cylinder Scalability results of the solver Linear solver based on GRES and L preconditioner; simulations performed using FE P2 P2, BDF 2, t = s Obtained Ideal 10 2 Obtained Ideal Time [s] Preconditioner assembly time vs. number of CPUs Number of CPUs Time [s] Number of CPUs Time to solve the linear system vs. number of CPUs Time to perform a time step vs. number of CPUs Time [s] Obtained Ideal Iterations Number of GRES iterations vs. number of CPUs Number of CPUs Number of CPUs Computations carried out with Piz Dora, a Cray XC40 supercomputer at the Swiss National Supercomputing Center (CSCS).

21 Introduction VS LES/BDF Implementation Results Conclusions Conclusions We considered a semi implicit scheme based on BDF formulas and extrapolation for the time discretization of the Navier Stokes equation with VS LES modeling (VS LES/BDF); spatial discretization was performed with low order Finite Elements method. We solved problems in a parallel computing framework (HPC), for which we showed the scalability of the solver with ultigrid preconditioning. We applied the method to internal and external flow problems at high Reynolds numbers. The numerical tests showed that the discretization based on the VS LES/BDF method is efficient, versatile, accurate, and stable for wide ranges of the time steps.

22 Introduction VS LES/BDF Implementation Results Conclusions References Y. Bazilevs, V.. Calo, J.A. Cottrell, T.J.R. Hughes, A. Reali, and G. Scovazzi. Variational multiscale residual based turbulence modeling for large eddy simulation of incompressible flows. Computer ethods Applied echanics and Engineering, 197: , O. Colomés, S. Badia, R. Codina, and J. Principe. Assessment of variational multiscale models for the large eddy simulation of turbulent incompressible flows. Computer ethods in Applied echanics and Engineering, 285:32 63, D. Forti and L. Dedè. Semi implicit BDF time discretization of the Navier Stokes equations with VS LES modeling in a High Performance Computing framework. ATHICSE report, , B. Koobus and C. Farhat. A variational multiscale method for the large eddy simulation of compressible turbulent flows on unstructured meshes. Application to vortex shedding. Computer ethods Applied echanics and Engineering, 193: , W. Rodi, J. Ferziger,. Breuer, and. Pourquié. Status of large eddy simulations: results of a workshop. ASE Journal of Fluids Engineering, 119: , 1997.

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

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

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

Newton s Method and Efficient, Robust Variants

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

More information

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

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

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

COMPUTATION OF MEAN DRAG FOR BLUFF BODY PROBLEMS USING ADAPTIVE DNS/LES

COMPUTATION OF MEAN DRAG FOR BLUFF BODY PROBLEMS USING ADAPTIVE DNS/LES COMPUTATION OF MEAN DRAG FOR BLUFF BODY PROBLEMS USING ADAPTIVE DNS/LES JOHAN HOFFMAN Abstract. We compute the time average of the drag in two benchmark bluff body problems: a surface mounted cube at Reynolds

More information

Universität des Saarlandes. Fachrichtung 6.1 Mathematik

Universität des Saarlandes. Fachrichtung 6.1 Mathematik Universität des Saarlandes U N I V E R S I T A S S A R A V I E N I S S Fachrichtung 6. Mathematik Preprint Nr. 228 A Variational Multiscale Method for Turbulent Flow Simulation with Adaptive Large Scale

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

Improvement of Reduced Order Modeling based on Proper Orthogonal Decomposition

Improvement of Reduced Order Modeling based on Proper Orthogonal Decomposition ICCFD5, Seoul, Korea, July 7-11, 28 p. 1 Improvement of Reduced Order Modeling based on Proper Orthogonal Decomposition Michel Bergmann, Charles-Henri Bruneau & Angelo Iollo Michel.Bergmann@inria.fr http://www.math.u-bordeaux.fr/

More information

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

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

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

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

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

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Antony Jameson Department of Aeronautics and Astronautics, Stanford University, Stanford, CA, 94305

More information

Compressible Navier-Stokes (Euler) Solver based on Deal.II Library

Compressible Navier-Stokes (Euler) Solver based on Deal.II Library Compressible Navier-Stokes (Euler) Solver based on Deal.II Library Lei Qiao Northwestern Polytechnical University Xi an, China Texas A&M University College Station, Texas Fifth deal.ii Users and Developers

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

A Finite-Element based Navier-Stokes Solver for LES

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

More information

A Variational Multiscale Stabilized Finite Element. Method for the Solution of the Euler Equations of

A Variational Multiscale Stabilized Finite Element. Method for the Solution of the Euler Equations of A Variational Multiscale Stabilized Finite Element Method for the Solution of the Euler Equations of Nonhydrostatic Stratified Flows M. Moragues S. Marras M. Vázquez G. Houzeaux Barcelona Supercomputing

More information

Computational Fluid Dynamics 2

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

More information

Non-Newtonian Fluids and Finite Elements

Non-Newtonian Fluids and Finite Elements Non-Newtonian Fluids and Finite Elements Janice Giudice Oxford University Computing Laboratory Keble College Talk Outline Motivating Industrial Process Multiple Extrusion of Pastes Governing Equations

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

The hybridized DG methods for WS1, WS2, and CS2 test cases

The hybridized DG methods for WS1, WS2, and CS2 test cases The hybridized DG methods for WS1, WS2, and CS2 test cases P. Fernandez, N.C. Nguyen and J. Peraire Aerospace Computational Design Laboratory Department of Aeronautics and Astronautics, MIT 5th High-Order

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

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical Outline Geurts Book Department of Fluid Mechanics, Budapest University of Technology and Economics Spring 2013 Outline Outline Geurts Book 1 Geurts Book Origin This lecture is strongly based on the book:

More information

NUMERICAL SIMULATION OF INTERACTION BETWEEN INCOMPRESSIBLE FLOW AND AN ELASTIC WALL

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

More information

Mestrado Integrado em Engenharia Mecânica Aerodynamics 1 st Semester 2012/13

Mestrado Integrado em Engenharia Mecânica Aerodynamics 1 st Semester 2012/13 Mestrado Integrado em Engenharia Mecânica Aerodynamics 1 st Semester 212/13 Exam 2ª época, 2 February 213 Name : Time : 8: Number: Duration : 3 hours 1 st Part : No textbooks/notes allowed 2 nd Part :

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

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

A Parallel Domain Decomposition Method for 3D Unsteady Incompressible Flows at High Reynolds Number

A Parallel Domain Decomposition Method for 3D Unsteady Incompressible Flows at High Reynolds Number Noname manuscript No. (will be inserted by the editor) A Parallel Domain Decomposition Method for 3D Unsteady Incompressible Flows at High Reynolds Number Rongliang Chen Yuqi Wu hengzheng Yan Yubo hao

More information

ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS

ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS Conference Applications of Mathematics 212 in honor of the 6th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 212 ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Gert Lube 1, Tobias Knopp 2, and Gerd Rapin 2 1 University of Göttingen, Institute of Numerical and Applied Mathematics (http://www.num.math.uni-goettingen.de/lube/)

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

An Introduction to Theories of Turbulence. James Glimm Stony Brook University

An Introduction to Theories of Turbulence. James Glimm Stony Brook University An Introduction to Theories of Turbulence James Glimm Stony Brook University Topics not included (recent papers/theses, open for discussion during this visit) 1. Turbulent combustion 2. Turbulent mixing

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

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

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

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

More information

OpenFOAM selected solver

OpenFOAM selected solver OpenFOAM selected solver Roberto Pieri - SCS Italy 16-18 June 2014 Introduction to Navier-Stokes equations and RANS Turbulence modelling Numeric discretization Navier-Stokes equations Convective term {}}{

More information

- Part 4 - Multicore and Manycore Technology: Chances and Challenges. Vincent Heuveline

- Part 4 - Multicore and Manycore Technology: Chances and Challenges. Vincent Heuveline - Part 4 - Multicore and Manycore Technology: Chances and Challenges Vincent Heuveline 1 Numerical Simulation of Tropical Cyclones Goal oriented adaptivity for tropical cyclones ~10⁴km ~1500km ~100km 2

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

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

Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, Berlin, Germany,

Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, Berlin, Germany, Volker John On the numerical simulation of population balance systems Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, 10117 Berlin, Germany, Free University of Berlin, Department

More information

RANS Solutions Using High Order Discontinuous Galerkin Methods

RANS Solutions Using High Order Discontinuous Galerkin Methods RANS Solutions Using High Order Discontinuous Galerkin Methods Ngoc Cuong Nguyen, Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 2139, U.S.A. We present a practical

More information

Masters in Mechanical Engineering Aerodynamics 1 st Semester 2015/16

Masters in Mechanical Engineering Aerodynamics 1 st Semester 2015/16 Masters in Mechanical Engineering Aerodynamics st Semester 05/6 Exam st season, 8 January 06 Name : Time : 8:30 Number: Duration : 3 hours st Part : No textbooks/notes allowed nd Part : Textbooks allowed

More information

Space-time Discontinuous Galerkin Methods for Compressible Flows

Space-time Discontinuous Galerkin Methods for Compressible Flows Space-time Discontinuous Galerkin Methods for Compressible Flows Jaap van der Vegt Numerical Analysis and Computational Mechanics Group Department of Applied Mathematics University of Twente Joint Work

More information

DNS of the Taylor-Green vortex at Re=1600

DNS of the Taylor-Green vortex at Re=1600 DNS of the Taylor-Green vortex at Re=1600 Koen Hillewaert, Cenaero Corentin Carton de Wiart, NASA Ames koen.hillewaert@cenaero.be, corentin.carton@cenaero.be Introduction This problem is aimed at testing

More information

ADAPTIVE DNS/LES: A NEW AGENDA IN CFD

ADAPTIVE DNS/LES: A NEW AGENDA IN CFD ADAPTIVE DNS/LES: A NEW AGENDA IN CFD JOHAN HOFFMAN AND CLAES JOHNSON Abstract. We show that using adaptive finite element methods it is possible to accurately simulate turbulent flow with the computational

More information

Multigrid Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations

Multigrid Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations Multigrid Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations Khosro Shahbazi,a Dimitri J. Mavriplis b Nicholas K. Burgess b a Division of Applied

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

STEADY AND UNSTEADY 2D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS FLOW. Radka Keslerová, Karel Kozel

STEADY AND UNSTEADY 2D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS FLOW. Radka Keslerová, Karel Kozel Conference Applications of Mathematics 1 in honor of the th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 1 STEADY AND UNSTEADY D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS

More information

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap Thirteenth International Conference on Domain Decomposition ethods Editors: N. Debit,.Garbey, R. Hoppe, J. Périaux, D. Keyes, Y. Kuznetsov c 001 DD.org 33 RASHO: A Restricted Additive Schwarz Preconditioner

More information

FLUID MECHANICS. Atmosphere, Ocean. Aerodynamics. Energy conversion. Transport of heat/other. Numerous industrial processes

FLUID MECHANICS. Atmosphere, Ocean. Aerodynamics. Energy conversion. Transport of heat/other. Numerous industrial processes SG2214 Anders Dahlkild Luca Brandt FLUID MECHANICS : SG2214 Course requirements (7.5 cr.) INL 1 (3 cr.) 3 sets of home work problems (for 10 p. on written exam) 1 laboration TEN1 (4.5 cr.) 1 written exam

More information

Fourth-Order Implicit Runge-Kutta Time Marching Using A Newton-Krylov Algorithm. Sammy Isono

Fourth-Order Implicit Runge-Kutta Time Marching Using A Newton-Krylov Algorithm. Sammy Isono Fourth-Order Implicit Runge-Kutta Time Marching Using A Newton-Krylov Algorithm by Sammy Isono A thesis submitted in conformity with the requirements for the degree of Master of Applied Science Graduate

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

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

C1.2 Ringleb flow. 2nd International Workshop on High-Order CFD Methods. D. C. Del Rey Ferna ndez1, P.D. Boom1, and D. W. Zingg1, and J. E.

C1.2 Ringleb flow. 2nd International Workshop on High-Order CFD Methods. D. C. Del Rey Ferna ndez1, P.D. Boom1, and D. W. Zingg1, and J. E. C. Ringleb flow nd International Workshop on High-Order CFD Methods D. C. Del Rey Ferna ndez, P.D. Boom, and D. W. Zingg, and J. E. Hicken University of Toronto Institute of Aerospace Studies, Toronto,

More information

1. Introduction. Let the nonlinear set of equations arising in nonlinear transient elasticity be given by. r(u) = 0, (1.1)

1. Introduction. Let the nonlinear set of equations arising in nonlinear transient elasticity be given by. r(u) = 0, (1.1) PSEUDO-TRANSIENT CONTINUATION FOR NONLINEAR TRANSIENT ELASTICITY MICHAEL W. GEE, C. T. KELLEY, AND R. B. LEHOUCQ Abstract. We show how the method of pseudo-transient continuation can be applied to improve

More information

Trust-Region SQP Methods with Inexact Linear System Solves for Large-Scale Optimization

Trust-Region SQP Methods with Inexact Linear System Solves for Large-Scale Optimization Trust-Region SQP Methods with Inexact Linear System Solves for Large-Scale Optimization Denis Ridzal Department of Computational and Applied Mathematics Rice University, Houston, Texas dridzal@caam.rice.edu

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

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

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement HONOM 2011 in Trento DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement Institute of Aerodynamics and Flow Technology DLR Braunschweig 11. April 2011 1 / 35 Research

More information

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods 1 Introduction Achieving high order time-accuracy in the approximation of the incompressible Navier Stokes equations by means of fractional-step

More information

Numerical Study of Natural Unsteadiness Using Wall-Distance-Free Turbulence Models

Numerical Study of Natural Unsteadiness Using Wall-Distance-Free Turbulence Models Numerical Study of Natural Unsteadiness Using Wall-Distance-Free urbulence Models Yi-Lung Yang* and Gwo-Lung Wang Department of Mechanical Engineering, Chung Hua University No. 707, Sec 2, Wufu Road, Hsin

More information

Simulation of Non-Equilibrium Flows: Plasma Turbulence and Radiation Transport

Simulation of Non-Equilibrium Flows: Plasma Turbulence and Radiation Transport Simulation of Non-Equilibrium Flows: Plasma Turbulence and Radiation Transport Juan Pablo Trelles Department of Mechanical Engineering and Energy Engineering Graduate Program University of Massachusetts

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

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

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

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

Introduction to Heat and Mass Transfer. Week 9

Introduction to Heat and Mass Transfer. Week 9 Introduction to Heat and Mass Transfer Week 9 補充! Multidimensional Effects Transient problems with heat transfer in two or three dimensions can be considered using the solutions obtained for one dimensional

More information

Nonlinear Wave Theory for Transport Phenomena

Nonlinear Wave Theory for Transport Phenomena JOSO 2016 March 9-11 2015 Nonlinear Wave Theory for Transport Phenomena ILYA PESHKOV CHLOE, University of Pau, France EVGENIY ROMENSKI Sobolev Institute of Mathematics, Novosibirsk, Russia MICHAEL DUMBSER

More information

Regularization modeling of turbulent mixing; sweeping the scales

Regularization modeling of turbulent mixing; sweeping the scales Regularization modeling of turbulent mixing; sweeping the scales Bernard J. Geurts Multiscale Modeling and Simulation (Twente) Anisotropic Turbulence (Eindhoven) D 2 HFest, July 22-28, 2007 Turbulence

More information

Compressible Flow LES Using OpenFOAM

Compressible Flow LES Using OpenFOAM Compressible Flow LES Using OpenFOAM I. B. Popov supervisor: S. J. Hulshoff promoter: H. Bijl PhD student, TU Delft, Delft, The Netherlands researcher, NEQLab Research B.V., The Hague, The Netherlands

More information

EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC ANALYSIS

EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC ANALYSIS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC

More information

Finite Element LES and VMS Methods on Tetrahedral Meshes

Finite Element LES and VMS Methods on Tetrahedral Meshes Finite Element LES and VMS Methods on Tetrahedral Meshes Volker John 1 Adela Kindl 2 and Carina Suciu 3 FR 6.1 Mathematik, Universität des Saarlandes, Postfach 15 11 50, 66041 Saarbrücken, Germany Abstract

More information

IMPLEMENTATION OF A PARALLEL AMG SOLVER

IMPLEMENTATION OF A PARALLEL AMG SOLVER IMPLEMENTATION OF A PARALLEL AMG SOLVER Tony Saad May 2005 http://tsaad.utsi.edu - tsaad@utsi.edu PLAN INTRODUCTION 2 min. MULTIGRID METHODS.. 3 min. PARALLEL IMPLEMENTATION PARTITIONING. 1 min. RENUMBERING...

More information

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

More information

Postprint.

Postprint. http://www.diva-portal.org Postprint This is the accepted version of a paper published in Mathematical Modelling and Analysis. This paper has been peer-reviewed but does not include the final publisher

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

RESIDUAL BASED ERROR ESTIMATES FOR THE SPACE-TIME DISCONTINUOUS GALERKIN METHOD APPLIED TO NONLINEAR HYPERBOLIC EQUATIONS

RESIDUAL BASED ERROR ESTIMATES FOR THE SPACE-TIME DISCONTINUOUS GALERKIN METHOD APPLIED TO NONLINEAR HYPERBOLIC EQUATIONS Proceedings of ALGORITMY 2016 pp. 113 124 RESIDUAL BASED ERROR ESTIMATES FOR THE SPACE-TIME DISCONTINUOUS GALERKIN METHOD APPLIED TO NONLINEAR HYPERBOLIC EQUATIONS VÍT DOLEJŠÍ AND FILIP ROSKOVEC Abstract.

More information

Performance tuning of Newton-GMRES methods for discontinuous Galerkin discretizations of the Navier-Stokes equations

Performance tuning of Newton-GMRES methods for discontinuous Galerkin discretizations of the Navier-Stokes equations Fluid Dynamics and Co-located Conferences June 24-27, 2013, San Diego, CA 21st AIAA Computational Fluid Dynamics Conference AIAA 2013-2685 Performance tuning of Newton-GMRES methods for discontinuous Galerkin

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions

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

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

Reduced basis method for the reliable model reduction of Navier-Stokes equations in cardiovascular modelling

Reduced basis method for the reliable model reduction of Navier-Stokes equations in cardiovascular modelling Reduced basis method for the reliable model reduction of Navier-Stokes equations in cardiovascular modelling Toni Lassila, Andrea Manzoni, Gianluigi Rozza CMCS - MATHICSE - École Polytechnique Fédérale

More information

Chapter 1: Basic Concepts

Chapter 1: Basic Concepts What is a fluid? A fluid is a substance in the gaseous or liquid form Distinction between solid and fluid? Solid: can resist an applied shear by deforming. Stress is proportional to strain Fluid: deforms

More information

nek5000 massively parallel spectral element simulations

nek5000 massively parallel spectral element simulations nek5000 massively parallel spectral element simulations PRACE Scientific Seminar HPC Boosts Science, 22th February 2011 P. Schlatter & D. S. Henningson Linné Flow Centre, KTH Mechanics Fluid flows Tornado,

More information

BOUNDARY LAYER ANALYSIS WITH NAVIER-STOKES EQUATION IN 2D CHANNEL FLOW

BOUNDARY LAYER ANALYSIS WITH NAVIER-STOKES EQUATION IN 2D CHANNEL FLOW Proceedings of,, BOUNDARY LAYER ANALYSIS WITH NAVIER-STOKES EQUATION IN 2D CHANNEL FLOW Yunho Jang Department of Mechanical and Industrial Engineering University of Massachusetts Amherst, MA 01002 Email:

More information

Numerical Modeling of Inclined Negatively Buoyant Jets

Numerical Modeling of Inclined Negatively Buoyant Jets Numerical Modeling of Inclined Negatively Buoyant Jets Presentation by: Hossein Kheirkhah Graduate Student in Civil Engineering Dep. of Civil Engineering University of Ottawa CANADA ICDEMOS April2014 Outline

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Reliability of LES in complex applications

Reliability of LES in complex applications Reliability of LES in complex applications Bernard J. Geurts Multiscale Modeling and Simulation (Twente) Anisotropic Turbulence (Eindhoven) DESIDER Symposium Corfu, June 7-8, 27 Sample of complex flow

More information

Turbulence Modeling. Cuong Nguyen November 05, The incompressible Navier-Stokes equations in conservation form are u i x i

Turbulence Modeling. Cuong Nguyen November 05, The incompressible Navier-Stokes equations in conservation form are u i x i Turbulence Modeling Cuong Nguyen November 05, 2005 1 Incompressible Case 1.1 Reynolds-averaged Navier-Stokes equations The incompressible Navier-Stokes equations in conservation form are u i x i = 0 (1)

More information

Structure preserving preconditioner for the incompressible Navier-Stokes equations

Structure preserving preconditioner for the incompressible Navier-Stokes equations Structure preserving preconditioner for the incompressible Navier-Stokes equations Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands

More information

Nonlinear Frequency Domain Methods Applied to the Euler and Navier-Stokes Equations p.1/50

Nonlinear Frequency Domain Methods Applied to the Euler and Navier-Stokes Equations p.1/50 Nonlinear Frequency Domain Methods Applied to the Euler and Navier-Stokes Equations Matthew McMullen Advisor: Antony Jameson Co-advisor: Juan Alonso Sponsor: Accelerated Strategic Computing Initiative

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