Parallel spacetime approach to turbulence

Size: px
Start display at page:

Download "Parallel spacetime approach to turbulence"

Transcription

1 Parallel spacetime approach to turbulence Peter V. Coveney1, Bruce M. Boghosian2, 1 1 Luis Fazendeiro, Derek Groen DEISA PRACE Symposium 2011, April , Helsinki, Finland p.v.coveney@ucl.ac.uk Centre for Computational Science, UCL, London, UK 2 Tufts University, Department of Mathematics, Medford, USA 1

2 Contents 1) 2) 3) 4) 5) 6) 7) Navier-Stokes Equations. Unstable Periodic Orbits. Dynamical Zeta Function. HYPO4D ( HYdrodynamic Periodic Orbits in 4D ). Computational aspects. JUGENE optimization work and results. Prospects.

3 1 - Navier-Stokes Equations Claude-Louis Navier ( ) George Gabriel Stokes ( ) Nonlinearity arises directly from the kinematic aspects of the problem. Typical control parameter, Reynolds number: Re ~106 for many common situations; algorithmic complexity scales with Re3. After the onset of turbulence, systems exhibit large fluctuations on many length and time scales. Solution to the 3D NSE (proof of existence and smoothness) still an open problem (Temam, 1984).

4 1 - Navier-Stokes Equations Kolmogorov picture of turbulence: Kolomogorov length: Big whorls have little whorls Which feed on their velocity And little whorls have lesser whorls And so on to viscosity - Lewis F. Richardson Dynamical systems approach: strange attractor is closure of the set of all the UPOs (in the neighbourhood of which the system will spend most of the time). For 2D NSE in the general case: finite-dimensional attracting set (scaling as a power of Re). For 3D NSE: proven with certain assumptions (Constantin, Foias, Temam, 1985).

5 Example of a strange attractor: Lorentz System ρ = Prandtl number σ = Rayleigh number ρ = 28 σ = 10 β = 8/3 Deterministic nonperiodic flow E. N. Lorenz, J. Atmos. Sci (1963) Picture:

6 2 - Unstable Periodic Orbits Role of UPO's has been acknowledged since the work of Poincaré ( founder of modern dynamical systems theory). Typical trajectory will wander incessantly in a sequence of close approaches to the UPOs. Analogy from statistical mechanics in physics: set of UPO's can be viewed as the microstates from which a macroscopic description of the system can be calculated. Accuracy of predictions is limited by the (non-composite) UPO of smaller period which we fail to include. by Cvitanovic et al.

7 2 - Unstable Periodic Orbits Abstract dynamical landscape with peaks representing the UPOs. Chaotic trajectory can be visualized as the motion of a ball rolling on this abstract dynamical landscape. Motion of the ball will be strongly affected by the sharpness of the peak (stability of the UPOs). Relative height of the peaks is related to the natural measure of the indicated UPOs (straight lines are just visual aids in identifying the corresponding cyclic pieces of the period-2 cycles in the diagram). from: Curator: Dr. Paul So, George Mason University, Fairfax, VA

8 2 - Unstable Periodic Orbits In traditional fluid turbulence, observables are computed as averages over many time frames: Alternative approach is using a generating function: Then the moments of the PDF of an observable A are:

9 3 - Dynamical Zeta Function If a sufficient number of UPOs is known, the DZF can be calculated; DZF expression: Generating function: Computation of expectation value:

10 3 - Dynamical Zeta Function Comparison between the two approaches for the Lorenz equations: exact polynomial expansion (left) versus noisy timeintegration (right). B. M. Boghosian et al. Unstable Periodic Orbits in the Lorenz attractor, Phil. Trans. R. Soc. A, 2011 (in press).

11 3 - Dynamical Zeta Function Main advantages of this approach: Degree of accuracy is high and converges quickly, with the number of known lower period UPOs. No need to redo initial value problem every time we wish to compute the average of some quantity. Averages are no longer stochastic in nature: we have an exact expansion to compute them.

12 4 - HYPO4D Kawahara & Kida (2001) found two periodic solutions in plane Couette flow, using spectral methods. Novel efficient variational algorithm to locate UPOs1. Tested on Lorenz model and other low-dimensional systems. Good convergence to the UPOs, including 2D fluid. Plot Δ(t,T): find initial guess (minimum) for whole trajectory, and value of T: Numerically relax minima (in 4D) towards finding UPO (and T). B. M. Boghosian et al. New Variational Principles for Locating Periodic Orbits of Differential Equations, accepted for publication, Phil. Trans. R. Soc. A,

13 4 - HYPO4D (lattice Boltzmann) Fluid flow (nearly incompressible NSE) is simulated using the Lattice Boltzmann Method1,2: S. Chen, G. D. Doolen, Annu. Rev. Fluid Mech., 30, , S. Succi, The LBE for Fluid Dynamics and Beyond, Oxford University Press, Oxford,

14 4 - HYPO4D (lattice Boltzmann) Communication pattern between proceses: only the halo values need to be sent to nearest neighbours = HYPO4D: Linear scaling up to 16K on Ranger (TACC), TG08 scalability award. Main advantages of LBM: Local collision operator + linear streaming operator (nearly embarrassingly parallel). Minimal set of velocities. No need for extra term for extra eq. for pressure term.

15 4 - HYPO4D In the halo-exchange step, all MPI communications are non-blocking, in order to prevent dead-lock. No aggressive optimization pursued, so that code can be (seamlessly) deployed on a great number of platforms. Perfectly linear scaling on the Cray XT5 machine Kraken (NICS, Oak Ridge Lab.), up to 65K cores.

16 4 - HYPO4D Current approach: fluid starts from rest, periodic boundary conditions in all directions (isotropic, homogeneous turbulence), ABC (Arnold-BeltramiChildress) type force1 applied: Numerical stability tests applied at all sites in the lattice at every time step, convergence tests and other quantities measured at regular intervals. After a certain threshold of the Reynolds number, inertia overcomes acceleration and (steady) turbulent behaviour sets in. L. Fazendeiro et al. Unstable Periodic Orbits in Weak Turbulence, JOCS, 1, 13-23,

17 4 HYPO4D: convergence test Cubic lattice, 643, varying LB relaxation time. Maximum Re ~ 500, taking velocity averaged over many time, steps, but DNS, no modeling included. Convergence test for the velocity field, taken between consecutive time steps. Notice sharp increase after inertia of the fluid becomes predominant (vertical axis scale is logarithmic). (L. Fazendeiro et al. Unstable Periodic Orbits in Weak Turbulence, JOCS, 1, 13-23, 2010).

18 4- HYPO4D: locating candidate orbits System is 643, with =0.53, Re=371. Vertical axis is T, horizontal axis is t, color code gives:

19 4- HYPO4D: Locating candidate orbits Detail of previous plot, showing several (purplish) minima/ areas of interest. Sampling rate = 500 (.xdr format for I/O).

20 4 - HYPO4D: Locating candidate orbits (now at fixed time t) Same as before, but this time fixed t, in order to determine optimal T, sampling rate = 1.

21 5 - Computational aspects: spacetime relaxation Memory critical resource for the full 4D relaxation procedure. For T=24.5K, we have to keep in memory at least 643*19 (number of LB velocities)*8(double precision)*2.45*104 variables ~ 1 TB; Then SD=5 copies and CG=8!! Minimization algorithm: Define functional compute gradient: with

22 5 - Computational aspects: spacetime relaxation

23 5 - Computational aspects: spacetime relaxation Left: t=177k, T=26864 orbit, RMS value of F per lattice site = e-05, after 340 SD iterations. Right: t=637k, T=24594 orbit, RMS value of F per lattice site = e-05 after 300 SD iterations.

24 5 - Computational aspects: vorticity field Magnitude of the vorticity field, thresholded, for the t=177k, T=26864 UPO, displaying very structured patterns (perhaps smaller UPOs may be escaping detection...).

25 5 - Computational aspects Memory is the critical resource for the full 4D relaxation procedure. For the minima shown previously, assuming T= 3*104 time steps, we have to load memory 643 x 19 (number of velocities) x 8 (double precision) x 3 x 104 variables ~ 1.2 TB. One single minimization run can take ~1M SUs and more (~24h wall clock time). Thus, very large number of computing cores required (order of T).

26 6 - Optimizing HYPO4D for JUGENE We optimized Hypo4D on several occasions: PRACE early access call, project PRA020, August November 2010 allocation. PRACE Extreme Scaling Workshop 2011 in Juelich. Code optimizations include: Improved halo_exchange. 3x fewer synchronization points, ~3.8x lower bandwidth use. Optimized collective operations. Previous implementation led to performance degradation and crashes on higher core counts.

27 6 - Optimizing HYPO4D for JUGENE Linear scaling up to 256K on JUGENE (IBM BlueGene/P), after the recent optimizations in the collectives and halo_exchange.

28 6 PRACE Early Access results On JUGENE: 17M core hours, with 7 new UPOs (and largest so far). Post-processing work still ongoing. About 15TBytes of data, shipped back to UCL (and US storage facilities) via globus-url-copy. We now possess several UPOs, which may go a long way towards alternative description (via DZF formalism) of turbulent flow.

29 7 - Prospects Further characterization of the turbulent state (energy dissipation rate, vorticity, enstrophy, etc). Relaxation procedure in order to identify prime (smaller period) UPOs in 3D NSE (and make sure we identify all the smallest ones). Implementation of more sophisticated minimization algorithms, using Newton-Krylov solvers and GMRES (maintaining spacetime variational principle).

30 7 - Prospects Ongoing work: new GMRES algorithm, coupled with Poincaré sections (in order to cut down on huge number of variables - LB distribution functions). Goal is to drive the value of the functional even further down (required to compute stability eigenvalues). Poincaré section (extension of HYPO4D) part coupled with PETSc ( package (uses MPI, deployed on very many large resources).

31 7 - Prospects Long-term goal: Compare averages from several UPOs (via DZF) with time forward averaging. Classification of the (prime) UPOs identified + creation and maintenance of a digital library of such orbits. Compute dynamical zeta function for turbulent hydrodynamics!

32 Acknowledgements Special thanks goes out to: PRACE Jülich Supercomputing Centre (JSC) Wolfgang Frings (JSC) Jutta Docter (JSC)

33 Acknowledgements

Parallel spacetime approach to turbulence: computation of unstable periodic orbits and the dynamical zeta function

Parallel spacetime approach to turbulence: computation of unstable periodic orbits and the dynamical zeta function Parallel spacetime approach to turbulence: computation of unstable periodic orbits and the dynamical zeta function Peter V. Coveney 1, Bruce M. Boghosian 2, Luis Fazendeiro 1, Derek Groen 1 Lorentz Center

More information

Unstable Periodic Orbits as a Unifying Principle in the Presentation of Dynamical Systems in the Undergraduate Physics Curriculum

Unstable Periodic Orbits as a Unifying Principle in the Presentation of Dynamical Systems in the Undergraduate Physics Curriculum Unstable Periodic Orbits as a Unifying Principle in the Presentation of Dynamical Systems in the Undergraduate Physics Curriculum Bruce M. Boghosian 1 Hui Tang 1 Aaron Brown 1 Spencer Smith 2 Luis Fazendeiro

More information

Spacetime Computing. A Dynamical Systems Approach to Turbulence. Bruce M. Boghosian. Department of Mathematics, Tufts University

Spacetime Computing. A Dynamical Systems Approach to Turbulence. Bruce M. Boghosian. Department of Mathematics, Tufts University Spacetime Computing A Dynamical Systems Approach to Turbulence Bruce M. Boghosian, Tufts University Presented at 3rd NA-HPC Roadmap Workshop, Royal Society, London January 26, 2009 Acknowledgements: Hui

More information

J. Szantyr Lecture No. 4 Principles of the Turbulent Flow Theory The phenomenon of two markedly different types of flow, namely laminar and

J. Szantyr Lecture No. 4 Principles of the Turbulent Flow Theory The phenomenon of two markedly different types of flow, namely laminar and J. Szantyr Lecture No. 4 Principles of the Turbulent Flow Theory The phenomenon of two markedly different types of flow, namely laminar and turbulent, was discovered by Osborne Reynolds (184 191) in 1883

More information

Nonequilibrium Dynamics in Astrophysics and Material Science YITP, Kyoto

Nonequilibrium Dynamics in Astrophysics and Material Science YITP, Kyoto Nonequilibrium Dynamics in Astrophysics and Material Science 2011-11-02 @ YITP, Kyoto Multi-scale coherent structures and their role in the Richardson cascade of turbulence Susumu Goto (Okayama Univ.)

More information

What is Turbulence? Fabian Waleffe. Depts of Mathematics and Engineering Physics University of Wisconsin, Madison

What is Turbulence? Fabian Waleffe. Depts of Mathematics and Engineering Physics University of Wisconsin, Madison What is Turbulence? Fabian Waleffe Depts of Mathematics and Engineering Physics University of Wisconsin, Madison it s all around,... and inside us! Leonardo da Vinci (c. 1500) River flow, pipe flow, flow

More information

Local flow structure and Reynolds number dependence of Lagrangian statistics in DNS of homogeneous turbulence. P. K. Yeung

Local flow structure and Reynolds number dependence of Lagrangian statistics in DNS of homogeneous turbulence. P. K. Yeung Local flow structure and Reynolds number dependence of Lagrangian statistics in DNS of homogeneous turbulence P. K. Yeung Georgia Tech, USA; E-mail: pk.yeung@ae.gatech.edu B.L. Sawford (Monash, Australia);

More information

Concentration and segregation of particles and bubbles by turbulence : a numerical investigation

Concentration and segregation of particles and bubbles by turbulence : a numerical investigation Concentration and segregation of particles and bubbles by turbulence : a numerical investigation Enrico Calzavarini Physics of Fluids Group University of Twente The Netherlands with Massimo Cencini CNR-ISC

More information

Single Curved Fiber Sedimentation Under Gravity. Xiaoying Rong, Dewei Qi Western Michigan University

Single Curved Fiber Sedimentation Under Gravity. Xiaoying Rong, Dewei Qi Western Michigan University Single Curved Fiber Sedimentation Under Gravity Xiaoying Rong, Dewei Qi Western Michigan University JunYong Zhu, Tim Scott USDA Forest Products Laboratory ABSTRACT Dynamics of single curved fiber sedimentation

More information

Tutorial School on Fluid Dynamics: Aspects of Turbulence Session I: Refresher Material Instructor: James Wallace

Tutorial School on Fluid Dynamics: Aspects of Turbulence Session I: Refresher Material Instructor: James Wallace Tutorial School on Fluid Dynamics: Aspects of Turbulence Session I: Refresher Material Instructor: James Wallace Adapted from Publisher: John S. Wiley & Sons 2002 Center for Scientific Computation and

More information

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations 1 / 16 Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas Simon Fraser University April 7, 2011 2 / 16 Ludwig Boltzmann and His Kinetic Theory of Gases The Boltzmann Transport

More information

Project Topic. Simulation of turbulent flow laden with finite-size particles using LBM. Leila Jahanshaloo

Project Topic. Simulation of turbulent flow laden with finite-size particles using LBM. Leila Jahanshaloo Project Topic Simulation of turbulent flow laden with finite-size particles using LBM Leila Jahanshaloo Project Details Turbulent flow modeling Lattice Boltzmann Method All I know about my project Solid-liquid

More information

Shear Turbulence. Fabian Waleffe. Depts. of Mathematics and Engineering Physics. Wisconsin

Shear Turbulence. Fabian Waleffe. Depts. of Mathematics and Engineering Physics. Wisconsin Shear Turbulence Fabian Waleffe Depts. of Mathematics and Engineering Physics, Madison University of Wisconsin Mini-Symposium on Subcritical Flow Instability for training of early stage researchers Mini-Symposium

More information

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow DOE-FIU SCIENCE & TECHNOLOGY WORKFORCE DEVELOPMENT PROGRAM STUDENT SUMMER INTERNSHIP TECHNICAL REPORT June 4, 2012 to August 10, 2012 Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver

More information

AER1310: TURBULENCE MODELLING 1. Introduction to Turbulent Flows C. P. T. Groth c Oxford Dictionary: disturbance, commotion, varying irregularly

AER1310: TURBULENCE MODELLING 1. Introduction to Turbulent Flows C. P. T. Groth c Oxford Dictionary: disturbance, commotion, varying irregularly 1. Introduction to Turbulent Flows Coverage of this section: Definition of Turbulence Features of Turbulent Flows Numerical Modelling Challenges History of Turbulence Modelling 1 1.1 Definition of Turbulence

More information

Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows

Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows Remark 7.1. Turbulent flows. The usually used model for turbulent incompressible flows are the incompressible Navier Stokes equations

More information

Simulation of 2D non-isothermal flows in slits using lattice Boltzmann method

Simulation of 2D non-isothermal flows in slits using lattice Boltzmann method Simulation of 2D non-isothermal flows in slits using lattice Boltzmann method João Chambel Leitão Department of Mechanical Engineering, Instituto Superior Técnico, Lisboa, Portugal Abstract: The present

More information

Before we consider two canonical turbulent flows we need a general description of turbulence.

Before we consider two canonical turbulent flows we need a general description of turbulence. Chapter 2 Canonical Turbulent Flows Before we consider two canonical turbulent flows we need a general description of turbulence. 2.1 A Brief Introduction to Turbulence One way of looking at turbulent

More information

DNS of the Taylor-Green vortex at Re=1600

DNS of the Taylor-Green vortex at Re=1600 DNS of the Taylor-Green vortex at Re=1600 Koen Hillewaert, Cenaero Corentin Carton de Wiart, NASA Ames koen.hillewaert@cenaero.be, corentin.carton@cenaero.be Introduction This problem is aimed at testing

More information

OPTIMIZATION OF HEAT TRANSFER ENHANCEMENT IN PLANE COUETTE FLOW

OPTIMIZATION OF HEAT TRANSFER ENHANCEMENT IN PLANE COUETTE FLOW OPTIMIZATION OF HEAT TRANSFER ENHANCEMENT IN PLANE COUETTE FLOW Shingo Motoki, Genta Kawahara and Masaki Shimizu Graduate School of Engineering Science Osaka University 1-3 Machikaneyama, Toyonaka, Osaka

More information

Large Scale High Resolution Blood Flow Simulations

Large Scale High Resolution Blood Flow Simulations Large Scale High Resolution Blood Flow Simulations Florian Janoschek Jens Harting Federico Toschi Department of Applied Physics, Eindhoven University of Technology, The Netherlands Institute for Computational

More information

Turbulence Instability

Turbulence Instability Turbulence Instability 1) All flows become unstable above a certain Reynolds number. 2) At low Reynolds numbers flows are laminar. 3) For high Reynolds numbers flows are turbulent. 4) The transition occurs

More information

nek5000 massively parallel spectral element simulations

nek5000 massively parallel spectral element simulations nek5000 massively parallel spectral element simulations PRACE Scientific Seminar HPC Boosts Science, 22th February 2011 P. Schlatter & D. S. Henningson Linné Flow Centre, KTH Mechanics Fluid flows Tornado,

More information

Computational Fluid Dynamics 2

Computational Fluid Dynamics 2 Seite 1 Introduction Computational Fluid Dynamics 11.07.2016 Computational Fluid Dynamics 2 Turbulence effects and Particle transport Martin Pietsch Computational Biomechanics Summer Term 2016 Seite 2

More information

Strategy in modelling irregular shaped particle behaviour in confined turbulent flows

Strategy in modelling irregular shaped particle behaviour in confined turbulent flows Title Strategy in modelling irregular shaped particle behaviour in confined turbulent flows M. Sommerfeld F L Mechanische Verfahrenstechnik Zentrum Ingenieurwissenschaften 699 Halle (Saale), Germany www-mvt.iw.uni-halle.de

More information

over the last few years the tantalizing

over the last few years the tantalizing Discrete Fluids over the last few years the tantalizing prospect of being able to perform hydrodynamic calculations orders-of-magnitude faster than present methods allow has prompted considerable interest

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

Direct numerical simulation of interfacial instability in gas-liquid flows

Direct numerical simulation of interfacial instability in gas-liquid flows Direct numerical simulation of interfacial instability in gas-liquid flows Iain Bethune 1, Lennon Ó Náraigh 2, David Scott 1, Peter Spelt 3,4, Prashant Valluri 5, Zlatko Solomenko 3 1 Edinburgh Parallel

More information

dynamical zeta functions: what, why and what are the good for?

dynamical zeta functions: what, why and what are the good for? dynamical zeta functions: what, why and what are the good for? Predrag Cvitanović Georgia Institute of Technology November 2 2011 life is intractable in physics, no problem is tractable I accept chaos

More information

CVS filtering to study turbulent mixing

CVS filtering to study turbulent mixing CVS filtering to study turbulent mixing Marie Farge, LMD-CNRS, ENS, Paris Kai Schneider, CMI, Université de Provence, Marseille Carsten Beta, LMD-CNRS, ENS, Paris Jori Ruppert-Felsot, LMD-CNRS, ENS, Paris

More information

Turbulence. 2. Reynolds number is an indicator for turbulence in a fluid stream

Turbulence. 2. Reynolds number is an indicator for turbulence in a fluid stream Turbulence injection of a water jet into a water tank Reynolds number EF$ 1. There is no clear definition and range of turbulence (multi-scale phenomena) 2. Reynolds number is an indicator for turbulence

More information

Lattice Boltzmann Modeling of Wave Propagation and Reflection in the Presence of Walls and Blocks

Lattice Boltzmann Modeling of Wave Propagation and Reflection in the Presence of Walls and Blocks Lattice Boltzmann Modeling of Wave Propagation and Reflection in the Presence of Walls and Blocs Maysam Saidi, Hassan Basirat Tabrizi, Member, IAENG, and Reza Sepahi Samian Abstract Lattice Boltzmann method

More information

Lattice Boltzmann model for the Elder problem

Lattice Boltzmann model for the Elder problem 1549 Lattice Boltzmann model for the Elder problem D.T. Thorne a and M.C. Sukop a a Department of Earth Sciences, Florida International University, PC 344, University Park, 11200 SW 8th Street, Miami,

More information

Energy spectrum in the dissipation range of fluid turbulence

Energy spectrum in the dissipation range of fluid turbulence J. Plasma Physics (1997), vol. 57, part 1, pp. 195 201 Copyright 1997 Cambridge University Press 195 Energy spectrum in the dissipation range of fluid turbulence D. O. MARTI NEZ,,, S. CHEN,, G. D. DOOLEN,

More information

The Johns Hopkins Turbulence Databases (JHTDB)

The Johns Hopkins Turbulence Databases (JHTDB) The Johns Hopkins Turbulence Databases (JHTDB) HOMOGENEOUS BUOYANCY DRIVEN TURBULENCE DATA SET Data provenance: D. Livescu 1 Database Ingest and Web Services: C. Canada 1, K. Kalin 2, R. Burns 2 & IDIES

More information

Computer simulations of fluid dynamics. Lecture 11 LBM: Algorithm for BGK Maciej Matyka

Computer simulations of fluid dynamics. Lecture 11 LBM: Algorithm for BGK Maciej Matyka Computer simulations of fluid dynamics Lecture 11 LBM: Algorithm for BGK Maciej Matyka https://www.youtube.com/watch? v=vluyp_ydfjc https://youtu.be/cj52zpggka (789 citations) Lecture goal l l Give a complete

More information

Drag Force Simulations of Particle Agglomerates with the Lattice-Boltzmann Method

Drag Force Simulations of Particle Agglomerates with the Lattice-Boltzmann Method Drag Force Simulations of Particle Agglomerates with the Lattice-Boltzmann Method Christian Feichtinger, Nils Thuerey, Ulrich Ruede Christian Binder, Hans-Joachim Schmid, Wolfgang Peukert Friedrich-Alexander-Universität

More information

LATTICE BOLTZMANN SIMULATION OF FLUID FLOW IN A LID DRIVEN CAVITY

LATTICE BOLTZMANN SIMULATION OF FLUID FLOW IN A LID DRIVEN CAVITY LATTICE BOLTZMANN SIMULATION OF FLUID FLOW IN A LID DRIVEN CAVITY M. Y. Gokhale, Ignatius Fernandes Maharashtra Institute of Technology, Pune 4 38, India University of Pune, India Email : mukundyg@yahoo.co.in,

More information

PHYSFLU - Physics of Fluids

PHYSFLU - Physics of Fluids Coordinating unit: 230 - ETSETB - Barcelona School of Telecommunications Engineering Teaching unit: 748 - FIS - Department of Physics Academic year: Degree: 2018 BACHELOR'S DEGREE IN ENGINEERING PHYSICS

More information

Andrés Santos Universidad de Extremadura, Badajoz (Spain)

Andrés Santos Universidad de Extremadura, Badajoz (Spain) Andrés Santos Universidad de Extremadura, Badajoz (Spain) Outline Moment equations molecules for Maxwell Some solvable states: Planar Fourier flow Planar Fourier flow with gravity Planar Couette flow Force-driven

More information

A Solution Method for the Reynolds-Averaged Navier-Stokes Equation

A Solution Method for the Reynolds-Averaged Navier-Stokes Equation A Solution Method for the Reynolds-Averaged Navier-Stokes Equation T.-W. Lee Mechanical and Aerospace Engineering, Arizona State University, Tempe, AZ, 8587 Abstract- Navier-Stokes equations are difficult

More information

2.3 The Turbulent Flat Plate Boundary Layer

2.3 The Turbulent Flat Plate Boundary Layer Canonical Turbulent Flows 19 2.3 The Turbulent Flat Plate Boundary Layer The turbulent flat plate boundary layer (BL) is a particular case of the general class of flows known as boundary layer flows. The

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Introduction to Turbulence AEEM Why study turbulent flows?

Introduction to Turbulence AEEM Why study turbulent flows? Introduction to Turbulence AEEM 7063-003 Dr. Peter J. Disimile UC-FEST Department of Aerospace Engineering Peter.disimile@uc.edu Intro to Turbulence: C1A Why 1 Most flows encountered in engineering and

More information

APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD

APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD Guillermo Izquierdo Bouldstridge Imperial College of London Department of Aeronautics Master s Thesis Supervisor: Dr. Joaquim Peiró September

More information

Acceleration of Time Integration

Acceleration of Time Integration Acceleration of Time Integration edited version, with extra images removed Rick Archibald, John Drake, Kate Evans, Doug Kothe, Trey White, Pat Worley Research sponsored by the Laboratory Directed Research

More information

A new statistical tool to study the geometry of intense vorticity clusters in turbulence

A new statistical tool to study the geometry of intense vorticity clusters in turbulence Journal of Physics: Conference Series PAPER OPEN ACCESS A new statistical tool to study the geometry of intense vorticity clusters in turbulence To cite this article: Alberto Vela-Martin and Takashi Ishihara

More information

Lattice Bhatnagar Gross Krook model for the Lorenz attractor

Lattice Bhatnagar Gross Krook model for the Lorenz attractor Physica D 154 (2001) 43 50 Lattice Bhatnagar Gross Krook model for the Lorenz attractor Guangwu Yan a,b,,liyuan a a LSEC, Institute of Computational Mathematics, Academy of Mathematics and System Sciences,

More information

Massively parallel molecular-continuum simulations with the macro-micro-coupling tool Neumann, P.; Harting, J.D.R.

Massively parallel molecular-continuum simulations with the macro-micro-coupling tool Neumann, P.; Harting, J.D.R. Massively parallel molecular-continuum simulations with the macro-micro-coupling tool Neumann, P.; Harting, J.D.R. Published in: Hybrid particle-continuum methods in computational materials physics, 4-7

More information

The Reynolds experiment

The Reynolds experiment Chapter 13 The Reynolds experiment 13.1 Laminar and turbulent flows Let us consider a horizontal pipe of circular section of infinite extension subject to a constant pressure gradient (see section [10.4]).

More information

ZFS - Flow Solver AIA NVIDIA Workshop

ZFS - Flow Solver AIA NVIDIA Workshop ZFS - Flow Solver AIA NVIDIA Workshop Andreas Lintermann, Matthias Meinke, Wolfgang Schröder Institute of Aerodynamics and Chair of Fluid Mechanics RWTH Aachen University Outline Softwareproject ZFS (applications

More information

Course 1 : basic concepts. Pierre Simon de Laplace (1814), in his book Essai Philosophique sur les Probabilités (Philosophical Essay on Probability):

Course 1 : basic concepts. Pierre Simon de Laplace (1814), in his book Essai Philosophique sur les Probabilités (Philosophical Essay on Probability): Course 1 : basic concepts Pierre Simon de Laplace (1814), in his book Essai Philosophique sur les Probabilités (Philosophical Essay on Probability): We must consider the present state of Universe as the

More information

Lecture 4: The Navier-Stokes Equations: Turbulence

Lecture 4: The Navier-Stokes Equations: Turbulence Lecture 4: The Navier-Stokes Equations: Turbulence September 23, 2015 1 Goal In this Lecture, we shall present the main ideas behind the simulation of fluid turbulence. We firts discuss the case of the

More information

On pressure and velocity boundary conditions for the lattice Boltzmann BGK model

On pressure and velocity boundary conditions for the lattice Boltzmann BGK model On pressure and velocity boundary conditions for the lattice Boltzmann BGK model Qisu Zou Theoretical Division, Los Alamos National Lab, Los Alamos, New Mexico 7545 and Department of Mathematics, Kansas

More information

B.1 NAVIER STOKES EQUATION AND REYNOLDS NUMBER. = UL ν. Re = U ρ f L μ

B.1 NAVIER STOKES EQUATION AND REYNOLDS NUMBER. = UL ν. Re = U ρ f L μ APPENDIX B FLUID DYNAMICS This section is a brief introduction to fluid dynamics. Historically, a simplified concept of the boundary layer, the unstirred water layer, has been operationally used in the

More information

arxiv:comp-gas/ v1 28 Apr 1993

arxiv:comp-gas/ v1 28 Apr 1993 Lattice Boltzmann Thermohydrodynamics arxiv:comp-gas/9304006v1 28 Apr 1993 F. J. Alexander, S. Chen and J. D. Sterling Center for Nonlinear Studies and Theoretical Division Los Alamos National Laboratory

More information

Fundamentals of Turbulence

Fundamentals of Turbulence Fundamentals of Turbulence Stanislav Boldyrev (University of Wisconsin - Madison) Center for Magnetic Self-Organization in Laboratory and Astrophysical Plasmas What is turbulence? No exact definition.

More information

Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method

Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method 10 th World Congress on Structural and Multidisciplinary Optimization May 19-24, 2013, Orlando, Florida, USA Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Turbulence: Basic Physics and Engineering Modeling

Turbulence: Basic Physics and Engineering Modeling DEPARTMENT OF ENERGETICS Turbulence: Basic Physics and Engineering Modeling Numerical Heat Transfer Pietro Asinari, PhD Spring 2007, TOP UIC Program: The Master of Science Degree of the University of Illinois

More information

Buoyancy Fluxes in a Stratified Fluid

Buoyancy Fluxes in a Stratified Fluid 27 Buoyancy Fluxes in a Stratified Fluid G. N. Ivey, J. Imberger and J. R. Koseff Abstract Direct numerical simulations of the time evolution of homogeneous stably stratified shear flows have been performed

More information

arxiv: v1 [physics.flu-dyn] 16 Nov 2018

arxiv: v1 [physics.flu-dyn] 16 Nov 2018 Turbulence collapses at a threshold particle loading in a dilute particle-gas suspension. V. Kumaran, 1 P. Muramalla, 2 A. Tyagi, 1 and P. S. Goswami 2 arxiv:1811.06694v1 [physics.flu-dyn] 16 Nov 2018

More information

Turbulence Laboratory

Turbulence Laboratory Objective: CE 319F Elementary Mechanics of Fluids Department of Civil, Architectural and Environmental Engineering The University of Texas at Austin Turbulence Laboratory The objective of this laboratory

More information

LES of Turbulent Flows: Lecture 3

LES of Turbulent Flows: Lecture 3 LES of Turbulent Flows: Lecture 3 Dr. Jeremy A. Gibbs Department of Mechanical Engineering University of Utah Fall 2016 1 / 53 Overview 1 Website for those auditing 2 Turbulence Scales 3 Fourier transforms

More information

Gyrotactic Trapping in Laminar and Turbulent shear flow

Gyrotactic Trapping in Laminar and Turbulent shear flow Gyrotactic Trapping in Laminar and Turbulent shear flow Filippo De Lillo, Guido Boffetta, Francesco Santamaria Dipartimento di Fisica and INFN, Università di Torino Massimo Cencini ISC-CNR Rome Gyrotactic

More information

VERTICAL TURBULENT BUOYANT HELIUM JET CFD MODELING AND VALIDATION

VERTICAL TURBULENT BUOYANT HELIUM JET CFD MODELING AND VALIDATION VERTICAL TURBULENT BUOYANT HELIUM JET CFD MODELING AND VALIDATION Cheng Z, Agranat V.M. and Tchouvelev A.V. A.V.Tchouvelev & Associates, Inc., 659 Spinnaker Circle, Mississauga, Ontario, Canada L5W R Hydrogenics

More information

A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries

A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries SC13, November 21 st 2013 Christian Godenschwager, Florian Schornbaum, Martin Bauer, Harald Köstler, Ulrich

More information

Statistical studies of turbulent flows: self-similarity, intermittency, and structure visualization

Statistical studies of turbulent flows: self-similarity, intermittency, and structure visualization Statistical studies of turbulent flows: self-similarity, intermittency, and structure visualization P.D. Mininni Departamento de Física, FCEyN, UBA and CONICET, Argentina and National Center for Atmospheric

More information

Kinematic and dynamic pair collision statistics of sedimenting inertial particles relevant to warm rain initiation

Kinematic and dynamic pair collision statistics of sedimenting inertial particles relevant to warm rain initiation Kinematic and dynamic pair collision statistics of sedimenting inertial particles relevant to warm rain initiation Bogdan Rosa 1, Hossein Parishani 2, Orlando Ayala 2, Lian-Ping Wang 2 & Wojciech W. Grabowski

More information

Lattice Boltzmann Method

Lattice Boltzmann Method 3 Lattice Boltzmann Method 3.1 Introduction The lattice Boltzmann method is a discrete computational method based upon the lattice gas automata - a simplified, fictitious molecular model. It consists of

More information

Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows

Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows Amir Eshghinejadfard, Abouelmagd Abdelsamie, Dominique Thévenin University of Magdeburg, Germany 14th Workshop on Two-Phase Flow Predictions

More information

Application of the Lattice-Boltzmann method in flow acoustics

Application of the Lattice-Boltzmann method in flow acoustics Application of the Lattice-Boltzmann method in flow acoustics Andreas Wilde Fraunhofer Institut für Integrierte Schaltungen, Außenstelle EAS Zeunerstr. 38, 01069 Dresden Abstract The Lattice-Boltzmann

More information

Research of Micro-Rectangular-Channel Flow Based on Lattice Boltzmann Method

Research of Micro-Rectangular-Channel Flow Based on Lattice Boltzmann Method Research Journal of Applied Sciences, Engineering and Technology 6(14): 50-55, 013 ISSN: 040-7459; e-issn: 040-7467 Maxwell Scientific Organization, 013 Submitted: November 08, 01 Accepted: December 8,

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

Simulation Study on the Generation and Distortion Process of the Geomagnetic Field in Earth-like Conditions

Simulation Study on the Generation and Distortion Process of the Geomagnetic Field in Earth-like Conditions Chapter 1 Earth Science Simulation Study on the Generation and Distortion Process of the Geomagnetic Field in Earth-like Conditions Project Representative Yozo Hamano Authors Ataru Sakuraba Yusuke Oishi

More information

MOMENTUM TRANSPORT Velocity Distributions in Turbulent Flow

MOMENTUM TRANSPORT Velocity Distributions in Turbulent Flow TRANSPORT PHENOMENA MOMENTUM TRANSPORT Velocity Distributions in Turbulent Flow Introduction to Turbulent Flow 1. Comparisons of laminar and turbulent flows 2. Time-smoothed equations of change for incompressible

More information

Turbulent drag reduction by streamwise traveling waves

Turbulent drag reduction by streamwise traveling waves 51st IEEE Conference on Decision and Control December 10-13, 2012. Maui, Hawaii, USA Turbulent drag reduction by streamwise traveling waves Armin Zare, Binh K. Lieu, and Mihailo R. Jovanović Abstract For

More information

A two-fluid model of turbulent two-phase flow for simulating turbulent stratified flows

A two-fluid model of turbulent two-phase flow for simulating turbulent stratified flows Ocean Engineering 30 (2003) 153 161 www.elsevier.com/locate/oceaneng A two-fluid model of turbulent two-phase flow for simulating turbulent stratified flows Y.M. Shen a,, C.-O. Ng b, A.T. Chwang b a State

More information

Regularity diagnostics applied to a turbulent boundary layer

Regularity diagnostics applied to a turbulent boundary layer Center for Turbulence Research Proceedings of the Summer Program 208 247 Regularity diagnostics applied to a turbulent boundary layer By H. J. Bae, J. D. Gibbon, R. M. Kerr AND A. Lozano-Durán Regularity

More information

ME EN 3700: FLUID MECHANICS (Fall 2003)

ME EN 3700: FLUID MECHANICS (Fall 2003) ME EN 3700: FLUID MECHANICS (Fall 2003) Lecturer: Eric R. Pardyjak Lecture: MTWThF 7:30am - 8:20am Room 104 EMCB Office Hours: (9:00am - 10:30am M W F, Room 169 KEN Website: http://www.mech.utah.edu/~pardyjak/

More information

Max Planck Institut für Plasmaphysik

Max Planck Institut für Plasmaphysik ASDEX Upgrade Max Planck Institut für Plasmaphysik 2D Fluid Turbulence Florian Merz Seminar on Turbulence, 08.09.05 2D turbulence? strictly speaking, there are no two-dimensional flows in nature approximately

More information

Chapter 8 Flow in Conduits

Chapter 8 Flow in Conduits 57:00 Mechanics of Fluids and Transport Processes Chapter 8 Professor Fred Stern Fall 013 1 Chapter 8 Flow in Conduits Entrance and developed flows Le = f(d, V,, ) i theorem Le/D = f(re) Laminar flow:

More information

Numerical Investigation of Fluid and Thermal Flow in a Differentially Heated Side Enclosure walls at Various Inclination Angles

Numerical Investigation of Fluid and Thermal Flow in a Differentially Heated Side Enclosure walls at Various Inclination Angles Numerical Investigation of Fluid and Thermal Flow in a Differentially Heated Side Enclosure walls at Various Inclination Angles O. A. SHAHRUL Faculty of Mechanical & Manufacturing Engineering Universiti

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

Study on lattice Boltzmann method/ large eddy simulation and its application at high Reynolds number flow

Study on lattice Boltzmann method/ large eddy simulation and its application at high Reynolds number flow Research Article Study on lattice Boltzmann method/ large eddy simulation and its application at high Reynolds number flow Advances in Mechanical Engineering 1 8 Ó The Author(s) 2015 DOI: 10.1177/1687814015573829

More information

The Turbulent Rotational Phase Separator

The Turbulent Rotational Phase Separator The Turbulent Rotational Phase Separator J.G.M. Kuerten and B.P.M. van Esch Dept. of Mechanical Engineering, Technische Universiteit Eindhoven, The Netherlands j.g.m.kuerten@tue.nl Summary. The Rotational

More information

Modeling of turbulence in stirred vessels using large eddy simulation

Modeling of turbulence in stirred vessels using large eddy simulation Modeling of turbulence in stirred vessels using large eddy simulation André Bakker (presenter), Kumar Dhanasekharan, Ahmad Haidari, and Sung-Eun Kim Fluent Inc. Presented at CHISA 2002 August 25-29, Prague,

More information

Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue

Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue 11 Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue Yang GUO*, Chisachi KATO** and Yoshinobu YAMADE*** 1 FrontFlow/Blue 1) is a general-purpose finite element program that calculates

More information

Lecture 6. Lorenz equations and Malkus' waterwheel Some properties of the Lorenz Eq.'s Lorenz Map Towards definitions of:

Lecture 6. Lorenz equations and Malkus' waterwheel Some properties of the Lorenz Eq.'s Lorenz Map Towards definitions of: Lecture 6 Chaos Lorenz equations and Malkus' waterwheel Some properties of the Lorenz Eq.'s Lorenz Map Towards definitions of: Chaos, Attractors and strange attractors Transient chaos Lorenz Equations

More information

Direct Numerical Simulations of converging-diverging channel flow

Direct Numerical Simulations of converging-diverging channel flow Intro Numerical code Results Conclusion Direct Numerical Simulations of converging-diverging channel flow J.-P. Laval (1), M. Marquillie (1) Jean-Philippe.Laval@univ-lille1.fr (1) Laboratoire de Me canique

More information

Of The Navier Stokes Equations Nar Associates

Of The Navier Stokes Equations Nar Associates 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, you have convenient answers with of the navier stokes

More information

SIMULATION OF MIXED CONVECTIVE HEAT TRANSFER USING LATTICE BOLTZMANN METHOD

SIMULATION OF MIXED CONVECTIVE HEAT TRANSFER USING LATTICE BOLTZMANN METHOD International Journal of Automotive and Mechanical Engineering (IJAME) ISSN: 2229-8649 (Print); ISSN: 2180-1606 (Online); Volume 2, pp. 130-143, July-December 2010 Universiti Malaysia Pahang DOI: http://dx.doi.org/10.15282/ijame.2.2010.3.0011

More information

OE4625 Dredge Pumps and Slurry Transport. Vaclav Matousek October 13, 2004

OE4625 Dredge Pumps and Slurry Transport. Vaclav Matousek October 13, 2004 OE465 Vaclav Matousek October 13, 004 1 Dredge Vermelding Pumps onderdeel and Slurry organisatie Transport OE465 Vaclav Matousek October 13, 004 Dredge Vermelding Pumps onderdeel and Slurry organisatie

More information

Coherent structures in stably stratified plane Couette flow

Coherent structures in stably stratified plane Couette flow Coherent structures in stably stratified plane Couette flow D. Olvera * & R. R. Kerswell School of Mathematics, University of Bristol, Bristol, UK. * do2542@bristol.ac.uk Abstract A large body of recent

More information

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

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods 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

More information

Anovel type of continuous mixing system is shown in

Anovel type of continuous mixing system is shown in Mixing in an Agitated Tubular Reactor J. J. Derksen* School of Engineering, University of Aberdeen, Aberdeen, UK We analyze, through numerical simulations, the single-phase liquid flow and associated passive

More information

5.1 2D example 59 Figure 5.1: Parabolic velocity field in a straight two-dimensional pipe. Figure 5.2: Concentration on the input boundary of the pipe. The vertical axis corresponds to r 2 -coordinate,

More information

Using Statistical State Dynamics to Study the Mechanism of Wall-Turbulence

Using Statistical State Dynamics to Study the Mechanism of Wall-Turbulence Using Statistical State Dynamics to Study the Mechanism of Wall-Turbulence Brian Farrell Harvard University Cambridge, MA IPAM Turbulence Workshop UCLA November 19, 2014 thanks to: Petros Ioannou, Dennice

More information

Turbulence and transport

Turbulence and transport and transport ` is the most important unsolved problem of classical physics.' - Richard Feynman - Da Vinci 14521519 Image: General Atomics Reynolds, Richardson, Kolmogorov Dr Ben Dudson, University of

More information

Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel

Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel Commun. Theor. Phys. 56 (2011) 756 760 Vol. 56, No. 4, October 15, 2011 Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel QIU Bing ( ), 1, TAN Hui-Li ( Û), 2 and

More information