Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev

Size: px
Start display at page:

Download "Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev"

Transcription

1 Implementation of 3D Incompressible N-S Equations Mikhail Sekachev

2 Navier-Stokes Equations The motion of a viscous incompressible fluid is governed by the Navier-Stokes equations u + t u = ( u ) 0 Quick Facts: u = 1 2 ρ P + ν Claude-Louis Navier Sir George Stokes The advection term is NON-LINEAR The mass and momentum equations are COUPLED (via the velocity) The pressure appears only as a source term in the momentum equation(up to f(t)) There is NO evolution equation for the pressure (4 equations and 4 unknowns) The continuity equation acts as a constraint for the velocity field. Mathematicians have not yet proven that in three dimensions solutions always exist, or that if they do exist, then they do not contain any singularity. The Clay Mathematics Institute has offered a $1,000,000 prize for a solution or a counterexample. [1] u [1] Millennium Prize Problems, Clay Mathematics Institute, retrieved

3 Boundary Conditions The solid walls are always a problem! A typical boundary condition is Dirichlet: u = u x Ω b ( ) Ω,t where Ω is the boundary of the domain Ω occupied by the fluid and x Ω Ω There is no B.C. for the pressure on no-slip boundaries.

4 Initial Conditions Specification of the velocity field at the initial time: Integrating the continuity equation over Ω and using the divergence theorem yields: where n denotes the outward unit normal to the boundary Ω The initial velocity field Also u b u u0 and u 0 n u t=0 = n u b ( x) dω = 0 u 0 u0 = 0 is assumed to be solenoidal, i.e. (Solenoidal condition) satisfy the compatibility condition b = n u t= 0 0 Ω (Compatibility condition)

5 Compatibility Condition The solenoidal and compatibility conditions are necessary to prove the existence and uniqueness of Euler equations (non-steady, 2-D, incompressible, zero viscosity) Hence these conditions are independent of the viscous/nonviscous character of the fluid These conditions for the initial velocity allow for an optimal choice of the linear space for the initial data (L.Quartapelle, 1993) Therefore the compatibility condition affords solution with a minimal regularity as in most numerical schemes relying on spatial discretizations of local type

6 LBB Condition The aforementioned considerations yield LBB condition The LBB condition, also known as inf-sup or div-stability condition, states that for a given pair of approximating h h functional spaces S, if there exists a positive real 0 andv0 number γ > 0 such that inf then the discrete solutions stable. (P. T. Williams, 1993) sup h h 0 q S h h 0 ( h h, ) i q γ b v v i h i 1 0 v V h 0 h h h h ui V0 and P S0 will be Failure to satisfy LBB condition often results into oscillations in the pressure field, usually termed spurious pressure modes LBB: Ladyzhenskaya(1969), Babushka(1973), Brezzi(1974) q 0

7 Mass conservation equation The mass conservation equation acts as a differential constraint on the solution to DP+DE In the nonisothermal case there are five equations with five unknowns (namely Ux, Uy, Uz, P, T) There is NO equation for determining the pressure distribution. Major Approaches for addressing this issue are: Vector field theory (convert DM to a vector potential) Problems arise with 3-D or pressure-driven flows. Projection methods WILL handle those problems

8 The Family of Projection Methods The origin of the Family of projection methods (also called fractionalstep, or splitting methods) dates back to Originators: Alexandre Chorin and Roger Temam. The method is based on the Helmholtz decomposition (sometimes called the Helmholtz-Hodge decomposition) Vector field solenoidal+irrotational The whole spectrum of projection methods can be tentatively categorized into three major groups:** Pressure-correction methods Velocity-correction methods Consistent splitting methods **An overview of projection methods for incompressible flows. Guermond, J.L., Minev, P. and Shen, Jie. 195, s.l. : Comput. Methods Appl. Mech. Engr., 2006, pp

9 Taxonomy of INS Algorithms Based on Projection From the course materials: ES 552 Computational Fluid-Thermal Analysis. Instructor: Prof. A. J. Baker

10 CONTINUITY CONSTRAINT METHOD 1. Use-implicit Taylor series approach 2. Replace the time derivatives using momentum equations 3. Integration of these equations with a guessed pressure field results in a velocity field that does not in general satisfy the continuity constraint.

11 4. A computable strategy must rely on the accumulation of φ solutions, i.e., 5. With the Poisson equation for φ: 6. When the genuine pressure, p, is required it is assumed computable from the pressure Poisson eqn.:

12 Consistent Splitting Scheme 1. The equations are expressed in primitive variables: 2. By taking the L2-inner product of the momentum equation with q and noticing that we obtain 3. The standard consistent splitting scheme written for the forward Euler time marching scheme and first order extrapolation for the pressure is expressed as:

13 4. The accuracy of the above splitting scheme can be improved by replacing by, leading to the following algorithm: 5. To avoid computing explicitly in the second step, we take the inner product of the first equation with and we subtract the result from the second equation. 6. Owing to the identity and denoting we have the following algorithm:

14 7. Finally, replacing the advection term with its skew-symmetric counterpart the scheme corresponds to solving the following set of governing equations: All six equations in are linear, with the last one being simply an algebraic update.

15 The Weak Form The weak form of the equations above can be established using Galerkin s FE implementation, also referred to as Galerkin Weak Statement. The momentum equation in x-direction has the following ingredients:

16 The weak form for the variable φ is expressed as: The weak form for the intermediate variable Π is written as: Finally, the week form for the corrected pressure is:

17 Benchmark: Lid-driven 3-D cavity flow using consistent splitting scheme (i) The local eddies are located in the region close to the corners and near the endextremities of the cavity and are associated with fluid transport in the spanwise direction. (ii) The global eddies are regularly distributed along the cavity span in planes perpendicular to the lid and stretch along the streamlines of the primary recirculating flow. They are usually referred to as Taylor-Gortler-like (TGL) vortices.

18 Numerical results Y.-H. Kuo, K.-L. Wong, J. C.-F.Wong/ Adv. Appl. Math. Mech., 6 (2009), pp Re=3200, 1x1x1 cavity, Δt=0.005 Three pairs of symmetric TGL vortices

19 Benchmark: Thermal Cavity Ra 6 = cavity Non-uniform mesh

20 Future work/challenges Thermal Cavity and Lid-Driven cavity on So far only is working mesh Spalart-Allmaras one equation model LES Smagorinsky Subgrid-Scale (SGS) model Rational LES (RLES)

In honor of Prof. Hokee Minn

In honor of Prof. Hokee Minn In honor of Prof. Hokee Minn It is my greatest honor to be here today to deliver the nd Minn Hokee memorial lecture. I would like to thank the Prof. Ha for the nomination and the selecting committee for

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

Second-order finite-element projection method for 3D flows

Second-order finite-element projection method for 3D flows Second-order finite-element projection method for 3D flows J.-L. Guermond I and L. Quartapelle 2 1 LIMSI-CNRS, BP 133, 91403 Orsay, France, (guermond@limsi.fr) 2 Dipartimento di Fisica del Politecnico

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

SECOND-ORDER FULLY DISCRETIZED PROJECTION METHOD FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

SECOND-ORDER FULLY DISCRETIZED PROJECTION METHOD FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Tenth MSU Conference on Differential Equations and Computational Simulations. Electronic Journal of Differential Equations, Conference 3 (06), pp. 9 0. ISSN: 07-669. URL: http://ejde.math.txstate.edu or

More information

Analysis and Computation of Navier-Stokes equation in bounded domains

Analysis and Computation of Navier-Stokes equation in bounded domains 1 Analysis and Computation of Navier-Stokes equation in bounded domains Jian-Guo Liu Department of Physics and Department of Mathematics Duke University with Jie Liu (National University of Singapore)

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

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Chapter 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

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

Due Tuesday, November 23 nd, 12:00 midnight

Due Tuesday, November 23 nd, 12:00 midnight Due Tuesday, November 23 nd, 12:00 midnight This challenging but very rewarding homework is considering the finite element analysis of advection-diffusion and incompressible fluid flow problems. Problem

More information

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows Author manuscript, published in "5th International Symposium on Finite Volumes for Complex Applications, Aussois : France 2008)" Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible

More information

Projection Methods for Rotating Flow

Projection Methods for Rotating Flow Projection Methods for Rotating Flow Daniel Arndt Gert Lube Georg-August-Universität Göttingen Institute for Numerical and Applied Mathematics IACM - ECCOMAS 2014 Computational Modeling of Turbulent and

More information

Study of Forced and Free convection in Lid driven cavity problem

Study of Forced and Free convection in Lid driven cavity problem MIT Study of Forced and Free convection in Lid driven cavity problem 18.086 Project report Divya Panchanathan 5-11-2014 Aim To solve the Navier-stokes momentum equations for a lid driven cavity problem

More information

SPECTRAL METHOD FOR TIME DEPENDENT NAVIER-STOKES EQUATIONS

SPECTRAL METHOD FOR TIME DEPENDENT NAVIER-STOKES EQUATIONS Miskolc Mathematical Notes HU e-issn 1787-2413 Vol. 17 (216), No. 1, pp. 43 56 DOI: 1.18514/MMN.216.1815 SPECTRAL METHOD FOR TIME DEPENDENT NAVIER-STOKES EQUATIONS GABRIELLA BOGNÁR AND ZOLTÁN CSÁTI Received

More information

An evaluation of a conservative fourth order DNS code in turbulent channel flow

An evaluation of a conservative fourth order DNS code in turbulent channel flow Center for Turbulence Research Annual Research Briefs 2 2 An evaluation of a conservative fourth order DNS code in turbulent channel flow By Jessica Gullbrand. Motivation and objectives Direct numerical

More information

Validation of an Entropy-Viscosity Model for Large Eddy Simulation

Validation of an Entropy-Viscosity Model for Large Eddy Simulation Validation of an Entropy-Viscosity Model for Large Eddy Simulation J.-L. Guermond, A. Larios and T. Thompson 1 Introduction A primary mainstay of difficulty when working with problems of very high Reynolds

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

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Jie Shen Department of Mathematics, Penn State University University Par, PA 1680, USA Abstract. We present in this

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

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

More information

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

DIRECT NUMERICAL SIMULATION IN A LID-DRIVEN CAVITY AT HIGH REYNOLDS NUMBER

DIRECT NUMERICAL SIMULATION IN A LID-DRIVEN CAVITY AT HIGH REYNOLDS NUMBER Conference on Turbulence and Interactions TI26, May 29 - June 2, 26, Porquerolles, France DIRECT NUMERICAL SIMULATION IN A LID-DRIVEN CAVITY AT HIGH REYNOLDS NUMBER E. Leriche, Laboratoire d Ingénierie

More information

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

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

More information

NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 7 Number Pages 3 39 c Institute for Scientific Computing and Information NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL

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

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

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

More information

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4 Gauge Finite Element Method for Incompressible Flows Weinan E 1 Courant Institute of Mathematical Sciences New York, NY 10012 Jian-Guo Liu 2 Temple University Philadelphia, PA 19122 Abstract: We present

More information

arxiv: v1 [physics.flu-dyn] 23 Apr 2016

arxiv: v1 [physics.flu-dyn] 23 Apr 2016 A numerical study of the transition to oscillatory flow in 3D lid-driven cubic cavity flows Shang-Huan Chiu, Tsorng-Whay Pan, Jiwen He, Aixia Guo, and Roland Glowinski Department of Mathematics, University

More information

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling Turbulence Modeling Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark 1 Outline

More information

SOE3213/4: CFD Lecture 3

SOE3213/4: CFD Lecture 3 CFD { SOE323/4: CFD Lecture 3 @u x @t @u y @t @u z @t r:u = 0 () + r:(uu x ) = + r:(uu y ) = + r:(uu z ) = @x @y @z + r 2 u x (2) + r 2 u y (3) + r 2 u z (4) Transport equation form, with source @x Two

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

ON LIQUID CRYSTAL FLOWS WITH FREE-SLIP BOUNDARY CONDITIONS. Chun Liu and Jie Shen

ON LIQUID CRYSTAL FLOWS WITH FREE-SLIP BOUNDARY CONDITIONS. Chun Liu and Jie Shen DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS Volume 7, Number2, April2001 pp. 307 318 ON LIQUID CRYSTAL FLOWS WITH FREE-SLIP BOUNDARY CONDITIONS Chun Liu and Jie Shen Department

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

Exam in Fluid Mechanics 5C1214

Exam in Fluid Mechanics 5C1214 Eam in Fluid Mechanics 5C1214 Final eam in course 5C1214 13/01 2004 09-13 in Q24 Eaminer: Prof. Dan Henningson The point value of each question is given in parenthesis and you need more than 20 points

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

Gauge finite element method for incompressible flows

Gauge finite element method for incompressible flows INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 34: 701 710 Gauge finite element method for incompressible flows Weinan E a, *,1 and Jian-Guo Liu b,2 a Courant Institute

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

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

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

ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS

ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS Submitted to Math. Comp. ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS J.L. GUERMOND 1 AND JIE SHEN 2 Abstract. In this paper we study the rotational form of the pressure-correction

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

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS FREE BOUNDARY PROBLEMS IN FLUID MECHANICS ANA MARIA SOANE AND ROUBEN ROSTAMIAN We consider a class of free boundary problems governed by the incompressible Navier-Stokes equations. Our objective is to

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Hierarchy of Mathematical Models 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 29

More information

Least Squares Finite Element Methods for Large Scale Incompressible Flows

Least Squares Finite Element Methods for Large Scale Incompressible Flows Least Squares Finite Element Methods for Large Scale Incompressible Flows by Tate T. H. Tsang Department of Chemical & Materials Engineering University of Kentucky Lexington, KY 40506 tsang@engr.uky.edu

More information

A Pressure-Correction Scheme for Rotational Navier-Stokes Equations and Its Application to Rotating Turbulent Flows

A Pressure-Correction Scheme for Rotational Navier-Stokes Equations and Its Application to Rotating Turbulent Flows Commun. Comput. Phys. doi: 10.4208/cicp.301109.040310s Vol. 9, No. 3, pp. 740-755 March 2011 A Pressure-Correction Scheme for Rotational Navier-Stoes Equations and Its Application to Rotating Turbulent

More information

Probing Fundamental Bounds in Hydrodynamics Using Variational Optimization Methods

Probing Fundamental Bounds in Hydrodynamics Using Variational Optimization Methods Probing Fundamental Bounds in Hydrodynamics Using Variational Optimization Methods Bartosz Protas and Diego Ayala Department of Mathematics & Statistics McMaster University, Hamilton, Ontario, Canada URL:

More information

SIMULATION OF THREE-DIMENSIONAL INCOMPRESSIBLE CAVITY FLOWS

SIMULATION OF THREE-DIMENSIONAL INCOMPRESSIBLE CAVITY FLOWS ICAS 2000 CONGRESS SIMULATION OF THREE-DIMENSIONAL INCOMPRESSIBLE CAVITY FLOWS H Yao, R K Cooper, and S Raghunathan School of Aeronautical Engineering The Queen s University of Belfast, Belfast BT7 1NN,

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

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

CONNECTIONS BETWEEN A CONJECTURE OF SCHIFFER S AND INCOMPRESSIBLE FLUID MECHANICS

CONNECTIONS BETWEEN A CONJECTURE OF SCHIFFER S AND INCOMPRESSIBLE FLUID MECHANICS CONNECTIONS BETWEEN A CONJECTURE OF SCHIFFER S AND INCOMPRESSIBLE FLUID MECHANICS JAMES P. KELLIHER Abstract. We demonstrate connections that exists between a conjecture of Schiffer s (which is equivalent

More information

NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD

NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD V. G. Guedes a, G. C. R. Bodstein b, and M. H. Hirata c a Centro de Pesquisas de Energia Elétrica Departamento de Tecnologias

More information

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS J.-L. GUERMOND 1, Abstract. This paper analyzes a nonstandard form of the Stokes problem where the mass conservation

More information

Differential relations for fluid flow

Differential relations for fluid flow Differential relations for fluid flow In this approach, we apply basic conservation laws to an infinitesimally small control volume. The differential approach provides point by point details of a flow

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

Analysis of the flow and heat transfer characteristics for MHD free convection in an enclosure with a heated obstacle

Analysis of the flow and heat transfer characteristics for MHD free convection in an enclosure with a heated obstacle Nonlinear Analysis: Modelling and Control, 2011, Vol. 16, No. 1, 89 99 89 Analysis of the flow and heat transfer characteristics for MHD free convection in an enclosure with a heated obstacle S. Parvin,

More information

Pseudo-divergence-free element free Galerkin method for incompressible fluid flow

Pseudo-divergence-free element free Galerkin method for incompressible fluid flow International Workshop on MeshFree Methods 23 Pseudo-divergence-free element free Galerkin method for incompressible fluid flow Y. Vidal () and A. Huerta (2) Abstract: Incompressible modelling in finite

More information

L.I.M.S.I. - U.P.R. C.N.R.S. 3251, B.P. 133, ORSAY CEDEX, FRANCE fax number:

L.I.M.S.I. - U.P.R. C.N.R.S. 3251, B.P. 133, ORSAY CEDEX, FRANCE  fax number: Large Eddy Simulations of a spatially developing incompressible 3D mixing layer using the v-ω formulation. C. TENAUD, S. PELLERIN, A. DULIEU and L. TA PHUOC L.I.M.S.I. - U.P.R. C.N.R.S. 3251, B.P. 133,

More information

Multipole-Based Preconditioners for Sparse Linear Systems.

Multipole-Based Preconditioners for Sparse Linear Systems. Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation. Overview Summary of Contributions Generalized Stokes Problem Solenoidal

More information

The vorticity field. A dust devil

The vorticity field. A dust devil The vorticity field The vector ω = u curl u is twice the local angular velocity in the flow, and is called the vorticity of the flow (from Latin for a whirlpool). Vortex lines are everywhere in the direction

More information

Turbulent Boundary Layers & Turbulence Models. Lecture 09

Turbulent Boundary Layers & Turbulence Models. Lecture 09 Turbulent Boundary Layers & Turbulence Models Lecture 09 The turbulent boundary layer In turbulent flow, the boundary layer is defined as the thin region on the surface of a body in which viscous effects

More information

Linear instability of the lid-driven flow in a cubic cavity

Linear instability of the lid-driven flow in a cubic cavity Linear instability of the lid-driven flow in a cubic cavity Alexander Yu. Gelfgat School of Mechanical Engineering, Faculty of Engineering, Tel-Aviv University, Ramat Aviv, Tel-Aviv 69978, Israel Abstract

More information

Minimal stabilization techniques for incompressible flows

Minimal stabilization techniques for incompressible flows Minimal stabilization tecniques for incompressible flows G. Lube 1, L. Röe 1 and T. Knopp 2 1 Numerical and Applied Matematics Georg-August-University of Göttingen D-37083 Göttingen, Germany 2 German Aerospace

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

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

Review of fluid dynamics

Review of fluid dynamics Chapter 2 Review of fluid dynamics 2.1 Preliminaries ome basic concepts: A fluid is a substance that deforms continuously under stress. A Material olume is a tagged region that moves with the fluid. Hence

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

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

Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue

Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue 11 Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue Yang GUO*, Chisachi KATO** and Yoshinobu YAMADE*** 1 FrontFlow/Blue 1) is a general-purpose finite element program that calculates

More information

Excerpt from the Proceedings of the COMSOL Users Conference 2006 Boston

Excerpt from the Proceedings of the COMSOL Users Conference 2006 Boston Using Comsol Multiphysics to Model Viscoelastic Fluid Flow Bruce A. Finlayson, Professor Emeritus Department of Chemical Engineering University of Washington, Seattle, WA 98195-1750 finlayson@cheme.washington.edu

More information

FINITE ELEMENT SUPG PARAMETERS COMPUTED FROM LOCAL DOF-MATRICES FOR COMPRESSIBLE FLOWS

FINITE ELEMENT SUPG PARAMETERS COMPUTED FROM LOCAL DOF-MATRICES FOR COMPRESSIBLE FLOWS FINITE ELEMENT SUPG PARAMETERS COMPUTED FROM LOCAL DOF-MATRICES FOR COMPRESSIBLE FLOWS Lucia Catabriga Department of Computer Science, Federal University of Espírito Santo (UFES) Av. Fernando Ferrari,

More information

Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows

Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows Remark 7.1. Turbulent flows. The usually used model for turbulent incompressible flows are the incompressible Navier Stokes equations

More information

Topics in Fluid Dynamics: Classical physics and recent mathematics

Topics in Fluid Dynamics: Classical physics and recent mathematics Topics in Fluid Dynamics: Classical physics and recent mathematics Toan T. Nguyen 1,2 Penn State University Graduate Student Seminar @ PSU Jan 18th, 2018 1 Homepage: http://math.psu.edu/nguyen 2 Math blog:

More information

7 The Navier-Stokes Equations

7 The Navier-Stokes Equations 18.354/12.27 Spring 214 7 The Navier-Stokes Equations In the previous section, we have seen how one can deduce the general structure of hydrodynamic equations from purely macroscopic considerations and

More information

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request.

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request. UNIVERSITY OF EAST ANGLIA School of Mathematics Spring Semester Examination 2004 FLUID DYNAMICS Time allowed: 3 hours Attempt Question 1 and FOUR other questions. Candidates must show on each answer book

More information

PDEs, part 1: Introduction and elliptic PDEs

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

More information

A Projection FEM for Variable Density Incompressible Flows

A Projection FEM for Variable Density Incompressible Flows Journal of Computational Physics 65, 67 88 (000) doi:0.006/jcph.000.6609, available online at http://www.idealibrary.com on A Projection FEM for Variable Density Incompressible Flows J.-L. Guermond and

More information

Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom. Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom

Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom. Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom MultiScience - XXX. microcad International Multidisciplinary Scientific Conference University of Miskolc, Hungary, 21-22 April 2016, ISBN 978-963-358-113-1 NUMERICAL INVESTIGATION OF AN INCOMPRESSIBLE

More information

Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows

Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows Interaction and Multiscale Mechanics, Vol. 5, No. 1 (2012) 27-40 27 Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows Ling Zhang and Jie Ouyang* Department of

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

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

Some recent developments on ROMs in computational fluid dynamics

Some recent developments on ROMs in computational fluid dynamics Some recent developments on ROMs in computational fluid dynamics F. Ballarin 1, S. Ali 1, E. Delgado 2, D. Torlo 1,3, T. Chacón 2, M. Gómez 2, G. Rozza 1 1 mathlab, Mathematics Area, SISSA, Trieste, Italy

More information

Basic Aspects of Discretization

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

More information

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

Computational Fluid Dynamics-1(CFDI)

Computational Fluid Dynamics-1(CFDI) بسمه تعالی درس دینامیک سیالات محاسباتی 1 دوره کارشناسی ارشد دانشکده مهندسی مکانیک دانشگاه صنعتی خواجه نصیر الدین طوسی Computational Fluid Dynamics-1(CFDI) Course outlines: Part I A brief introduction to

More information

FEM solution of the ψ-ω equations with explicit viscous diffusion 1

FEM solution of the ψ-ω equations with explicit viscous diffusion 1 FEM solution of te ψ-ω equations wit explicit viscous diffusion J.-L. Guermond and L. Quartapelle 3 Abstract. Tis paper describes a variational formulation for solving te D time-dependent incompressible

More information

Week 2 Notes, Math 865, Tanveer

Week 2 Notes, Math 865, Tanveer Week 2 Notes, Math 865, Tanveer 1. Incompressible constant density equations in different forms Recall we derived the Navier-Stokes equation for incompressible constant density, i.e. homogeneous flows:

More information

Week 6 Notes, Math 865, Tanveer

Week 6 Notes, Math 865, Tanveer Week 6 Notes, Math 865, Tanveer. Energy Methods for Euler and Navier-Stokes Equation We will consider this week basic energy estimates. These are estimates on the L 2 spatial norms of the solution u(x,

More information

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION JOHNNY GUZMÁN, ABNER J. SALGADO, AND FRANCISCO-JAVIER SAYAS Abstract. The analysis of finite-element-like Galerkin discretization techniques for the

More information

Hamiltonian aspects of fluid dynamics

Hamiltonian aspects of fluid dynamics Hamiltonian aspects of fluid dynamics CDS 140b Joris Vankerschaver jv@caltech.edu CDS 01/29/08, 01/31/08 Joris Vankerschaver (CDS) Hamiltonian aspects of fluid dynamics 01/29/08, 01/31/08 1 / 34 Outline

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

Numerical solutions of 2-D incompressible driven cavity flow with wavy bottom surface

Numerical solutions of 2-D incompressible driven cavity flow with wavy bottom surface American Journal of Applied Mathematics 015; (1-1): 0-4 Published online December 5, 014 (http://www.sciencepublishinggroup.com/j/ajam) doi: 10.11648/j.ajam.s.01500101.14 ISSN: 0-004 (Print); ISSN: 0-006X

More information

SG2221 Wave Motion and Hydrodinamic Stability. MATLAB Project on 2D Poiseuille Flow Alessandro Ceci

SG2221 Wave Motion and Hydrodinamic Stability. MATLAB Project on 2D Poiseuille Flow Alessandro Ceci SG2221 Wave Motion and Hydrodinamic Stability MATLAB Project on 2D Poiseuille Flow Alessandro Ceci Base Flow 2D steady Incompressible Flow Flow driven by a constant pressure gradient Fully developed flow

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow DOE-FIU SCIENCE & TECHNOLOGY WORKFORCE DEVELOPMENT PROGRAM STUDENT SUMMER INTERNSHIP TECHNICAL REPORT June 4, 2012 to August 10, 2012 Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver

More information

HIGH-ORDER NUMERICAL METHODS FOR PRESSURE POISSON NAVIER-STOKES EQUATIONS

HIGH-ORDER NUMERICAL METHODS FOR PRESSURE POISSON NAVIER-STOKES EQUATIONS HIGH-ORDER NUMERICAL METHODS FOR PRESSURE POISSON EQUATION REFORMULATIONS OF THE INCOMPRESSIBLE NAVIER-STOKES EQUATIONS DOCTOR OF PHILOSOPHY Dong Zhou August, 214 Benjamin Seibold, Advisory Chair, Mathematics

More information

Finite Difference Methods for 3D Viscous Incompressible Flows in the Vorticity Vector Potential Formulation on Nonstaggered Grids

Finite Difference Methods for 3D Viscous Incompressible Flows in the Vorticity Vector Potential Formulation on Nonstaggered Grids JOURNAL OF COMPUTATIONAL PHYSICS 138, 57 82 (1997) ARTICLE NO. CP975815 Finite Difference Methods for 3D Viscous Incompressible Flows in the Vorticity Vector Potential Formulation on Nonstaggered Grids

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

Velocity Fluctuations in a Particle-Laden Turbulent Flow over a Backward-Facing Step

Velocity Fluctuations in a Particle-Laden Turbulent Flow over a Backward-Facing Step Copyright c 2004 Tech Science Press CMC, vol.1, no.3, pp.275-288, 2004 Velocity Fluctuations in a Particle-Laden Turbulent Flow over a Backward-Facing Step B. Wang 1, H.Q. Zhang 1, C.K. Chan 2 and X.L.

More information

Fine Grid Numerical Solutions of Triangular Cavity Flow

Fine Grid Numerical Solutions of Triangular Cavity Flow Published in : The European Physical Journal - Applied Physics (2007) Eur. Phys. J. Appl. Phys. 2007; Vol 38: pp 97-105 Fine Grid Numerical Solutions of Triangular Cavity Flow Ercan Erturk 1 and Orhan

More information