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

Size: px
Start display at page:

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

Transcription

1 Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v t + (uv) x + (v ) y + p y = 1 v + g, Re where u and v are the velocity components in x and y direction, p is the pressure, Re is the Reynolds number and f and g are given source functions. Assume that the equations are solved with boundary conditions periodic boundary conditions in x-direction normal derivative of the pressure p y = 0 at y = H no-slip condition on the velocity at y = 0 and y = H Suppose the equations are discretized in space by the finite volume approximation on a staggered grid. The discretized equations are solved in time by the Marker and Cell (MAC) method: u n+1 = u n dt [ (u n ) x + (u n v n ] dt ) y + Re un + f n }{{} F n ] dt + v n+1 = v n dt [ (u n v n ) x + (v n ) y Re vn + g n }{{} G n dtp n+1 x dtp n+1 y By substituting the velocities at t n+1 into the continuity equation, show that the pressure at this time is given by the Poisson equation () p n+1 = 1 dt (F n x + G n y ) (3) Now the procedure to compute the velocities at t n+1 can be given by; 1) Compute F n and G n. ) Solve the Poisson equation for the pressure. 3) Compute u n+1 and v n+1. The second task is to add the energy equation, a temperature dependent density and source functions to simulate natural convection of an ideal gas, see handouts from Numerical Simulations in Fluid Dynamics by Griebel, Dornseifer and Neunhoeffer (GDN). The final form of the equations to be solved numerically is u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + T T g x v t + (uv) x + (v ) y + p y = 1 Re v + T T g y T t + (ut ) x + (vt ) y = 1 T + Q, Re P r (4)

2 where g x and g y are the components of the gravitational acceleration, T is the temperature in the gas, P r is the Prandtl number and Q is a heat source. Here we have assumed that the Boussinesq approximation is valid; the density is constant except in the buoyancy terms (source terms in NS). Boundary conditions for the temperature are: 1) periodic in x-direction. ) T y = α(t T wall,u ) on at y = H and T y = α(t T wall,l ) at y = 0. Here α = h/κ with h being the termal heat transfer coefficient and κ the coefficient of heat conduction. Setting h = 0 gives an adiabatic wall, i.e. no heat is exchanged across the wall. If the temperature is defined in the same grid points as the pressure (in the middle of the cell), see the sample MATLAB files NSmain.m and Heatflx.m for a grid description. Show that the discretization of the last equation in (4) becomes T n+1 = T n dt ( u n+1 T n + T i+1j n u n+1 Ti 1j n + T n ) i 1j dx dt ( v n+1 T n + T +1 n v n+1 T 1 n + T n ) 1 dy + dt ( T n i+1j T n + T i 1j Re P r dx + T +1 n T n + T ) 1 dy PS: Note that you are not required to do any simulations in this part of the homework. The aim of the homework is to understand the time updating and the staggered discretization. (5) Homework 4 in 5C11; Part B: COMSOL lab, Finite Element Methods This homework is intended to give a brief introduction to the use of finite element packages for fluids problems. The main parts which should be learnt are the work flow with the GUI and to always check simple flow cases before going on to big complicated geometries. As such, this homework will give you an insight to how the problem is typically set up; from the drawing of the geometry, to the meshing and the set up of the equations and the boundary conditions. Note that a large part of a CFD practitioner s work time is spent meshing. The flow case We are solving the incompressible Navier Stokes for a two-dimensional channel confined by rigid walls at the top and bottom (infinite in the third direction). The equations are solved in dimensional form over a domain of [x y] [0, L 0, h], where L = 1[m] and h = 0.1[m]. We consider air at 0 C, so that the density is ρ = 1.1[kg/m 3 ] and a dynamic viscosity of µ = [Ns/m ]. A triangle streamwise velocity profile is prescribed at the inflow boundary u(y) = U in h y, y < h/, (6) U in h h y, y h/,

3 where U in decides the peak of the profile. At the top and bottom boundaries no slip is enforced and a pressure boundary condition at outflow simulates a free boundary (outflow boundary). As the flow developes downstream we expect a parabolic profile to gradually form. The parabolic profile given a pressure gradient dp/dx is of the form u a (y) = dp/dx def y(h y) = 4U max µ h y(h y), (7) so that U max is the peak value of the velocity in the middle of the channel, i.e. at y = h/. The flow rate is defined as Q = h 0 u a dy = 4U max h [ 1 y h 1 ] h 3 y3 = 0 3 U maxh. (8) For an incompressible flow the quantity Q is conserved. The shear stress of the flow is given by so that at the lower wall it can be written as τ 1 = τ 1 = µ u a y = 4U max h (h y) (9) τ w = τ 1 (0) = 4U max h (10) Exercise 1: A simple warm up on basic fluid dynamics Given the triangle inflow (6) and the fact that Q given by (8) is conserved, calculate the relationship between U in the peak velocity at inflow and U max. How is the Reynolds number defined and what is its value for U in = 0.01[m/s]? Getting Started With COMSOL You can start COMSOL by typing bash> comsol & in your terminal. Depending on your system perhaps you might need to first do bash> module add comsol. You will now have a window called MODEL NAVIGATOR. Under the tab NEW you choose SPACE DIMENSION D and click COMSOL MULTIPHYSICS FLUID DY- NAMICS INCOMPRESSIBLE NAVIER STOKES. Click ok. Now you see that you are solving for u, v and p, with quadratic Lagrange elements. We will here mostly consider LAGRANGE LINEAR elements. Note that in general you could start with the general PDE mode and set up your own problem, but here we already have a module for fluid dynamics. We will here consider STATIONARY analysis where COMSOL uses an iterative procedure to obtain a steady state. From this steady state all the analysis will be performed.

4 Assume that the inflow velocity peak is U in = 0.01[m/s]. To make it easy the geometry can be loaded from Since COMSOL solves the equations in dimensional form you need to set the constants in the program: OPTIONS CONSTANTS. This includes ρ, µ, the height of the channel h and U in. In addition you should set the scalar expressions that depend on these constants, such as U max and the Reynolds number Re. This is especially important concerning U max, which is used for setting the global nalytical velocity profile necessary to perform a check of the validity of the solution. Now you can use the rightmost seven buttons at the toolbar in the main window. Normally you start from left to right with the DRAW MODE followed by the POINT MODE, BOUNDARY MODE, SUBDOMAIN MODE and the MESH MODE. The DRAW MODE is meant for drawing a geometry, but you have already loaded the geometry. There is no need for setting POINT MODE values for this case. The BOUNDARY MODE settings

5 are predefined for your convenience, so all you need to do is to check and understand why they are set as they are. It is here the boundary conditions are set. In the SUBDO- MAIN MODE you need to set the values for the density ρ and the dynamic viscosity η (what we have defined as µ) at the PHYSICS tab. For geometries of this size it would perhaps be smart to use a structured grid, but we will use the generic unstructured grid which works for any geometry. A clean way of changing the resolution is to set the maximum allowed element size in MESH->FREE MESH PARAMETERS (MESH- >MESH PARAMETERS in older versions of COMSOL ). In that window you click the tab SUBDOMAIN where you can set the MAXIMUM ELEMENT SIZE. Choose a suitable value, for instance Click REMESH. Exercise : Comparing solution to the analytic expressions Run this flow case for different resolutions, i.e starting with MAXIMUM ELEMENT SIZE 0.01 or/and 0.0. You can run the SOLVER by pressing the = (equals) button or click SOLVE - SOLVE PROBLEM. Produce plots of both the centerline velocity (at y = h/) x [0, 1] and the wall shear stress at y = 0 and x [0, 1] for a couple of different resolutions. At which resolution has it converged and at what x position do we have fully developed channel flow? Is the v velocity zero? Help: You can plot these quantities in POSTPROCESSING - CROSS-SECTION PLOT PARAMETERS. Go to the tab LINE-EXTRUSION and as Y-DATA you type in u-uanalytic (remember that uanalytic was predefined in OPTIONS-EXPRESSIONS). Below select x as X-DATA and select suitable ranges for the coordinates. The procedure is similar for the wall shear stress. Exercise 3: A real convergence study Plots as such give you the insight to the physics and the behaviour of the code, and one should always play around and visualize the different quantities from different views using both one and two-dimensional plots. However for a real verification of the code one needs to compare scalar expressions. A possible quantity to look at is the L -norm of the outflow streamwise velocity error h E = 0 (u u a ) dy. (11) Note that in general one should be careful in analysing quantities at outflow boundaries, but in this case the flow is quite simple yielding it relevant to analyse convergence here. The integration can be done in POSTPROCESSING-BOUNDARY INTEGRATION. Here mark the outflow boundary and in EXPRESSION type (u-uanalytic)^), the square root can be taken afterwards. Redo this for at least four different resolution using LAGRANGE LINEAR elements. The output can be plotted in a log log scale with the number of elements on the x-axis and the error on the y-axis. The plotting can be done in the COMSOL SCRIPT found under FILE -> COMSOL SCRIPT, which has a similar behaviour as a MATLAB-window. Fitting a straight line to these points will approximately provide the convergence rate r, with r being the slope of the curve.

6 To realize this note that we should have the error decaying as E (1/n) r, where n is the number of elements. Applying log to both sides yields log(e) = r log(n). Provide a plot of the error versus the number of elements and give an estimate of r. What value of r is expected for LAGRANGE LINEAR elements? Try to redo this for LAGRANGE P-P1 elements (quadratic). Why can you not gain any clear insight to the convergence rate when using these elements?

Multiphysics Modeling

Multiphysics Modeling 11 Multiphysics Modeling This chapter covers the use of FEMLAB for multiphysics modeling and coupled-field analyses. It first describes the various ways of building multiphysics models. Then a step-by-step

More information

Peristaltic Pump. Introduction. Model Definition

Peristaltic Pump. Introduction. Model Definition Peristaltic Pump Introduction In a peristaltic pump, rotating rollers are squeezing a flexible tube. As the pushed down rollers move along the tube, the fluid in the tube follows the motion. The main advantage

More information

Mass Transfer in a Stirred Batch Reactor

Mass Transfer in a Stirred Batch Reactor Mass Transfer in a Stirred Batch Reactor In many processes, efficient reactor usage goes hand in hand with efficient mixing. The ability to accurately examine the effects of impeller placement, speed,

More information

Finite Element Modules for Enhancing Undergraduate Transport Courses: Application to Fuel Cell Fundamentals

Finite Element Modules for Enhancing Undergraduate Transport Courses: Application to Fuel Cell Fundamentals Finite Element Modules for Enhancing Undergraduate Transport Courses: Application to Fuel Cell Fundamentals Originally published in 007 American Society for Engineering Education Conference Proceedings

More information

Shape, Convection and Convergence

Shape, Convection and Convergence Presented at the COMSOL Conference 2008 Boston Shape, Convection and Convergence,VP Research, Inc. Who is? Who is? We are: A Technical Consultation firm in business since 1993 Who is? We are: A Technical

More information

Generator. Introduction. Modeling in COMSOL Multiphysics

Generator. Introduction. Modeling in COMSOL Multiphysics Generator Introduction This example shows how the circular motion of a rotor with permanent magnets generates an induced EMF in a stator winding. The generated voltage is calculated as a function of time

More information

Example Resistive Heating

Example Resistive Heating Example Resistive Heating SOLVED WITH COMSOL MULTIPHYSICS 3.5a COPYRIGHT 2008. All right reserved. No part of this documentation may be photocopied or reproduced in any form without prior written consent

More information

DUE: WEDS MARCH 26TH 2018

DUE: WEDS MARCH 26TH 2018 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS DUE: WEDS MARCH 26TH 2018 NOTE: In this homework, you will choose ONE of the following three questions to perform and hand-in. Each

More information

Parabolic Flow in Parallel Plate Channel ME 412 Project 4

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

More information

Dimerization in a Tubular Reactor

Dimerization in a Tubular Reactor Dimerization in a Tubular Reactor Tubular reactors are very common in large-scale continuous, for example in the petroleum industry. One key design and optimization parameter is the conversion, that is

More information

Physics to PDE. Tutorial

Physics to PDE. Tutorial Physics to PDE Tutorial 1 1. Exercise Heat Transfer: Heat conduction in the steady state 2. Exercise Structural Mechanics: Bending test 3. Exercise Electrodynamics: Plate capacitor 4. Exercise Fluid Dynamics:

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

Scientific Computing I

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

More information

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

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

More information

Elmer :Heat transfert with phase change solid-solid in transient problem Application to silicon properties. SIF file : phasechange solid-solid

Elmer :Heat transfert with phase change solid-solid in transient problem Application to silicon properties. SIF file : phasechange solid-solid Elmer :Heat transfert with phase change solid-solid in transient problem Application to silicon properties 3 6 1. Tb=1750 [K] 2 & 5. q=-10000 [W/m²] 0,1 1 Ω1 4 Ω2 7 3 & 6. α=15 [W/(m²K)] Text=300 [K] 4.

More information

1 Exercise: Linear, incompressible Stokes flow with FE

1 Exercise: Linear, incompressible Stokes flow with FE Figure 1: Pressure and velocity solution for a sinking, fluid slab impinging on viscosity contrast problem. 1 Exercise: Linear, incompressible Stokes flow with FE Reading Hughes (2000), sec. 4.2-4.4 Dabrowski

More information

Transient flow and heat equations - the Rayleigh-Benard instability

Transient flow and heat equations - the Rayleigh-Benard instability Transient flow and heat equations - the Rayleigh-Benard instability Directory: RayleighBenard Solvers: HeatSolve, FlowSolve Tools: ElmerGUI Dimensions: 2D, Transient Case definition This tutorial is about

More information

Chapter 9: Differential Analysis

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

More information

Mixing in Flow Devices:

Mixing in Flow Devices: Mixing in Flow Devices: Spiral microchannels in two and three dimensions Prepared by Ha Dinh Mentor: Professor Emeritus Bruce A. Finlayson Department of Chemical Engineering University of Washington June

More information

Integrated Square-Shaped Spiral Inductor

Integrated Square-Shaped Spiral Inductor Page 1 of 9 Electrical Component Models : Integrated Square-Shaped Spiral Inductor Integrated Square-Shaped Spiral Inductor This example presents a model of a micro-scale square inductor, used for LC bandpass

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

Electromagnetic Forces on Parallel Current-

Electromagnetic Forces on Parallel Current- Page 1 of 5 Tutorial Models : Electromagnetic Forces on Parallel Current-Carrying Wires Electromagnetic Forces on Parallel Current- Carrying Wires Introduction One ampere is defined as the constant current

More information

ME 431A/538A/538B Homework 22 October 2018 Advanced Fluid Mechanics

ME 431A/538A/538B Homework 22 October 2018 Advanced Fluid Mechanics ME 431A/538A/538B Homework 22 October 2018 Advanced Fluid Mechanics For Friday, October 26 th Start reading the handout entitled Notes on finite-volume methods. Review Chapter 7 on Dimensional Analysis

More information

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

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

More information

Chapter 9: Differential Analysis of Fluid Flow

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

More information

Getting started: CFD notation

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

More information

Nicholas Cox, Pawel Drapala, and Bruce F. Finlayson Department of Chemical Engineering, University of Washington, Seattle, WA, USA.

Nicholas Cox, Pawel Drapala, and Bruce F. Finlayson Department of Chemical Engineering, University of Washington, Seattle, WA, USA. Transport Limitations in Thermal Diffusion Nicholas Cox, Pawel Drapala, and Bruce F. Finlayson Department of Chemical Engineering, University of Washington, Seattle, WA, USA Abstract Numerical simulations

More information

Taylor Dispersion Created by Robert P. Hesketh, Chemical Engineering, Rowan University Fall 2005

Taylor Dispersion Created by Robert P. Hesketh, Chemical Engineering, Rowan University Fall 2005 Taylor Dispersion Created by Robert P. Hesketh, Chemical Engineering, Rowan University Fall 005 In this problem you will simulate a tubular reactor with fluid flowing in laminar flow. The governing equations

More information

Due Tuesday, November 23 nd, 12:00 midnight

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

More information

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

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

More information

UNIVERSITY of LIMERICK

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

More information

PDE Solvers for Fluid Flow

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

More information

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

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

More information

MOMENTUM PRINCIPLE. Review: Last time, we derived the Reynolds Transport Theorem: Chapter 6. where B is any extensive property (proportional to mass),

MOMENTUM PRINCIPLE. Review: Last time, we derived the Reynolds Transport Theorem: Chapter 6. where B is any extensive property (proportional to mass), Chapter 6 MOMENTUM PRINCIPLE Review: Last time, we derived the Reynolds Transport Theorem: where B is any extensive property (proportional to mass), and b is the corresponding intensive property (B / m

More information

Turbulent Boundary Layers & Turbulence Models. Lecture 09

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

More information

DIRECT NUMERICAL SIMULATION OF SPATIALLY DEVELOPING TURBULENT BOUNDARY LAYER FOR SKIN FRICTION DRAG REDUCTION BY WALL SURFACE-HEATING OR COOLING

DIRECT NUMERICAL SIMULATION OF SPATIALLY DEVELOPING TURBULENT BOUNDARY LAYER FOR SKIN FRICTION DRAG REDUCTION BY WALL SURFACE-HEATING OR COOLING DIRECT NUMERICAL SIMULATION OF SPATIALLY DEVELOPING TURBULENT BOUNDARY LAYER FOR SKIN FRICTION DRAG REDUCTION BY WALL SURFACE-HEATING OR COOLING Yukinori Kametani Department of mechanical engineering Keio

More information

fluid mechanics as a prominent discipline of application for numerical

fluid mechanics as a prominent discipline of application for numerical 1. fluid mechanics as a prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

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

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

More information

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

More information

Turbulence - Theory and Modelling GROUP-STUDIES:

Turbulence - Theory and Modelling GROUP-STUDIES: Lund Institute of Technology Department of Energy Sciences Division of Fluid Mechanics Robert Szasz, tel 046-0480 Johan Revstedt, tel 046-43 0 Turbulence - Theory and Modelling GROUP-STUDIES: Turbulence

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

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

More information

Tutorial for the supercritical pressure pipe with STAR-CCM+

Tutorial for the supercritical pressure pipe with STAR-CCM+ Tutorial for the supercritical pressure pipe with STAR-CCM+ For performing this tutorial, it is necessary to have already studied the tutorial on the upward bend. In fact, after getting abilities with

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches Joint probability density function modeling of velocity and scalar in turbulence with unstructured grids arxiv:6.59v [physics.flu-dyn] Jun J. Bakosi, P. Franzese and Z. Boybeyi George Mason University,

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Analysis of Mixing Chambers for the Processing of Two-Component Adhesives for Transport Applications

Analysis of Mixing Chambers for the Processing of Two-Component Adhesives for Transport Applications Analysis of Mixing Chambers for the Processing of Two-Component Adhesives for Transport Applications P. Steinert* 1, I. Schaarschmidt 1, R. Paul 1, M. Zinecker 1, M. Hackert-Oschätzchen 1, Th. Muschalek

More information

Wall Effects in Convective Heat Transfer from a Sphere to Power Law Fluids in Tubes

Wall Effects in Convective Heat Transfer from a Sphere to Power Law Fluids in Tubes Excerpt from the Proceedings of the COMSOL Conference 9 Boston Wall Effects in Convective Heat Transfer from a Sphere to Power Law Fluids in Tubes Daoyun Song *1, Rakesh K. Gupta 1 and Rajendra P. Chhabra

More information

6. Expressions for Describing Steady Shear Non-Newtonian Flow

6. Expressions for Describing Steady Shear Non-Newtonian Flow Non-Newtonian Flows Modified from the Comsol ChE Library module. Rev 10/15/08 2:30PM Modified by Robert P. Hesketh, Chemical Engineering, Rowan University Fall 2008 http://ciks.cbt.nist.gov/~garbocz/sp946/node8.htm

More information

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

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

More information

Entropic Evaluation of Dean Flow Micromixers

Entropic Evaluation of Dean Flow Micromixers COMSOL Conference, Boston, 2013 Brian Vyhnalek, Petru S. Fodor and Miron Kaufman Physics Department Cleveland State University Entropic Evaluation of Dean Flow Micromixers ABSTRACT We study the use of

More information

Comparison of Heat and Mass Transport at the Micro-Scale

Comparison of Heat and Mass Transport at the Micro-Scale Comparison of Heat and Mass Transport at the Micro-Scale E. Holzbecher, S. Oehlmann Georg-August Univ. Göttingen *Goldschmidtstr. 3, 37077 Göttingen, GERMANY, eholzbe@gwdg.de Abstract: Phenomena of heat

More information

Turbulence Modeling I!

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

More information

Homework #4 Solution. μ 1. μ 2

Homework #4 Solution. μ 1. μ 2 Homework #4 Solution 4.20 in Middleman We have two viscous liquids that are immiscible (e.g. water and oil), layered between two solid surfaces, where the top boundary is translating: y = B y = kb y =

More information

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

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

More information

An Overview of Impellers, Velocity Profile and Reactor Design

An Overview of Impellers, Velocity Profile and Reactor Design An Overview of s, Velocity Profile and Reactor Design Praveen Patel 1, Pranay Vaidya 1, Gurmeet Singh 2 1 Indian Institute of Technology Bombay, India 1 Indian Oil Corporation Limited, R&D Centre Faridabad

More information

The dependence of the cross-sectional shape on the hydraulic resistance of microchannels

The dependence of the cross-sectional shape on the hydraulic resistance of microchannels 3-weeks course report, s0973 The dependence of the cross-sectional shape on the hydraulic resistance of microchannels Hatim Azzouz a Supervisor: Niels Asger Mortensen and Henrik Bruus MIC Department of

More information

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

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

More information

Viscous Fluids. Amanda Meier. December 14th, 2011

Viscous Fluids. Amanda Meier. December 14th, 2011 Viscous Fluids Amanda Meier December 14th, 2011 Abstract Fluids are represented by continuous media described by mass density, velocity and pressure. An Eulerian description of uids focuses on the transport

More information

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems

Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems Martin Engel and Michael Griebel Institute of Numerical Simulation, University of Bonn, Wegelerstr.

More information

CHAPTER 4 ANALYTICAL SOLUTIONS OF COUPLE STRESS FLUID FLOWS THROUGH POROUS MEDIUM BETWEEN PARALLEL PLATES WITH SLIP BOUNDARY CONDITIONS

CHAPTER 4 ANALYTICAL SOLUTIONS OF COUPLE STRESS FLUID FLOWS THROUGH POROUS MEDIUM BETWEEN PARALLEL PLATES WITH SLIP BOUNDARY CONDITIONS CHAPTER 4 ANALYTICAL SOLUTIONS OF COUPLE STRESS FLUID FLOWS THROUGH POROUS MEDIUM BETWEEN PARALLEL PLATES WITH SLIP BOUNDARY CONDITIONS Introduction: The objective of this chapter is to establish analytical

More information

The JHU Turbulence Databases (JHTDB)

The JHU Turbulence Databases (JHTDB) The JHU Turbulence Databases (JHTDB) TURBULENT CHANNEL FLOW DATA SET Data provenance: J. Graham 1, M. Lee 2, N. Malaya 2, R.D. Moser 2, G. Eyink 1 & C. Meneveau 1 Database ingest and Web Services: K. Kanov

More information

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

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

More information

JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman

JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman The exercises will be carried out on PC s in the practicum rooms. Several (Matlab and Fortran) files are required. How these can be obtained

More information

Helical Coil Flow: a Case Study

Helical Coil Flow: a Case Study Excerpt from the Proceedings of the COMSOL Conference 2009 Milan Helical Coil Flow: a Case Study Marco Cozzini Renewable Energies and Environmental Technologies (REET) Research Unit, Fondazione Bruno Kessler

More information

Two Dimensional Orbital Mixing for a Fluid. Written by Shawn Lillie Supervised by Dr. Bruce Finlayson

Two Dimensional Orbital Mixing for a Fluid. Written by Shawn Lillie Supervised by Dr. Bruce Finlayson Two Dimensional Orbital Mixing for a Fluid Written by Shawn Lillie Supervised by Dr. Bruce Finlayson University of Washington Department of Chemical Engineering Undergraduate Research December 13, 2006

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

BOUNDARY LAYER ANALYSIS WITH NAVIER-STOKES EQUATION IN 2D CHANNEL FLOW

BOUNDARY LAYER ANALYSIS WITH NAVIER-STOKES EQUATION IN 2D CHANNEL FLOW Proceedings of,, BOUNDARY LAYER ANALYSIS WITH NAVIER-STOKES EQUATION IN 2D CHANNEL FLOW Yunho Jang Department of Mechanical and Industrial Engineering University of Massachusetts Amherst, MA 01002 Email:

More information

Numerical investigation of multiple slot jets in air knife coating

Numerical investigation of multiple slot jets in air knife coating Numerical investigation of multiple slot jets in air knife coating A. Yahyaee Soufiani 1, J.R. McDermid 2, A.N. Hrymak 3 and F.E. Goodwin 4 1 McMaster University 128 Main street west, Hamilton, ON, Canada,

More information

Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer

Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer Thomas P. Forbes and Jason G. Kralj National Institute of Standards and Technology,

More information

Basic Fluid Mechanics

Basic Fluid Mechanics Basic Fluid Mechanics Chapter 6A: Internal Incompressible Viscous Flow 4/16/2018 C6A: Internal Incompressible Viscous Flow 1 6.1 Introduction For the present chapter we will limit our study to incompressible

More information

GENERALISATION OF THE TWO-SCALE MOMENTUM THEORY FOR COUPLED WIND TURBINE/FARM OPTIMISATION

GENERALISATION OF THE TWO-SCALE MOMENTUM THEORY FOR COUPLED WIND TURBINE/FARM OPTIMISATION 25 th National Symposium on Wind Engineering, Tokyo, Japan, 3-5 December 2018 第 25 回風工学シンポジウム (2018) GENERALISATION OF THE TWO-SCALE MOMENTUM THEORY FOR COUPLED WIND TURBINE/FARM OPTIMISATION Takafumi

More information

Computation Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computation Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computation Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. # 40 What is there in implementing a CFD Code So far, we

More information

Tutorial for the heated pipe with constant fluid properties in STAR-CCM+

Tutorial for the heated pipe with constant fluid properties in STAR-CCM+ Tutorial for the heated pipe with constant fluid properties in STAR-CCM+ For performing this tutorial, it is necessary to have already studied the tutorial on the upward bend. In fact, after getting abilities

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Large Scale Fluid-Structure Interaction by coupling OpenFOAM with external codes

Large Scale Fluid-Structure Interaction by coupling OpenFOAM with external codes Large Scale Fluid-Structure Interaction by coupling OpenFOAM with external codes Thomas Gallinger * Alexander Kupzok Roland Wüchner Kai-Uwe Bletzinger Lehrstuhl für Statik Technische Universität München

More information

Application of Solution Mapping to Reduce Computational Time in Actively Cooled Power Electronics

Application of Solution Mapping to Reduce Computational Time in Actively Cooled Power Electronics Excerpt from the Proceedings of the COMSOL Conference 2008 Boston Application of Solution Mapping to Reduce Computational Time in Actively Cooled Power Electronics Kirk T. Lowe *,1,2 and Rao V. Arimilli

More information

6.2 Governing Equations for Natural Convection

6.2 Governing Equations for Natural Convection 6. Governing Equations for Natural Convection 6..1 Generalized Governing Equations The governing equations for natural convection are special cases of the generalized governing equations that were discussed

More information

A multiscale framework for lubrication analysis of bearings with textured surface

A multiscale framework for lubrication analysis of bearings with textured surface A multiscale framework for lubrication analysis of bearings with textured surface *Leiming Gao 1), Gregory de Boer 2) and Rob Hewson 3) 1), 3) Aeronautics Department, Imperial College London, London, SW7

More information

Validation 3. Laminar Flow Around a Circular Cylinder

Validation 3. Laminar Flow Around a Circular Cylinder Validation 3. Laminar Flow Around a Circular Cylinder 3.1 Introduction Steady and unsteady laminar flow behind a circular cylinder, representing flow around bluff bodies, has been subjected to numerous

More information

Spatial discretization scheme for incompressible viscous flows

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

More information

Fluid Mechanics II Viscosity and shear stresses

Fluid Mechanics II Viscosity and shear stresses Fluid Mechanics II Viscosity and shear stresses Shear stresses in a Newtonian fluid A fluid at rest can not resist shearing forces. Under the action of such forces it deforms continuously, however small

More information

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES Proceedings of the International Conference on Mechanical Engineering 2 (ICME2) 8-2 December 2, Dhaka, Bangladesh ICME-TH-6 FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

More information

WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID

WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID Zia Ghiasi sghias@uic.edu Dongru Li dli@uic.edu Jonathan Komperda jonk@uic.edu Farzad

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

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

More information

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

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

More information

Computation of turbulent Prandtl number for mixed convection around a heated cylinder

Computation of turbulent Prandtl number for mixed convection around a heated cylinder Center for Turbulence Research Annual Research Briefs 2010 295 Computation of turbulent Prandtl number for mixed convection around a heated cylinder By S. Kang AND G. Iaccarino 1. Motivation and objectives

More information

Marching on the BL equations

Marching on the BL equations Marching on the BL equations Harvey S. H. Lam February 10, 2004 Abstract The assumption is that you are competent in Matlab or Mathematica. White s 4-7 starting on page 275 shows us that all generic boundary

More information

CFD STUDY OF MASS TRANSFER IN SPACER FILLED MEMBRANE MODULE

CFD STUDY OF MASS TRANSFER IN SPACER FILLED MEMBRANE MODULE GANIT J. Bangladesh Math. Soc. (ISSN 1606-3694) 31 (2011) 33-41 CFD STUDY OF MASS TRANSFER IN SPACER FILLED MEMBRANE MODULE Sharmina Hussain Department of Mathematics and Natural Science BRAC University,

More information

CONVECTIVE HEAT TRANSFER

CONVECTIVE HEAT TRANSFER CONVECTIVE HEAT TRANSFER Mohammad Goharkhah Department of Mechanical Engineering, Sahand Unversity of Technology, Tabriz, Iran CHAPTER 4 HEAT TRANSFER IN CHANNEL FLOW BASIC CONCEPTS BASIC CONCEPTS Laminar

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

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

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

More information

Application of COMSOL Multiphysics in Transport Phenomena Educational Processes

Application of COMSOL Multiphysics in Transport Phenomena Educational Processes Application of COMSOL Multiphysics in Transport Phenomena Educational Processes M. Vasilev, P. Sharma and P. L. Mills * Department of Chemical and Natural Gas Engineering, Texas A&M University-Kingsville,

More information

Investigation of laminar boundary layers with and without pressure gradients

Investigation of laminar boundary layers with and without pressure gradients Investigation of laminar boundary layers with and without pressure gradients FLUID MECHANICS/STRÖMNINGSMEKANIK SG1215 Lab exercise location: Lab exercise duration: Own material: Strömningsfysiklaboratoriet

More information

Shell Balances in Fluid Mechanics

Shell Balances in Fluid Mechanics Shell Balances in Fluid Mechanics R. Shankar Subramanian Department of Chemical and Biomolecular Engineering Clarkson University When fluid flow occurs in a single direction everywhere in a system, shell

More information

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical Outline Geurts Book Department of Fluid Mechanics, Budapest University of Technology and Economics Spring 2013 Outline Outline Geurts Book 1 Geurts Book Origin This lecture is strongly based on the book:

More information

Modeling of Humidification in Comsol Multiphysics 4.4

Modeling of Humidification in Comsol Multiphysics 4.4 Modeling of Humidification in Comsol Multiphysics 4.4 Indrajit Wadgaonkar *1 and Suresh Arikapudi 1 1 Tata Motors Ltd. Pimpri, Pune, India, 411018. *Corresponding author: Indrajit Wadgaonkar, Tata Motors

More information

Numerical analysis of fluid flow and heat transfer in 2D sinusoidal wavy channel

Numerical analysis of fluid flow and heat transfer in 2D sinusoidal wavy channel Numerical analysis of fluid flow and heat transfer in 2D sinusoidal wavy channel Arunanshu Chakravarty 1* 1 CTU in Prague, Faculty of Mechanical Engineering, Department of Process Engineering,Technická

More information

Effect on heat transfer for laminar flow over Backward Facing Step with square cylinder placed inside using Higher Order Compact Scheme

Effect on heat transfer for laminar flow over Backward Facing Step with square cylinder placed inside using Higher Order Compact Scheme ISSN (e): 2250 3005 Volume, 06 Issue, 01 January 2016 International Journal of Computational Engineering Research (IJCER) Effect on heat transfer for laminar flow over Backward Facing Step with square

More information