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

Size: px
Start display at page:

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

Transcription

1 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, Mathematics, Physics, no. 39 Bd. Bucuresti, , Ploiesti, ROMANIA danatudorica@gmail.com Abstract Automatic monitoring of fluids transportation through pipelines requires first of all modeling and simulation of flow process. The development of mathematical model is based on the application of Newton's second law (conservation of momentum), plus boundary conditions, the continuity equation (mass conservation), energy conservation equation or an equation of state. Since the parameters involved in these equations are variable in time, result in a system of partial differential equations known as the Navier-Stokes equations. Solving theoretical (analytical) Navier-Stokes equations is possible only for some specific simple cases, otherwise are used numerical solutions. The most common solutions use the simplified case of flow in a two-dimensional space (2D) - for example a rectangular surface. This paper presents a Matlab application for the numerical solution of the Navier-Stokes equations for incompressible flow through pipes, using the method of lines, in threedimensional space. The application treats the laminar flow, but it can also be adapted for turbulent flow. Keywords: Navier-Stokes, Modeling, Pipeline, Transportation process 1. Introduction Pipelines are the most convenient way to transport various products. Considering the example of the oil industry, pipelines carry crude oil from the field to the separation park, to the park warehouse and finally to refineries or to export. Petroleum refinery products results from the process of fractionation are transported to consumers. This means a complex network of pipes, whose safe operation can be achieved by implementing control and monitoring systems more efficient. Automatic monitoring of fluid transport by pipeline requires first of all modeling and simulation of flow process. For this, there are used different equations of fluid dynamics. Equations that best describe the motion of a fluid are the Navier-Stokes equations. These are partial differential equations, whose theoretical solution is possible only for some particular simple cases, less common in practice. The fact that few mathematical demonstrations so far failed to fully describe and explain the Navier-Stokes equations, the problem is one of the seven millennium problems proposed in 2000 by the Clay Mathematics Institute, with prizes of 1 million dollars each. ( In practice, flow modeling is done by writing the Navier-Stokes equations in a way best suited to the case considered, adding appropriate boundary conditions and by solving them numerically.

2 368 University of Bucharest and "Transilvania" University of Brasov 2 Classification of fluid motion Fluid motion is a complex phenomenon that can be classified according to several criteria. For a more suitable model, must identify the type of flow, according to all criteria. Are listed below the types of flow, which are described in detail in (Soare, 2002) - Stationary and nonstationary flow; - Uniform and non-uniform flow; - Three-dimensional, two-dimensional and one-dimensional flow; - Under pressure and the free surface flow; - Laminar and turbulent flow. The paper considers the non-uniform, laminar and under pressure flow of an incompressible fluid in three-dimensional space, through a circular pipe. 3 Equations of fluid incompressible laminar flow Mathematical relations that describe the movement of fluids are based on three fundamental laws of physics: - The mass conservation Law equation of continuity - Newton's Second Law dynamic equilibrium equation (conservation of momentum) - The Energy Conservation Law energy balance equation (Bernoulli equation) In these equations, the indepent variables are spatial coordinates x, y, z and time t, and the depent variables (expressed in terms of the indepent ones) are velocity v, temperature T and pressure p. The first two equations are known as the Navier-Stokes equations. In the following, we use the following notation for physical quantities: - - density of the fluid; - - dynamic viscosity of the fluid; - v velocity; - t time; - T temperature; - p pressure; - g gravitational acceleration. 3.1 The continuity equation For three-dimensional flow of an incompressible fluid (constant density), the continuity equation has the following form: v v x y vz [1] 0 x y z Or, using the symbol, the vector of partial derivatives, (,, ), the continuity x y z equation can be written in a simpler form: [2] v Dynamic equilibrium equation For three-dimensional flow of an incompressible fluid, this equation is: v 2 [3] p ( v) g t

3 The 7 th International Conference on Virtual Learning ICVL is the Laplacian operator that in Cartesian coordinates is [4] x y z 3.3 Bernoulli equation Bernoulli equation allows calculation of energy losses through friction. For a real fluid, in isothermal flow in steady state the equation has the following form: P [5] f g where f is the coefficient of friction. The application proposed in this paper does not use Bernoulli equation. Application is limited to solving Navier-Stokes equations, written in a simplified form using the continuity equation. Equations considered have the following characteristics: - Are hyperbolic partial differential equations; - Are strongly nonlinear; - Difficult to solve by numerical methods. Solving partial differential equations require formulation of initial conditions and boundary conditions. These are restrictions imposed on domain boundaries and may be of the following types: - Dirichlet conditions (if the depent variable is specified); - Neumann conditions (if the derivative of depent variable is specified); - Cauchy type (Dirichlet and Neumann); - Robin type (linear combination between Dirichlet and Neumann conditions). Boundary conditions used here in solving the equations will be presented in next chapter. 4 Numerical solution of the Navier-Stokes equations using method of lines 4.1 Numerical methods of solving partial differential equations Simulation of flow through pipeline using computer, which is capable only of simple mathematical operations, requires that partial differential equations to be transformed into algebraic form, suitable programming. This stage is called discretization. There are different methods of discretization, described in detail in specialized books and used extensively in engineering calculations: - the finite difference method FDM - the finite element method FEM - the finite volume method FVM - the boundary element method BEM - the method of lines MOL 4.2 Method of lines The basic idea of the MOL is to replace the spatial (boundary-value) derivatives in the PDE with algebraic approximations. Once this is done, the spatial derivatives are no longer stated explicitly in terms of the spatial indepent variables. Thus, in effect, only the initial-value variable, typically time in a physical problem, remains. In other words, with only one remaining indepent variable, we have a system of ODEs that approximate the original PDE. The challenge, then, is to formulate the approximating system of ODEs. Once this is done, we can apply any integration algorithm for initial-value ODEs to compute an approximate numerical

4 370 University of Bucharest and "Transilvania" University of Brasov solution to the PDE. Thus, one of the salient features of the MOL is the use of existing, and generally well-established, numerical methods for ODEs. (Schiesser, 2009). In the book A compium of Partial Differential Equation Models (Schiesser W., Griffiths G., 2009) are described in detail various uses of the method of lines for solving partial differential equations. The application proposed in this paper was based on examples from the book mentioned above, but adapted to the equations for incompressible fluid transport modeling. Transformation of partial differential equations (PDEs) in ordinary differential equations (ODEs) can be done using finite differences as follows: v vi vi1 [6] x x where i is an index designating a position along a grid in x and Δx is the spacing in x along the grid. If equation [3] is reduced to one-dimensional 1D case and the pressure gradient is considered null, the result is the Burgers equation. This equation was solved analytically, finding the solution: (Schiesser, 2009) ( is the kinematic viscosity [7] 0.1e v( x, t) e a a b 0.5e e b c e e [8] a ( x t) 0.25 b ( x t 0.5 c ( x [9] ) [10] ) c ) Numerical solution of the Navier-Stokes equations in 3D will use as boundary conditions the relations [7] [10]. MOL method is a popular tool for solving the PDE equations. Also Matlab library contains a function called PDEPE for this. The following are sequences from application code in Matlab for numerical solution of the Navier-Stokes equations, focusing more on results. Calculation of analytical solution: function an=cond(x,t) a=(0.05/visc)*(x *t); b=(0.25/visc)*(x *t); c=(0.5/visc)*(x-0.375); ea=exp(-a); eb=exp(-b); ec=exp(-c); an=(0.1*exp(-a)+0.5*exp(-b)+exp(-c))/(exp(-a)+exp(-b)+exp(c));

5 The 7 th International Conference on Virtual Learning ICVL Initial conditions: t0=0.0; for i=1:n dx=(xu-xl)/(n-1); for j=1:n x(j)=xl+(j-1)*dx; u0(j)=cond(x(j),0.0); ODE integration: mf=1; reltol=1.0e-04; abstol=1.0e-04; options=odeset('reltol',reltol,'abstol',abstol); if(mf==1) [t,u]=ode15s(@pde_1,tout,u0,options); if(mf==2) ndss=4; [t,u]=ode15s(@pde_2,tout,u0,options); Storing analytical and numerical solutions, calculation of error: n2=(n-1)/2.0+1; for i=1:n u_num(i)=u(i,n2); u_anal(i)=cond(x(i),t(i)); err_plot(i)=u_num(i)-u_anal(i); In Figure 1, you can see the results from running the application. For time values from 0.0 to 5.0, analytical solutions of simplified Navier-Stokes equations, numerical solutions obtained with the method of lines and error are displayed. Note that as time increases, the error decreases. Figure 1. Analytical solutions, numerical solutions and error The same is seen in Figure 2, where analytical solutions are plotted, and the evolution of the error.

6 372 University of Bucharest and "Transilvania" University of Brasov Figure 2. Graphical representation of error 5 Conclusions This example application attempts to illustrate the basic steps of MOL/PDE analysis used to obtain a numerical solution of acceptable accuracy for the Navier-Stokes equations. It was considered the laminar under pressure flow of an incompressible fluid in threedimensional space. The application did not treat the case more complicated of compressible fluids (gas), nor the multiphase flow. Application can be adapted to the case of turbulent flow, by rewriting the Navier-Stokes equations - using models of turbulence like Reynolds mediation or semiempirical models. 6 References Benjamin Seibold (2008): A compact and fast Matlab code solving the incompressible Navier-Stokes equations on rectangular domains, www-math.mit.edu/, March 31, Gavrila L. (2000): Transfer phenomena, Vol I, momentum transfer Fenomene, Ed. Alma Mater, Bacau. Schiesser W., Griffiths G.(2009): A compium of Partial Differential Equation Models, Cambridge University Press. Shampine L.F., Gladwell I., Thompson S. (2009): Solving ODEs with Matlab, Cambridge University Press. Soare, Al. (2002): Transport and storage of fluids, Vol 1, Ed.UPG Ploiesti. Soare, Al. (2002): Transport and storage of fluids, Vol 2, Ed.UPG Ploiesti

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

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 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

More information

Solution for Euler Equations Lagrangian and Eulerian Descriptions

Solution for Euler Equations Lagrangian and Eulerian Descriptions Solution for Euler Equations Lagrangian and Eulerian Descriptions Valdir Monteiro dos Santos Godoi valdir.msgodoi@gmail.com Abstract We find an exact solution for the system of Euler equations, supposing

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

Solution for Euler Equations Lagrangian and Eulerian Descriptions

Solution for Euler Equations Lagrangian and Eulerian Descriptions Solution for Euler Equations Lagrangian and Eulerian Descriptions Valdir Monteiro dos Santos Godoi valdir.msgodoi@gmail.com Abstract We find an exact solution for the system of Euler equations, following

More information

Numerical and theoretical analysis of shock waves interaction and reflection

Numerical and theoretical analysis of shock waves interaction and reflection Fluid Structure Interaction and Moving Boundary Problems IV 299 Numerical and theoretical analysis of shock waves interaction and reflection K. Alhussan Space Research Institute, King Abdulaziz City for

More information

SPC 307 Aerodynamics. Lecture 1. February 10, 2018

SPC 307 Aerodynamics. Lecture 1. February 10, 2018 SPC 307 Aerodynamics Lecture 1 February 10, 2018 Sep. 18, 2016 1 Course Materials drahmednagib.com 2 COURSE OUTLINE Introduction to Aerodynamics Review on the Fundamentals of Fluid Mechanics Euler and

More information

BASICS OF FLUID MECHANICS AND INTRODUCTION TO COMPUTATIONAL FLUID DYNAMICS

BASICS OF FLUID MECHANICS AND INTRODUCTION TO COMPUTATIONAL FLUID DYNAMICS BASICS OF FLUID MECHANICS AND INTRODUCTION TO COMPUTATIONAL FLUID DYNAMICS Numerical Methods and Algorithms Volume 3 Series Editor: Claude Brezinski Université des Sciences et Technologies de Lille, France

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

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

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

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

Realistic Animation of Fluids

Realistic Animation of Fluids Realistic Animation of Fluids p. 1/2 Realistic Animation of Fluids Nick Foster and Dimitri Metaxas Realistic Animation of Fluids p. 2/2 Overview Problem Statement Previous Work Navier-Stokes Equations

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

FLOWING FLUIDS AND PRESSURE VARIATION

FLOWING FLUIDS AND PRESSURE VARIATION Chapter 4 Pressure differences are (often) the forces that move fluids FLOWING FLUIDS AND PRESSURE VARIATION Fluid Mechanics, Spring Term 2011 e.g., pressure is low at the center of a hurricane. For your

More information

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects Tenth International Conference on Computational Fluid Dynamics (ICCFD10), Barcelona,Spain, July 9-13, 2018 ICCFD10-047 ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving

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

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

Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard

Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard Dimitri P. Tselepidakis & Lewis Collins ASME 2012 Verification and Validation Symposium May 3 rd, 2012 1 Outline

More information

Fluid Simulation. [Thürey 10] [Pfaff 10] [Chentanez 11]

Fluid Simulation. [Thürey 10] [Pfaff 10] [Chentanez 11] Fluid Simulation [Thürey 10] [Pfaff 10] [Chentanez 11] 1 Computational Fluid Dynamics 3 Graphics Why don t we just take existing models from CFD for Computer Graphics applications? 4 Graphics Why don t

More information

Pressure Correction Scheme for Incompressible Fluid Flow

Pressure Correction Scheme for Incompressible Fluid Flow AALTO UNIVERSITY School of Chemical Technology CHEM-E7160 Fluid Flow in Process Units Pressure Correction Scheme for Incompressible Fluid Flow Ong Chin Kai 620503 Lee De Ming Benedict 620448 Page 1 Abstract

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

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

Solving partial differential equations using the NAG Library

Solving partial differential equations using the NAG Library Solving partial differential equations using the NAG Library 1. Introduction Jeremy Walton The Numerical Algorithms Group, Ltd. Wilkinson House, Jordan Hill Road Oxford OX2 8DR, United Kingdom A partial

More information

NUMERICAL VISCOSITY. Convergent Science White Paper. COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved.

NUMERICAL VISCOSITY. Convergent Science White Paper. COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved. Convergent Science White Paper COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved. This document contains information that is proprietary to Convergent Science. Public dissemination of this document

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

Using a Single Rotating Reference Frame

Using a Single Rotating Reference Frame Tutorial 9. Using a Single Rotating Reference Frame Introduction This tutorial considers the flow within a 2D, axisymmetric, co-rotating disk cavity system. Understanding the behavior of such flows is

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

CHAPTER 3. Elementary Fluid Dynamics

CHAPTER 3. Elementary Fluid Dynamics CHAPTER 3. Elementary Fluid Dynamics - Understanding the physics of fluid in motion - Derivation of the Bernoulli equation from Newton s second law Basic Assumptions of fluid stream, unless a specific

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

Animation of Fluids. Animating Fluid is Hard

Animation of Fluids. Animating Fluid is Hard Animation of Fluids Animating Fluid is Hard Too complex to animate by hand Surface is changing very quickly Lots of small details In short, a nightmare! Need automatic simulations AdHoc Methods Some simple

More information

Traveling Wave Analysis of Partial Differential Equations

Traveling Wave Analysis of Partial Differential Equations Traveling Wave Analysis of Partial Differential Equations Numerical and Analytical Methods with Matlab and Maple Graham W. Griffiths and William E. Schiesser (Academic Press, ISBN: 9780123846525) Chapter

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

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

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

CFD in COMSOL Multiphysics

CFD in COMSOL Multiphysics CFD in COMSOL Multiphysics Christian Wollblad Copyright 2017 COMSOL. Any of the images, text, and equations here may be copied and modified for your own internal use. All trademarks are the property of

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

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes L. Jofre, O. Lehmkuhl, R. Borrell, J. Castro and A. Oliva Corresponding author: cttc@cttc.upc.edu Centre Tecnològic

More information

Chapter 1 - Basic Equations

Chapter 1 - Basic Equations 2.20 Marine Hydrodynamics, Fall 2017 Lecture 2 Copyright c 2017 MIT - Department of Mechanical Engineering, All rights reserved. 2.20 Marine Hydrodynamics Lecture 2 Chapter 1 - Basic Equations 1.1 Description

More information

Continued Investigation of Small-Scale Air-Sea Coupled Dynamics Using CBLAST Data

Continued Investigation of Small-Scale Air-Sea Coupled Dynamics Using CBLAST Data Continued Investigation of Small-Scale Air-Sea Coupled Dynamics Using CBLAST Data Dick K.P. Yue Center for Ocean Engineering Department of Mechanical Engineering Massachusetts Institute of Technology Cambridge,

More information

Solution for Euler Equations Lagrangian and Eulerian Descriptions

Solution for Euler Equations Lagrangian and Eulerian Descriptions Solution for Euler Equations Lagrangian and Eulerian Descriptions Valdir Monteiro dos Santos Godoi valdir.msgodoi@gmail.com Abstract We find an exact solution for the system of Euler equations, supposing

More information

Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion

Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion James F. Price Woods Hole Oceanographic Institution Woods Hole, MA, 02543 July 31, 2006 Summary: This essay

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

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

Calculate a solution using the pressure-based coupled solver.

Calculate a solution using the pressure-based coupled solver. Tutorial 19. Modeling Cavitation Introduction This tutorial examines the pressure-driven cavitating flow of water through a sharpedged orifice. This is a typical configuration in fuel injectors, and brings

More information

Study on the Numerical Accuracy for the CFD

Study on the Numerical Accuracy for the CFD Study on the Numerical Accuracy for the CFD T.Yamanashi 1, H.Uchida, and M.Morita 1 Department of Mathematics, Master s Research Course of Faculty of Science, Tokyo University of Science,1-3 Kagurazaka,

More information

Tutorial 17. Using the Mixture and Eulerian Multiphase Models

Tutorial 17. Using the Mixture and Eulerian Multiphase Models Tutorial 17. Using the Mixture and Eulerian Multiphase Models Introduction: This tutorial examines the flow of water and air in a tee junction. First you will solve the problem using the less computationally-intensive

More information

A Finite Element Solution Of The Beam Equation Via Matlab

A Finite Element Solution Of The Beam Equation Via Matlab A Finite Element Solution Of The Beam Equation Via Matlab We have made it easy for you to find a PDF Ebooks without any digging. And by having access to our ebooks online or by storing it on your computer,

More information

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Masanori Hashiguchi 1 1 Keisoku Engineering System Co., Ltd. 1-9-5 Uchikanda, Chiyoda-ku,

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

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

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

Literature Report. Daniël Pols. 23 May 2018

Literature Report. Daniël Pols. 23 May 2018 Literature Report Daniël Pols 23 May 2018 Applications Two-phase flow model The evolution of the momentum field in a two phase flow problem is given by the Navier-Stokes equations: u t + u u = 1 ρ p +

More information

New Rules of ME Ph.D. Qualifying Exams 1/8

New Rules of ME Ph.D. Qualifying Exams 1/8 New Rules of ME Ph.D. Qualifying Exams 1/8 Qualifying Examination The student must pass a Qualifying Examination before the Dissertation Director, the Interdisciplinary Committee, and the courses for the

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

MAE 3130: Fluid Mechanics Lecture 5: Fluid Kinematics Spring Dr. Jason Roney Mechanical and Aerospace Engineering

MAE 3130: Fluid Mechanics Lecture 5: Fluid Kinematics Spring Dr. Jason Roney Mechanical and Aerospace Engineering MAE 3130: Fluid Mechanics Lecture 5: Fluid Kinematics Spring 2003 Dr. Jason Roney Mechanical and Aerospace Engineering Outline Introduction Velocity Field Acceleration Field Control Volume and System Representation

More information

2.29 Numerical Marine Hydrodynamics Spring 2007

2.29 Numerical Marine Hydrodynamics Spring 2007 Numerical Marine Hydrodynamics Spring 2007 Course Staff: Instructor: Prof. Henrik Schmidt OCW Web Site: http://ocw.mit.edu/ocwweb/mechanical- Engineering/2-29Spring-2003/CourseHome/index.htm Units: (3-0-9)

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

Essay 1: Dimensional Analysis of Models and Data Sets: Similarity Solutions

Essay 1: Dimensional Analysis of Models and Data Sets: Similarity Solutions Table of Contents Essay 1: Dimensional Analysis of Models and Data Sets: Similarity Solutions and Scaling Analysis 1 About dimensional analysis 4 1.1 Thegoalandtheplan... 4 1.2 Aboutthisessay... 5 2 Models

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

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

Terminal Falling Velocity of a Sand Grain

Terminal Falling Velocity of a Sand Grain Terminal Falling Velocity of a Sand Grain Introduction The first stop for polluted water entering a water work is normally a large tank, where large particles are left to settle. More generally, gravity

More information

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Review of the Air Force Academy No.3 (35)/2017 NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Cvetelina VELKOVA Department of Technical Mechanics, Naval Academy Nikola Vaptsarov,Varna, Bulgaria (cvetelina.velkova1985@gmail.com)

More information

Object Oriented Simulation of Multiphase Flow

Object Oriented Simulation of Multiphase Flow Object Oriented Simulation of Multiphase Flow P.Klebert and O.J.Nydal Norwegian University of Science and Technology (NTNU) 7491 Trondheim Norway Abstract Pipelines in offshore oil and gas production systems

More information

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow Excerpt from the Proceedings of the COMSOL Conference 8 Boston Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow E. Kaufman

More information

Acknowledgements. Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn. SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar

Acknowledgements. Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn. SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar Philipp Hahn Acknowledgements Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar 2 Outline Motivation Lumped Mass Model Model properties Simulation

More information

A Particle Cellular Automata Model for Fluid Simulations

A Particle Cellular Automata Model for Fluid Simulations Annals of University of Craiova, Math. Comp. Sci. Ser. Volume 36(2), 2009, Pages 35 41 ISSN: 1223-6934 A Particle Cellular Automata Model for Fluid Simulations Costin-Radu Boldea Abstract. A new cellular-automaton

More information

Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE Synthesis of the technical report -

Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE Synthesis of the technical report - Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE-2011-3-0256 - Synthesis of the technical report - Phase 1: Preparation phase Authors: Delia Teleaga, Eliza

More information

Realistic Animation of Fluids

Realistic Animation of Fluids 1 Realistic Animation of Fluids Nick Foster and Dimitris Metaxas Presented by Alex Liberman April 19, 2005 2 Previous Work Used non physics-based methods (mostly in 2D) Hard to simulate effects that rely

More information

A numerical model of mass movements over complex topography

A numerical model of mass movements over complex topography massmov2d A numerical model of mass movements over complex topography Description massmov2d is a simple fluid mechanics model for simulating the kinematics (run out and deposition) of fluid-like mass movements

More information

Level Set Methods and Fast Marching Methods

Level Set Methods and Fast Marching Methods Level Set Methods and Fast Marching Methods I.Lyulina Scientific Computing Group May, 2002 Overview Existing Techniques for Tracking Interfaces Basic Ideas of Level Set Method and Fast Marching Method

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

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

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

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

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

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

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS Dr W. Malalasekera Version 3.0 August 2013 1 COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE

More information

the lines of the solution obtained in for the twodimensional for an incompressible secondorder

the lines of the solution obtained in for the twodimensional for an incompressible secondorder Flow of an Incompressible Second-Order Fluid past a Body of Revolution M.S.Saroa Department of Mathematics, M.M.E.C., Maharishi Markandeshwar University, Mullana (Ambala), Haryana, India ABSTRACT- The

More information

Continuum-Microscopic Models

Continuum-Microscopic Models Scientific Computing and Numerical Analysis Seminar October 1, 2010 Outline Heterogeneous Multiscale Method Adaptive Mesh ad Algorithm Refinement Equation-Free Method Incorporates two scales (length, time

More information

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia Applied Mechanics and Materials Vol. 393 (2013) pp 305-310 (2013) Trans Tech Publications, Switzerland doi:10.4028/www.scientific.net/amm.393.305 The Implementation of Cell-Centred Finite Volume Method

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

Computational Fluid Dynamics (CFD) for Built Environment

Computational Fluid Dynamics (CFD) for Built Environment Computational Fluid Dynamics (CFD) for Built Environment Seminar 4 (For ASHRAE Members) Date: Sunday 20th March 2016 Time: 18:30-21:00 Venue: Millennium Hotel Sponsored by: ASHRAE Oryx Chapter Dr. Ahmad

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

Numerical Methods in Aerodynamics. Fluid Structure Interaction. Lecture 4: Fluid Structure Interaction

Numerical Methods in Aerodynamics. Fluid Structure Interaction. Lecture 4: Fluid Structure Interaction Fluid Structure Interaction Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark

More information

Scientific Review ISSN: Vol. 1, No. 5, pp: , 2015 URL:

Scientific Review ISSN: Vol. 1, No. 5, pp: , 2015 URL: Academic Research Publishing Group Scientific Review ISSN: 2412-2599 Vol. 1, No. 5, pp: 99-101, 2015 URL: http://arpgweb.com/?ic=journal&journal=10&info=aims Is Schrodinger Equation Describing A Turbulent

More information

NUMERICAL METHOD FOR FREE SURFACE VISCOUS FLOWS

NUMERICAL METHOD FOR FREE SURFACE VISCOUS FLOWS STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume LIII, Number 3, September 2008 NUMERICAL METHOD FOR FREE SURFACE VISCOUS FLOWS TIBERIU IOANA AND TITUS PETRILA Abstract. In this paper we present a new algorithm

More information

Fluidlrigid body interaction in complex industrial flows

Fluidlrigid body interaction in complex industrial flows Fluidlrigid body interaction in complex industrial flows D. ~bouri', A. parry1 & A. ~arndouni~ 1 Schlumberger - Riboud Product Center, Clamart, France 2 University of La Rochelle, LEPTAB, La Rochelle,

More information

Computational Study of Laminar Flowfield around a Square Cylinder using Ansys Fluent

Computational Study of Laminar Flowfield around a Square Cylinder using Ansys Fluent MEGR 7090-003, Computational Fluid Dynamics :1 7 Spring 2015 Computational Study of Laminar Flowfield around a Square Cylinder using Ansys Fluent Rahul R Upadhyay Master of Science, Dept of Mechanical

More information

Isotropic Porous Media Tutorial

Isotropic Porous Media Tutorial STAR-CCM+ User Guide 3927 Isotropic Porous Media Tutorial This tutorial models flow through the catalyst geometry described in the introductory section. In the porous region, the theoretical pressure drop

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

: 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

True 3D CAE visualization of filling imbalance in geometry-balanced runners

True 3D CAE visualization of filling imbalance in geometry-balanced runners True 3D CAE visualization of filling imbalance in geometry-balanced runners C.C. Chien, * C.C. Chiang, W. H. Yang, Vito Tsai and David C.Hsu CoreTech System Co.,Ltd., HsinChu, Taiwan, ROC Abstract The

More information

CGT 581 G Fluids. Overview. Some terms. Some terms

CGT 581 G Fluids. Overview. Some terms. Some terms CGT 581 G Fluids Bedřich Beneš, Ph.D. Purdue University Department of Computer Graphics Technology Overview Some terms Incompressible Navier-Stokes Boundary conditions Lagrange vs. Euler Eulerian approaches

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

Compressible Flow in a Nozzle

Compressible Flow in a Nozzle SPC 407 Supersonic & Hypersonic Fluid Dynamics Ansys Fluent Tutorial 1 Compressible Flow in a Nozzle Ahmed M Nagib Elmekawy, PhD, P.E. Problem Specification Consider air flowing at high-speed through a

More information

ISSN(PRINT): ,(ONLINE): ,VOLUME-1,ISSUE-1,

ISSN(PRINT): ,(ONLINE): ,VOLUME-1,ISSUE-1, NUMERICAL ANALYSIS OF THE TUBE BANK PRESSURE DROP OF A SHELL AND TUBE HEAT EXCHANGER Kartik Ajugia, Kunal Bhavsar Lecturer, Mechanical Department, SJCET Mumbai University, Maharashtra Assistant Professor,

More information

Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways

Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways Latif Bouhadji ASL-AQFlow Inc., Sidney, British Columbia, Canada Email: lbouhadji@aslenv.com ABSTRACT Turbulent flows over a spillway

More information

Turbulent Premixed Combustion with Flamelet Generated Manifolds in COMSOL Multiphysics

Turbulent Premixed Combustion with Flamelet Generated Manifolds in COMSOL Multiphysics Turbulent Premixed Combustion with Flamelet Generated Manifolds in COMSOL Multiphysics Rob J.M Bastiaans* Eindhoven University of Technology *Corresponding author: PO box 512, 5600 MB, Eindhoven, r.j.m.bastiaans@tue.nl

More information