1.2 Numerical Solutions of Flow Problems

Size: px
Start display at page:

Download "1.2 Numerical Solutions of Flow Problems"

Transcription

1 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian fluid with constant viscosity: Comments: The above system of four equations is closed, i.e., it has the same number of independent equations as the number of unknowns (u,v,w and p). Proper boundary and initial conditions must be specified. These equations are very difficult to solve because they are coupled and contain nonlinear terms. To simplify them, one may make new assumptions (e.g., to neglect friction), but this is possible only in certain cases. Analytical solutions are known for few simple cases only. Numerical solutions are possible for a wide range of problems.

2 TYPICAL STEPS FOR THE NUMERICAL SOLUTION OF A FLOW PROBLEM 1. Define the physical problem (i.e., the geometry and the required solution variables); if possible, make simplifying assumptions (e.g. incompressible flow or inviscid flow; justification must be given). 2. Formulate a mathematical model, including the governing equations (namely the mathematical expressions of the physical principles of conservation of mass, momentum and energy or other theoretical or empirical concepts) as well as proper boundary and/or initial conditions. The governing equations could be algebraic, differential (ordinary or partial), integral or integro-differential. The usual form in fluid mechanics is differential, which implies that the solution must specify the values of the required parameters at all points in the flow. 3. Transform differential equations into a form convenient for solution by digital computers. This means to discretize the differential equations by transforming them into a set of algebraic equations. Common discretization techniques are the finite difference technique and the finite element technique. The algebraic equations apply to selected positions of the flow field (e.g., at the nodes of a grid); values at other points can be found by interpolation. 4. Analyze the properties of the discretization scheme, namely check its stability, convergence and error bounds. Commercial packages have incorporated appropriate tests. 5. Solve the system of algebraic equations by iteration or with the use of matrix solvers. Commercial packages have incorporated properly optimized algorithms. Building block type subroutines are available for custom developed codes. 6. Present, interpret and discuss the results. Validate vs. experimental results and compare with other related studies, if available.

3 DISCRETIZATION IN CFD In fluid dynamics, space and time are in most cases assumed to be continuous. The differential equations of motion are also continuous, namely they apply to all mathematical points in space and time within the flow domain. Digital computers, however, cannot provide continuous solutions. Instead, they can estimate discrete values of the variables of interest at discrete locations. Therefore, a first step in all CFD formulations is to discretize both the space-time domain and the differential equations. Space discretization: This is achieved by defining a mesh or a grid that covers the flow domain and replacing the continuous domain by a finite number of discrete points. The part of a code that generates the discrete set of points is called the mesh generator. The solution will be then computed only at those points. Values at other points may be estimated by interpolation. Obviously, the higher the number of discrete points is, the more accurate the representation of the flow domain would be. One may also expect that the accuracy of the solution improves as the number of discrete points increases. On the other hand, as this number increases, the solution would require an increasing amount of computer resources (e.g., computer memory and execution time). Time discretization: This is usually achieved by dividing the time interval of interest into a number of equal discrete time steps and computing the solution at these steps only. Even steady flows are sometimes computed by using a time-dependent (pseudo-unsteady) formulation, in which the partial differential equations are replaced by ordinary differential equations with respect to time. Equation discretization: This requires the transformation of the continuous differential equations into a system of algebraic (i.e., without derivatives or integrals) equations of the variable values at the discrete space-time points mentioned earlier. The solution of this system of algebraic equations can be achieved either directly (i.e., in one step), or iteratively. The three most commonly used methods for the space-time discretization of differential operators are the finite difference method (FDM), the finite element method (FEM) and the finite volume method (FVM).

4 EQUATION DISCRETIZATION METHODS Finite difference method: This is the simplest and oldest method, and it is best applied to relatively regular meshes. The flow domain is fitted by a grid consisting of intersecting families of lines, straight or curved, and the solution is obtained at the intersection points (nodes). The various derivatives in the equations are approximated as finite differences, by using the Taylor series expansion. Thus, each differential equation is replaced by a set of algebraic, finite difference equations. Finite element method: The flow domain is divided into a number of finite elements, namely subdomains with various shapes (e.g., rectangular, triangular, tetrahedral etc.). These elements are defined by their vertices. They should not overlap and should cover the entire flow domain. A number of discrete points (nodes) are defined for each finite element, either at its interior or at its boundary. The discrete values of the unknown parameters and their derivatives are expressed at these nodes. The differential equations are first expressed in an integral form over the entire flow domain. Then, the approximate solutions, valid at the nodes, are expressed as linear combinations of certain functions, multiplied by coefficients which are selected such that the integral relationships are satisfied. One approach to find these coefficients is to use a variational method (Ritz method) that minimizes some appropriate function. Another method is the weighted residual method or Galerkin method. The finite element method was first developed in structural dynamics and it took some time before it could be applied to fluid mechanics. This method is suitable for coupling fluid and solid motions (fluid-structure interaction). Finite volume method: In this approach, the integral forms of the basic principles (i.e., continuity, momentum and energy principles) are discretized directly in the physical space. Although conceptually this method resembles the finite difference method, it is suitable for complex geometries, as it utilizes arbitrary mesh shapes. Thus, the finite volume method is similar to the finite element method as far as the subdivision of space is concerned.

5 STRUCTURED AND UNSTRUCTURED MESHES We wish to solve numerically the flow in a rectangular channel containing a solid cylinder. We need to fit a mesh in the space between the cylinder and plane wall surfaces. Two choices are possible: a structured mesh, which follows the boundaries in some regular fashion and an unstructured mesh, which has randomly connected elements. Structured mesh would generally provide higher accuracy of the solution but they may be difficult or impossible to generate for complex geometries. Structured mesh with detail near the gap Unstructured mesh with detail near the gap

6 FINITE DIFFERENCE APPROXIMATION OF LAPLACE'S EQUATION USING A RECTANGULAR GRID N PN W y PW x PE E P 2 Δ y PS 2 Δ x S 2-D Laplace s Equation: 0 In the following, we shall use Taylor series expansions to approximate derivatives by finite differences. As a first step, the first-order derivatives at mid-points PE and PW are approximated as Δ Δ Then, the second derivative at the central point P is approximated as Δ Δ Δ 2 Δ 2

7 Similarly, following the same procedure along the y-axis, one can get 2 Δy 2 Then the 2-D Laplace's equation in finite difference form becomes Δ 2 Δy 2 Further solving for the function at the central point, one gets Δy 2 Δ 2 2 Δ 2 2 Δ 2 For a square grid ( x = y), this is simplified to the central average value 4 1

8 N b y y W P E S x a x a<1, b<1, x= y If the grid has uneven spacing (e.g., near a boundary, as shown in the sketch), the above relation has to be modified as where the coefficients are given by the expressions 2 1, 2 1,

9 NUMERICAL SOLUTION OF LAPLACE'S EQUATION Boundary condition: Laplace's equation can be solved if and only if the values of the unknown function are specified over the entire boundary (Note: other types of equations may require the specification of boundary conditions in part of the boundary only as well as the specification of initial conditions). For simplicity, assume that the flow domain is a square (left side of the figure). First, assume that a uniform grid with only 3 rows and three columns is fitted to this domain. If is specified at the four boundary nodes, then eq. (1) can be used to compute the value of at the only existing interior node 2,2 and the problem is solved, within this level of approximation. Next, assume that a uniform grid with M rows and N columns is fitted to the domain (right side of the figure). must be specified at all boundary nodes. There will be (N-2)(M-2) interior nodes, for each of which one can write a linear algebraic equation like eq. (1). Then, one can obtain a system of (N-2)(M-2) linear algebraic equations with an equal number of unknowns, namely the values of at all interior nodes. This is a well known problem and can be solved exactly, e.g., by matrix inversion methods. However, when N and M are large, this approach is extremely tedious and even unnecessary because most of the coefficients of these equations are zero. A more practical approach is to use an iterative, approximate method of solution, such as the Gauss-Seidel iteration method.

10 GAUSS-SEIDEL ITERATION METHOD FOR SOLVING A SYSTEM OF LINEAR ALGEBRAIC EQUATIONS This method consists of the following steps: a) as the boundary condition, specify the values of at all exterior nodes b) prescribe starting values of (e.g., zero values) at all interior nodes c) compute new values of at all interior nodes using equations like (1) d) compare the new and old values e) if the mean square difference between new and all values is smaller than a prescribed error limit, stop the iteration; otherwise, go back to step c) and repeat steps d) and e)

CHAPTER 1. Introduction

CHAPTER 1. Introduction ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

The Finite Element Method

The Finite Element Method The Finite Element Method A Practical Course G. R. Liu and S. S. Quek Chapter 1: Computational modeling An overview 1 CONTENTS INTRODUCTION PHYSICAL PROBLEMS IN ENGINEERING COMPUTATIONAL MODELLING USING

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

computational Fluid Dynamics - Prof. V. Esfahanian

computational Fluid Dynamics - Prof. V. Esfahanian Three boards categories: Experimental Theoretical Computational Crucial to know all three: Each has their advantages and disadvantages. Require validation and verification. School of Mechanical Engineering

More information

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD TASK QUARTERLY 12 No 3, 273 287 FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD ZBIGNIEW KOSMA Institute of Applied Mechanics, Technical University

More information

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

Application of Finite Volume Method for Structural Analysis

Application of Finite Volume Method for Structural Analysis Application of Finite Volume Method for Structural Analysis Saeed-Reza Sabbagh-Yazdi and Milad Bayatlou Associate Professor, Civil Engineering Department of KNToosi University of Technology, PostGraduate

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

Computational Fluid Dynamics for Engineers

Computational Fluid Dynamics for Engineers Tuncer Cebeci Jian P. Shao Fassi Kafyeke Eric Laurendeau Computational Fluid Dynamics for Engineers From Panel to Navier-Stokes Methods with Computer Programs With 152 Figures, 19 Tables, 84 Problems and

More information

MATLAB. Advanced Mathematics and Mechanics Applications Using. Third Edition. David Halpern University of Alabama CHAPMAN & HALL/CRC

MATLAB. Advanced Mathematics and Mechanics Applications Using. Third Edition. David Halpern University of Alabama CHAPMAN & HALL/CRC Advanced Mathematics and Mechanics Applications Using MATLAB Third Edition Howard B. Wilson University of Alabama Louis H. Turcotte Rose-Hulman Institute of Technology David Halpern University of Alabama

More information

Stream Function-Vorticity CFD Solver MAE 6263

Stream Function-Vorticity CFD Solver MAE 6263 Stream Function-Vorticity CFD Solver MAE 66 Charles O Neill April, 00 Abstract A finite difference CFD solver was developed for transient, two-dimensional Cartesian viscous flows. Flow parameters are solved

More information

Analysis of Flow Dynamics of an Incompressible Viscous Fluid in a Channel

Analysis of Flow Dynamics of an Incompressible Viscous Fluid in a Channel Analysis of Flow Dynamics of an Incompressible Viscous Fluid in a Channel Deepak Kumar Assistant Professor, Department of Mechanical Engineering, Amity University Gurgaon, India E-mail: deepak209476@gmail.com

More information

Overview and Recent Developments of Dynamic Mesh Capabilities

Overview and Recent Developments of Dynamic Mesh Capabilities Overview and Recent Developments of Dynamic Mesh Capabilities Henrik Rusche and Hrvoje Jasak h.rusche@wikki-gmbh.de and h.jasak@wikki.co.uk Wikki Gmbh, Germany Wikki Ltd, United Kingdom 6th OpenFOAM Workshop,

More information

A numerical grid and grid less (Mesh less) techniques for the solution of 2D Laplace equation

A numerical grid and grid less (Mesh less) techniques for the solution of 2D Laplace equation Available online at www.pelagiaresearchlibrary.com Advances in Applied Science Research, 2014, 5(1):150-155 ISSN: 0976-8610 CODEN (USA): AASRFC A numerical grid and grid less (Mesh less) techniques for

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 6:

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 6: file:///d:/chitra/nptel_phase2/mechanical/cfd/lecture6/6_1.htm 1 of 1 6/20/2012 12:24 PM The Lecture deals with: ADI Method file:///d:/chitra/nptel_phase2/mechanical/cfd/lecture6/6_2.htm 1 of 2 6/20/2012

More information

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr.

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr. Mid-Year Report Discontinuous Galerkin Euler Equation Solver Friday, December 14, 2012 Andrey Andreyev Advisor: Dr. James Baeder Abstract: The focus of this effort is to produce a two dimensional inviscid,

More information

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS International Journal of Mechanical Engineering and Technology (IJMET Volume 9 Issue 10 October 2018 pp. 179 189 Article ID: IJMET_09_10_11 Available online at http://www.iaeme.com/ijmet/issues.asp?jtypeijmet&vtype9&itype10

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

More information

course outline basic principles of numerical analysis, intro FEM

course outline basic principles of numerical analysis, intro FEM idealization, equilibrium, solutions, interpretation of results types of numerical engineering problems continuous vs discrete systems direct stiffness approach differential & variational formulation introduction

More information

Module D: Laminar Flow over a Flat Plate

Module D: Laminar Flow over a Flat Plate Module D: Laminar Flow over a Flat Plate Summary... Problem Statement Geometry and Mesh Creation Problem Setup Solution. Results Validation......... Mesh Refinement.. Summary This ANSYS FLUENT tutorial

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4 UMEÅ UNIVERSITY Department of Physics Claude Dion Olexii Iukhymenko May 15, 2015 Strömningslära Fluid Dynamics (5FY144) Computer laboratories using COMSOL v4.4!! Report requirements Computer labs must

More information

Best Practices Workshop: Overset Meshing

Best Practices Workshop: Overset Meshing Best Practices Workshop: Overset Meshing Overview Introduction to Overset Meshes Range of Application Workflow Demonstrations and Best Practices What are Overset Meshes? Overset meshes are also known as

More information

f xx + f yy = F (x, y)

f xx + f yy = F (x, y) Application of the 2D finite element method to Laplace (Poisson) equation; f xx + f yy = F (x, y) M. R. Hadizadeh Computer Club, Department of Physics and Astronomy, Ohio University 4 Nov. 2013 Domain

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Siva Nadarajah Antony Jameson Stanford University 15th AIAA Computational Fluid Dynamics Conference

More information

Module 1 Lecture Notes 2. Optimization Problem and Model Formulation

Module 1 Lecture Notes 2. Optimization Problem and Model Formulation Optimization Methods: Introduction and Basic concepts 1 Module 1 Lecture Notes 2 Optimization Problem and Model Formulation Introduction In the previous lecture we studied the evolution of optimization

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

Lecture 3.2 Methods for Structured Mesh Generation

Lecture 3.2 Methods for Structured Mesh Generation Lecture 3.2 Methods for Structured Mesh Generation 1 There are several methods to develop the structured meshes: Algebraic methods, Interpolation methods, and methods based on solving partial differential

More information

Middle East Technical University Mechanical Engineering Department ME 485 CFD with Finite Volume Method Fall 2017 (Dr. Sert)

Middle East Technical University Mechanical Engineering Department ME 485 CFD with Finite Volume Method Fall 2017 (Dr. Sert) Middle East Technical University Mechanical Engineering Department ME 485 CFD with Finite Volume Method Fall 2017 (Dr. Sert) ANSYS Fluent Tutorial Developing Laminar Flow in a 2D Channel 1 How to use This

More information

Shape optimisation using breakthrough technologies

Shape optimisation using breakthrough technologies Shape optimisation using breakthrough technologies Compiled by Mike Slack Ansys Technical Services 2010 ANSYS, Inc. All rights reserved. 1 ANSYS, Inc. Proprietary Introduction Shape optimisation technologies

More information

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics I. Pantle Fachgebiet Strömungsmaschinen Karlsruher Institut für Technologie KIT Motivation

More information

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models C. Aberle, A. Hakim, and U. Shumlak Aerospace and Astronautics University of Washington, Seattle American Physical Society

More information

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs)

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) OBJECTIVE FLUID SIMULATIONS Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) The basic objective of the project is the implementation of the paper Stable Fluids (Jos Stam, SIGGRAPH 99). The final

More information

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer ENERGY-224 Reservoir Simulation Project Report Ala Alzayer Autumn Quarter December 3, 2014 Contents 1 Objective 2 2 Governing Equations 2 3 Methodolgy 3 3.1 BlockMesh.........................................

More information

Use of CFD in Design and Development of R404A Reciprocating Compressor

Use of CFD in Design and Development of R404A Reciprocating Compressor Purdue University Purdue e-pubs International Compressor Engineering Conference School of Mechanical Engineering 2006 Use of CFD in Design and Development of R404A Reciprocating Compressor Yogesh V. Birari

More information

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM)

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) Computational Methods and Experimental Measurements XVII 235 Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) K. Rehman Department of Mechanical Engineering,

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 24

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 24 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 24 So in today s class, we will look at quadrilateral elements; and we will

More information

Non-Newtonian Transitional Flow in an Eccentric Annulus

Non-Newtonian Transitional Flow in an Eccentric Annulus Tutorial 8. Non-Newtonian Transitional Flow in an Eccentric Annulus Introduction The purpose of this tutorial is to illustrate the setup and solution of a 3D, turbulent flow of a non-newtonian fluid. Turbulent

More information

CFD-1. Introduction: What is CFD? T. J. Craft. Msc CFD-1. CFD: Computational Fluid Dynamics

CFD-1. Introduction: What is CFD? T. J. Craft. Msc CFD-1. CFD: Computational Fluid Dynamics School of Mechanical Aerospace and Civil Engineering CFD-1 T. J. Craft George Begg Building, C41 Msc CFD-1 Reading: J. Ferziger, M. Peric, Computational Methods for Fluid Dynamics H.K. Versteeg, W. Malalasekara,

More information

SYSTEMS OF NONLINEAR EQUATIONS

SYSTEMS OF NONLINEAR EQUATIONS SYSTEMS OF NONLINEAR EQUATIONS Widely used in the mathematical modeling of real world phenomena. We introduce some numerical methods for their solution. For better intuition, we examine systems of two

More information

CFD MODELING FOR PNEUMATIC CONVEYING

CFD MODELING FOR PNEUMATIC CONVEYING CFD MODELING FOR PNEUMATIC CONVEYING Arvind Kumar 1, D.R. Kaushal 2, Navneet Kumar 3 1 Associate Professor YMCAUST, Faridabad 2 Associate Professor, IIT, Delhi 3 Research Scholar IIT, Delhi e-mail: arvindeem@yahoo.co.in

More information

Method of Finite Elements I

Method of Finite Elements I Institute of Structural Engineering Page 1 Held by Prof. Dr. E. Chatzi, Dr. P. Steffen Assistants: Adrian Egger (HIL E 13.3), Harry Mylonas (HIL H33.1), Konstantinos Tatsis (HIL H33.1) Lectures homepage:

More information

Coupled Analysis of FSI

Coupled Analysis of FSI Coupled Analysis of FSI Qin Yin Fan Oct. 11, 2008 Important Key Words Fluid Structure Interface = FSI Computational Fluid Dynamics = CFD Pressure Displacement Analysis = PDA Thermal Stress Analysis = TSA

More information

Program: Advanced Certificate Program

Program: Advanced Certificate Program Program: Advanced Certificate Program Course: CFD-Vehicle Aerodynamics Directorate of Training and Lifelong Learning #470-P, Peenya Industrial Area, 4th Phase Peenya, Bengaluru 560 058 www.msruas.ac.in

More information

Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders

Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders Objective: The objective of this laboratory is to introduce how to use FLUENT to solve both transient and natural convection problems.

More information

Journal of Engineering Research and Studies E-ISSN

Journal of Engineering Research and Studies E-ISSN Journal of Engineering Research and Studies E-ISS 0976-79 Research Article SPECTRAL SOLUTIO OF STEADY STATE CODUCTIO I ARBITRARY QUADRILATERAL DOMAIS Alavani Chitra R 1*, Joshi Pallavi A 1, S Pavitran

More information

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions Milovan Perić Contents The need to couple STAR-CCM+ with other theoretical or numerical solutions Coupling approaches: surface and volume

More information

Lecture 2.2 Cubic Splines

Lecture 2.2 Cubic Splines Lecture. Cubic Splines Cubic Spline The equation for a single parametric cubic spline segment is given by 4 i t Bit t t t i (..) where t and t are the parameter values at the beginning and end of the segment.

More information

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech Multi-Mesh CFD Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech cjroy@vt.edu May 21, 2014 CCAS Program Review, Columbus, OH 1 Motivation Automated

More information

Finite Volume Methodology for Contact Problems of Linear Elastic Solids

Finite Volume Methodology for Contact Problems of Linear Elastic Solids Finite Volume Methodology for Contact Problems of Linear Elastic Solids H. Jasak Computational Dynamics Ltd. Hythe House 200 Shepherds Bush Road London W6 7NY, England E-mail: h.jasak@cd.co.uk H.G. Weller

More information

MESH INDEPENDENCE AND CONVERGENCE TEST IN THE OIL FILM CHARACTERISTICS OF A TILTING PAD THRUST BEARING

MESH INDEPENDENCE AND CONVERGENCE TEST IN THE OIL FILM CHARACTERISTICS OF A TILTING PAD THRUST BEARING Mesh independence and convergence test in the oil film characteristics MESH INDEPENDENCE AND CONVERGENCE TEST IN THE OIL FILM CHARACTERISTICS OF A TILTING PAD THRUST BEARING D.V.Srikanth a, K.K.Chaturvedi

More information

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

Nonlinear Potential Flow Solver Development in OpenFOAM

Nonlinear Potential Flow Solver Development in OpenFOAM Nonlinear Potential Flow Solver Development in OpenFOAM A. Mehmood Plymouth University, UK April 19,2016 A. Mehmood Table of Contents 1 Motivation 2 Solution Methodology Mathematical Formulation Sequence

More information

Optimizing Bio-Inspired Flow Channel Design on Bipolar Plates of PEM Fuel Cells

Optimizing Bio-Inspired Flow Channel Design on Bipolar Plates of PEM Fuel Cells Excerpt from the Proceedings of the COMSOL Conference 2010 Boston Optimizing Bio-Inspired Flow Channel Design on Bipolar Plates of PEM Fuel Cells James A. Peitzmeier *1, Steven Kapturowski 2 and Xia Wang

More information

Simulation of Turbulent Flow in an Asymmetric Diffuser

Simulation of Turbulent Flow in an Asymmetric Diffuser Simulation of Turbulent Flow in an Asymmetric Diffuser 1. Purpose 58:160 Intermediate Mechanics of Fluids CFD LAB 3 By Tao Xing and Fred Stern IIHR-Hydroscience & Engineering The University of Iowa C.

More information

AS 5850 Finite Element Analysis

AS 5850 Finite Element Analysis AS 5850 Finite Element Analysis INTRODUCTION Prof. IIT Madras Goal of engineering computations Perform analysis and design of physical systems and processes subjected to imposed conditions (or loads) and

More information

A Hybrid Magnetic Field Solver Using a Combined Finite Element/Boundary Element Field Solver

A Hybrid Magnetic Field Solver Using a Combined Finite Element/Boundary Element Field Solver A Hybrid Magnetic Field Solver Using a Combined Finite Element/Boundary Element Field Solver Abstract - The dominant method to solve magnetic field problems is the finite element method. It has been used

More information

Supersonic Flow Over a Wedge

Supersonic Flow Over a Wedge SPC 407 Supersonic & Hypersonic Fluid Dynamics Ansys Fluent Tutorial 2 Supersonic Flow Over a Wedge Ahmed M Nagib Elmekawy, PhD, P.E. Problem Specification A uniform supersonic stream encounters a wedge

More information

lecture 8 Groundwater Modelling -1

lecture 8 Groundwater Modelling -1 The Islamic University of Gaza Faculty of Engineering Civil Engineering Department Water Resources Msc. Groundwater Hydrology- ENGC 6301 lecture 8 Groundwater Modelling -1 Instructor: Dr. Yunes Mogheir

More information

Module 3 Mesh Generation

Module 3 Mesh Generation Module 3 Mesh Generation 1 Lecture 3.1 Introduction 2 Mesh Generation Strategy Mesh generation is an important pre-processing step in CFD of turbomachinery, quite analogous to the development of solid

More information

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001)

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001) An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (000/001) Summary The objectives of this project were as follows: 1) Investigate iterative

More information

Modeling and simulation the incompressible flow through pipelines 3D solution for the Navier-Stokes equations

Modeling and simulation the incompressible flow through pipelines 3D solution for the Navier-Stokes equations Modeling and simulation the incompressible flow through pipelines 3D solution for the Navier-Stokes equations Daniela Tudorica 1 (1) Petroleum Gas University of Ploiesti, Department of Information Technology,

More information

Finite Element Method. Chapter 7. Practical considerations in FEM modeling

Finite Element Method. Chapter 7. Practical considerations in FEM modeling Finite Element Method Chapter 7 Practical considerations in FEM modeling Finite Element Modeling General Consideration The following are some of the difficult tasks (or decisions) that face the engineer

More information

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering Debojyoti Ghosh Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering To study the Dynamic Stalling of rotor blade cross-sections Unsteady Aerodynamics: Time varying

More information

Module 1: Introduction to Finite Element Analysis. Lecture 4: Steps in Finite Element Analysis

Module 1: Introduction to Finite Element Analysis. Lecture 4: Steps in Finite Element Analysis 25 Module 1: Introduction to Finite Element Analysis Lecture 4: Steps in Finite Element Analysis 1.4.1 Loading Conditions There are multiple loading conditions which may be applied to a system. The load

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with:

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with: The Lecture deals with: Some more Suggestions for Improvement of Discretization Schemes Some Non-Trivial Problems with Discretized Equations file:///d /chitra/nptel_phase2/mechanical/cfd/lecture13/13_1.htm[6/20/2012

More information

: What is Finite Element Analysis (FEA)?

: What is Finite Element Analysis (FEA)? Q: What is Finite Element Analysis (FEA)? A1: It is a numerical technique for finding approximate solutions of partial differential equations (PDE) as well as of integral equations. The solution approach

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 36 In last class, we have derived element equations for two d elasticity problems

More information

OpenFOAM: Open Platform for Complex Physics Simulations

OpenFOAM: Open Platform for Complex Physics Simulations OpenFOAM: Open Platform for Complex Physics Simulations Hrvoje Jasak h.jasak@wikki.co.uk, hrvoje.jasak@fsb.hr FSB, University of Zagreb, Croatia Wikki Ltd, United Kingdom 18th October 2007 OpenFOAM: Open

More information

IMAGE ANALYSIS DEDICATED TO POLYMER INJECTION MOLDING

IMAGE ANALYSIS DEDICATED TO POLYMER INJECTION MOLDING Image Anal Stereol 2001;20:143-148 Original Research Paper IMAGE ANALYSIS DEDICATED TO POLYMER INJECTION MOLDING DAVID GARCIA 1, GUY COURBEBAISSE 2 AND MICHEL JOURLIN 3 1 European Polymer Institute (PEP),

More information

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1 Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, attilio.frangi@polimi.it Politecnico di Milano, February 3, 2017, Lesson 1 1 Politecnico di Milano, February 3, 2017, Lesson 1 2 Outline

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

Isogeometric Analysis of Fluid-Structure Interaction

Isogeometric Analysis of Fluid-Structure Interaction Isogeometric Analysis of Fluid-Structure Interaction Y. Bazilevs, V.M. Calo, T.J.R. Hughes Institute for Computational Engineering and Sciences, The University of Texas at Austin, USA e-mail: {bazily,victor,hughes}@ices.utexas.edu

More information

Three dimensional meshless point generation technique for complex geometry

Three dimensional meshless point generation technique for complex geometry Three dimensional meshless point generation technique for complex geometry *Jae-Sang Rhee 1), Jinyoung Huh 2), Kyu Hong Kim 3), Suk Young Jung 4) 1),2) Department of Mechanical & Aerospace Engineering,

More information

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution Multigrid Pattern I. Problem Problem domain is decomposed into a set of geometric grids, where each element participates in a local computation followed by data exchanges with adjacent neighbors. The grids

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

Sweeping Jet Flushing Method for EDM

Sweeping Jet Flushing Method for EDM International Conference on Multidisciplinary Research & Practice P a g e 192 Sweeping Jet Flushing Method for EDM Kishor K Kulkarni # Production Engineering, ShivajiUniversity/Ashokrao Mane Group of Institution

More information

Verification and Validation of Turbulent Flow around a Clark-Y Airfoil

Verification and Validation of Turbulent Flow around a Clark-Y Airfoil Verification and Validation of Turbulent Flow around a Clark-Y Airfoil 1. Purpose 58:160 Intermediate Mechanics of Fluids CFD LAB 2 By Tao Xing and Fred Stern IIHR-Hydroscience & Engineering The University

More information

Simulation in Computer Graphics. Particles. Matthias Teschner. Computer Science Department University of Freiburg

Simulation in Computer Graphics. Particles. Matthias Teschner. Computer Science Department University of Freiburg Simulation in Computer Graphics Particles Matthias Teschner Computer Science Department University of Freiburg Outline introduction particle motion finite differences system of first order ODEs second

More information

In this problem, we will demonstrate the following topics:

In this problem, we will demonstrate the following topics: Z Periodic boundary condition 1 1 0.001 Periodic boundary condition 2 Y v V cos t, V 1 0 0 The second Stokes problem is 2D fluid flow above a plate that moves horizontally in a harmonic manner, schematically

More information

and to the following students who assisted in the creation of the Fluid Dynamics tutorials:

and to the following students who assisted in the creation of the Fluid Dynamics tutorials: Fluid Dynamics CAx Tutorial: Pressure Along a Streamline Basic Tutorial #3 Deryl O. Snyder C. Greg Jensen Brigham Young University Provo, UT 84602 Special thanks to: PACE, Fluent, UGS Solutions, Altair

More information

Comparison of different solvers for two-dimensional steady heat conduction equation ME 412 Project 2

Comparison of different solvers for two-dimensional steady heat conduction equation ME 412 Project 2 Comparison of different solvers for two-dimensional steady heat conduction equation ME 412 Project 2 Jingwei Zhu March 19, 2014 Instructor: Surya Pratap Vanka 1 Project Description The purpose of this

More information

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 First-Order Hyperbolic System Method If you have a CFD book for hyperbolic problems, you have a CFD book for all problems.

More information

Flow and Heat Transfer in a Mixing Elbow

Flow and Heat Transfer in a Mixing Elbow Flow and Heat Transfer in a Mixing Elbow Objectives The main objectives of the project are to learn (i) how to set up and perform flow simulations with heat transfer and mixing, (ii) post-processing and

More information

Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities

Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities Ben Grier Clemson University Richard Figliola, Larry

More information

Alaska Mathematics Standards Vocabulary Word List Grade 7

Alaska Mathematics Standards Vocabulary Word List Grade 7 1 estimate proportion proportional relationship rate ratio rational coefficient rational number scale Ratios and Proportional Relationships To find a number close to an exact amount; an estimate tells

More information

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS L. Mangani Maschinentechnik CC Fluidmechanik und Hydromaschinen Hochschule Luzern Technik& Architektur

More information

Problem description. The FCBI-C element is used in the fluid part of the model.

Problem description. The FCBI-C element is used in the fluid part of the model. Problem description This tutorial illustrates the use of ADINA for analyzing the fluid-structure interaction (FSI) behavior of a flexible splitter behind a 2D cylinder and the surrounding fluid in a channel.

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

QUASI-3D SOLVER OF MEANDERING RIVER FLOWS BY CIP-SOROBAN SCHEME IN CYLINDRICAL COORDINATES WITH SUPPORT OF BOUNDARY FITTED COORDINATE METHOD

QUASI-3D SOLVER OF MEANDERING RIVER FLOWS BY CIP-SOROBAN SCHEME IN CYLINDRICAL COORDINATES WITH SUPPORT OF BOUNDARY FITTED COORDINATE METHOD QUASI-3D SOLVER OF MEANDERING RIVER FLOWS BY CIP-SOROBAN SCHEME IN CYLINDRICAL COORDINATES WITH SUPPORT OF BOUNDARY FITTED COORDINATE METHOD Keisuke Yoshida, Tadaharu Ishikawa Dr. Eng., Tokyo Institute

More information

Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition

Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition.5.5.5.5.5.5.5..5.95.9.85.8.75.7 Patrick A. LeGresley and Juan J. Alonso Dept. of Aeronautics & Astronautics

More information

CFD Analysis of 2-D Unsteady Flow Past a Square Cylinder at an Angle of Incidence

CFD Analysis of 2-D Unsteady Flow Past a Square Cylinder at an Angle of Incidence CFD Analysis of 2-D Unsteady Flow Past a Square Cylinder at an Angle of Incidence Kavya H.P, Banjara Kotresha 2, Kishan Naik 3 Dept. of Studies in Mechanical Engineering, University BDT College of Engineering,

More information

An Overview of Computational Fluid Dynamics

An Overview of Computational Fluid Dynamics An Overview of Computational Fluid Dynamics Dr. Nor Azwadi bin Che Sidik Faculty of Mechanical Engineering Universiti Teknologi Malaysia INSPIRING CREATIVE AND INNOVATIVE MINDS 1 What is CFD? C computational

More information

HPC Algorithms and Applications

HPC Algorithms and Applications HPC Algorithms and Applications Dwarf #5 Structured Grids Michael Bader Winter 2012/2013 Dwarf #5 Structured Grids, Winter 2012/2013 1 Dwarf #5 Structured Grids 1. dense linear algebra 2. sparse linear

More information

2 T. x + 2 T. , T( x, y = 0) = T 1

2 T. x + 2 T. , T( x, y = 0) = T 1 LAB 2: Conduction with Finite Difference Method Objective: The objective of this laboratory is to introduce the basic steps needed to numerically solve a steady state two-dimensional conduction problem

More information

A Study of the Development of an Analytical Wall Function for Large Eddy Simulation of Turbulent Channel and Rectangular Duct Flow

A Study of the Development of an Analytical Wall Function for Large Eddy Simulation of Turbulent Channel and Rectangular Duct Flow University of Wisconsin Milwaukee UWM Digital Commons Theses and Dissertations August 2014 A Study of the Development of an Analytical Wall Function for Large Eddy Simulation of Turbulent Channel and Rectangular

More information

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Per-Olof Persson (persson@mit.edu) Department of Mathematics Massachusetts Institute of Technology http://www.mit.edu/

More information