ZFS - Flow Solver AIA NVIDIA Workshop

Size: px
Start display at page:

Download "ZFS - Flow Solver AIA NVIDIA Workshop"

Transcription

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

2 Outline Softwareproject ZFS (applications at the AIA) Structure of ZFS Computational hotspots in ZFS Scalability The future of ZFS Summary, Conclusion, and Questions

3 Softwareproject ZFS ZFS (C++) Two major flow solvers Finite-Volume solver Lattice-Boltzmann solver

4 3D-Engine Flows within the Cluster of Excellence: TMFB Unsteady 3D simulation of engine flow full DNS requires 3.0 x 10⁹ cells simulations are performed on HPC systems valves combustion chamber refinement based on Level-Set

5 Level-Set Method Representation of surfaces by zero contour 0 of a signed distance function (x, t) Level-Set representation of an engine valve Solve Level-Set equation: t +f =0 body velocity Hartmann et al., J. Comput Phys., 227: , 2008; Hartmann et al., J. Comput. Phys., 229: , 2010; Hartmann et al., Combust. Flame, 158: , 2010

6 Level-Sets and Solution-Adaptive Refinement Schneiders et al., An accurate moving boundary formulation in cut-cell, method, submitted to J. Comput Phys. Sensor: Level-Set Sensors: Entropy, Vorticity Oscillating 2D-Cylinder flow, Re=180 Solution-Adaptive Refinement

7 Simulation of Particle Transport Atmospheric Research: droplet formation in clouds particle transport, collision and coagulation Combustion: heat conduction transport and collision of coal particles particle distribution important for combustion efficiency Aims: Simulation of O(1000) particles in a turbulent flow (full DNS)

8 SFB Combustion Flame Front Propagation:

9 SFB Combustion Flame Front Propagation: Level-Set and G₀-Band

10 COupled PArallel Simulation of Gas Turbines (COPA-GT) Full simulation of all components of a jet engine Development of fully coupled tools Aeroacoustic field prediction of an engine jet our aim: noise reduction Velocity gradients of a jet at Re=3600

11 Nasal cavity flows Major goals: analysis of the respiratory capability (pressure loss) analysis of the olfactory capability (streamline analysis) analysis of the heating capability (temperature difference) analysis of the humidification capability (particle retention times) warped septum left paranasal sinus left nostril swollen center turbinate warped septum right nostril swollen inferior turbinate right paranasal sinus swollen inferior turbinate CT-data of the human head pharynx Surface of the human nasal cavity

12 Nasal cavity flows velocity [m/s] septum bending and channel convergence cause acceleration flow is split by inferior and center turbinate converging channel swollen inferior and center turbinate bended septum channel mixing zone left nostril right nostril cavity mixing zone swollen inferior and center turbinate cavity mixing zone acceleration in pharynx right nostril flow is split by inferior turbinate acceleration in pharynx small opening below inferior turbinate acceleration of flow left nostril pharynx pharynx

13 Flow in the human airways Major goals: Basic understanding of the flow in the human lungs: analysis of the respiration process analysis of particle transport Understanding COPD (Chronic Obstructive Lung Disease) particle deposition during exhalation Analysis of Diesel aerosol deposition particle deposition during inhalation

14 Flow in the human lungs

15 Particle transport in the upper human airways First approach: analyze particle transport and deposition in pipes Particle simulation in a bended pipe, Re=1200

16 Structure of ZFS ZFS (C++) Cartesian Grid generator grid refinement BCs Initialization BCs Moving Boundaries BGK-model Finite-Volume solver Lattice-Boltzmann solver Combustion model Particle-Tracing Thermal model Turbulence model Level-Set solver Output Postprocessing

17 Computational hotspots in LBM Solve the Lattice-BGK equation: f i ( x + i t, t + t) =f i ( x, t)+ t (f eq i ( x, t) f i ( x, t)) Loop over all cells: collision step propagation step Lattice-Boltzmann solver iteration loop Collision step 1st BC Loop over BC cells: 1st and 2nd BC Communication Propagation step 2nd BC

18 Inner loop structure LBM-collision (example) //Run over all cells for (ZFSId i=0; i < m_currentmaxnocells; i++){... // Calculate macroscopic variables rho = 0.0; for ( ZFSId j = 0; j < m_nodists; j ++) rho += f_old[i][j];... // Recalculate new distribution functions for (ZFSId j=0; j < nodists; j ++) // Perform relaxation towards equilibrium f[i][j] = f_old[i][j] + omega * (f_eq[i][j] - f_old[i][j]);... }

19 Computational hotspots in FV Solve the NS-equations in integral form: Z ~ dv + I S ~F ~nds =0, ~ Q =(, ~v, e) T Loop over all cells: Finite-Volume solver iteration loop Flux calculation: cell-centered gradients (LS) surface variables (MUSCL) RHS: convective fluxes (AUSM) viscous fluxes Runge-Kutta time-integration Boundary Conditions Flux-calculation Time-integration (BCs) (BCs) Communication Sponge

20 Scalabilty Scalability of ZFS (Lattice-BGK D3Q19) on CRAY Hermit at HLRS Stuttgart 5 ideal speedup x 10 9 cells x 10 9 cells 1.4 ideal speedup x 10 6 cells/core speedup 3 2 speedup number of cores number of cores Strong scaling Weak scaling total number of cells on 4096 cores: x 10⁹

21 The future of ZFS Planned and ongoing implementations: Zonal coupling of: LBM and FV part Structured FV solver FSI-code (DEAL - Uni Siegen) CAA coupling (Discontinuous Galerkin) Implementation of a distributed geometry Load-balancing and dynamic remeshing

22 Summary, Conclusions, and Questions ZFS is a scalable C++ multitool: parallel grid-generator flow solvers (LBM, FV, DG, structured FV) particle tracer post-processing tool ZFS is used in various simulation projects Mechanical engineering applications: 3D-engine flow, Combustion in combustion chambers, Noise prediction in jets of gas turbines Geophysical applications: droplet formation in clouds Bio-fluidmechanical applications: nasal cavity and lung flows ZFS has several hotspots possibly suited for GPU-calculations LBM: collision, propagation, BCs FV: flux computation, BCs

23 Summary, Conclusions, and Questions How expensive is the GPU memory exchange? how do we decrease the memory transfer? e.g. copy all data only once e.g. do exchange only if I/O is required What about the communication? how efficient is Cuda-aware MPI? is it necessary to copy data back to the CPU? What is best-practice GPU programming model? Cuda, OpenACC How big is the required code reconstruction effort? what about compatibility to other systems?

Reynolds number scaling of inertial particle statistics in turbulent channel flows

Reynolds number scaling of inertial particle statistics in turbulent channel flows Reynolds number scaling of inertial particle statistics in turbulent channel flows Matteo Bernardini Dipartimento di Ingegneria Meccanica e Aerospaziale Università di Roma La Sapienza Paolo Orlandi s 70th

More information

INTRODUCTION OBJECTIVES

INTRODUCTION OBJECTIVES INTRODUCTION The transport of particles in laminar and turbulent flows has numerous applications in engineering, biological and environmental systems. The deposition of aerosol particles in channels and

More information

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

More information

FINITE-DIFFERENCE IMPLEMENTATION OF LATTICE BOLTZMANN METHOD FOR USE WITH NON-UNIFORM GRIDS

FINITE-DIFFERENCE IMPLEMENTATION OF LATTICE BOLTZMANN METHOD FOR USE WITH NON-UNIFORM GRIDS 7. ANKARA INTERNATIONAL AEROSPACE CONFERENCE AIAC-2013-143 11-13 September 2013 - METU, Ankara TURKEY FINITE-DIFFERENCE IMPLEMENTATION OF LATTICE BOLTZMANN METHOD FOR USE WITH NON-UNIFORM GRIDS Fatih ÇEVİK

More information

The Lattice Boltzmann Method for Laminar and Turbulent Channel Flows

The Lattice Boltzmann Method for Laminar and Turbulent Channel Flows The Lattice Boltzmann Method for Laminar and Turbulent Channel Flows Vanja Zecevic, Michael Kirkpatrick and Steven Armfield Department of Aerospace Mechanical & Mechatronic Engineering The University of

More information

68 Guo Wei-Bin et al Vol. 12 presented, and are thoroughly compared with other numerical data with respect to the Strouhal number, lift and drag coeff

68 Guo Wei-Bin et al Vol. 12 presented, and are thoroughly compared with other numerical data with respect to the Strouhal number, lift and drag coeff Vol 12 No 1, January 2003 cfl 2003 Chin. Phys. Soc. 1009-1963/2003/12(01)/0067-08 Chinese Physics and IOP Publishing Ltd Lattice-BGK simulation of a two-dimensional channel flow around a square cylinder

More information

Numerical Investigation of the Transonic Base Flow of A Generic Rocket Configuration

Numerical Investigation of the Transonic Base Flow of A Generic Rocket Configuration 1 Numerical Investigation of the Transonic Base Flow of A Generic Rocket Configuration A. Henze, C. Glatzer, M. Meinke, W. Schröder Institute of Aerodynamics, RWTH Aachen University, Germany March 21,

More information

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand Institute of Aerospace Thermodynamics Numerical modelling of phase change processes in clouds Challenges and Approaches Martin Reitzle Bernard Weigand Introduction Institute of Aerospace Thermodynamics

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

Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs

Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs 1 School of Information Engineering, China University of Geosciences (Beijing) Beijing, 100083, China E-mail: Yaolk1119@icloud.com Ailan

More information

COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD

COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD XVIII International Conference on Water Resources CMWR 2010 J. Carrera (Ed) c CIMNE, Barcelona, 2010 COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD James.E. McClure, Jan F. Prins

More information

Improving Dynamical Core Scalability, Accuracy, and Limi:ng Flexibility with the ADER- DT Time Discre:za:on

Improving Dynamical Core Scalability, Accuracy, and Limi:ng Flexibility with the ADER- DT Time Discre:za:on Improving Dynamical Core Scalability, Accuracy, and Limi:ng Flexibility with the ADER- DT Time Discre:za:on Matthew R. Norman Scientific Computing Group National Center for Computational Sciences Oak Ridge

More information

On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code

On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code E Calore, S F Schifano, R Tripiccione Enrico Calore INFN Ferrara, Italy 7 th Workshop on UnConventional High Performance

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

DEVELOPMENT OF CFD MODEL FOR A SWIRL STABILIZED SPRAY COMBUSTOR

DEVELOPMENT OF CFD MODEL FOR A SWIRL STABILIZED SPRAY COMBUSTOR DRAFT Proceedings of ASME IMECE: International Mechanical Engineering Conference & Exposition Chicago, Illinois Nov. 5-10, 2006 IMECE2006-14867 DEVELOPMENT OF CFD MODEL FOR A SWIRL STABILIZED SPRAY COMBUSTOR

More information

Overview of Turbulent Reacting Flows

Overview of Turbulent Reacting Flows Overview of Turbulent Reacting Flows Outline Various Applications Overview of available reacting flow models LES Latest additions Example Cases Summary Reacting Flows Applications in STAR-CCM+ Ever-Expanding

More information

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters H. Köstler 2nd International Symposium Computer Simulations on GPU Freudenstadt, 29.05.2013 1 Contents Motivation walberla software concepts

More information

ANSYS Advanced Solutions for Gas Turbine Combustion. Gilles Eggenspieler 2011 ANSYS, Inc.

ANSYS Advanced Solutions for Gas Turbine Combustion. Gilles Eggenspieler 2011 ANSYS, Inc. ANSYS Advanced Solutions for Gas Turbine Combustion Gilles Eggenspieler ANSYS, Inc. 1 Agenda Steady State: New and Existing Capabilities Reduced Order Combustion Models Finite-Rate Chemistry Models Chemistry

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

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Khramtsov D.P., Nekrasov D.A., Pokusaev B.G. Department of Thermodynamics, Thermal Engineering and Energy Saving Technologies,

More information

Computational Fluid Dynamics

Computational Fluid Dynamics Computational Fluid Dynamics A Practical Approach Jiyuan Tu RMIT University, Australia Guan Heng Yeoh Australian Nuclear Science and Technology Organisation Chaoqun Liu University of Texas, Arlington ^fl

More information

Kinetic Models and Gas-Kinetic Schemes with Rotational Degrees of Freedom for Hybrid Continuum/Kinetic Boltzmann Methods

Kinetic Models and Gas-Kinetic Schemes with Rotational Degrees of Freedom for Hybrid Continuum/Kinetic Boltzmann Methods Kinetic Models and Gas-Kinetic Schemes with Rotational Degrees of Freedom for Hybrid Continuum/Kinetic Boltzmann Methods Simone Colonia, René Steijl and George N. Barakos CFD Laboratory - School of Engineering

More information

Proceedings of Meetings on Acoustics

Proceedings of Meetings on Acoustics Proceedings of Meetings on Acoustics Volume 19, 2013 http://acousticalsociety.org/ ICA 2013 Montreal Montreal, Canada 2-7 June 2013 Engineering Acoustics Session 1pEAa: Active and Passive Control of Fan

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Available online at ScienceDirect. Procedia Engineering 61 (2013 ) 94 99

Available online at  ScienceDirect. Procedia Engineering 61 (2013 ) 94 99 Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 6 (203 ) 94 99 Parallel Computational Fluid Dynamics Conference (ParCFD203) Simulations of three-dimensional cavity flows with

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

Lattice Boltzmann approach to liquid - vapour separation

Lattice Boltzmann approach to liquid - vapour separation Lattice Boltzmann approach to liquid - vapour separation T.Biciușcă 1,2, A.Cristea 1, A.Lamura 3, G.Gonnella 4, V.Sofonea 1 1 Centre for Fundamental and Advanced Technical Research, Romanian Academy Bd.

More information

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas April 14, 2011 1 Introduction In the last two decades, the Lattice Boltzmann method (LBM) has emerged as a promising tool

More information

Practical Combustion Kinetics with CUDA

Practical Combustion Kinetics with CUDA Funded by: U.S. Department of Energy Vehicle Technologies Program Program Manager: Gurpreet Singh & Leo Breton Practical Combustion Kinetics with CUDA GPU Technology Conference March 20, 2015 Russell Whitesides

More information

arxiv: v1 [physics.comp-ph] 12 Nov 2018

arxiv: v1 [physics.comp-ph] 12 Nov 2018 arxiv:1811.04742v1 [physics.comp-ph] 12 Nov 2018 Load balancing strategies for the DSMC simulation of hypersonic flows using HPC T. Binder 1, S. Copplestone 2, A. Mirza 1, P. Nizenkov 1, P. Ortwein 2,

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

Application of a Modular Particle-Continuum Method to Partially Rarefied, Hypersonic Flows

Application of a Modular Particle-Continuum Method to Partially Rarefied, Hypersonic Flows Application of a Modular Particle-Continuum Method to Partially Rarefied, Hypersonic Flows Timothy R. Deschenes and Iain D. Boyd Department of Aerospace Engineering, University of Michigan, Ann Arbor,

More information

Fluid Mechanics Based Classification of the Respiratory Efficiency of Several Nasal Cavities

Fluid Mechanics Based Classification of the Respiratory Efficiency of Several Nasal Cavities Fluid Mechanics Based Classification of the Respiratory Efficiency of Several Nasal Cavities Andreas Lintermann a,,matthiasmeinke a,wolfgangschröder a a Institute of Aerodynamics, RWTH Aachen University,

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

TAU Extensions for High Enthalpy Flows. Sebastian Karl AS-RF

TAU Extensions for High Enthalpy Flows. Sebastian Karl AS-RF TAU Extensions for High Enthalpy Flows Sebastian Karl AS-RF Contents Motivation Extensions available in the current release: Numerical schemes for super- and hypersonic flow fields Models for gas mixtures,

More information

External and Internal Incompressible Viscous Flows Computation using Taylor Series Expansion and Least Square based Lattice Boltzmann Method

External and Internal Incompressible Viscous Flows Computation using Taylor Series Expansion and Least Square based Lattice Boltzmann Method Available online at http://ijim.srbiau.ac.ir/ Int. J. Industrial Mathematics (ISSN 2008-5621) Vol. 10, No. 2, 2018 Article ID IJIM-00726, 8 pages Research Article External and Internal Incompressible Viscous

More information

Using LBM to Investigate the Effects of Solid-Porous Block in Channel

Using LBM to Investigate the Effects of Solid-Porous Block in Channel International Journal of Modern Physics and Applications Vol. 1, No. 3, 015, pp. 45-51 http://www.aiscience.org/journal/ijmpa Using LBM to Investigate the Effects of Solid-Porous Bloc in Channel Neda Janzadeh,

More information

Simulation of Lid-driven Cavity Flow by Parallel Implementation of Lattice Boltzmann Method on GPUs

Simulation of Lid-driven Cavity Flow by Parallel Implementation of Lattice Boltzmann Method on GPUs Simulation of Lid-driven Cavity Flow by Parallel Implementation of Lattice Boltzmann Method on GPUs S. Berat Çelik 1, Cüneyt Sert 2, Barbaros ÇETN 3 1,2 METU, Mechanical Engineering, Ankara, TURKEY 3 METU-NCC,

More information

ME615 Project Presentation Aeroacoustic Simulations using Lattice Boltzmann Method

ME615 Project Presentation Aeroacoustic Simulations using Lattice Boltzmann Method ME615 Project Presentation Aeroacoustic Simulations using Lattice Boltzmann Method Kameswararao Anupindi Graduate Research Assistant School of Mechanical Engineering Purdue Universit December 11, 11 Outline...

More information

Drag Reduction via Transversal Wave Motions of Structured Surfaces

Drag Reduction via Transversal Wave Motions of Structured Surfaces th International Symposium on Turbulence and Shear Flow Phenomena (TSFP), Chicago, U, July, 7 Drag Reduction via Transversal Wave Motions of Structured Surfaces Marian Albers Institute of Aerodynamics

More information

Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes

Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes Applied Mathematical Sciences, Vol. 9, 2015, no. 84, 4191-4199 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2015.5138 Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes G. V.

More information

CLASS SCHEDULE 2013 FALL

CLASS SCHEDULE 2013 FALL CLASS SCHEDULE 2013 FALL Class # or Lab # 1 Date Aug 26 2 28 Important Concepts (Section # in Text Reading, Lecture note) Examples/Lab Activities Definition fluid; continuum hypothesis; fluid properties

More information

Adjoint-based Trailing-Edge Noise Minimization via Porous Material

Adjoint-based Trailing-Edge Noise Minimization via Porous Material Adjoint-based Trailing-Edge Noise Minimization via Porous Material Beckett Y. Zhou 1,2, Nicolas R. Gauger 1, Seong R. Koh 3, Matthias Meinke 3, Wolfgang Schröder 3 1 Chair for Scientific Computing, TU

More information

There are no simple turbulent flows

There are no simple turbulent flows Turbulence 1 There are no simple turbulent flows Turbulent boundary layer: Instantaneous velocity field (snapshot) Ref: Prof. M. Gad-el-Hak, University of Notre Dame Prediction of turbulent flows standard

More information

CORBIS: Code Raréfié Bidimensionnel Implicite Stationnaire

CORBIS: Code Raréfié Bidimensionnel Implicite Stationnaire CORBIS: Code Raréfié Bidimensionnel Implicite Stationnaire main ingredients: [LM (M3AS 00, JCP 00)] plane flow: D BGK Model conservative and entropic velocity discretization space discretization: finite

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

Chapter 3 Bernoulli Equation

Chapter 3 Bernoulli Equation 1 Bernoulli Equation 3.1 Flow Patterns: Streamlines, Pathlines, Streaklines 1) A streamline, is a line that is everywhere tangent to the velocity vector at a given instant. Examples of streamlines around

More information

AMRITA VISHWA VIDYAPEETHAM DEPARTMENT OF CHEMICAL ENGINEERING AND MATERIALS SCIENCE. PhD Entrance Examination - Syllabus

AMRITA VISHWA VIDYAPEETHAM DEPARTMENT OF CHEMICAL ENGINEERING AND MATERIALS SCIENCE. PhD Entrance Examination - Syllabus AMRITA VISHWA VIDYAPEETHAM DEPARTMENT OF CHEMICAL ENGINEERING AND MATERIALS SCIENCE PhD Entrance Examination - Syllabus The research being carried out in the department of Chemical Engineering & Materials

More information

S3D Direct Numerical Simulation: Preparation for the PF Era

S3D Direct Numerical Simulation: Preparation for the PF Era S3D Direct Numerical Simulation: Preparation for the 10 100 PF Era Ray W. Grout, Scientific Computing SC 12 Ramanan Sankaran ORNL John Levesque Cray Cliff Woolley, Stan Posey nvidia J.H. Chen SNL NREL

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544 MULTIGRID CALCULATIONS FOB. CASCADES Antony Jameson and Feng Liu Princeton University, Princeton, NJ 0544 1. Introduction Development of numerical methods for internal flows such as the flow in gas turbines

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

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

Example Problems in FIDAP January, Compiled by Bruce A. Finlayson For use only by Students at the University of Washington

Example Problems in FIDAP January, Compiled by Bruce A. Finlayson For use only by Students at the University of Washington Example Problems in FIDAP January, 2000 Compiled by Bruce A. Finlayson For use only by Students at the University of Washington This document is a collection of lists and pictures showing the examples

More information

On the influence of tube row number for mixed convection around micro tubes

On the influence of tube row number for mixed convection around micro tubes Thessaloniki, Greece, 22-24 August 211 On the influence of tube row number for mixed convection around micro tubes Chuanshan DAI, Qiuxiang WANG, Biao LI * Corresponding author: Tel.: +86-22274183; Fax:

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

More information

Prospects for High-Speed Flow Simulations

Prospects for High-Speed Flow Simulations Prospects for High-Speed Flow Simulations Graham V. Candler Aerospace Engineering & Mechanics University of Minnesota Support from AFOSR and ASDR&E Future Directions in CFD Research: A Modeling & Simulation

More information

Comparison of steady and unsteady exhalation using multiplane-stereo PIV

Comparison of steady and unsteady exhalation using multiplane-stereo PIV Comparison of steady and unsteady exhalation using multiplane-stereo PIV Franka Schröder 1,*, Susanna Bordin 1, Sven Härtel 1, Mark Washausen 1, Michael Klaas 1, Wolfgang Schröder 1 1: Institute of Aerodynamics,

More information

Introduction to Chemical Engineering Computing, 2 nd edition, Bruce A. Finlayson, Wiley (2012)

Introduction to Chemical Engineering Computing, 2 nd edition, Bruce A. Finlayson, Wiley (2012) Introduction to Chemical Engineering Computing, 2 nd edition, Bruce A. Finlayson, Wiley (2012) The following web sites can be used to obtain material from Wiley. It includes the keys to the problems (useful

More information

Non-Equilibrium Flow Modeling Using High- Order Schemes for the Boltzmann Model Equations

Non-Equilibrium Flow Modeling Using High- Order Schemes for the Boltzmann Model Equations Purdue University Purdue e-pubs School of Aeronautics and Astronautics Faculty Publications School of Aeronautics and Astronautics 28 Non-Equilibrium Flow Modeling Using High- Order Schemes for the Boltzmann

More information

Implicit Large Eddy Simulation of Transitional Flow over a SD7003 Wing Using High-order Spectral Difference Method

Implicit Large Eddy Simulation of Transitional Flow over a SD7003 Wing Using High-order Spectral Difference Method 40th Fluid Dynamics Conference and Exhibit 28 June - 1 July 2010, Chicago, Illinois AIAA 2010-4442 Implicit Large Eddy Simulation of Transitional Flow over a SD7003 Wing Using High-order Spectral Difference

More information

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Simone Colonia, René Steijl and George N. Barakos CFD Laboratory - School of Engineering - University

More information

A Finite-Element based Navier-Stokes Solver for LES

A Finite-Element based Navier-Stokes Solver for LES A Finite-Element based Navier-Stokes Solver for LES W. Wienken a, J. Stiller b and U. Fladrich c. a Technische Universität Dresden, Institute of Fluid Mechanics (ISM) b Technische Universität Dresden,

More information

CFD Based Optimization of a Vertical Axis Wind Turbine

CFD Based Optimization of a Vertical Axis Wind Turbine SCHOOL OF ENGINEERING INSTITUTE FOR ENERGY SYSTEMS CFD Based Optimization of a Vertical Axis Wind Turbine Emmanouil Falagkaris Supervisory Team Prof. David Ingram, Dr Ignazio Maria Viola, Dr Daniel Friedrich

More information

Solution Methods. Steady State Diffusion Equation. Lecture 04

Solution Methods. Steady State Diffusion Equation. Lecture 04 Solution Methods Steady State Diffusion Equation Lecture 04 1 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence.

More information

Scalability Programme at ECMWF

Scalability Programme at ECMWF Scalability Programme at ECMWF Picture: Stan Tomov, ICL, University of Tennessee, Knoxville Peter Bauer, Mike Hawkins, George Mozdzynski, Tiago Quintino, Deborah Salmond, Stephan Siemen, Yannick Trémolet

More information

High-resolution Global Climate Modeling of Saturn s and Jupiter s tropospheric and stratospheric circulations

High-resolution Global Climate Modeling of Saturn s and Jupiter s tropospheric and stratospheric circulations High-resolution Global Climate Modeling of Saturn s and Jupiter s tropospheric and stratospheric circulations Aymeric SPIGA, S. Guerlet, E. Millour, Y. Meurdesoif (LSCE/CEA), M. Indurain, S. Cabanes, M.

More information

Lecture 9 Laminar Diffusion Flame Configurations

Lecture 9 Laminar Diffusion Flame Configurations Lecture 9 Laminar Diffusion Flame Configurations 9.-1 Different Flame Geometries and Single Droplet Burning Solutions for the velocities and the mixture fraction fields for some typical laminar flame configurations.

More information

2D Direct Numerical Simulation of methane/air turbulent premixed flames under high turbulence intensity Julien Savre 04/13/2011

2D Direct Numerical Simulation of methane/air turbulent premixed flames under high turbulence intensity Julien Savre 04/13/2011 1 2D Direct Numerical Simulation of methane/air turbulent premixed flames under high turbulence intensity Julien Savre 04/13/2011 2 Outline Why studying turbulent premixed flames under high turbulent intensity?

More information

The University of the West Indies, St. Augustine, Trinidad and Tobago. The University of the West Indies, St. Augustine, Trinidad and Tobago

The University of the West Indies, St. Augustine, Trinidad and Tobago. The University of the West Indies, St. Augustine, Trinidad and Tobago Unsteady MHD Free Convection Couette Flow Through a Vertical Channel in the Presence of Thermal Radiation With Viscous and Joule Dissipation Effects Using Galerkin's Finite Element Method Victor M. Job

More information

FINITE ELEMENT ANALYSIS OF MIXED CONVECTION HEAT TRANSFER ENHANCEMENT OF A HEATED SQUARE HOLLOW CYLINDER IN A LID-DRIVEN RECTANGULAR ENCLOSURE

FINITE ELEMENT ANALYSIS OF MIXED CONVECTION HEAT TRANSFER ENHANCEMENT OF A HEATED SQUARE HOLLOW CYLINDER IN A LID-DRIVEN RECTANGULAR ENCLOSURE Proceedings of the International Conference on Mechanical Engineering 2011 (ICME2011) 18-20 December 2011, Dhaka, Bangladesh ICME11-TH-014 FINITE ELEMENT ANALYSIS OF MIXED CONVECTION HEAT TRANSFER ENHANCEMENT

More information

Flame / wall interaction and maximum wall heat fluxes in diffusion burners

Flame / wall interaction and maximum wall heat fluxes in diffusion burners Flame / wall interaction and maximum wall heat fluxes in diffusion burners de Lataillade A. 1, Dabireau F. 1, Cuenot B. 1 and Poinsot T. 1 2 June 5, 2002 1 CERFACS 42 Avenue Coriolis 31057 TOULOUSE CEDEX

More information

Reduced Vlasov-Maxwell modeling

Reduced Vlasov-Maxwell modeling Reduced Vlasov-Maxwell modeling Philippe Helluy, Michel Massaro, Laurent Navoret, Nhung Pham, Thomas Strub To cite this version: Philippe Helluy, Michel Massaro, Laurent Navoret, Nhung Pham, Thomas Strub.

More information

Direct numerical simulation of compressible multi-phase ow with a pressure-based method

Direct numerical simulation of compressible multi-phase ow with a pressure-based method Seventh International Conference on Computational Fluid Dynamics (ICCFD7), Big Island, Hawaii, July 9-13, 2012 ICCFD7-2902 Direct numerical simulation of compressible multi-phase ow with a pressure-based

More information

Hybrid LES RANS Method Based on an Explicit Algebraic Reynolds Stress Model

Hybrid LES RANS Method Based on an Explicit Algebraic Reynolds Stress Model Hybrid RANS Method Based on an Explicit Algebraic Reynolds Stress Model Benoit Jaffrézic, Michael Breuer and Antonio Delgado Institute of Fluid Mechanics, LSTM University of Nürnberg bjaffrez/breuer@lstm.uni-erlangen.de

More information

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Contours of Pressure.8.6.4...4.6.8 Matthew McMullen Antony Jameson Juan J. Alonso Aero Astro Dept. Stanford

More information

Unsteady CFD for Automotive Aerodynamics

Unsteady CFD for Automotive Aerodynamics Unsteady CFD for Automotive Aerodynamics T. Indinger, B. Schnepf, P. Nathen, M. Peichl, TU München, Institute of Aerodynamics and Fluid Mechanics Prof. Dr.-Ing. N.A. Adams Outline 2 Motivation Applications

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

Free energy concept Free energy approach LBM implementation Parameters

Free energy concept Free energy approach LBM implementation Parameters BINARY LIQUID MODEL A. Kuzmin J. Derksen Department of Chemical and Materials Engineering University of Alberta Canada August 22,2011 / LBM Workshop OUTLINE 1 FREE ENERGY CONCEPT 2 FREE ENERGY APPROACH

More information

Numerical Study of Natural Unsteadiness Using Wall-Distance-Free Turbulence Models

Numerical Study of Natural Unsteadiness Using Wall-Distance-Free Turbulence Models Numerical Study of Natural Unsteadiness Using Wall-Distance-Free urbulence Models Yi-Lung Yang* and Gwo-Lung Wang Department of Mechanical Engineering, Chung Hua University No. 707, Sec 2, Wufu Road, Hsin

More information

Grid refinement in LBM based on continuous distribution functions

Grid refinement in LBM based on continuous distribution functions Grid refement LBM based on contuous distribution functions Denis Ricot 1 Simon Marié 1,2 Pierre Sagaut 2 1 Renault - Research, Material and Advanced Engeerg Department 2 d Alembert Institute, Université

More information

Multi-source Aeroacoustic Noise Prediction Method

Multi-source Aeroacoustic Noise Prediction Method Multi-source Aeroacoustic Noise Prediction Method Jonathan SCOTT CFD Engineer 03/12/2013 1 Introduction Trend to reduce engine displacement while increasing break power by turbo charging engines Traditionally

More information

Numerical Simulation of Flow Field around an Inflatable Vehicle during a Reentry Demonstration Flight considering Membrane Deformation

Numerical Simulation of Flow Field around an Inflatable Vehicle during a Reentry Demonstration Flight considering Membrane Deformation Numerical Simulation of Flow Field around an Inflatable Vehicle during a Reentry Demonstration Flight considering Membrane Deformation Dongheun HA 1,Yusuke TAKAHASHI 1 Kazuhiko YAMADA 2 1) Hokkaido Univ.

More information

HIGH PERFORMANCE CTC TRAINING FOR END-TO-END SPEECH RECOGNITION ON GPU

HIGH PERFORMANCE CTC TRAINING FOR END-TO-END SPEECH RECOGNITION ON GPU April 4-7, 2016 Silicon Valley HIGH PERFORMANCE CTC TRAINING FOR END-TO-END SPEECH RECOGNITION ON GPU Minmin Sun, NVIDIA minmins@nvidia.com April 5th Brief Introduction of CTC AGENDA Alpha/Beta Matrix

More information

arxiv: v1 [physics.flu-dyn] 5 Oct 2017

arxiv: v1 [physics.flu-dyn] 5 Oct 2017 Hermite regularization of the Lattice Boltzmann Method for open source computational aeroacoustics arxiv:1710.02065v1 [physics.flu-dyn] 5 Oct 2017 F. Brogi a),b) Department of Earth Science, University

More information

Exploring STAR-CCM+ Capabilities, Enhancements and Practices for Aerospace Combustion. Niveditha Krishnamoorthy CD-adapco

Exploring STAR-CCM+ Capabilities, Enhancements and Practices for Aerospace Combustion. Niveditha Krishnamoorthy CD-adapco Exploring STAR-CCM+ Capabilities, Enhancements and Practices for Aerospace Combustion Niveditha Krishnamoorthy CD-adapco Outline Overview of modeling capability Applications, Practices and Enhancements

More information

Lattice Boltzmann Method Solver Documentation

Lattice Boltzmann Method Solver Documentation Lattice Boltzmann Method Solver Documentation Release 0.0.1 Sayop Kim May 03, 2016 Contents 1 Code Instruction 3 1.1 Quick instruction for running the simulation.............................. 3 2 Results

More information

Performance Evaluation of Scientific Applications on POWER8

Performance Evaluation of Scientific Applications on POWER8 Performance Evaluation of Scientific Applications on POWER8 2014 Nov 16 Andrew V. Adinetz 1, Paul F. Baumeister 1, Hans Böttiger 3, Thorsten Hater 1, Thilo Maurer 3, Dirk Pleiter 1, Wolfram Schenck 4,

More information

RECENT DEVELOPMENTS IN COMPUTATIONAL REACTOR ANALYSIS

RECENT DEVELOPMENTS IN COMPUTATIONAL REACTOR ANALYSIS RECENT DEVELOPMENTS IN COMPUTATIONAL REACTOR ANALYSIS Dean Wang April 30, 2015 24.505 Nuclear Reactor Physics Outline 2 Introduction and Background Coupled T-H/Neutronics Safety Analysis Numerical schemes

More information

Contents. I Introduction 1. Preface. xiii

Contents. I Introduction 1. Preface. xiii Contents Preface xiii I Introduction 1 1 Continuous matter 3 1.1 Molecules................................ 4 1.2 The continuum approximation.................... 6 1.3 Newtonian mechanics.........................

More information

Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form

Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form Julian Koellermeier, Manuel Torrilhon May 18th, 2017 FU Berlin J. Koellermeier 1 / 52 Partially-Conservative

More information

TURBINE BURNERS: Engine Performance Improvements; Mixing, Ignition, and Flame-Holding in High Acceleration Flows

TURBINE BURNERS: Engine Performance Improvements; Mixing, Ignition, and Flame-Holding in High Acceleration Flows TURBINE BURNERS: Engine Performance Improvements; Mixing, Ignition, and Flame-Holding in High Acceleration Flows Presented by William A. Sirignano Mechanical and Aerospace Engineering University of California

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

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

Aeroacoustic simulation of automotive ventilation outlets

Aeroacoustic simulation of automotive ventilation outlets Aeroacoustic simulation of automotive ventilation outlets J.-L. Adam a, D. Ricot a, F. Dubief a and C. Guy b a Renault SAS, 1 avenue du golf, 78288 Guyancourt, France b Ligeron, Les Algorithmes Bâtiment

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

[N175] Development of Combined CAA-CFD Algorithm for the Efficient Simulation of Aerodynamic Noise Generation and Propagation

[N175] Development of Combined CAA-CFD Algorithm for the Efficient Simulation of Aerodynamic Noise Generation and Propagation The 32nd International Congress and Exposition on Noise Control Engineering Jeju International Convention Center, Seogwipo, Korea, August 25-28, 2003 [N175] Development of Combined CAA-CFD Algorithm for

More information

Force analysis of underwater object with supercavitation evolution

Force analysis of underwater object with supercavitation evolution Indian Journal of Geo-Marine Sciences Vol. 42(8), December 2013, pp. 957-963 Force analysis of underwater object with supercavitation evolution B C Khoo 1,2,3* & J G Zheng 1,3 1 Department of Mechanical

More information

APPLICATION OF HYBRID CFD/CAA TECHNIQUE FOR MODELING PRESSURE FLUCTUATIONS IN TRANSONIC FLOWS

APPLICATION OF HYBRID CFD/CAA TECHNIQUE FOR MODELING PRESSURE FLUCTUATIONS IN TRANSONIC FLOWS TASK QUARTERLY Vol. 17, Nos 3 4, 2013, pp. 145 154 APPLICATION OF HYBRID CFD/CAA TECHNIQUE FOR MODELING PRESSURE FLUCTUATIONS IN TRANSONIC FLOWS SŁAWOMIR DYKAS, WŁODZIMIERZ WRÓBLEWSKI AND SEBASTIAN RULIK

More information

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling Turbulence Modeling Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark 1 Outline

More information