Notes Shallow Water Equations Advection Exploiting Lagrangian View

Total Page:16

File Type:pdf, Size:1020Kb

Notes Shallow Water Equations Advection Exploiting Lagrangian View Notes Shallow water equations ! To recap, using eta for depth=h+H: D! = "!# $ u Dt Du = "g#h Dt ! We!re currently working on the advection (material derivative) part cs533d-term1-2005 1 cs533d-term1-2005 2 Advection Exploiting Lagrangian view ! Let!s discretize just the material derivative ! We want to stick an Eulerian grid for now, (advection equation): but somehow exploit the fact that Dq q + u! "q = 0 or = 0 • If we know q at some point x at time t, we just t Dt follow a particle through the flow starting at x ! For a Lagrangian scheme this is trivial: just to see where that value of q ends up move the particle that stores q, don!t change the value of q at all q(x(t + !t),t + !t) = q(x(t),t) q(x(t),t) = q(x0,0) dx = u(x), x(t) = x0 dt cs533d-term1-2005 3 cs533d-term1-2005 4 Looking backwards Semi-Lagrangian method ! Problem with tracing particles - we want values at grid ! Developed in weather prediction, going back to nodes at the end of the step the 50!s • Particles could end up anywhere ! Also dubbed “stable fluids” in graphics ! But… we can look backwards in time (reinvention by Stam #99) q = q x(t ! "t),t ! "t ijk ( ) ! To find new value of q at a grid point, trace dx particle backwards from grid point (with velocity = u(x), x(t) = xijk dt u) for -"t and interpolate from old values of q ! Same formulas as before - but new interpretation ! Two questions • To get value of q at a grid point, follow a particle backwards • How do we trace? through flow to wherever it started • How do we interpolate? cs533d-term1-2005 5 cs533d-term1-2005 6 Tracing Tracing: 1st order ! The errors we make in tracing backwards ! We!re at grid node (i,j,k) at position xijk aren!t too big a deal ! Trace backwards through flow for -"t • We don!t compound them - stability isn!t an x = x ! "t u issue old ijk ijk • How accurate we are in tracing doesn!t effect • Note - using u value at grid point (what we know shape of q much, just location already) like Forward Euler. ! Whether we get too much blurring, oscillations, or ! Then can get new q value (with interpolation) a nice result is really up to interpolation n +1 n ! Thus look at “Forward” Euler and RK2 qijk = q (xold ) n = q (xijk ! "tuijk ) cs533d-term1-2005 7 cs533d-term1-2005 8 Interpolation Linear interpolation ! “First” order accurate: nearest neighbour ! Error in linear interpolation is proportional to 2 • Just pick q value at grid node closest to xold " q !x 2 • Doesn!t work for slow fluid (small time steps) -- "x 2 nothing changes! • When we divide by grid spacing to put in terms of ! Modified PDE ends up something like… advection equation, drops to zero!th order accuracy Dq " 2q = k(!t)!x 2 ! “Second” order accurate: linear or bilinear (2D) Dt "x 2 • Ends up first order in advection equation • We have numerical viscosity, things will smear out • Still fast, easy to handle boundary conditions… • For reasonable time steps, k looks like 1/"t ~ 1/"x • How well does it work? ! [Equivalent to 1st order upwind for CFL "t] ! In practice, too much smearing for inviscid fluids cs533d-term1-2005 9 cs533d-term1-2005 10 Nice properties of lerping Cubic interpolation ! Linear interpolation is completely stable ! To fix the problem of excessive smearing, • Interpolated value of q must lie between the go to higher order old values of q on the grid ! E.g. use cubic splines • Thus with each time step, max(q) cannot • Finding interpolating C2 cubic spline is a little increase, and min(q) cannot decrease painful, an alternative is the ! Thus we end up with a fully stable • C1 Catmull-Rom (cubic Hermite) spline algorithm - take "t as big as you want ! [derive] • Great for interactive applications ! Introduces overshoot problems • Also simplifies whole issue of picking time • Stability isn!t so easy to guarantee anymore steps cs533d-term1-2005 11 cs533d-term1-2005 12 Min-mod limited Catmull-Rom Back to Shallow Water ! See Fedkiw, Stam, Jensen #01 ! So we can now handle advection of both ! Trick is to check if either slope at the endpoints water depth and each component of water of the interval has the wrong sign velocity • If so, clamp the slope to zero ! Left with the divergence and gradient • Still use cubic Hermite formulas with more reliable slopes terms !" $ !u !w' = #"& + ) ! This has same stability guarantee as linear !t % !x !z ( interpolation !u !h • But in smoother parts of flow, higher order accurate = #g • Called “high resolution” !t !x ! Still has issues with boundary conditions… !w !h = #g cs533d-term1-2005 13 !t !z cs533d-term1-2005 14 Staggered grid Spatial Discretization ! We like central differences - more ! So on the MAC grid: accurate, unbiased ! So natural to use a staggered grid for % u 1 # u 1 w 1 # w 1 ( !"ij i+ 2, j i# 2, j i, j + 2 i, j# 2 velocity and height variables = #"ij ' + * • Called MAC grid after the Marker-and-Cell !t & $x $z ) method (Harlow and Welch #65) that !u 1 h # h introduced it i+ 2, j = #g i+1, j i, j ! Heights at cell centres !t $x ! u-velocities at x-faces of cells !wi, j + 1 hi, j +1 # hi, j 2 = #g ! w-velocities at z-faces of cells !t $z cs533d-term1-2005 15 cs533d-term1-2005 16 Solving Full Equations Operator Splitting ! Let!s now solve the full incompressible ! Generally a bad idea to treat Euler or Navier-Stokes equations incompressible flow as conservation laws ! We!ll first avoid interfaces with constraints (e.g. free surfaces) ! Instead: split equations up into easy ! Think smoke chunks, just like Shallow Water ut + u! "u = 0 2 ut = #" u ut = g 1 ut + $ "p = 0 (" ! u = 0) cs533d-term1-2005 17 cs533d-term1-2005 18 Time integration Advection boundary conditions ! Don!t mix the steps at all - 1st order accurate ! But first, one last issue u(1) = advect(un ,!t) ! Semi-Lagrangian procedure may need to (2) (1) 2 (2) interpolate from values of u outside the domain, u = u + "!t# u or inside solids u(3) = u(2) + !tg • Outside: no correct answer. Extrapolating from nearest point on domain is fine, or assuming some n +1 (3) 1 u = u $ !t % #p far-field velocity perhaps ! We!ve already seen how to do the advection step • Solid walls: velocity should be velocity of wall (e.g.zero) ! Often can ignore the second step (viscosity) ! Technically only normal component of velocity needs to be ! Let!s focus for now on the last step (pressure) taken from wall, in absence of viscosity the tangential component may be better extrapolated from the fluid cs533d-term1-2005 19 cs533d-term1-2005 20 Continuous pressure Pressure boundary conditions ! Before we discretize in space, last step is ! Issue of what to do for p and u at to take u(3), figure out the pressure p that boundaries in pressure solve n+1 makes u incompressible: ! Think in terms of control volumes: • Want ! " un +1 = 0 subtract pn from u on boundary so that u(3) t 1 p 0 • Plug in pressure update formula: ! " ( # $ % ! ) = integral of u•n is zero • Rearrange: t 1 p u(3) ! " (# $ ! ) = ! " ! So at closed boundary we end up with • Solve this Poisson problem (often density is n +1 constant and you can rescale p by it, also "t) u ! n = 0 ! Make this assumption from now on: 2 (3) #p ! p = ! " u un +1 ! n = u(3) ! n " un +1 = u(3) # !p #n cs533d-term1-2005 21 cs533d-term1-2005 22 Pressure BC’s cont’d. Approximate projection ! At closed wall boundary have two choices: ! Can now directly discretize Poisson equation on a grid # " 2 p " 2 p " 2 p& • Set u•n=0 first, then solve for p with $p/$n=0, 2 p (! ) = % 2 + 2 + 2 ( don!t update velocity at boundary ijk $ "x "y "z ' p * 2p + p p * 2p + p p * 2p + p ) i+1 jk ijk i*1 jk + ij +1k ijk ij*1k + ijk+1 ijk ijk*1 • Or simply solve for p with $p/$n=u•n and +x 2 +y 2 +z2 update u•n at boundary with -$p/$n # "u "v "w& (! , u) = % + + ( ijk "x "y "z • Equivalent, but the second option make sense $ ' ijk u * u v * v w * w in the continuous setting, and generally keeps ) i+1 jk i*1 jk + ij +1k ij*1k + ijk+1 ijk*1 you more honest 2+x 2+y 2+z - pi+1 jk * pi*1 jk pij +1k * pij*1k pijk+1 * pijk*1 0 (!p) ) / , , 2 ! At open (or free-surface) boundaries, no ijk . 2+x 2+y 2+z 1 constraint on u•n, so typically pick p=0 ! Central differences - 2nd order, no bias cs533d-term1-2005 23 cs533d-term1-2005 24 Issues Exact projection (1st try) ! On the plus side: simple grid, simple discretization, ! Connection becomes exact in limit for smooth u… ! But it doesn!t work • use the discrete divergence as a hard • Divergence part of equation can!t “see” high frequency constraint to enforce, pressure p turns out to compression waves be the Lagrange multipliers… • Left with high frequency oscillatory error • Need to filter this out - smooth out velocity field before ! Or let!s just follow the route before, but subtracting off pressure gradient • Filtering introduces more numerical viscosity, eliminates features discretize divergence and gradient first on coarse grids First try: use centred differences as before ! Also: doesn!t exactly make u incompressible • • Measuring divergence of result gives nonzero • u and p all “live” on same grid: uijk, pijk ! So let!s look at exactly enforcing the incompressibility This is called a “collocated” scheme constraint • cs533d-term1-2005 25 cs533d-term1-2005 26 Exact collocated projection Problems ! " un +1 = 0 ! So want ( )ijk ! Pressure problem decouples into 8 independent un +1 # un +1 v n +1 # v n +1 w n +1 # w n +1 subproblems i+1 jk i#1 jk + ij +1k ij#1k + ijk+1 ijk#1 = 0 2$x 2$y 2$z ! “Checkerboard” instability • Divergence still doesn!t see high-frequency ! Update with discrete gradient of p un +1 = u(3) ! "p compression waves # p ! p p !
Recommended publications
  • Aerodynamics Material - Taylor & Francis
    CopyrightAerodynamics material - Taylor & Francis ______________________________________________________________________ 257 Aerodynamics Symbol List Symbol Definition Units a speed of sound ⁄ a speed of sound at sea level ⁄ A area aspect ratio ‐‐‐‐‐‐‐‐ b wing span c chord length c Copyrightmean aerodynamic material chord- Taylor & Francis specific heat at constant pressure of air · root chord tip chord specific heat at constant volume of air · / quarter chord total drag coefficient ‐‐‐‐‐‐‐‐ , induced drag coefficient ‐‐‐‐‐‐‐‐ , parasite drag coefficient ‐‐‐‐‐‐‐‐ , wave drag coefficient ‐‐‐‐‐‐‐‐ local skin friction coefficient ‐‐‐‐‐‐‐‐ lift coefficient ‐‐‐‐‐‐‐‐ , compressible lift coefficient ‐‐‐‐‐‐‐‐ compressible moment ‐‐‐‐‐‐‐‐ , coefficient , pitching moment coefficient ‐‐‐‐‐‐‐‐ , rolling moment coefficient ‐‐‐‐‐‐‐‐ , yawing moment coefficient ‐‐‐‐‐‐‐‐ ______________________________________________________________________ 258 Aerodynamics Aerodynamics Symbol List (cont.) Symbol Definition Units pressure coefficient ‐‐‐‐‐‐‐‐ compressible pressure ‐‐‐‐‐‐‐‐ , coefficient , critical pressure coefficient ‐‐‐‐‐‐‐‐ , supersonic pressure coefficient ‐‐‐‐‐‐‐‐ D total drag induced drag Copyright material - Taylor & Francis parasite drag e span efficiency factor ‐‐‐‐‐‐‐‐ L lift pitching moment · rolling moment · yawing moment · M mach number ‐‐‐‐‐‐‐‐ critical mach number ‐‐‐‐‐‐‐‐ free stream mach number ‐‐‐‐‐‐‐‐ P static pressure ⁄ total pressure ⁄ free stream pressure ⁄ q dynamic pressure ⁄ R
    [Show full text]
  • Potential Flow Theory
    2.016 Hydrodynamics Reading #4 2.016 Hydrodynamics Prof. A.H. Techet Potential Flow Theory “When a flow is both frictionless and irrotational, pleasant things happen.” –F.M. White, Fluid Mechanics 4th ed. We can treat external flows around bodies as invicid (i.e. frictionless) and irrotational (i.e. the fluid particles are not rotating). This is because the viscous effects are limited to a thin layer next to the body called the boundary layer. In graduate classes like 2.25, you’ll learn how to solve for the invicid flow and then correct this within the boundary layer by considering viscosity. For now, let’s just learn how to solve for the invicid flow. We can define a potential function,!(x, z,t) , as a continuous function that satisfies the basic laws of fluid mechanics: conservation of mass and momentum, assuming incompressible, inviscid and irrotational flow. There is a vector identity (prove it for yourself!) that states for any scalar, ", " # "$ = 0 By definition, for irrotational flow, r ! " #V = 0 Therefore ! r V = "# ! where ! = !(x, y, z,t) is the velocity potential function. Such that the components of velocity in Cartesian coordinates, as functions of space and time, are ! "! "! "! u = , v = and w = (4.1) dx dy dz version 1.0 updated 9/22/2005 -1- ©2005 A. Techet 2.016 Hydrodynamics Reading #4 Laplace Equation The velocity must still satisfy the conservation of mass equation. We can substitute in the relationship between potential and velocity and arrive at the Laplace Equation, which we will revisit in our discussion on linear waves.
    [Show full text]
  • Introduction to Compressible Computational Fluid Dynamics James S
    Introduction to Compressible Computational Fluid Dynamics James S. Sochacki Department of Mathematics James Madison University [email protected] Abstract This document is intended as an introduction to computational fluid dynamics at the upper undergraduate level. It is assumed that the student has had courses through three dimensional calculus and some computer programming experience with numer- ical algorithms. A course in differential equations is recommended. This document is intended to be used by undergraduate instructors and students to gain an under- standing of computational fluid dynamics. The document can be used in a classroom or research environment at the undergraduate level. The idea of this work is to have the students use the modules to discover properties of the equations and then relate this to the physics of fluid dynamics. Many issues, such as rarefactions and shocks are left out of the discussion because the intent is to have the students discover these concepts and then study them with the instructor. The document is used in part of the undergraduate MATH 365 - Computation Fluid Dynamics course at James Madi- son University (JMU) and is part of the joint NSF Grant between JMU and North Carolina Central University (NCCU): A Collaborative Computational Sciences Pro- gram. This document introduces the full three-dimensional Navier Stokes equations. As- sumptions to these equations are made to derive equations that are accessible to un- dergraduates with the above prerequisites. These equations are approximated using finite difference methods. The development of the equations and finite difference methods are contained in this document. Software modules and their corresponding documentation in Fortran 90, Maple and Matlab can be downloaded from the web- site: http://www.math.jmu.edu/~jim/compressible.html.
    [Show full text]
  • INCOMPRESSIBLE FLOW AERODYNAMICS 3 0 0 3 Course Category: Programme Core A
    COURSE CODE COURSE TITLE L T P C 1151AE107 INCOMPRESSIBLE FLOW AERODYNAMICS 3 0 0 3 Course Category: Programme core a. Preamble : The primary objective of this course is to teach students how to determine aerodynamic lift and drag over an airfoil and wing at incompressible flow regime by analytical methods. b. Prerequisite Courses: Fluid Mechanics c. Related Courses: Airplane Performance Compressible flow Aerodynamics Aero elasticity Flapping wing dynamics Industrial aerodynamics Transonic Aerodynamics d. Course Educational Objectives: To introduce the concepts of mass, momentum and energy conservation relating to aerodynamics. To make the student understand the concept of vorticity, irrotationality, theory of air foils and wing sections. To introduce the basics of viscous flow. e. Course Outcomes: Upon the successful completion of the course, students will be able to: Knowledge Level CO Course Outcomes (Based on revised Nos. Bloom’s Taxonomy) Apply the physical principles to formulate the governing CO1 K3 aerodynamics equations Find the solution for two dimensional incompressible inviscid CO2 K3 flows Apply conformal transformation to find the solution for flow over CO3 airfoils and also find the solutions using classical thin airfoil K3 theory Apply Prandtl’s lifting-line theory to find the aerodynamic CO4 K3 characteristics of finite wing Find the solution for incompressible flow over a flat plate using CO5 K3 viscous flow concepts f. Correlation of COs with POs: COs PO1 PO2 PO3 PO4 PO5 PO6 PO7 PO8 PO9 PO10 PO11 PO12 CO1 H L H L M H H CO2 H L H L M H H CO3 H L H L M H H CO4 H L H L M H H CO5 H L H L M H H H- High; M-Medium; L-Low g.
    [Show full text]
  • Shallow-Water Equations and Related Topics
    CHAPTER 1 Shallow-Water Equations and Related Topics Didier Bresch UMR 5127 CNRS, LAMA, Universite´ de Savoie, 73376 Le Bourget-du-Lac, France Contents 1. Preface .................................................... 3 2. Introduction ................................................. 4 3. A friction shallow-water system ...................................... 5 3.1. Conservation of potential vorticity .................................. 5 3.2. The inviscid shallow-water equations ................................. 7 3.3. LERAY solutions ........................................... 11 3.3.1. A new mathematical entropy: The BD entropy ........................ 12 3.3.2. Weak solutions with drag terms ................................ 16 3.3.3. Forgetting drag terms – Stability ............................... 19 3.3.4. Bounded domains ....................................... 21 3.4. Strong solutions ............................................ 23 3.5. Other viscous terms in the literature ................................. 23 3.6. Low Froude number limits ...................................... 25 3.6.1. The quasi-geostrophic model ................................. 25 3.6.2. The lake equations ...................................... 34 3.7. An interesting open problem: Open sea boundary conditions .................... 41 3.8. Multi-level and multi-layers models ................................. 43 3.9. Friction shallow-water equations derivation ............................. 44 3.9.1. Formal derivation ....................................... 44 3.10.
    [Show full text]
  • Lattice Boltzmann Modeling for Shallow Water Equations Using High
    Louisiana State University LSU Digital Commons LSU Doctoral Dissertations Graduate School 2010 Lattice Boltzmann modeling for shallow water equations using high performance computing Kevin Tubbs Louisiana State University and Agricultural and Mechanical College, [email protected] Follow this and additional works at: https://digitalcommons.lsu.edu/gradschool_dissertations Part of the Engineering Science and Materials Commons Recommended Citation Tubbs, Kevin, "Lattice Boltzmann modeling for shallow water equations using high performance computing" (2010). LSU Doctoral Dissertations. 34. https://digitalcommons.lsu.edu/gradschool_dissertations/34 This Dissertation is brought to you for free and open access by the Graduate School at LSU Digital Commons. It has been accepted for inclusion in LSU Doctoral Dissertations by an authorized graduate school editor of LSU Digital Commons. For more information, please [email protected]. LATTICE BOLTZMANN MODELING FOR SHALLOW WATER EQUATIONS USING HIGH PERFORMANCE COMPUTING A Dissertation Submitted to the Graduate Faculty of the Louisiana State University and Agricultural and Mechanical College in partial fulfillment of the requirements for the degree of Doctor of Philosophy in The Interdepartmental Program in Engineering Science by Kevin Tubbs B.S. Physics , Southern University, 2001 M.S. Physics, Louisiana State University, 2004 May, 2010 To my family ii ACKNOWLEDGMENTS I want to acknowledge the love and support of my family and friends which was instrumental in completing my degree. I would like to especially thank my parents, John and Veronica Tubbs and my siblings Kanika Tubbs and Keosha Tubbs. I dedicate this dissertation in loving memory of my brother Kendrick Tubbs and my grandmother Gertrude Nicholas. I would also like to thank Dr.
    [Show full text]
  • 1 David Apsley 3. APPROXIMATIONS and SIMPLIFIED EQUATIONS
    3. APPROXIMATIONS AND SIMPLIFIED EQUATIONS SPRING 2021 3.1 Steady-state vs time-dependent flow 3.2 Two-dimensional vs three-dimensional flow 3.3 Incompressible vs compressible flow 3.4 Inviscid vs viscous flow 3.5 Hydrostatic vs non-hydrostatic flow 3.6 Boussinesq approximation for density 3.7 Depth-averaged (shallow-water) equations 3.8 Reynolds-averaged equations (turbulent flow) Examples Fluid dynamics is governed by equations for mass, momentum and energy. The momentum equation for a viscous fluid is called the Navier-Stokes equation; it is based upon: • continuum mechanics; • the momentum principle; • shear stress proportional to velocity gradient. A fluid for which the last is true is called a Newtonian fluid. This is the case for most fluids in engineering. However, there are important non-Newtonian fluids; e.g. mud, cement, blood, paint, polymer solutions. CFD is very useful for these, as their governing equations are usually impossible to solve analytically. The full equations are time-dependent, 3-dimensional, viscous, compressible, non-linear and highly coupled. However, in most cases it is possible to simplify analysis by adopting a reduced equation set. Some common approximations are listed below. Reduction of dimension: • steady-state; • two-dimensional. Neglect of some fluid property: • incompressible; • inviscid. Simplified forces: • hydrostatic; • Boussinesq approximation for density. Approximations based upon averaging: • depth-averaging (shallow-water equations); • Reynolds-averaging (turbulent flows). The consequences of these approximations are examined in the following sections. CFD 3 – 1 David Apsley 3.1 Steady-State vs Time-Dependent Flow Many flows are naturally time-dependent. Examples include waves, tides, turbines, reciprocating pumps and internal combustion engines.
    [Show full text]
  • Incompressible Flow (Page 60): Bernoulli's Equation (Steady
    70 Incompressible flow (page 60): Bernoulli’s equation (steady, inviscid, incompressible): p0 is the stagnation (or total) pressure, constant along a streamline. Pressure tapping in a wall parallel to Pitot tube records the stagnation pressure the flow records static pressure (flow is brought isentropically to rest). IB-ATE-nts10.01.doc 71 Why is the concept of Stagnation Pressure p0 useful in incompressible flow? For steady, inviscid incompressible flow: Although the velocity and pressure have changed, for steady, inviscid, incompressible flow, the stagnation pressure has the same value at points “1” and “2”. IB-ATE-nts10.01.doc 72 Stagnation enthalpy (page 61): The steady flow energy equation: Define the stagnation (or total) enthalpy as: h0 = SFEE becomes: Thus, the stagnation enthalpy only changes when heat or shaft-work are interchanged (it is independent of the local flow velocity, but does depend on the frame of reference). The SFEE is TRUE FOR COMPRESSIBLE AND INCOMPRESSIBLE flow. IB-ATE-nts10.01.doc 73 Stagnation temperature (page 61): For a perfect gas, define the stagnation (or total) temperature T0 as: CpT0 = CpT + SFEE becomes: Stagnation temperature only changes when heat or shaft-work are interchanged. (It is independent of the local flow velocity, but does depend on the frame of reference). This is why, in earlier courses, we have often ignored the KE of the flow in the SFEE. We have actually been using stagnation temperature: T0 is the temperature of the air when brought to rest adiabatically. IB-ATE-nts10.01.doc 74 Stagnation Pressure (page 62): It is possible to define a useful reference pressure, the stagnation (or total) pressure p0 by considering an isentropic deceleration between: physical (static) state with velocity V specified by: T and p and reference stagnation state at zero velocity specified by: T0 and p0 Thus: = Note that for steady flow along a streamline: Stagnation temperature is constant provided there is no heat or work transfer.
    [Show full text]
  • Aerodynamics
    Aerodynamics Basic Aerodynamics Flow with no Flow with friction friction (inviscid) (viscous) Continuity equation (mass conserved) Boundary layer concept Momentum equation Some thermodynamics (F = ma) Laminar boundary layer Energy equation 1. Euler’s equation Turbulent boundary (energy conserved) layer 2. Bernoulli’s equation Equation for Transition from laminar isentropic flow to turbulent flow Flow separation Some Applications Reading: Chapter 4 Recall: Aerodynamic Forces • “Theoretical and experimental aerodynamicists labor to calculate and measure flow fields of many types.” • … because “the aerodynamic force exerted by the airflow on the surface of an airplane, missile, etc., stems from only two simple natural sources: Pressure distribution on the surface (normal to surface) Shear stress (friction) on the surface (tangential to surface) p τw Fundamental Principles • Conservation of mass ⇒ Continuity equation (§§ 4.1-4.2) • Newton’s second law (F = ma) ⇒ Euler’s equation & Bernoulli’s equation (§§ 4.3-4.4) • Conservation of energy ⇒ Energy equation (§§ 4.5-4.7) First: Buoyancy • One way to get lift is through Archimedes’ principle of buoyancy • The buoyancy force acting on an object in a fluid is equal to the weight of the volume of fluid displaced by the object p0-2rρ0g0 • Requires integral p0-ρ0g0(r-r cos θ) (assume ρ0 is constant) p = p0-ρ0g0(r-r cos θ) r Force is θ p dA = [p0-ρ0g0(r-r cos θ)] dA mg dA = 2 π r2 sin θ dθ Increasing altitude Integrate using “shell element” approach p0 Buoyancy: Integration Over Surface of Sphere
    [Show full text]
  • A Class of High-Resolution Algorithms for Incompressible Flows
    A class of high-resolution algorithms for incompressible flows Long Lee Department of Mathematics University of Wyoming Laramie, WY 82071, USA Abstract We present a class of a high-resolution Godunov-type algorithms for solving flow problems governed by the incompressible Navier-Stokes equations. The algorithms use high-resolution finite volume methods developed in SIAM J. Numer. Anal., 33, (1996) 627-665 for the advective terms and finite difference methods for the diffusion and the Poisson pressure equation. The high-resolution algorithm advects the cell-centered velocities using the divergence-free cell edge velocities. The resulting cell-centered velocity is then updated by the solution of the Poisson equation. The algorithms are proven to be robust for constant- density flows at high Reynolds numbers via an example of lid-driven cavity flow. With a slight modification for the projection operator in the constant-density solvers, the algorithms also solve incompressible flows with finite-amplitude density variation. The strength of such algorithms is illustrated through problems like Rayleigh-Taylor instability and the Boussinesq equations for Rayleigh-B´enard convection. Numerical studies of the convergence and order of accuracy for the velocity field are provided. While simulations for two-dimensional regular-geometry problems are presented in this study, in principle, extension of the algorithms to three dimensions with complex geometry is feasible. keywords: high-resolution, finite volume methods, incompressible Navier-Stokes equations, finite-amplitude density variation, lid- driven cavity flow, Rayleigh-Taylor instability, Rayleigh-B´enard convection 1 Introduction Chorin, in a series of papers [7–9] introduced a practical fractional-step method for solving viscous incompress- ible Navier-Stokes equations.
    [Show full text]
  • Chapter 1 Governing Equations of Fluid Flow and Heat Transfer
    ME 582 Finite Element Analysis in Thermofluids Dr. Cüneyt Sert Chapter 1 Governing Equations of Fluid Flow and Heat Transfer Following fundamental laws can be used to derive governing differential equations that are solved in a Computational Fluid Dynamics (CFD) study [1] conservation of mass conservation of linear momentum (Newton's second law) conservation of energy (First law of thermodynamics) In this course we’ll consider the motion of single phase fluids, i.e. either liquid or gas, and we'll treat them as continuum. The three primary unknowns that can be obtained by solving these equations are (actually there are five scalar unknowns if we count the three velocity components separately) velocity vector ⃗ pressure temperature But in the governing equations that we solve numerically following four additional variables appear density enthalpy (or internal energy ) viscosity thermal conductivity Pressure and temperature can be treated as two independent thermodynamic variables that define the equilibrium state of the fluid. Four additional variables listed above are determined in terms of pressure and temperature using tables, charts or additional equations. However, for many problems it is possible to consider , and to be constants and to be proportional to with the proportionally constant being the specific heat . Due to different mathematical characters of governing equations for compressible and incompressible flows, CFD codes are usually written for only one of them. It is not common to find a code that can effectively and accurately work in both compressible and incompressible flow regimes. In the following two sections we'll provide differential forms of the governing equations used to study compressible and incompressible flows.
    [Show full text]
  • Fundamental of Incomp Flow
    Fundamentals of Inviscid, Incompressible Flow Isaac Choutapalli Department of Mechanical Engineering The University of Texas - Pan American Edinburg, TX Introduction We will focus on fundamentals of inviscid, incompressible flow. How low-speed tunnels work Low-speed velocity measurement Flow over streamlined bodies Roadmap Introduction Bernoulli’s Equation Relates pressure and velocity in inviscid and incompressible flow. @u @u @u @u @p ⇢ + u + v + = @t @x @y @z −@x Euler’s Equation: dp = ⇢VdV − 1 p + ⇢V 2 = constant 2 Incompressible Flow in a Duct @ + ⇢V.dS =0 @t ZV ZS @ ⇢d⌫ + ⇢V.dS =0 @t ZV ZS 2(p p ) V = 1 − 2 2 ⇢[1 (A /A )2] s − 2 1 2⇢g∆h V = 2 ⇢[1 (A /A )2] s − 2 1 Measurement of Airspeed The most common device for measuring airspeed is the pitot tube. Static Pressure Pressure is associated with rate of change of momentum of gas molecules impacting/crossing a surface. Pressure clearly related to the random motion of the molecules. Static pressure is a measure of the purely random motion of molecules in a Lagrangian frame of reference When flow moves over point A, the pressure felt is due only to the random motion of the particles - Static pressure. The Pitot-Static Probe 2(p0 p1) V1 = − s ⇢ 1 p + ⇢V 2 = p 1 2 1 0 Static pressure Dynamic pressure Total pressure The Pitot-Static Probe 2(p0 p1) V1 = − s ⇢ 1 p + ⇢V 2 = p 1 2 1 0 Static pressure Dynamic pressure Total pressure Pitot-Static Probe Design The probe should be long, streamlined such that the static pressure over a substantial portion of the probe is equal to free stream static pressure pressure drop as flow expands over nose Pitot-Static Probe Design Pitot-static probes should be located in a position away from influences of local flow field.
    [Show full text]