Improved treatment of the open boundary in the method of lattice Boltzmann equation

Size: px
Start display at page:

Download "Improved treatment of the open boundary in the method of lattice Boltzmann equation"

Transcription

1 Improved treatment of the open boundary in the method of lattice Boltzmann equation Dazhi Yu, Renwei Mei and Wei Shyy Department of Mechanical and Aerospace Engineering, University of Florida, Gainesville, FL USA Abstract: The method of lattice Boltzmann equation (LBE) is a kineticbased approach for fluid flow computations. In LBE, the distribution functions on various boundaries are often derived approximately. In this paper, the pressure interaction between an inlet boundary and the interior of the flow field is analysed when the bounce-back condition is specified at the inlet. It is shown that this treatment reflects most of the pressure waves back into the flow field and results in a poor convergence towards the steady state or a noisy flow field. An improved open boundary condition is developed to reduce the inlet interaction. Test results show that the new treatment greatly reduces the interaction and improves the computational stability and the quality of the flow field. Keywords: lattice Boltzmann equation; boundary condition; inlet; bounce-back. Reference to this paper should be made as follows: Yu, D., Mei, R. and Shyy, W. (xxxx) Improved treatment of the open boundary in the method of lattice Boltzmann equation, Progress in Computational Fluid Design, Vol. x, No. x, pp.xxx xxx. Biographical notes: Dazhi Yu received his PhD in Aerospace from University of Florida. He is now a Postdoctoral Research Associate in Aerospace Department at Texas A&M University. His research interests include lattice Boltzmann method, parallel computation, and turbulence. Renwei Mei is Professor of the Department of Mechanical and Aerospace Engineering at University of Florida. His research areas include particle dispersion and collision in turbulence, boiling heat transfer and two-phase flow, lattice Boltzmann method, and desalination. He is interested in applying computational methods and applied mathematics to solve practical thermal fluid problem. Wei Shyy is currently Professor and Chairman of the Department of Mechanical and Aerospace Engineering at University of Florida (UF). He is the author or a coauthor of three books dealing with computational and modelling techniques involving fluid flow, interfacial dynamics, and moving boundary problems. He has written papers dealing with computational and modelling issues related to fluid dynamics, heat/mass transfer, combustion, material processing, parallel computing, biological flight and aerodynamics, 1 design optimisation, micro-scale and biofluid dynamics.

2 1 INTRODUCTION 1.1 General description of the method Since the last two decades or so, there has been a rapid progress in developing the method of the lattice Boltzmann equation (LBE) as an alternative, computational technique for solving a variety of complex fluid dynamic systems [1 16]. Adopting the macroscopic method for computational fluid dynamics (CFD), macroscopic variables of interest, such as velocity u and pressure p, are usually obtained by solving the Navier-Stokes (NS) equations (e.g., see [17,18]). In the LBE approach, one solves the kinetic equation for the particle velocity distribution function f(x,ξ,t), where ξ is the particle velocity vector, x is the spatial position vector, and t is the time. The macroscopic quantities (such as mass density ρ and momentum density ρu) can then be obtained by evaluating the hydrodynamic moments of the distribution function f. Lattice gas automata, the predecessor of LBE, were first proposed by Frisch et al. [19]. The theoretical foundation of LBE was established in the subsequent papers, notably in McNamara and Zanetti [20], Higuera and Jimenez [21], Koelman [22] and Qian et al. [23]. A popular kinetic model adopted in the literature is the single relaxation time approximation, the socalled BGK model [24]: f t + ξ f = 1 λ (f f (eq) ) (1) where f (eq) is the equilibrium distribution function (the Maxwell-Boltzmann distribution function), and λ is the relaxation time. To solve for f numerically, equation (1) is first discretised in the velocity space using a finite set of velocities {ξ α } without affecting the conservation laws [15, 24,25], f a t + ξ a f a = 1 λ (f a f a (eq) ) (2) In the above equation, f α (x,t) f(x,ξ α,t)isthe distribution function associated with the α-th discrete velocity ξ α and f α (eq) is the corresponding equi- Figure 1: A 2-D, 9-velocity lattice (Q9D2) model librium distribution function. The 9-bit square lattice model, which is often referred to as the D2Q9 model (Figure 1), has been successfully used for simulating 2-D flows. In the D2Q9 model, we use e α to denote the discrete velocity set and we have e 0 =0, e α = c(cos((a 1)p/4), sin((a 1)p/4)) forα =1, 3, 5, 7, e α = 2c(cos((a 1)p/4), sin((a 1)p/4)) forα =2, 4, 6, 8 (3) where c = δx/δt, δx and δt are the lattice constant and the time step size, respectively. The equilibrium distribution for D2Q9 model is of the following form [23] [ f a (eq) = w a ρ + 3 c 2 e α u + 9 2c 4 (e α u) 2 3 ] 2c 2 u u where w α is the weighting factor given by 4/9, α =0 w α = 1/9, α =1, 3, 5, 7 1/36, α =2, 4, 6, 8. (4) (5) With the discretised velocity space, the density and 2

3 momentum fluxes can be evaluated as and ρ = ρu = f α = k=0 e α f α = k=1 k=0 k=1 f (eq) α (6) e α f (eq) α (7) The speed of sound in this model is c s = c/ 3 and the equation of state is that of an ideal gas, p = ρc 2 s (8) Equation (2) can be further discretised in space and time. The completely discretised form of equation (1), with the time step δt and space step e α δt, is: f α (x i + e α δt, t + δt) f α (x i,t) = 1 τ [f α(x i,t) f (eq) α (x i,t)] (9) where τ = λ/δt, and x i is a point in the discretised physical space. The above equation is the discrete lattice Boltzmann equation [20,21,26] with BGK approximation [24]. Equation (9) is usually solved in the following two steps where represents the postcollision state. The viscosity in the NS equation derived from equation (9) is ν =(τ 1/2)c 2 sδt (10) This modification of the viscosity formally makes the LBGK scheme a second-order method for solving incompressible flows [25,27]. The positivity of the viscosity requires that τ> 1 / 2. It is noted that the collision step is completely local and the streaming step takes very little computational effort. Equation (9) is explicit, easy to implement, and straightforward to parallelise. 1.2 Issues in the boundary condition treatment Like in any other fluid flow computations, the numerical boundary condition is a very important issue in the LBE method. Two classes of boundaries are often encountered in computational fluid dynamics: open boundaries and the solid wall. The open boundaries typically include lines (or planes) of symmetry, periodic cross-sections, infinity, and inlet and outlet. At these boundaries, velocity or pressure is usually specified in the macroscopic description of fluid flow. Unlike solving the NS equations where the macroscopic variables, their derivatives, or a well established constraint (such as the mass continuity for pressure distributions) can often be explicitly specified at boundary [28], in the LBE method, these conditions need to be converted into distribution function f. 2 COMPUTATIONAL ASSESSMENT In the computational cases to be presented and discussed, the following questions are addressed: Will the interpolation-based superposition scheme give the same accuracy as those of bounce back if both conditions lead to converged results? How does the inlet/free-stream boundary condition impact the convergence of the solution and the quality of the flow field? At the symmetric and periodic boundaries, the conditions for f α s can be given exactly. At the outlet of a computational domain, f α s can usually be approximated by simple extrapolation. In general, the boundary condition for f α s on a solid wall with a known velocity can only be given approximately. A popular approach is to employ the bounce-back scheme [29 31]. It is intuitively derived from lattice gas automata and has been extensively applied in lattice Boltzamnn equation simulations. The same idea for the solid wall has been directly extended to the inlet boundary with known velocity to provide the required inlet condition for f α s [31 34]. Let us consider a horizontal flow at an inlet (Figure 2). The first vertical grid line is at x A. The inlet is arbitrarily x I which is between lattice node A at x A and located at node B at x B. The node B at x B is the first fluid node next to the inlet. Using the bounce 3

4 based inlet condition results in slower convergence towards steady or dynamically steady state and causes stronger interaction between the inlet and interior field. Such interaction may affect the longterm behaviour of the solution, especially at higher Re. The interpolation-based superposition scheme can reduce the impact of the boundary-interior interaction on the unsteady development of the flow field, improves the convergence rate, improves the computational stability, and improves the quality of the overall solution. ACKNOWLEDGEMENTS Figure 2: Schematic of lattice nodes at inlet back on the link scheme [29], one typically requires that the known velocity profile u(x I ) be specified at x A e 1 dt with Ω = 0.5, where Ω is the fraction of a link in the fluid region intersected by inlet boundary, Ω= x B x I x B x A 0 Ω 1 (11) The standard bounce-back scheme for fᾱ(x A )atthe inlet x A gives: fᾱ(x A ) = f a (x A + eᾱδt) +2w α ρ(x A e ādt) 3 c 2 e ᾱ u(x(12) i ) for ᾱ = 1, 2, 8 and α = 5, 6, 4. We note that f ᾱx ( A ) in equation (12) depends on f αx ( A + eᾱδt) and ρ(x A + 1/2eᾱδt). Thus, it creates a mechanism for the pressure waves to propagate along the e α direction through f αx ( A + eᾱδt)and to reflect back to the interior of computational domain along the eᾱ direction through fᾱ(x A ). 3 CONCLUSIONS Computations based on the bounce-back based inlet condition and interpolation-based superposition condition are performed for various cases. Bounce-back The work reported in this paper has been partially supported by NASA Langley Research Center, with David Rudy as the project monitor. The authors thank Dr. Li-Shi Luo for many helpful discussions. The work reported in this paper has been partially supported by NASA Langley Research Center, with David Rudy as the project monitor. The authors thank Dr. Li-Shi Luo for many helpful discussions. REFERENCES 1 Alves, A.S. (Ed.) (1991) Discrete Models of Fluid Dynamics, Figueira da Foz, Portugal, September 19 22, 1990, World Scientific, Singapore. 2 Verheggen, T.M.M. (Ed.) (1992) Numerical methods for the simulation of multi-phase and complex flow, Proceedings of a Workshop held at Koninklijke/Shell-Laboratorium, Amsterdam, The Netherlands, May 30th June 1, 1990, Springer, Berlin. 3 Lebowitz, J.L., Orszag, S.A. and Qian, Y.H. (Eds.) (1995) J. Stat. Phys., Vol. 81, Nos. 1/2, pp.1 538, Proceedings of the 5th International Conference on Discrete Models for Fluid Mechanics, Princeton, New Jersey, June 27 29, Boghosian, B.M., Alexander, F.J. and Coveney, P.V. (Eds.) (1997) Int. J. Mod. Phys., Vol. 8, No. 4, pp , Proceedings of 1996 Conference on Discrete Models for Fluid Mechanics, Boston, Massachusetts, August 26 28, Boghosian, B.M. (Ed.) (1998) Int. J. Mod. Phys. C, Vol. 9, No. 8, pp , Proceedings of the 7th 4

5 International Conference on the Discrete Simulation of Fluids, Oxford, UK, July 14 18, Ohashi, H. and Chen, Y. (Eds.) (2000) Comp. Phys. Commun., Vol. 129, Nos. 1 3, pp.1 291, Proceedings of the 8th International Symposium on the Discrete Simulation of Fluid Dynamics, Tokyo, Japan, July 28 30, Lebowitz, J.L. (Ed.) (2002) J. Stat. Phys., Vol. 107, Nos. 1 2, pp.1 598, Special issue based on the 9th Annual International Conference on Discrete Simulation of Fluid Dynamics, Santa Fe, New Mexico, August 21 24, Coveney, P.V. and Succi, S. (Eds.) (2002) Phil. Trans. R. Soc. Lond. A., Vol. 360, No. 1792, pp.1 573, Discrete Modeling and Simulation of Fluid Dynamics, the 10th International Conference on Discrete Simulation of Fluid Dynamics, Cargese, July 2 6, Monaco, R. and Preziosi, L. (1991) Fluid Dynamic Applications of the Discrete Boltzmann Equation, World Scientific, Singapore. 10 Chopard, B. and Droz, M. (1998) Cellular Automata Modeling of Physical Systems, Cambridge University Press, Cambridge, UK. 11 Wolf-Gladrow, D.A. (2000) Lattice-Gas Cellular Automata and Lattice Boltzmann Models, Springer, Berlin. 12 Succi, S. (2001) The Lattice Boltzmann Equation for Fluid Dynamics and Beyond, Oxford University Press, New York. 13 Benzi, R., Succi, S. and Vergassola, M. (1992) The lattice Boltzmann equation theory and applications, Phys. Reports, Vol. 222, pp Qian, Y.H, Succi, S. and Orszag, S.A. (1996) Recent advances in lattice Boltzmann computing, in Stauffer, D. (Ed.): Annual Reviews of Computational Physics III, World Scientific, Singapore. 15 Chen, S. and Doolen GD. (1986) Lattice Boltzmann method for fluid flows, Ann. Rev. Fluid. Mech., Vol. 30, pp Luo, L-S. (2000) The lattice-gas and lattice Boltzmann methods: past, present, and future, in Wu, J-H. and Zhu, Z-J. (Ed.): Proceedings of the International Conference on Applied Computational Fluid Dynamics, Beijing, China, pp Peyret, R. and Taylor, T.D. (1983) Computational Technique for Fluid Dynamics, Vol. II, Springer- Verlag, New York. 18 Fletcher, C.A.J. (1988) Computational Techniques for Fluid Dynamics, Vol. I and II, Springer-Verlag, New York. 19 Frisch, U., Hasslacher, B. and Pomeau, Y. (1986) Lattice-gas automata for the Navier-Stokes equations, Phys. Rev. Lett., Vol. 56, pp McNamara, G. and Zanetti, G. (1988) Use of the Boltzmann equation to simulate lattice-gas automata, Phys. Rev. Lett., Vol. 61, pp Higuera, F.J. and Jimenez, J. (1989) Boltzmann approach to lattice gas simulations, Europhys. Lett., Vol. 9, pp Koelman, J.M.V.A. (1991) A simple lattice Boltzmann scheme for Navier-Stokes fluid flow, Europhys. Lett., Vol. 15, pp Qian, Y., d Humieres, D. and Lallemand, P. (1992) Recovery of Navier-Stokes equations using a latticegas Boltzmann method, Europhys. Lett., Vol. 17, pp Bhatnagar, P.L., Gross, E.P. and Krook, M. (1954) A model for collision processes in gases, I. small amplitude processes in charged and neutral onecomponent system, Phys. Rev., Vol. 94, pp He, X. and Luo, L.-S. (1997) A priori derivation of the lattice Boltzmann equation, Phys. Rev. E, Vol. 55, pp.r6333 R Chen, H., Chen, S. and Matthaeus, W.H. (1992) Recovery of the Navier-Stokes equations using a lattice-gas Boltzmann method, Phys. Rev. A., Vol. 45, pp.r5339 R He, X., Zou, Q., Luo, L.-S. and Dembo, M. (1997) Analytic solutions and analysis on non-slip boundary condition for the lattice Boltzmann BGK model, J. Stat. Phys., Vol. 87, pp Shyy, W., Liu, J. and Wright, J. (1994) Pressurebased viscous flow computation using multiblock overlapping curvilinear grid, Numer. Heat Transf., Vol. 25, pp Ladd, A.J.C. (1994) Numerical simulation of particular suspensions via a discretized Boltzmann equation. Part 1. Theoretical foundation, J. Fluid Mech., Vol. 271, pp Ladd, A.J.C. (1994) Numerical simulation of particular suspensions via a discretized Boltzmann equation. Part 2. Numerical results, J. Fluid Mech., Vol. 271, pp

6 31 Behrend, Q. (1995) Solid-fluid boundaries in particle suspension simulation via the lattice Boltzmann method, Phys. Rev. E., Vol. 52, pp Cornubert, R., Dhumieres, D. and Levermore, D. A Knudsen layer theory for lattice gases, Physica D, Vol. 47, pp Ziegler, D.P. (1993) Boundary conditions for lattice Boltzmann simulations, J. Stat. Phys., Vol. 71, pp Zou, Q. and He, X. (1997) On pressure and velocity boundary conditions for the lattice Boltzmann BGK model, Phys. Fluids, Vol. 9, pp Filippova, O. and Hänel, D. (2000) A novel lattice BGK approach for low mach number combustion, J. Comp. Phys., Vol. 158, pp Gruna, D.W. (1993) Lattice methods for modeling hydrodynamics, PhD Dissertation, Colorado State University. 6

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

Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components

Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components Xiaoyi He and Qisu Zou arxiv:comp-gas/9507002v1 22 Jul 1995 Abstract In this paper, we study the two dimensional

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

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

Connection Between the Lattice Boltzmann Equation and the Beam Scheme

Connection Between the Lattice Boltzmann Equation and the Beam Scheme NASA/CR-1999-209001 ICASE Report No. 99-10 Connection Between the Lattice Boltzmann Equation and the Beam Scheme Kun Xu Hong Kong University of Science and Technology, Kowloon, Hong Kong Li-Shi Luo ICASE,

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

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

SEMICLASSICAL LATTICE BOLTZMANN EQUATION HYDRODYNAMICS

SEMICLASSICAL LATTICE BOLTZMANN EQUATION HYDRODYNAMICS The Seventh Nobeyama Workshop on CFD: To the Memory of Prof. Kuwahara Sanjo Kaikan, the University of Tokyo, Japan, September. 23-24, 2009 SEMICLASSICAL LATTICE BOLTZMANN EQUATION HYDRODYNAMICS Jaw-Yen

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

Grad s approximation for missing data in lattice Boltzmann simulations

Grad s approximation for missing data in lattice Boltzmann simulations Europhysics Letters PREPRINT Grad s approximation for missing data in lattice Boltzmann simulations S. Ansumali 2, S. S. Chikatamarla 1 and I. V. Karlin 1 1 Aerothermochemistry and Combustion Systems Laboratory,

More information

arxiv: v1 [physics.flu-dyn] 10 Aug 2015

arxiv: v1 [physics.flu-dyn] 10 Aug 2015 Slip velocity of lattice Boltzmann simulation using bounce-back boundary scheme Jianping Meng, Xiao-Jun Gu, and David R Emerson Scientific Computing Department, STFC Daresbury laboratory, arxiv:1508.009v1

More information

An Accurate Curved Boundary Treatment in the Lattice Boltzmann Method

An Accurate Curved Boundary Treatment in the Lattice Boltzmann Method NASA/CR-2000-209854 ICASE Report No. 2000-6 An Accurate Curved Boundary Treatment in the Lattice Boltzmann Method Renwei Mei University of Florida, Gainesville, Florida Li-Shi Luo ICASE, Hampton, Virginia

More information

Thermal lattice Bhatnagar-Gross-Krook model for flows with viscous heat dissipation in the incompressible limit

Thermal lattice Bhatnagar-Gross-Krook model for flows with viscous heat dissipation in the incompressible limit PHYSICAL REVIEW E 70, 066310 (2004) Thermal lattice Bhatnagar-Gross-Krook model for flows with viscous heat dissipation in the incompressible limit Yong Shi, T. S. Zhao,* Z. L. Guo Department of Mechanical

More information

A one-point boundary condition for the lattice Boltzmann method

A one-point boundary condition for the lattice Boltzmann method manuscript A one-point boundary condition for the lattice Boltzmann method Michael Junk and Zhaoxia Yang FB Mathematik und Statistik, Universität Konstanz, Fach D194, 78457 Konstanz, Germany (Dated: September

More information

Using OpenMP on a Hydrodynamic Lattice-Boltzmann Code

Using OpenMP on a Hydrodynamic Lattice-Boltzmann Code Using OpenMP on a Hydrodynamic Lattice-Boltzmann Code Gino Bella Nicola Rossi Salvatore Filippone Stefano Ubertini Università degli Studi di Roma Tor Vergata 1 Introduction The motion of a uid ow is governed

More information

A Momentum Exchange-based Immersed Boundary-Lattice. Boltzmann Method for Fluid Structure Interaction

A Momentum Exchange-based Immersed Boundary-Lattice. Boltzmann Method for Fluid Structure Interaction APCOM & ISCM -4 th December, 03, Singapore A Momentum Exchange-based Immersed Boundary-Lattice Boltzmann Method for Fluid Structure Interaction Jianfei Yang,,3, Zhengdao Wang,,3, and *Yuehong Qian,,3,4

More information

Generalized Local Equilibrium in the Cascaded Lattice Boltzmann Method. Abstract

Generalized Local Equilibrium in the Cascaded Lattice Boltzmann Method. Abstract Accepted for publication on Physical Review E (R), code ERR1034 Generalized Local Equilibrium in the Cascaded Lattice Boltzmann Method Pietro Asinari Department of Energetics, Politecnico di Torino, Corso

More information

MODELLING OF THE BOUNDARY CONDITION FOR MICRO CHANNELS WITH USING LATTICE BOLTZMANN METHOD (LBM)

MODELLING OF THE BOUNDARY CONDITION FOR MICRO CHANNELS WITH USING LATTICE BOLTZMANN METHOD (LBM) Reports Awarded with "Best Paper" Crystal Prize 17 FRI-1.417-1-MEMBT-05 MODELLING OF THE BOUNDARY CONDITION FOR MICRO CHANNELS WITH USING LATTICE BOLTZMANN METHOD (LBM) Rsc. Asst. İlkay Çolpan, BSc Department

More information

LATTICE BOLTZMANN MODELLING OF PULSATILE FLOW USING MOMENT BOUNDARY CONDITIONS

LATTICE BOLTZMANN MODELLING OF PULSATILE FLOW USING MOMENT BOUNDARY CONDITIONS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 5 June 28, Glasgow, UK LATTICE BOLTZMANN MODELLING OF PULSATILE FLOW USING MOMENT

More information

NON-DARCY POROUS MEDIA FLOW IN NO-SLIP AND SLIP REGIMES

NON-DARCY POROUS MEDIA FLOW IN NO-SLIP AND SLIP REGIMES THERMAL SCIENCE, Year 2012, Vol. 16, No. 1, pp. 167-176 167 NON-DARCY POROUS MEDIA FLOW IN NO-SLIP AND SLIP REGIMES by Antonio F. MIGUEL Geophysics Centre of Evora & Department of Physics, University of

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 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

THE INTERNATIONAL JOURNAL OF SCIENCE & TECHNOLEDGE

THE INTERNATIONAL JOURNAL OF SCIENCE & TECHNOLEDGE THE INTERNATIONAL JOURNAL OF SCIENCE & TECHNOLEDGE Stability Evaluation of Lattice Boltzmann Method for High Viscosity Fluid Model Applied in Pore Scale Porous Media Pahala Richard Panjaitan Ph.D. Student,

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

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

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

arxiv:cond-mat/ v1 [cond-mat.stat-mech] 11 Dec 2002

arxiv:cond-mat/ v1 [cond-mat.stat-mech] 11 Dec 2002 arxiv:cond-mat/0212257v1 [cond-mat.stat-mech] 11 Dec 2002 International Journal of Modern Physics B c World Scientific Publishing Company VISCOUS FINGERING IN MISCIBLE, IMMISCIBLE AND REACTIVE FLUIDS PATRICK

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

Three-dimensional simulation of slip-flow and heat transfer in a microchannel using the lattice Boltzmann method

Three-dimensional simulation of slip-flow and heat transfer in a microchannel using the lattice Boltzmann method 75 Three-dimensional simulation of slip-flow and heat transfer in a microchannel using the lattice Boltzmann method A. C. M. Sousa,2, M. Hadavand & A. Nabovati 3 Department of Mechanical Engineering, University

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

Simulation of Rarefied Gas Flow in Slip and Transitional Regimes by the Lattice Boltzmann Method

Simulation of Rarefied Gas Flow in Slip and Transitional Regimes by the Lattice Boltzmann Method www.cfdl.issres.net Vol. 2 (2) June 2010 Simulation of Rarefied Gas Flow in Slip and Transitional Regimes by the Lattice Boltzmann Method N. Azwadi C. Sidik 1C, N.C. Horng 1, M.A. Mussa 2, and S. Abdullah

More information

Applications of the Lattice Boltzmann Method to Complex and Turbulent Flows

Applications of the Lattice Boltzmann Method to Complex and Turbulent Flows NASA/CR-2002-211659 ICASE Report No. 2002-19 Applications of the Lattice Boltzmann Method to Complex and Turbulent Flows Li-Shi Luo ICASE, Hampton, Virginia Dewei Qi Western Michigan University, Kalamazoo,

More information

The Lift Force on a Spherical Particle in Rectangular Pipe Flow. Houhui Yi

The Lift Force on a Spherical Particle in Rectangular Pipe Flow. Houhui Yi CHINESE JOURNAL OF PHYSICS VOL. 52, NO. 1-I February 2014 The Lift Force on a Spherical Particle in Rectangular Pipe Flow Houhui Yi Institute of Theoretical Physics, Department of Opto-Electronic Engineering,

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

Alternative and Explicit Derivation of the Lattice Boltzmann Equation for the Unsteady Incompressible Navier-Stokes Equation

Alternative and Explicit Derivation of the Lattice Boltzmann Equation for the Unsteady Incompressible Navier-Stokes Equation ISSN (e): 2250 3005 Volume, 06 Issue, 12 December 2016 International Journal of Computational Engineering Research (IJCER) Alternative and Explicit Derivation of the Lattice Boltzmann Equation for the

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

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

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

A numerical method for incompressible non-newtonian fluid flows based on the lattice Boltzmann method

A numerical method for incompressible non-newtonian fluid flows based on the lattice Boltzmann method A numerical method for incompressible non-newtonian fluid flows based on the lattice Boltzmann method M. Yoshino a,, Y. Hotta a,, T. Hirozane a, M. Endo b a Department of Mechanical Systems Engineering,

More information

comp-gas/ Jan 1994

comp-gas/ Jan 1994 Simulation of non-ideal gases and liquid-gas phase transitions by lattice Boltzmann equation Xiaowen Shan Center for Nonlinear Studies, Los Alamos National Laboratory, Los Alamos, NM 87545 Hudong Chen

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 Method for Moving Boundaries

Lattice Boltzmann Method for Moving Boundaries Lattice Boltzmann Method for Moving Boundaries Hans Groot March 18, 2009 Outline 1 Introduction 2 Moving Boundary Conditions 3 Cylinder in Transient Couette Flow 4 Collision-Advection Process for Moving

More information

Lattice Boltzmann Model

Lattice Boltzmann Model Lattice Boltzmann Model Paul Walsh January 6, 2003 Computational Physics, Dept of Physics, Trinity College, Dublin 2, Ireland Submitted January 6 th 2003. Abstract The validity of the Lattice Boltzmann

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

UC Irvine UC Irvine Electronic Theses and Dissertations

UC Irvine UC Irvine Electronic Theses and Dissertations UC Irvine UC Irvine Electronic Theses and Dissertations Title Lattice Boltzmann Method for Fluid Flow Permalink https://escholarship.org/uc/item/8vf0g3zk Author Abdellah-El-Hadj, Amine Publication Date

More information

Computers and Mathematics with Applications

Computers and Mathematics with Applications Computers and Mathematics with Applications 59 (2010 2194 2199 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa Toward

More information

PREDICTION OF INTRINSIC PERMEABILITIES WITH LATTICE BOLTZMANN METHOD

PREDICTION OF INTRINSIC PERMEABILITIES WITH LATTICE BOLTZMANN METHOD PREDICTION OF INTRINSIC PERMEABILITIES WITH LATTICE BOLTZMANN METHOD Luís Orlando Emerich dos Santos emerich@lmpt.ufsc.br Carlos Enrique Pico Ortiz capico@lmpt.ufsc.br Henrique Cesar de Gaspari henrique@lmpt.ufsc.br

More information

Simulation of lid-driven cavity ows by parallel lattice Boltzmann method using multi-relaxation-time scheme

Simulation of lid-driven cavity ows by parallel lattice Boltzmann method using multi-relaxation-time scheme INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2004; 46:921 937 Published online 27 September 2004 in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/d.787

More information

On the lattice Boltzmann method for multiphase flows

On the lattice Boltzmann method for multiphase flows Center for Turbulence Research Annual Research Briefs 2009 377 On the lattice Boltzmann method for multiphase flows By S. H. Kim AND H. Pitsch 1. Motivation and objectives The lattice Boltzmann (LB) method

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

Stochastic Particle Methods for Rarefied Gases

Stochastic Particle Methods for Rarefied Gases CCES Seminar WS 2/3 Stochastic Particle Methods for Rarefied Gases Julian Köllermeier RWTH Aachen University Supervisor: Prof. Dr. Manuel Torrilhon Center for Computational Engineering Science Mathematics

More information

Numerical Simulation Of Pore Fluid Flow And Fine Sediment Infiltration Into The Riverbed

Numerical Simulation Of Pore Fluid Flow And Fine Sediment Infiltration Into The Riverbed City University of New York (CUNY) CUNY Academic Works International Conference on Hydroinformatics 8-1-2014 Numerical Simulation Of Pore Fluid Flow And Fine Sediment Infiltration Into The Riverbed Tobias

More information

Lattice Boltzmann Method

Lattice Boltzmann Method Chapter 5 Lattice Boltzmann Method 5.1 Pseudo-kinetic computational methods Understanding the flow properties of complex fluids in complex topologies is of importance to technological applications and

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

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

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

Lattice Boltzmann method for adiabatic acoustics

Lattice Boltzmann method for adiabatic acoustics 369, 2371 2380 doi:10.1098/rsta.2011.0109 Lattice Boltzmann method for adiabatic acoustics BY YANBING LI AND XIAOWEN SHAN* Exa Corporation, Burlington, MA 01803, USA The lattice Boltzmann method (LBM)

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

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

LATTICE BOLTZMANN METHOD FOR FLUID FLOWS

LATTICE BOLTZMANN METHOD FOR FLUID FLOWS Annu. Rev. Fluid Mech. 1998. 30:329 64 Copyright c 1998 by Annual Reviews Inc. All rights reserved LATTICE BOLTZMANN METHOD FOR FLUID FLOWS Shiyi Chen 1,2 and Gary D. Doolen 2 1 IBM Research Division,

More information

A consistent hydrodynamic boundary condition for the lattice Boltzmann method

A consistent hydrodynamic boundary condition for the lattice Boltzmann method A consistent hydrodynamic boundary condition for the lattice Boltzmann method David R. Noble Department of Mechanical and ndustrial Engineering, University of llinois, Urbana, llinois 61801 Shiyi Chen

More information

Kinetic boundary conditions in the lattice Boltzmann method

Kinetic boundary conditions in the lattice Boltzmann method Kinetic oundary conditions in the lattice Boltzmann method Santosh Ansumali and Iliya V. Karlin ETH-Zürich, Department of Materials, Institute of Polymers, ETH-Zentrum, Sonneggstrasse 3, ML J 19, CH-8092

More information

arxiv:comp-gas/ v1 15 Jun 1993

arxiv:comp-gas/ v1 15 Jun 1993 Stability Analysis of Lattice Boltzmann Methods arxiv:comp-gas/9306001v1 15 Jun 1993 James D. Sterling Center for Nonlinear Studies, MS-B58 Los Alamos National Laboratory Los Alamos, NM 87545 Permanent

More information

Simulation of Flow Induced Noise in Exhaust Silencers

Simulation of Flow Induced Noise in Exhaust Silencers Simulation of Flow Induced Noise in Exhaust Silencers Barbara NEUHIERL 1 ; 1 Exa GmbH, Germany ABSTRACT This paper deals with the simulation of flow generated noise in exhaust systems. Exhaust noise typically

More information

Single curved fiber sedimentation under gravity

Single curved fiber sedimentation under gravity Single curved fiber sedimentation under gravity Xiaoying Rong, Dewei Qi, Guowei He, JunYong Zhu, Tim Scott Abstract Dynamics of single curved fiber sedimentation under gravity are simulated by using the

More information

Solution of the Hirota Equation Using Lattice-Boltzmann and the Exponential Function Methods

Solution of the Hirota Equation Using Lattice-Boltzmann and the Exponential Function Methods Advanced Studies in Theoretical Physics Vol. 11, 2017, no. 7, 307-315 HIKARI Ltd, www.m-hikari.com https://doi.org/10.12988/astp.2017.7418 Solution of the Hirota Equation Using Lattice-Boltzmann and the

More information

The lattice Boltzmann equation (LBE) has become an alternative method for solving various fluid dynamic

The lattice Boltzmann equation (LBE) has become an alternative method for solving various fluid dynamic 36th AIAA Fluid Dynamics Conference and Exhibit 5-8 June 2006, San Francisco, California AIAA 2006-3904 Direct and Large-Eddy Simulation of Decaying and Forced Isotropic Turbulence Using Lattice Boltzmann

More information

Matrix lattice Boltzmann reloaded

Matrix lattice Boltzmann reloaded Matrix lattice Boltzmann reloaded By Ilya Karlin,2, Pietro Asinari 3, Sauro Succi 4,5 Aerothermochemistry and Combustion Systems Lab, ETH Zurich, 8092 Zurich, Switzerland 2 School of Engineering Sciences,

More information

The lattice Boltzmann equation: background and boundary conditions

The lattice Boltzmann equation: background and boundary conditions The lattice Boltzmann equation: background and boundary conditions Tim Reis Department of Mathematics Sciences University of Greenwich Leslie Comrie Seminar Series November 2016 Acknowledgements: P. Dellar

More information

A Unified Gas-kinetic Scheme for Continuum and Rarefied Flows

A Unified Gas-kinetic Scheme for Continuum and Rarefied Flows A Unified Gas-kinetic Scheme for Continuum and Rarefied Flows K. Xu and J.C. Huang Mathematics Department, Hong Kong University of Science and Technology, Hong Kong Department of Merchant Marine, National

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

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

Simulation of floating bodies with lattice Boltzmann

Simulation of floating bodies with lattice Boltzmann Simulation of floating bodies with lattice Boltzmann by Simon Bogner, 17.11.2011, Lehrstuhl für Systemsimulation, Friedrich-Alexander Universität Erlangen 1 Simulation of floating bodies with lattice Boltzmann

More information

A Compact and Efficient Lattice Boltzmann Scheme to Simulate Complex Thermal Fluid Flows

A Compact and Efficient Lattice Boltzmann Scheme to Simulate Complex Thermal Fluid Flows A Compact and Efficient Lattice Boltzmann Scheme to Simulate Complex Thermal Fluid Flows Tao Zhang 1[0000-0001-7216-0423] and Shuyu Sun 1[0000-0002-3078-864X] 1 Computational Transport Phenomena Laboratory

More information

EXTENDED FREE SURFACE FLOW MODEL BASED ON THE LATTICE BOLTZMANN APPROACH

EXTENDED FREE SURFACE FLOW MODEL BASED ON THE LATTICE BOLTZMANN APPROACH METALLURGY AND FOUNDRY ENGINEERING Vol. 36, 2010, No. 2 Micha³ Szucki*, Józef S. Suchy***, Pawe³ ak*, Janusz Lelito**, Beata Gracz* EXTENDED FREE SURFACE FLOW MODEL BASED ON THE LATTICE BOLTZMANN APPROACH

More information

Force Evaluation in the Lattice Boltzmann Method Involving Curved Geometry

Force Evaluation in the Lattice Boltzmann Method Involving Curved Geometry NASA/CR-2002-211662 ICASE Report No. 2002-22 Force Evaluation in the Lattice Boltzmann Method Involving Curved Geometry Renwei Mei, Dazhi Yu, and Wei Shyy University of Florida, Gainesville, Florida Li-Shi

More information

Physical Modeling of Multiphase flow. Boltzmann method

Physical Modeling of Multiphase flow. Boltzmann method with lattice Boltzmann method Exa Corp., Burlington, MA, USA Feburary, 2011 Scope Scope Re-examine the non-ideal gas model in [Shan & Chen, Phys. Rev. E, (1993)] from the perspective of kinetic theory

More information

Structural stability of Lattice Boltzmann schemes

Structural stability of Lattice Boltzmann schemes Structural stability of Lattice Boltzmann schemes Claire David, Pierre Sagaut To cite this version: Claire David, Pierre Sagaut. Structural stability of Lattice Boltzmann schemes. Physica A, Elsevier,

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

66 LI-SHI LUO 988, the rst proposal to use the lattice Boltzmann equation to simulate uid dynamics was made (McNamara & Zanetti, 988). The evidence th

66 LI-SHI LUO 988, the rst proposal to use the lattice Boltzmann equation to simulate uid dynamics was made (McNamara & Zanetti, 988). The evidence th THE FUTURE OF LATTICE-GAS AND LATTICE BOLTZMANN METHODS LI-SHI LUO ICASE MS 403, NASA Langley Research Center 6 North Dryden Street, Building 98 Hampton, Virginia 368-000. Brief History Although the lattice-gas

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

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

A Lattice Boltzmann Model for Diffusion of Binary Gas Mixtures

A Lattice Boltzmann Model for Diffusion of Binary Gas Mixtures A Lattice Boltzmann Model for Diffusion of Binary Gas Mixtures University of Cambridge Department of Engineering This dissertation is submitted for the degree of Doctor of Philosophy by: Sam Bennett King

More information

Assessment of the far-field sound radiation of ducts using the lattice Boltzmann method and a two-dimensional Ffwocs Williams and Hawkings formulation

Assessment of the far-field sound radiation of ducts using the lattice Boltzmann method and a two-dimensional Ffwocs Williams and Hawkings formulation Numerical Techniques (others): Paper ICA2016-802 Assessment of the far-field sound radiation of ducts using the lattice Boltzmann method and a two-dimensional Ffwocs Williams and Hawkings formulation Danilo

More information

Entropic lattice Boltzmann method for microflows

Entropic lattice Boltzmann method for microflows Entropic lattice Boltzmann method for microflows S. Ansumali, I. V. Karlin, C. E. Frouzakis, K. B. Boulouchos Aerothermochemistry and Combustion Systems Laboratory Swiss Federal Institute of Technology

More information

Numerical Investigation on Shear Driven Cavity Flow by the Constrained Interpolated Profile Lattice Boltzmann Method

Numerical Investigation on Shear Driven Cavity Flow by the Constrained Interpolated Profile Lattice Boltzmann Method Numerical Investigation on Shear Driven Cavity Flow by the Constrained Interpolated Profile Lattice Boltzmann Method *C. S. NOR AZWADI, M. H. Al-MOLA and S. AGUS Department of Thermo-fluid Universiti Teknologi

More information

Lattice Boltzmann Simulations of 2D Laminar Flows past Two Tandem Cylinders

Lattice Boltzmann Simulations of 2D Laminar Flows past Two Tandem Cylinders Lattice Boltzmann Simulations of 2D Laminar Flows past Two Tandem Cylinders Alberto Mussa a, Pietro Asinari a,, and Li-Shi Luo b a Department of Energetics, Politecnico di Torino, Torino 10129, Italy Tel.:

More information

Fluid Equations for Rarefied Gases

Fluid Equations for Rarefied Gases 1 Fluid Equations for Rarefied Gases Jean-Luc Thiffeault Department of Applied Physics and Applied Mathematics Columbia University http://plasma.ap.columbia.edu/~jeanluc 21 May 2001 with E. A. Spiegel

More information

Coupling of Lattice Boltzmann Equation and Finite Volume Method to Simulate Heat Transfer in a Square Cavity

Coupling of Lattice Boltzmann Equation and Finite Volume Method to Simulate Heat Transfer in a Square Cavity Copyright 2009 Tech Science Press FDMP, vol.5, no.3, pp.283-295, 2009 Coupling of Lattice Boltzmann Equation and Finite Volume Method to Simulate Heat Transfer in a Square Cavity Ahmed Mezrhab 1 and Hassan

More information

On the stability of a relative velocity lattice Boltzmann scheme for compressible Navier-Stokes equations

On the stability of a relative velocity lattice Boltzmann scheme for compressible Navier-Stokes equations On the stability of a relative velocity lattice Boltzmann scheme for compressible Navier-Stokes equations François Dubois, Tony Fevrier, Benjamin Graille To cite this version: François Dubois, Tony Fevrier,

More information

Lateral Migration and Orientation of Elliptical Particles in Poiseuille Flows

Lateral Migration and Orientation of Elliptical Particles in Poiseuille Flows Journal of Statistical Physics, Vol. 17, Nos. 1/2, April 22 ( 22) Lateral Migration and Orientation of Elliptical Particles in Poiseuille Flows Dewei Qi, 1 Lishi Luo, 2 Raja Aravamuthan, 3 and William

More information

Physical symmetry, spatial accuracy, and relaxation time of the lattice Boltzmann equation for microgas flows

Physical symmetry, spatial accuracy, and relaxation time of the lattice Boltzmann equation for microgas flows JOURNAL OF APPLIED PHYSICS 99, 074903 2006 Physical symmetry, spatial accuracy, and relaxation time of the lattice Boltzmann equation for microgas flows Zhaoli Guo a National Laboratory of Coal Combustion,

More information

Analytic Solutions of Simple Flows and Analysis of Nonslip Boundary Conditions for the Lattice Boltzmann BGK Model

Analytic Solutions of Simple Flows and Analysis of Nonslip Boundary Conditions for the Lattice Boltzmann BGK Model Journal of Statistical Physics, Vol. 87, Nos. 1/2, 1997 Analytic Solutions of Simple Flows and Analysis of Nonslip Boundary Conditions for the Lattice Boltzmann BGK Model Xiaoyi He, i.~_ Qisu Zou, t.3.5

More information

Lattice Boltzmann simulations of a time-dependent natural convection problem

Lattice Boltzmann simulations of a time-dependent natural convection problem Lattice Boltzmann simulations of a time-dependent natural convection problem B. Trouette To cite this version: B. Trouette. Lattice Boltzmann simulations of a time-dependent natural convection problem.

More information

Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann Method

Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann Method nd Micro and Nano Flows Conference West London, UK, 1- September 009 Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann

More information

The lattice Boltzmann method for contact line dynamics

The lattice Boltzmann method for contact line dynamics The lattice Boltzmann method for contact line dynamics Sudhir Srivastava, J.H.M. ten Thije Boonkkamp, Federico Toschi April 13, 2011 Overview 1 Problem description 2 Huh and Scriven model 3 Lattice Boltzmann

More information

DURING the past two decades, the standard lattice Boltzmann

DURING the past two decades, the standard lattice Boltzmann IAENG International Journal of Computer Science 44:4 IJCS_44_4_4 Scalable Parallel Algorithm of Finite Difference Lattice Boltzmann Method Lei Xu Anping Song Zhixiang Liu and Wu Zhang Abstract The lattice

More information

Simplified Mesoscale Lattice Boltzmann Numerical Model for Prediction of Natural Convection in a Square Enclosure filled with Homogeneous Porous Media

Simplified Mesoscale Lattice Boltzmann Numerical Model for Prediction of Natural Convection in a Square Enclosure filled with Homogeneous Porous Media Simplified Mesoscale Lattice Boltzmann Numerical Model for Prediction of Natural Convection in a Square Enclosure filled with Homogeneous Porous Media C.S.NOR AZWADI M.A.M. IRWAN Faculty of Mechanical

More information

Discontinuous shear thickening on dense non-brownian suspensions via lattice Boltzmann method

Discontinuous shear thickening on dense non-brownian suspensions via lattice Boltzmann method Discontinuous shear thickening on dense non-brownian suspensions via lattice Boltzmann method Pradipto and Hisao Hayakawa Yukawa Insitute for Theoretical Physics Kyoto University Rheology of disordered

More information

Lattice Boltzmann simulations of a time-dependent natural convection problem

Lattice Boltzmann simulations of a time-dependent natural convection problem Lattice Boltzmann simulations of a time-dependent natural convection problem Benoît Trouette To cite this version: Benoît Trouette. Lattice Boltzmann simulations of a time-dependent natural convection

More information