NumAn2014 Conference Proceedings

Size: px
Start display at page:

Download "NumAn2014 Conference Proceedings"

Transcription

1 OpenAccess Proceedings of the 6th International Conference on Numerical Analysis, pp Contents lists available at AMCL s Digital Library. NumAn014 Conference Proceedings Digital Library Triton : A multigrid accelerated high-order pressure correction compact scheme for incompressible Navier-Stokes solvers V. G. Mandikas a, E. N. Mathioudakis a, G. V. Kozyrakis b,c, J. A. Ekaterinaris d and N.A. Kampanis b a Applied Mathematics and Computers Laboratory, Technical University of Crete, University Campus, 7313 Chania, Hellas b Institute of Applied and Computational Mathematics, Foundation for Research and Technology - Hellas, Heraklion, Hellas c Department of Marine Sciences, University of the Aegean, University Hill, Mytilene 81100, Hellas d Department of Aerospace Engineering, Daytona Beach College of Engineering, Embry-Riddle Aeronautical University, 600 S. Clyde Morris Blvd., Daytona Beach FL 3114, USA bmandikas@science.tuc.gr, manolis@amcl.tuc.gr, gkoz@iacm.forth.gr, ekaterin@iacm.forth.gr, kampanis@iacm.forth.gr Abstract. A high-order accurate compact finite-difference numerical scheme, based on multigrid techniques, is constructed on staggered grids in order to develop an efficient incompressible Navier-Stokes solver. The enforcement of the incompressibility condition by solving a Poisson-type equation at each time step is commonly accepted to be the most computationally demanding part of the global pressure correction procedure of a numerical method. Since the efficiency of the overall algorithm depends on the Poisson solver, a multigrid acceleration technique coupled with compact high-order descretization scheme is implemented to accelerate the iterative procedure of the pressure updates and enhance computational efficiency. The employment of geometric multigrid techniques on staggered grids has an intrinsic difficulty, since the coarse grids do not constitute part of the finer grids. Appropriate boundary closure formulas are developed for the cell-centered pressure approximations of the boundary conditions. Performance investigations demonstrate that the proposed multigrid algorithm can significantly accelerate the numerical solution process, while retaining the high order of accuracy of the numerical method even for high Reynolds number flows. Key words: Global pressure correction, Poisson type equation, Incompressible Navier-Stokes equations, High-order compact schemes, staggered grids, Geometric MultiGrid techniques. 1 Introduction Modern applications in Computational Fluid Dynamics, require high order accurate methods for the numerical solution of the incompressible Navier-Stokes equations. In ISBN: AMCL/TUC

2 Mandikas V.G. et al. 199 the current work, the N S equations are solved using finite differences with high order accurate compact scheme discretizations. The incompressibility constraint can be enforced by a global pressure correction method based on the (elliptic in nature) Poisson equation and it is obtained by taking the divergence of the momentum equations and invoking continuity. A geometric Multigrid technique [1], [], [8] is employed for the acceleration of the solution of the elliptic BVP part. Recent studies focus on the development of methods based on high-order discretizations of the numerical solution, [5], that avoid the disadvantages of lower order methods and high-order-upwind techniques. The Poisson-type equation is solved with fourthorder accurate, compact, finite difference, energy conserving schemes (and applied to enforce the incompressibility condition to the Navier-Stokes solution) in [5, 7]. The solution of a Poisson-type equation is highly demanding in terms of computational cost, with a large and sparse resulting linear system, that requires an iterative solver to compute. Affordable computational times can be achieved by incorporating geometric multigrid techniques coupled with the iterative solver. Boundary closure formulas, for Dirichlet, Neumann, Robin or mixed boundary conditions can be accommodated on the physical boundary. For this purpose, appropriate intergrid transfer operators with special treatments for boundary closures are constructed for the multigrid technique. The incompressible Navier-Stokes equations in two dimensional Cartesian (x, y) coordinates are @y = rp + v, where u =[u, v, ] T and p are the velocity vector and pressure, respectively, and Re is the non-dimensional Reynolds number. F and G are the inviscid flux vectors, while F v and G v are the viscous fluxes given as: F =[u,uv] T, G =[vu, v ] T, F v @v i T @v i The current solution uses 4th Order accurate compact schemes, formulated over a staggered arrangement of variables (Fig. 1). Incompressibility is enforced using a globally defined pressure correction, computed by a Poisson-type equation and temporal discretisation is carried out by the explicit fourth-order Runge-Kutta method [3]. Multigrid acceleration techniques for the numerical solution of the Poisson-type equation are carried out by high order finite difference methods and a fourth order compact scheme is also used for the discretization of the Poisson-type equation. Proceedings of NumAn014 Conference

3 00 Multigrid accelerated high-order compact scheme for Navier-Stokes solvers Fig. 1: Staggered arrangement of variables on the computational grid. Numerical solution for the Poisson equation for pressure Following the incompressibility constraint, imposed on the N-S equations, the computed velocity field at each time step should be iteratively corrected to satisfy (1). The numerical solver proposed in [5], solves the following Poisson-type equation at each time step, with the pressure correction term p defined globally on, and valid on cell centers M ij (i =1,...,N x, j =1,...N y ( with f ij = f(m ij )= 1 a`,` 1 t (r un,` old ) i,j. ( p) ij = f ij, (3) The Neumann type BC can be applied by taking the normal projection for the momentum equations () on the wall, as shown in [4]. In their work it is suggested that, for the continuous expression of the Poisson equation the Neumann-type BC provides a unique solution for t 0, whereas a Dirichlet type is valid for t>0. For Dirichlet boundary conditions, p is constant on the walls of the domain and therefore p =0. With Neumann =0, which leads p)/@n =0, with n being the outward normal on the boundary. For the development of a fourth order finite difference compact discretization scheme of the pressure correction equation (3), the two one-dimensional fourth order compact finite difference operators P and Q are applied in the form, P y Q x p ij + P x Q y p ij = P y P x f ij + O( 4 ), (4) with P x, Q x, P y and Q y being the corresponding operators for each partial derivative s direction. The above relation is valid for all grid points (x i,y j ), where O( 4 ) denotes the truncated terms of the order of O( x 4 + y 4 ). Proceedings of NumAn014 Conference

4 Mandikas V.G. et al Multigrid acceleration technique The Multigrid method consists of an iterative solver called smoother, which is a relaxation scheme for the error linear system and two grid-transfer operators, the restriction for mapping residual vectors from the fine h to coarse H grid and the prolongation (interpolation) for returning the corrected error vectors back to the fine grid, [], [10]. 3.1 Prolongation/Interpolation operator The bilinear interpolation operator shown here as I h H, takes the coarse-grid vectors wh i,j and constructs the fine-grid vectors w h i,j according to Ih H wh = w h, w h i,j = 1 16 (9wH i,j +3w H i+1,j +3w H i,j+1 + w H i+1,j+1), (5) for i =1,..., Nx 1, j=1,..., Ny 1. The components of vectors wi+1,j h, wh i,j+1 and wi+1,j+1 h are similarly evaluated. 3. Restriction operator The reverse intergrid operator of prolongation is called restriction and transports the residual vectors from the fine grid wi,j h to the coarse grid wh i,j. It is shown here as, Ih Hwh = w H. Choosing the full-weighted operator (FW) IH h and satisfying the relation all interior coarse grid values can be written as: I h H = 1 4 IH h, (6) w H i,j = 1 64 (wh i,j +3w h i 1,j +3w h i,j + w h i+1,j +3w h i,j 1 +9w h i 1,j 1 +9w h i,j 1 +3w h i+1,j 1 +3w h i,j +9w h i 1,j +9w h i,j +3w h i+1,j + w h i,j+1 +3w h i 1,j+1 +3w h i,j+1 + w h i+1,j+1), for i =,..., Nx 1, j =,..., Ny 1. (7) 4 Numerical Results and Discussion The results presented hereafter are computed for a steady-state and a time-dependent flow problem. For the steady Kovasznay flow [6], exists an analytical solution of the form, u =1 e x cos( y) v = e x sin( y) p = 1 (1 e x ), (8) Proceedings of NumAn014 Conference

5 0 Multigrid accelerated high-order compact scheme for Navier-Stokes solvers where the following convergence estimates in Table 1. = Re q Re Comparison with the numerical solution to (8), yields Table 1 Computational error and convergence estimates for the Kovasznay flow grid size u u L p p L Error Order Error Order e e e e e e e e e e The unsteady flow problem describes the decay of an ideal vortex (Oseen vortex) with uniform pressure and initial velocity distribution, v (r, t = 0) = r, (9) where is the strength of the vortex and r is the distance from origin. This vortex decays under viscous dissipation with the velocity distribution at time t described by an exact solution [9], v (r, t) = r (1 e r Re 4t ). (10) Fig. compares the results for the velocity distribution in (10) over equidistanced, Cartesian grids (64x64, 18x18) with the exact solution, at time T =4. Fig. : Analytical and approximated velocity distribution over 64x64 and 18x18 grid points at T =4for the Oseen vortex decay. Proceedings of NumAn014 Conference

6 Mandikas V.G. et al. 03 Evidently, the approximate solution in both flow cases agrees very well with the analytical expressions and as seen in Table 1 and Fig. 3, the solution is fourth-orderaccurate both in space and time. Fig. 3: decay. L norms of the spatial (left) and temporal (right) error at T =1for the Oseen vortex References 1. A. Brandt, Multi-level adaptive solutions to boundary value problems, Mathematics of Computation 31 (1997) W. L. Briggs, V. E. Henson, S. McCormick, A Multigrid Tutorial, SIAM, Philadelphia, J. Butcher, The Numerical Analysis of Ordinary Differential Equations: Runge-Kutta Methods and General Linear Methods, J. Wiley and Sons, Chichester, P. M. Gresho, R. L. Sani, On pressure boundary conditions for the incompressible Navier- Stokes equations, International Journal for Numerical Methods in Fluids 7 (10) (1987) N. Kampanis, J. Ekaterinaris, A staggered grid, high-order accurate method for the incompressible Navier-Stokes equations, J. Comp. Physics 15 (006) L. I. G. Kovasznay, Laminar flow behind a two-dimensional grid, Proc. Camb. Phil. Soc. 44 (1948) V. Mandikas, E. Mathioudakis, E. Papadopoulou, N. Kampanis, in: Proc. of the World Congress on Engineering 013 (WCE013, London, U.K., July 3-, 013), vol. 1, pp , award Certificate of Merit for The 013 International Conference of Applied and Engineering Mathematics. 8. S. McCormick, Multigrid Methods, SIAM, Philadelphia, R. L. Panton, Incompressible Flow, J. Wiley and Sons, Chichester, P. Wesseling, An Introduction to Multigrid Methods, J. Wiley and Sons, Chichester, U.K., 199. Proceedings of NumAn014 Conference

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

A staggered grid, high-order accurate method for the incompressible Navier Stokes equations

A staggered grid, high-order accurate method for the incompressible Navier Stokes equations Journal of Computational Physics 15 (006) 589 613 www.elsevier.com/locate/jcp A staggered grid, high-order accurate method for the incompressible Navier Stokes equations Nikolaos A. Kampanis a, *, John

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

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

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

School of Mineral Resources Engineering, Technical University of Crete. Member of the Applied Mathematics and Computers Laboratory

School of Mineral Resources Engineering, Technical University of Crete. Member of the Applied Mathematics and Computers Laboratory Curriculum Vitae Emmanuel N. Mathioudakis PERSONAL RECORD Name: Citizenship: Current Employment: Affiliate: Work Address: Tel.: email: Emmanuel N. Mathioudakis Hellenic Assistant Professor with tenure

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

The Effect of the Schedule on the CPU Time for 2D Poisson Equation

The Effect of the Schedule on the CPU Time for 2D Poisson Equation Trabalho apresentado no XXXV CNMAC, Natal-RN, 2014. The Effect of the Schedule on the CPU Time for 2D Poisson Equation Fabiane de Oliveira, State University of Ponta Grossa, Department of Mathematics and

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

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

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

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

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

THE EFFECT OF MULTIGRID PARAMETERS IN A 3D HEAT DIFFUSION EQUATION

THE EFFECT OF MULTIGRID PARAMETERS IN A 3D HEAT DIFFUSION EQUATION Int. J. of Applied Mechanics and Engineering, 2018, vol.23, No.1, pp.213-221 DOI: 10.1515/ijame-2018-0012 Brief note THE EFFECT OF MULTIGRID PARAMETERS IN A 3D HEAT DIFFUSION EQUATION F. DE OLIVEIRA *

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

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

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

Iterative Methods and High-Order Difference Schemes for 2D Elliptic Problems with Mixed Derivative

Iterative Methods and High-Order Difference Schemes for 2D Elliptic Problems with Mixed Derivative Iterative Methods and High-Order Difference Schemes for 2D Elliptic Problems with Mixed Derivative Michel Fournié and Samir Karaa Laboratoire MIP, CNRS UMR 5640, Université Paul Sabatier, 118 route de

More information

Research Article Evaluation of the Capability of the Multigrid Method in Speeding Up the Convergence of Iterative Methods

Research Article Evaluation of the Capability of the Multigrid Method in Speeding Up the Convergence of Iterative Methods International Scholarly Research Network ISRN Computational Mathematics Volume 212, Article ID 172687, 5 pages doi:1.542/212/172687 Research Article Evaluation of the Capability of the Multigrid Method

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

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544 MULTIGRID CALCULATIONS FOB. CASCADES Antony Jameson and Feng Liu Princeton University, Princeton, NJ 0544 1. Introduction Development of numerical methods for internal flows such as the flow in gas turbines

More information

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Do Y. Kwak, 1 JunS.Lee 1 Department of Mathematics, KAIST, Taejon 305-701, Korea Department of Mathematics,

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

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

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS LONG CHEN In this chapter we discuss iterative methods for solving the finite element discretization of semi-linear elliptic equations of the form: find

More information

HIGH ACCURACY NUMERICAL METHODS FOR THE SOLUTION OF NON-LINEAR BOUNDARY VALUE PROBLEMS

HIGH ACCURACY NUMERICAL METHODS FOR THE SOLUTION OF NON-LINEAR BOUNDARY VALUE PROBLEMS ABSTRACT Of The Thesis Entitled HIGH ACCURACY NUMERICAL METHODS FOR THE SOLUTION OF NON-LINEAR BOUNDARY VALUE PROBLEMS Submitted To The University of Delhi In Partial Fulfillment For The Award of The Degree

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

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

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

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition C. Pozrikidis m Springer Contents Preface v 1 Introduction to Kinematics 1 1.1 Fluids and solids 1 1.2 Fluid parcels and flow

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

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations NASA/CR-1998-208741 ICASE Report No. 98-51 Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations David L. Darmofal Massachusetts Institute of Technology, Cambridge,

More information

A finite-volume algorithm for all speed flows

A finite-volume algorithm for all speed flows A finite-volume algorithm for all speed flows F. Moukalled and M. Darwish American University of Beirut, Faculty of Engineering & Architecture, Mechanical Engineering Department, P.O.Box 11-0236, Beirut,

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

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

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

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

Direct Numerical Simulation of fractal-generated turbulence

Direct Numerical Simulation of fractal-generated turbulence Direct Numerical Simulation of fractal-generated turbulence S. Laizet and J.C. Vassilicos Turbulence, Mixing and Flow Control Group, Department of Aeronautics and Institute for Mathematical Sciences, Imperial

More information

Spectral element agglomerate AMGe

Spectral element agglomerate AMGe Spectral element agglomerate AMGe T. Chartier 1, R. Falgout 2, V. E. Henson 2, J. E. Jones 4, T. A. Manteuffel 3, S. F. McCormick 3, J. W. Ruge 3, and P. S. Vassilevski 2 1 Department of Mathematics, Davidson

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

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

ENERGY PERFORMANCE IMPROVEMENT, FLOW BEHAVIOR AND HEAT TRANSFER INVESTIGATION IN A CIRCULAR TUBE WITH V-DOWNSTREAM DISCRETE BAFFLES

ENERGY PERFORMANCE IMPROVEMENT, FLOW BEHAVIOR AND HEAT TRANSFER INVESTIGATION IN A CIRCULAR TUBE WITH V-DOWNSTREAM DISCRETE BAFFLES Journal of Mathematics and Statistics 9 (4): 339-348, 2013 ISSN: 1549-3644 2013 doi:10.3844/jmssp.2013.339.348 Published Online 9 (4) 2013 (http://www.thescipub.com/jmss.toc) ENERGY PERFORMANCE IMPROVEMENT,

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

CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE

CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE In this chapter, the governing equations for the proposed numerical model with discretisation methods are presented. Spiral

More information

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

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

Spatial discretization scheme for incompressible viscous flows

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

More information

FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES

FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES SHRUTI JAIN B.Tech III Year, Electronics and Communication IIT Roorkee Tutors: Professor G. Biswas Professor S. Chakraborty ACKNOWLEDGMENTS I would like

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

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

Nonlinear iterative solvers for unsteady Navier-Stokes equations

Nonlinear iterative solvers for unsteady Navier-Stokes equations Proceedings of Symposia in Applied Mathematics Nonlinear iterative solvers for unsteady Navier-Stokes equations Philipp Birken and Antony Jameson This paper is dedicated to Gene Golub. Abstract. The application

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

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

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Mohamed S. Ebeida Carnegie Mellon University, Pittsburgh, PA 15213 Roger L. Davis and Roland W. Freund

More information

arxiv: v1 [math.na] 6 Nov 2017

arxiv: v1 [math.na] 6 Nov 2017 Efficient boundary corrected Strang splitting Lukas Einkemmer Martina Moccaldi Alexander Ostermann arxiv:1711.02193v1 [math.na] 6 Nov 2017 Version of November 6, 2017 Abstract Strang splitting is a well

More information

MATHEMATICAL MODELING AND NUMERICAL SOLUTION OF 3D ATMOSPHERIC BOUNDARY LAYER

MATHEMATICAL MODELING AND NUMERICAL SOLUTION OF 3D ATMOSPHERIC BOUNDARY LAYER , Vol, Pt, Special Issue Proceedings of International Conference RDAMM 585 MATHEMATICAL MODELING AND NUMERICAL SOLUTION OF D ATMOSPHERIC BOUNDARY LAYER L. Beneš, K. Kozel Department of Technical Mathematics,

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

(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

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients AM 205: lecture 13 Last time: ODE convergence and stability, Runge Kutta methods Today: the Butcher tableau, multi-step methods, boundary value problems Butcher tableau Can summarize an s + 1 stage Runge

More information

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

More information

MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW

MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW VAN EMDEN HENSON CENTER FOR APPLIED SCIENTIFIC COMPUTING LAWRENCE LIVERMORE NATIONAL LABORATORY Abstract Since their early application to elliptic

More information

2 Z. Li and C. Wang where u = (u; v) is the velocity, p is the pressure, ν is the viscosity. We assume that the boundary of the is piecewise

2 Z. Li and C. Wang where u = (u; v) is the velocity, p is the pressure, ν is the viscosity. We assume that the boundary of the is piecewise A fast finite difference method for solving Navier-Stokes Equations on irregular domains Zhilin Li Λ Cheng Wang y April 17, 2002 keywords: Navier-Stokes equations, irregular domains, vorticity stream-function

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

A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver

A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver Journal of Microwaves, Optoelectronics and Electromagnetic Applications, Vol. 10, No.2, December 2011 379 A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver

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

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

A Continuous/Discontinuous FE Method for the 3D Incompressible Flow Equations

A Continuous/Discontinuous FE Method for the 3D Incompressible Flow Equations Dissertations and Theses 11-2014 A Continuous/Discontinuous FE Method for the 3D Incompressible Flow Equations Nikolaos Kyriazis Follow this and additional works at: http://commons.erau.edu/edt Part of

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

Slip flow boundary conditions in discontinuous Galerkin discretizations of the Euler equations of gas dynamics

Slip flow boundary conditions in discontinuous Galerkin discretizations of the Euler equations of gas dynamics Slip flow boundary conditions in discontinuous Galerkin discretizations of the Euler equations of gas dynamics J.J.W. van der Vegt and H. van der Ven Nationaal Lucht- en Ruimtevaartlaboratorium National

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

Spectral method for the unsteady incompressible Navier Stokes equations in gauge formulation

Spectral method for the unsteady incompressible Navier Stokes equations in gauge formulation Report no. 04/09 Spectral method for the unsteady incompressible Navier Stokes equations in gauge formulation T. W. Tee I. J. Sobey A spectral method which uses a gauge method, as opposed to a projection

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

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. Bottaro, D. Venkataraman & F. Negrello Università di Genova, Italy

A. Bottaro, D. Venkataraman & F. Negrello Università di Genova, Italy A. Bottaro, D. Venkataraman & F. Negrello Università di Genova, Italy A. Bottaro, D. Venkataraman & F. Negrello & G. Tadmor Università di Genova, Italy Focus on passive actuators, what works, why it does,

More information

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

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

Detailed Outline, M E 521: Foundations of Fluid Mechanics I

Detailed Outline, M E 521: Foundations of Fluid Mechanics I Detailed Outline, M E 521: Foundations of Fluid Mechanics I I. Introduction and Review A. Notation 1. Vectors 2. Second-order tensors 3. Volume vs. velocity 4. Del operator B. Chapter 1: Review of Basic

More information

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

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

More information

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

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU MATHEMATICS OF COMPUTATION Volume 69, Number 232, Pages 135{1407 S 0025-571(00)0124-5 Article electronically published on March 24, 2000 CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND

More information

New explicit Runge-Kutta methods for the incompressible Navier-Stokes equations

New explicit Runge-Kutta methods for the incompressible Navier-Stokes equations Seventh International Conference on Computational Fluid Dynamics (ICCFD7), Big Island, Hawaii, July 9-, 0 ICCFD7-0 New explicit Runge-Kutta methods for the incompressible Navier-Stokes equations B. Sanderse,

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

The Deflation Accelerated Schwarz Method for CFD

The Deflation Accelerated Schwarz Method for CFD The Deflation Accelerated Schwarz Method for CFD J. Verkaik 1, C. Vuik 2,, B.D. Paarhuis 1, and A. Twerda 1 1 TNO Science and Industry, Stieltjesweg 1, P.O. Box 155, 2600 AD Delft, The Netherlands 2 Delft

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

Simulation and improvement of the ventilation of a welding workshop using a Finite volume scheme code

Simulation and improvement of the ventilation of a welding workshop using a Finite volume scheme code 1 st. Annual (National) Conference on Industrial Ventilation-IVC2010 Feb 24-25, 2010, Sharif University of Technology, Tehran, Iran IVC2010 Simulation and improvement of the ventilation of a welding workshop

More information

Modeling Unsteady Flow in Turbomachinery Using a Harmonic Balance Technique

Modeling Unsteady Flow in Turbomachinery Using a Harmonic Balance Technique Modeling Unsteady Flow in Turbomachinery Using a Harmonic Balance Technique Torsten Palenschat 317220 30.04.2014 Master seminar CES WS 2013/2014 Center for Computational Engineering Sciences RWTH Aachen

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

EULER AND SECOND-ORDER RUNGE-KUTTA METHODS FOR COMPUTATION OF FLOW AROUND A CYLINDER

EULER AND SECOND-ORDER RUNGE-KUTTA METHODS FOR COMPUTATION OF FLOW AROUND A CYLINDER EULER AND SEOND-ORDER RUNGE-KUTTA METHODS FOR OMPUTATION OF FLOW AROUND A YLINDER László Daróczy, László Baranyi MSc student, Professor University of Miskolc, Hungary Department of Fluid and Heat Engineering,

More information

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

More information

Runge-Kutta-Chebyshev Projection Method

Runge-Kutta-Chebyshev Projection Method Runge-Kutta-Chebyshev Projection Method Zheming Zheng Linda Petzold Department of Mechanical Engineering, University of California Santa Barbara, Santa Barbara, CA 93106, USA June 8, 2006 This work was

More information

16. Solution of elliptic partial differential equation

16. Solution of elliptic partial differential equation 16. Solution of elliptic partial differential equation Recall in the first lecture of this course. Assume you know how to use a computer to compute; but have not done any serious numerical computations

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

More information

Multigrid Method for 2D Helmholtz Equation using Higher Order Finite Difference Scheme Accelerated by Krylov Subspace

Multigrid Method for 2D Helmholtz Equation using Higher Order Finite Difference Scheme Accelerated by Krylov Subspace 201, TextRoad Publication ISSN: 2090-27 Journal of Applied Environmental and Biological Sciences www.textroad.com Multigrid Method for 2D Helmholtz Equation using Higher Order Finite Difference Scheme

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 39, pp. 3-45, 01. Copyright 01,. ISSN 1068-9613. ETNA A COMBINED FOURTH-ORDER COMPACT SCHEME WITH AN ACCELERATED MULTIGRID METHOD FOR THE ENERGY EQUATION

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

A numerical study of heat transfer and fluid flow over an in-line tube bank

A numerical study of heat transfer and fluid flow over an in-line tube bank Fluid Structure Interaction VI 295 A numerical study of heat transfer and fluid flow over an in-line tube bank Z. S. Abdel-Rehim Mechanical Engineering Department, National Research Center, Egypt Abstract

More information

The family of Runge Kutta methods with two intermediate evaluations is defined by

The family of Runge Kutta methods with two intermediate evaluations is defined by AM 205: lecture 13 Last time: Numerical solution of ordinary differential equations Today: Additional ODE methods, boundary value problems Thursday s lecture will be given by Thomas Fai Assignment 3 will

More information

International Conference on Energy Efficient Technologies For Automobiles (EETA 15) Journal of Chemical and Pharmaceutical Sciences ISSN:

International Conference on Energy Efficient Technologies For Automobiles (EETA 15) Journal of Chemical and Pharmaceutical Sciences ISSN: HEAT TRANSFER ENHANCEMENT WITH PRESSURE LOSS REDUCTION IN COMPACT HEAT EXCHANGERS USING VORTEX GENERATORS Viswajith M V*, Gireesh Kumaran Thampi, James Varghese Department of Mechanical Engineering, School

More information

1. Fluid Dynamics Around Airfoils

1. Fluid Dynamics Around Airfoils 1. Fluid Dynamics Around Airfoils Two-dimensional flow around a streamlined shape Foces on an airfoil Distribution of pressue coefficient over an airfoil The variation of the lift coefficient with the

More information

Draft Notes ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer

Draft Notes ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer Draft Notes ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer Instructor: Jayathi Y. Murthy School of Mechanical Engineering Purdue University Spring 00 c 1998 J.Y. Murthy and S.R. Mathur.

More information