Spatial discretization scheme for incompressible viscous flows

Size: px
Start display at page:

Download "Spatial discretization scheme for incompressible viscous flows"

Transcription

1 Spatial discretization scheme for incompressible viscous flows N. Kumar Supervisors: J.H.M. ten Thije Boonkkamp and B. Koren CASA-day /29

2 Challenges in CFD Accuracy a primary concern with all CFD solvers How to get higher accuracy? * Using higher order methods higher computational effort * Using finer grids significant increase in computational effort * Designing better numerical schemes 2/29

3 Incompressible viscous flow Flow governed by the incompressible Navier-Stokes equations: u x + v y =0 u t + (u 2 ) x + (uv) y = p x + ɛ(u xx + u yy ) v t + (uv) x + (v 2 ) y = p y + ɛ(v xx + v yy ) (ɛ = 1/Re) Spatial discretization: Finite volume method on a uniform staggered grid 3/29

4 Grid structure Figure : Mesh structure of a two-dimensional staggered grid 4/29

5 Control volumes Ω v y j+1 p i,j+1 o v i,j+1/2 Ω u y y j p i,j o u i+1/2,j o u i+3/2,j x i x i+1 x Figure : Control volumes for the spatial discretization of the momentum equations. 5/29

6 Discretization of the convective term Discretizing : (u 2 ) x + (uv) y Discretized convective term ( N u (u) ) i,j = y( ui+1,j 2 ui,j 2 ) + x ( ) u i+1/2,j+1/2 v i+1/2,j+1/2 u i+1/2,j 1/2 v i+1/2,j 1/2 Second order accurate FVM 6/29

7 Computation of interface velocities Required interface velocities: u i+1,j, v i+i/2,j+1/2, u i+1/2,j+1/2 Commonly used techniques: * Average value * Upwind value 7/29

8 Interface velocity u i+1,j u i+1,j y j u i+1/2,j u i+3/2,j x i x i+1/2 x i+1 x x i+3/2 8/29

9 Our research Computing interface velocities using local two-point boundary value problems Pros: Cons: * Interface velocity depending on the local Péclet number * Higher accuracy (lower error constants) * Higher computational effort * Slower convergence of the solutions 9/29

10 Computation of u i+1,j Solve the two-point local BVP : ((u 2 ) x ɛu xx ) = p x ((uv) y ɛu yy ), for x [x i+1/2,j, x i+3/2,j ] subject to the boundary conditions, u(x i+1/2,j ) = u i+1/2,j, u(x i+3/2,j ) = u i+3/2,j 10/29

11 Solution strategy Homogeneous case Including pressure gradient (u 2 ) x ɛu xx = 0 (u 2 ) x ɛu xx = p x Including the pressure gradient and the cross flux term (u 2 ) x ɛu xx = p x ((uv) y ɛu yy ) 11/29

12 The homogeneous case Further simplification: - Linearize the equation- Solution - Uu x ɛu xx = 0, (U is an estimate for u i+1,j ) u h i+1,j = A( P/2)u i+1/2,j + A(P/2)u i+3/2,j P U x, A(z) (e z + 1) 1 ɛ 12/29

13 Plot of A(z) 13/29

14 Including the pressure gradient Uu x ɛu xx = p x Assumption: p is piecewise linear over (x i+1/2,j, x i+3/2,j ) u i+1,j as a sum of homogeneous and inhomogeneous part u i+1,j = u h i+1,j + u p i+1,j, [ u p i+1,j = ( x)2 F ( P/2) p i+1 p i 4ɛ x F (z) ez 1 z z 2 (e z + 1). + F (P/2) p i+2 p ] i+1, x 14/29

15 Plot of F (z) 15/29

16 Including the cross flux term Uu x ɛu xx = p x ((uv) y ɛu yy ) }{{} constant = C i+1,j Assumption: ((uv) y ɛu yy ) is piecewise constant over (x i+1/2,j, x i+3/2,j ) u i+1,j = u h i+1,j + u p i+1,j + uc i+1,j u c i+1,j = 1 ɛ x 2 C i+1,j P (A(P/2) 0.5) 16/29

17 Interface velocity u i+1,j u i+1,j = u h i+1,j + u p i+1,j + uc i+1,j u h i+1,j = A( P/2)u i+1/2,j + A(P/2)u i+3/2,j, [ u p i+1,j = ( x)2 F ( P/2) p i+1 p i 4ɛ x u c i+1,j = 1 ɛ x 2 C i+1,j P (A(P/2) 0.5) + F (P/2) p i+2 p ] i+1, x 17/29

18 Iterative computation Linearization of the BVP (u 2 ) x Uu x Compute u i+1,j iteratively: update U and P etc. 18/29

19 Interface velocities: u i+1/2,j+1/2 and v i+1/2,j+1/2 For u i+1/2,j+1/2 use the local BVP Vu y ɛu yy = 0, y j < y < y j+1, u(y j ) = u i+1/2,j, u(y j+1 ) = u i+1/2,j+1, For v i+1/2,j+1/2 use Uv x ɛv xx = 0, x i < x < x i+1, v(x i ) = v i,j+1/2, v(x i+1 ) = v i+1,j+1/2. 19/29

20 Interface velocity u i+1/2,j+1/2 y j+1 u i+1/2,j+1 y y j+1/2 u i+1/2,j+1/2 y j u i+1/2,j x i Figure : Interface velocity u i+1/2,j+1/2. 20/29

21 Interface velocity v i+1/2,j+1/2 v i+1/2,j+1/2 v i,j+1/2 v i+1,j+1/2 y j x i x i+1/2 x i+1 x Figure : Interface velocity v i+1/2,j+1/2. 21/29

22 Numerical results Flow in a lid driven cavity 22/29

23 y Validation for driven cavity flow Ghia, Ghia ( ) 1-D local BVP method (8 8) Present (8 8) 1-D local BVP method (16 16) Present (16 16) 1-D local BVP method (32 32) Present (32 32) Velocity component (u) along the vertical centerline Figure : Velocity component u along the vertical centerline of the cavity for Re = /29

24 Flow in a lid driven cavity at Re = 100 Ghia-Ghia-Shin ( ) Upwind method Present method Standard average method 1D local BVP method y u Figure : Comparison of the velocity component u along the vertical centerline of the cavity for Re = 100. Grids used are 8 8 (dotted lines), (dashed lines) and (solid lines) 24/29

25 Flat plate boundary layer flow Figure : Flow over a flat plate at zero incidence. 25/29

26 Re-sensitivity Figure : Plot of velocity component u along the center of the plate over a family of Re = 4 i 100, (i = 0, 1, 2, 3, 4, 5). 26/29

27 Comparison with Blasius solution Figure : Comparison of the function f (η) = u/u 0 along a flat plate at zero incidence. 27/29

28 Conclusions Interface velocities dependent on Péclet number - Average: P 0 - Upwind: P Iterative computation: fast convergence Does not affect the formal order of accuracy, lower error constants Increased accuracy with the inclusion of pressure gradient and cross flux terms 28/29

29 References [1] N. Kumar, J.H.M. ten Thije Boonkkamp, and B. Koren. A new discretization method for the convective terms in the incompressible navier-stokes equations. In Finite Volumes for Complex Applications VII - Methods and Theoretical Aspects. [2] N. Kumar, J.H.M. ten Thije Boonkkamp, and B. Koren. A sub-cell discretization method for the convective terms in the incompressible navier-stokes equations. In International Conference on Spectral and Higher Order Methods 2014 (Submitted). 29/29

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report November 2016

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report November 2016 EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science CASA-Report 16-21 November 2016 Local BVP methods for the computation of cell-face velocities in the incompressible Navier-Stokes

More information

Flow in Corrugated Pipes

Flow in Corrugated Pipes Flow in Corrugated Pipes CASA Day April 7, 2010 Patricio Rosen Promotor: R.M.M. Mattheij Supervisors: J.H.M. ten Thije Boonkkamp J.A.M. Dam Outline Motivation Fluid Flow equations Method of slow variations

More information

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions R. S. Sellers MAE 5440, Computational Fluid Dynamics Utah State University, Department of Mechanical and Aerospace Engineering

More information

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j Helsinki University of Technology CFD-group/ The Laboratory of Applied Thermodynamics MEMO No CFD/TERMO-5-97 DATE: December 9,997 TITLE A comparison of complete vs. simplied viscous terms in boundary layer

More information

Chapter 9: Differential Analysis

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

More information

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations Today's Lecture 2D grid colocated arrangement staggered arrangement Exercise: Make a Fortran program which solves a system of linear equations using an iterative method SIMPLE algorithm Pressure-velocity

More information

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report March2008

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report March2008 EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science CASA-Report 08-08 March2008 The complexe flux scheme for spherically symmetrie conservation laws by J.H.M. ten Thije Boonkkamp,

More information

Block-Structured Adaptive Mesh Refinement

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

More information

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

Chapter 9: Differential Analysis of Fluid Flow

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

More information

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

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

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

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

Computation of Incompressible Flows: SIMPLE and related Algorithms

Computation of Incompressible Flows: SIMPLE and related Algorithms Computation of Incompressible Flows: SIMPLE and related Algorithms Milovan Perić CoMeT Continuum Mechanics Technologies GmbH milovan@continuummechanicstechnologies.de SIMPLE-Algorithm I - - - Consider

More information

IMPLEMENTATION OF PRESSURE BASED SOLVER FOR SU2. 3rd SU2 Developers Meet Akshay.K.R, Huseyin Ozdemir, Edwin van der Weide

IMPLEMENTATION OF PRESSURE BASED SOLVER FOR SU2. 3rd SU2 Developers Meet Akshay.K.R, Huseyin Ozdemir, Edwin van der Weide IMPLEMENTATION OF PRESSURE BASED SOLVER FOR SU2 3rd SU2 Developers Meet Akshay.K.R, Huseyin Ozdemir, Edwin van der Weide Content ECN part of TNO SU2 applications at ECN Incompressible flow solver Pressure-based

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

5.8 Laminar Boundary Layers

5.8 Laminar Boundary Layers 2.2 Marine Hydrodynamics, Fall 218 ecture 19 Copyright c 218 MIT - Department of Mechanical Engineering, All rights reserved. 2.2 - Marine Hydrodynamics ecture 19 5.8 aminar Boundary ayers δ y U potential

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

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

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

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

More information

Info. No lecture on Thursday in a week (March 17) PSet back tonight

Info. No lecture on Thursday in a week (March 17) PSet back tonight Lecture 0 8.086 Info No lecture on Thursday in a week (March 7) PSet back tonight Nonlinear transport & conservation laws What if transport becomes nonlinear? Remember: Nonlinear transport A first attempt

More information

The lattice Boltzmann method for contact line dynamics

The lattice Boltzmann method for contact line dynamics The lattice Boltzmann method for contact line dynamics Sudhir Srivastava, J.H.M. ten Thije Boonkkamp, Federico Toschi April 13, 2011 Overview 1 Problem description 2 Huh and Scriven model 3 Lattice Boltzmann

More information

The investigation on SIMPLE and SIMPLER algorithm through lid driven cavity

The investigation on SIMPLE and SIMPLER algorithm through lid driven cavity 29, Issue 1 (2017) 10-23 Journal of Advanced Research in Fluid Mechanics and Thermal Sciences Journal homepage: www.akademiabaru.com/arfmts.html ISSN: 2289-7879 The investigation on SIMPLE and SIMPLER

More information

Getting started: CFD notation

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

More information

Traffic Flow Problems

Traffic Flow Problems Traffic Flow Problems Nicodemus Banagaaya Supervisor : Dr. J.H.M. ten Thije Boonkkamp October 15, 2009 Outline Introduction Mathematical model derivation Godunov Scheme for the Greenberg Traffic model.

More information

On a high-order Newton linearization method for solving the incompressible Navier Stokes equations

On a high-order Newton linearization method for solving the incompressible Navier Stokes equations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 25; 62:1559 1578 Published online 11 January 25 in Wiley InterScience (www.interscience.wiley.com). DOI: 1.12/nme.125

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

More information

FLUID MECHANICS. Chapter 9 Flow over Immersed Bodies

FLUID MECHANICS. Chapter 9 Flow over Immersed Bodies FLUID MECHANICS Chapter 9 Flow over Immersed Bodies CHAP 9. FLOW OVER IMMERSED BODIES CONTENTS 9.1 General External Flow Characteristics 9.3 Drag 9.4 Lift 9.1 General External Flow Characteristics 9.1.1

More information

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

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

More information

Active Flux for Advection Diffusion

Active Flux for Advection Diffusion Active Flux for Advection Diffusion A Miracle in CFD Hiroaki Nishikawa National Institute of Aerospace! NIA CFD Seminar! August 25, 2015 In collaboration with the University of Michigan Supported by NASA

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

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

Linear Hydrodynamic Stability Analysis Summary and Review. Example of Stability Problems. Start with Base Velocity Profile

Linear Hydrodynamic Stability Analysis Summary and Review. Example of Stability Problems. Start with Base Velocity Profile Linear Hydrodynamic Stability Analysis Summary and Review OCEN 678 Fall 2007 Scott A. Socolofsky Example of Stability Problems Shear Flows: flows with strong velocity gradients Classic examples Wakes Jets

More information

L UNAM Université, ONIRIS, CNRS, GEPEA, UMR6144, Nantes, F-44322, France.

L UNAM Université, ONIRIS, CNRS, GEPEA, UMR6144, Nantes, F-44322, France. ing Heating During Batch Processing of Liquid Sample in a Single Mode Cavity S. Curet 1, F. Bellincanta Begnini, O. Rouaud 1, L. Boillereau 1 1 L UNAM Université, ONIRIS, CNRS, GEPEA, UMR6144, Nantes,

More information

Turbulence Modeling I!

Turbulence Modeling I! Outline! Turbulence Modeling I! Grétar Tryggvason! Spring 2010! Why turbulence modeling! Reynolds Averaged Numerical Simulations! Zero and One equation models! Two equations models! Model predictions!

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

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

Anisotropic grid-based formulas. for subgrid-scale models. By G.-H. Cottet 1 AND A. A. Wray

Anisotropic grid-based formulas. for subgrid-scale models. By G.-H. Cottet 1 AND A. A. Wray Center for Turbulence Research Annual Research Briefs 1997 113 Anisotropic grid-based formulas for subgrid-scale models By G.-H. Cottet 1 AND A. A. Wray 1. Motivations and objectives Anisotropic subgrid-scale

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

Hybrid Discontinuous Galerkin methods for incompressible flow problems

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

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 10: Case Study Computational Fluid Dynamics Michael Bader Winter 2012/2013 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 1 Fluid mechanics as a Discipline

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

An Unstructured Grid Incompressible Navier-Stokes Algorithm for Convective Heat. Transfer Based on Artificial Compressibility. Jessica Elaine Kress

An Unstructured Grid Incompressible Navier-Stokes Algorithm for Convective Heat. Transfer Based on Artificial Compressibility. Jessica Elaine Kress An Unstructured Grid Incompressible Navier-Stokes Algorithm for Convective Heat Transfer Based on Artificial Compressibility By Jessica Elaine Kress Approved: Lafayette Taylor Professor of Computational

More information

Enhancement of the momentum interpolation method on non-staggered grids

Enhancement of the momentum interpolation method on non-staggered grids INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 33: 1 22 Enhancement of the momentum interpolation method on non-staggered grids J. Papageorgakopoulos, G. Arampatzis,

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

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

LES of turbulent shear flow and pressure driven flow on shallow continental shelves.

LES of turbulent shear flow and pressure driven flow on shallow continental shelves. LES of turbulent shear flow and pressure driven flow on shallow continental shelves. Guillaume Martinat,CCPO - Old Dominion University Chester Grosch, CCPO - Old Dominion University Ying Xu, Michigan State

More information

Application of Chimera Grids in Rotational Flow

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

More information

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations An Extended Abstract submitted for the 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada January 26 Preferred Session Topic: Uncertainty quantification and stochastic methods for CFD A Non-Intrusive

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

More information

Entropy stable schemes for compressible flows on unstructured meshes

Entropy stable schemes for compressible flows on unstructured meshes Entropy stable schemes for compressible flows on unstructured meshes Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore deep@math.tifrbng.res.in http://math.tifrbng.res.in/

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

5. FVM discretization and Solution Procedure

5. FVM discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized

More information

Projection Dynamics in Godunov-Type Schemes

Projection Dynamics in Godunov-Type Schemes JOURNAL OF COMPUTATIONAL PHYSICS 142, 412 427 (1998) ARTICLE NO. CP985923 Projection Dynamics in Godunov-Type Schemes Kun Xu and Jishan Hu Department of Mathematics, Hong Kong University of Science and

More information

NumAn2014 Conference Proceedings

NumAn2014 Conference Proceedings OpenAccess Proceedings of the 6th International Conference on Numerical Analysis, pp 198-03 Contents lists available at AMCL s Digital Library. NumAn014 Conference Proceedings Digital Library Triton :

More information

Momentum Equation-Derivation-1 Consider the 2D continuity equation and integrate over the height of the boundary layer

Momentum Equation-Derivation-1 Consider the 2D continuity equation and integrate over the height of the boundary layer Module 2 : Convection Lecture 25 : Integral Boundary Layer Equations Objectives In this class: Integral equations for the momentum and thermal boundary layers are obtained Solution of these equations for

More information

Space-time XFEM for two-phase mass transport

Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Christoph Lehrenfeld joint work with Arnold Reusken EFEF, Prague, June 5-6th 2015 Christoph Lehrenfeld EFEF, Prague,

More information

Boundary conditions and estimates for the linearized Navier-Stokes equations on staggered grids

Boundary conditions and estimates for the linearized Navier-Stokes equations on staggered grids Boundary conditions and estimates for the linearized Navier-Stokes equations on staggered grids Wendy Kress and Jonas Nilsson Department of Scientific Computing Uppsala University Box S-75 4 Uppsala Sweden

More information

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

Problem 4.3. Problem 4.4

Problem 4.3. Problem 4.4 Problem 4.3 Problem 4.4 Problem 4.5 Problem 4.6 Problem 4.7 This is forced convection flow over a streamlined body. Viscous (velocity) boundary layer approximations can be made if the Reynolds number Re

More information

Well-balanced central finite volume methods for the Ripa system

Well-balanced central finite volume methods for the Ripa system Well-balanced central finite volume methods for the Ripa system R. Touma a C. Klingenberg b a Lebanese American University, Beirut, Lebanon b Würzburg University, Würzburg, Germany This paper is dedicated

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

arxiv: v1 [physics.comp-ph] 10 Aug 2015

arxiv: v1 [physics.comp-ph] 10 Aug 2015 Numerical experiments on the efficiency of local grid refinement based on truncation error estimates Alexandros Syrakos a,, Georgios Efthimiou a, John G. Bartzis a, Apostolos Goulas b arxiv:1508.02345v1

More information

A THREE DIMENSIONAL, FINITE VOLUME METHOD FOR INCOMPRESSIBLE NAVIER STOKES EQUATIONS ON UNSTRUCTURED, STAGGERED GRIDS

A THREE DIMENSIONAL, FINITE VOLUME METHOD FOR INCOMPRESSIBLE NAVIER STOKES EQUATIONS ON UNSTRUCTURED, STAGGERED GRIDS European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 A THREE DIMENSIONAL, FINITE VOLUME METHOD FOR INCOMPRESSIBLE

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

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

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

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu and Roy H. Stogner roystgnr@cfdlab.ae.utexas.edu Univ. of Texas at Austin September 9, 2008 1 Introduction 2 Weighted Residuals

More information

Stability of Shear Flow

Stability of Shear Flow Stability of Shear Flow notes by Zhan Wang and Sam Potter Revised by FW WHOI GFD Lecture 3 June, 011 A look at energy stability, valid for all amplitudes, and linear stability for shear flows. 1 Nonlinear

More information

REE Internal Fluid Flow Sheet 2 - Solution Fundamentals of Fluid Mechanics

REE Internal Fluid Flow Sheet 2 - Solution Fundamentals of Fluid Mechanics REE 307 - Internal Fluid Flow Sheet 2 - Solution Fundamentals of Fluid Mechanics 1. Is the following flows physically possible, that is, satisfy the continuity equation? Substitute the expressions for

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

SIMPLE Algorithm for Two-Dimensional Channel Flow. Fluid Flow and Heat Transfer

SIMPLE Algorithm for Two-Dimensional Channel Flow. Fluid Flow and Heat Transfer SIMPLE Algorithm for Two-Dimensional Channel Flow Fluid Flow and Heat Transfer by Professor Jung-Yang San Mechanical Engineering Department National Chung Hsing University Two-dimensional, transient, incompressible

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

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

More information

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

Finite Volume Method

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

More information

A boundary-layer model of thermocapillary flow in a cold corner

A boundary-layer model of thermocapillary flow in a cold corner PHYSICS OF FLUIDS VOLUME 14, NUMBER 9 SEPTEMBER 2002 A boundary-layer model of thermocapillary flow in a cold corner D. Canright Mathematics Department, Code MA/Ca, Naval Postgraduate School, Monterey,

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

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

A Solution Method for the Reynolds-Averaged Navier-Stokes Equation

A Solution Method for the Reynolds-Averaged Navier-Stokes Equation A Solution Method for the Reynolds-Averaged Navier-Stokes Equation T.-W. Lee Mechanical and Aerospace Engineering, Arizona State University, Tempe, AZ, 8587 Abstract- Navier-Stokes equations are difficult

More information

Convergence of the MAC scheme for incompressible flows

Convergence of the MAC scheme for incompressible flows Convergence of the MAC scheme for incompressible flows T. Galloue t?, R. Herbin?, J.-C. Latche??, K. Mallem????????? Aix-Marseille Universite I.R.S.N. Cadarache Universite d Annaba Calanque de Cortiou

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

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas April 14, 2011 1 Introduction In the last two decades, the Lattice Boltzmann method (LBM) has emerged as a promising tool

More information

Fine grid numerical solutions of triangular cavity flow

Fine grid numerical solutions of triangular cavity flow Eur. Phys. J. Appl. Phys. 38, 97 105 (2007) DOI: 10.1051/epjap:2007057 THE EUROPEAN PHYSICAL JOURNAL APPLIED PHYSICS Fine grid numerical solutions of triangular cavity flow E. Erturk 1,a and O. Gokcol

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu Univ. of Texas at Austin January 12, 2007 1 Introduction 2 Weighted Residuals 3 Poisson Equation 4 Other Examples 5 Essential

More information

Numerical Solution of Partial Differential Equations governing compressible flows

Numerical Solution of Partial Differential Equations governing compressible flows Numerical Solution of Partial Differential Equations governing compressible flows Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore

More information

THE CONVECTION DIFFUSION EQUATION

THE CONVECTION DIFFUSION EQUATION 3 THE CONVECTION DIFFUSION EQUATION We next consider the convection diffusion equation ɛ 2 u + w u = f, (3.) where ɛ>. This equation arises in numerous models of flows and other physical phenomena. The

More information

Efficient numerical solution of the Biot poroelasticity system in multilayered domains

Efficient numerical solution of the Biot poroelasticity system in multilayered domains Efficient numerical solution of the Biot poroelasticity system Anna Naumovich Oleg Iliev Francisco Gaspar Fraunhofer Institute for Industrial Mathematics Kaiserslautern, Germany, Spain Workshop on Model

More information

A Simple Turbulence Closure Model

A Simple Turbulence Closure Model A Simple Turbulence Closure Model Atmospheric Sciences 6150 1 Cartesian Tensor Notation Reynolds decomposition of velocity: Mean velocity: Turbulent velocity: Gradient operator: Advection operator: V =

More information

. p.1/31. Department Mathematics and Statistics Arizona State University. Don Jones

. p.1/31. Department Mathematics and Statistics Arizona State University. Don Jones Modified-Truncation Finite Difference Schemes. p.1/31 Department Mathematics and Statistics Arizona State University Don Jones dajones@math.asu.edu . p.2/31 Heat Equation t u = λu xx + f . p.2/31 Heat

More information

Simulation of the evolution of concentrated shear layers in a Maxwell fluid with a fast high-resolution finite-difference scheme

Simulation of the evolution of concentrated shear layers in a Maxwell fluid with a fast high-resolution finite-difference scheme J. Non-Newtonian Fluid Mech. 84 (1999) 275±287 Simulation of the evolution of concentrated shear layers in a Maxwell fluid with a fast high-resolution finite-difference scheme Raz Kupferman 1,a,*, Morton

More information

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg Advanced numerical methods for nonlinear advectiondiffusion-reaction equations Peter Frolkovič, University of Heidelberg Content Motivation and background R 3 T Numerical modelling advection advection

More information

CFD with OpenSource software

CFD with OpenSource software CFD with OpenSource software The Harmonic Balance Method in foam-extend Gregor Cvijetić Supervisor: Hrvoje Jasak Faculty of Mechanical Engineering and Naval Architecture University of Zagreb gregor.cvijetic@fsb.hr

More information

PAPER. Stabilized and Galerkin Least Squares Formulations

PAPER. Stabilized and Galerkin Least Squares Formulations PAPER Stabilized and Galerkin Least Squares Formulations R. Ranjan a Y. Feng b A.T. Chronopoulos c a Senior Computational Modeler, Astronautics Corporation of America, Madison b Professor, Department of

More information

Parabolic Flow in Parallel Plate Channel ME 412 Project 4

Parabolic Flow in Parallel Plate Channel ME 412 Project 4 Parabolic Flow in Parallel Plate Channel ME 412 Project 4 Jingwei Zhu April 12, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of this project is to develop and apply a computer

More information

Investigating advection control in parabolic PDE systems for competitive populations

Investigating advection control in parabolic PDE systems for competitive populations Investigating advection control in parabolic PDE systems for competitive populations Kokum De Silva Department of Mathematics University of Peradeniya, Sri Lanka Tuoc Phan and Suzanne Lenhart Department

More information

arxiv: v2 [math.na] 5 Dec 2016

arxiv: v2 [math.na] 5 Dec 2016 Spectral semi-implicit and space-time discontinuous Galerkin methods for the incompressible Navier-Stokes equations on staggered Cartesian grids Francesco Fambri a, Michael Dumbser a a Laboratory of Applied

More information