Lattice Boltzmann methods
   HOME

TheInfoList



OR:

The lattice Boltzmann methods (LBM), originated from the lattice gas automata (LGA) method (Hardy- Pomeau-Pazzis and Frisch- Hasslacher- Pomeau models), is a class of
computational fluid dynamics Computational fluid dynamics (CFD) is a branch of fluid mechanics that uses numerical analysis and data structures to analyze and solve problems that involve fluid flows. Computers are used to perform the calculations required to simulate ...
(CFD) methods for
fluid simulation Fluid animation refers to computer graphics techniques for generating realistic animations of fluids such as water and smoke. Fluid animations are typically focused on emulating the qualitative visual behavior of a fluid, with less emphasis plac ...
. Instead of solving the
Navier–Stokes equations In physics, the Navier–Stokes equations ( ) are partial differential equations which describe the motion of viscous fluid substances, named after French engineer and physicist Claude-Louis Navier and Anglo-Irish physicist and mathematician Geo ...
directly, a fluid density on a lattice is simulated with streaming and collision (relaxation) processes. The method is versatile as the model fluid can straightforwardly be made to mimic common fluid behaviour like vapour/liquid coexistence, and so fluid systems such as liquid droplets can be simulated. Also, fluids in complex environments such as porous media can be straightforwardly simulated, whereas with complex boundaries other CFD methods can be hard to work with.


Algorithm

Unlike CFD methods that solve the conservation equations of macroscopic properties (i.e., mass, momentum, and energy) numerically, LBM models the fluid consisting of fictive particles, and such particles perform consecutive propagation and collision processes over a discrete lattice. Due to its particulate nature and local dynamics, LBM has several advantages over other conventional CFD methods, especially in dealing with complex boundaries, incorporating microscopic interactions, and parallelization of the algorithm. A different interpretation of the lattice Boltzmann equation is that of a discrete-velocity
Boltzmann equation The Boltzmann equation or Boltzmann transport equation (BTE) describes the statistical behaviour of a thermodynamic system not in a state of equilibrium, devised by Ludwig Boltzmann in 1872.Encyclopaedia of Physics (2nd Edition), R. G. Lerne ...
. The numerical methods of solution of the system of partial differential equations then give rise to a discrete map, which can be interpreted as the propagation and collision of fictitious particles. In an algorithm, there are collision and streaming steps. These evolve the density of the fluid \rho(\vec,t), for \vec the position and t the time. As the fluid is on a lattice, the density has a number of components f_i, i=0,\ldots, a equal to the number of lattice vectors connected to each lattice point. As an example, the lattice vectors for a simple lattice used in simulations in two dimensions is shown here. This lattice is usually denoted D2Q9, for two dimensions and nine vectors: four vectors along north, east, south and west, plus four vectors to the corners of a unit square, plus a vector with both components zero. Then, for example vector \vec_4=(0,-1), i.e., it points due south and so has no x component but a y component of -1. So one of the nine components of the total density at the central lattice point, f_4(\vec,t), is that part of the fluid at point \vec moving due south, at a speed in lattice units of one. Then the steps that evolve the fluid in time are: ; The collision step: : f_i(\vec,t+\delta_t) = f_i(\vec,t) + \frac \,\! : which is the Bhatnagar Gross and Krook (BGK) model for relaxation to equilibrium via collisions between the molecules of a fluid. f_i^(\vec,t) is the equilibrium density along direction ''i'' at the current density there. The model assumes that the fluid locally relaxes to equilibrium over a characteristic timescale \tau_f. This timescale determines the
kinematic viscosity The viscosity of a fluid is a measure of its resistance to deformation at a given rate. For liquids, it corresponds to the informal concept of "thickness": for example, syrup has a higher viscosity than water. Viscosity quantifies the int ...
, the larger it is, the larger is the kinematic viscosity. ; The streaming step: : f_i(\vec+\vec_i,t+\delta_t) =f_i(\vec,t) \,\! : As f_i(\vec,t) is, by definition, the fluid density at point \vec at time t, that is moving at a velocity of \vec_i per time step, then at the next time step t+\delta_t it will have flowed to point \vec+\vec_i.


Advantages

* The LBM was designed from scratch to run efficiently on massively parallel architectures, ranging from inexpensive embedded
FPGAs A field-programmable gate array (FPGA) is an integrated circuit designed to be configured by a customer or a designer after manufacturinghence the term '' field-programmable''. The FPGA configuration is generally specified using a hardware de ...
and DSPs up to GPUs and heterogeneous clusters and supercomputers (even with a slow interconnection network). It enables complex physics and sophisticated algorithms. Efficiency leads to a qualitatively new level of understanding since it allows solving problems that previously could not be approached (or only with insufficient accuracy). * The method originates from a molecular description of a fluid and can directly incorporate physical terms stemming from a knowledge of the interaction between molecules. Hence it is an indispensable instrument in fundamental research, as it keeps the cycle between the elaboration of a theory and the formulation of a corresponding numerical model short. * Automated data pre-processing and lattice generation in a time that accounts for a small fraction of the total simulation. * Parallel data analysis, post-processing and evaluation. * Fully resolved multi-phase flow with small droplets and bubbles. * Fully resolved flow through complex geometries and porous media. * Complex, coupled flow with heat transfer and chemical reactions.


Limitations

Despite the increasing popularity of LBM in simulating complex fluid systems, this novel approach has some limitations. At present, high-Mach number flows in
aerodynamics Aerodynamics, from grc, ἀήρ ''aero'' (air) + grc, δυναμική (dynamics), is the study of the motion of air, particularly when affected by a solid object, such as an airplane wing. It involves topics covered in the field of fluid dy ...
are still difficult for LBM, and a consistent thermo-hydrodynamic scheme is absent. However, as with Navier–Stokes based CFD, LBM methods have been successfully coupled with thermal-specific solutions to enable heat transfer (solids-based conduction, convection and radiation) simulation capability. For multiphase/multicomponent models, the interface thickness is usually large and the density ratio across the interface is small when compared with real fluids. Recently this problem has been resolved by Yuan and
Schaefer Schaefer is an alternative spelling and cognate for the German word ''schäfer'', meaning 'shepherd', which itself descends from the Old High German '' scāphare''. Variants "Shaefer", "Schäfer" (a standardized spelling in many German-speaking ...
who improved on models by Shan and Chen, Swift, and He, Chen, and Zhang. They were able to reach density ratios of 1000:1 by simply changing the
equation of state In physics, chemistry, and thermodynamics, an equation of state is a thermodynamic equation relating state variables, which describe the state of matter under a given set of physical conditions, such as pressure, volume, temperature, or intern ...
. It has been proposed to apply Galilean Transformation to overcome the limitation of modelling high-speed fluid flows. Nevertheless, the wide applications and fast advancements of this method during the past twenty years have proven its potential in computational physics, including
microfluidics Microfluidics refers to the behavior, precise control, and manipulation of fluids that are geometrically constrained to a small scale (typically sub-millimeter) at which surface forces dominate volumetric forces. It is a multidisciplinary field th ...
: LBM demonstrates promising results in the area of high
Knudsen number The Knudsen number (Kn) is a dimensionless number defined as the ratio of the molecular mean free path length to a representative physical length scale. This length scale could be, for example, the radius of a body in a fluid. The number is name ...
flows.


Development from the LGA method

LBM originated from the lattice gas automata (LGA) method, which can be considered as a simplified fictitious molecular dynamics model in which space, time, and particle velocities are all discrete. For example, in the 2-dimensional FHP Model each lattice node is connected to its neighbors by 6 lattice velocities on a triangular lattice; there can be either 0 or 1 particles at a lattice node moving with a given lattice velocity. After a time interval, each particle will move to the neighboring node in its direction; this process is called the propagation or streaming step. When more than one particle arrives at the same node from different directions, they collide and change their velocities according to a set of collision rules. Streaming steps and collision steps alternate. Suitable collision rules should conserve the
particle number The particle number (or number of particles) of a thermodynamic system, conventionally indicated with the letter ''N'', is the number of constituent particles in that system. The particle number is a fundamental parameter in thermodynamics which i ...
(mass), momentum, and energy before and after the collision. LGA suffer from several innate defects for use in hydrodynamic simulations: lack of Galilean invariance for fast flows, statistical noise and poor
Reynolds number In fluid mechanics, the Reynolds number () is a dimensionless quantity that helps predict fluid flow patterns in different situations by measuring the ratio between inertial and viscous forces. At low Reynolds numbers, flows tend to be dom ...
scaling with lattice size. LGA are, however, well suited to simplify and extend the reach of reaction diffusion and
molecular dynamics Molecular dynamics (MD) is a computer simulation method for analyzing the physical movements of atoms and molecules. The atoms and molecules are allowed to interact for a fixed period of time, giving a view of the dynamic "evolution" of th ...
models. The main motivation for the transition from LGA to LBM was the desire to remove the statistical noise by replacing the Boolean particle number in a lattice direction with its ensemble average, the so-called density distribution function. Accompanying this replacement, the discrete collision rule is also replaced by a continuous function known as the collision operator. In the LBM development, an important simplification is to approximate the collision operator with the Bhatnagar-Gross-Krook (BGK) relaxation term. This lattice BGK (LBGK) model makes simulations more efficient and allows flexibility of the transport coefficients. On the other hand, it has been shown that the LBM scheme can also be considered as a special discretized form of the continuous Boltzmann equation. From Chapman-Enskog theory, one can recover the governing continuity and Navier–Stokes equations from the LBM algorithm.


Lattices and the D''n''Q''m'' classification

Lattice Boltzmann models can be operated on a number of different lattices, both cubic and triangular, and with or without rest particles in the discrete distribution function. A popular way of classifying the different methods by lattice is the D''n''Q''m'' scheme. Here "D''n''" stands for "''n'' dimensions", while "Q''m''" stands for "''m'' speeds". For example, D3Q15 is a 3-dimensional lattice Boltzmann model on a cubic grid, with rest particles present. Each node has a crystal shape and can deliver particles to 15 nodes: each of the 6 neighboring nodes that share a surface, the 8 neighboring nodes sharing a corner, and itself. (The D3Q15 model does not contain particles moving to the 12 neighboring nodes that share an edge; adding those would create a "D3Q27" model.) Real quantities as space and time need to be converted to lattice units prior to simulation. Nondimensional quantities, like the
Reynolds number In fluid mechanics, the Reynolds number () is a dimensionless quantity that helps predict fluid flow patterns in different situations by measuring the ratio between inertial and viscous forces. At low Reynolds numbers, flows tend to be dom ...
, remain the same.


Lattice units conversion

In most Lattice Boltzmann simulations \delta_x\,\! is the basic unit for lattice spacing, so if the domain of length L\,\! has N\,\! lattice units along its entire length, the space unit is simply defined as \delta_x=L/N\,\!. Speeds in lattice Boltzmann simulations are typically given in terms of the speed of sound. The discrete time unit can therefore be given as \delta_t = \frac\,\!, where the denominator C_s is the physical speed of sound. For small-scale flows (such as those seen in
porous media A porous medium or a porous material is a material containing pores (voids). The skeletal portion of the material is often called the "matrix" or "frame". The pores are typically filled with a fluid (liquid or gas). The skeletal material is usu ...
mechanics), operating with the true speed of sound can lead to unacceptably short time steps. It is therefore common to raise the lattice
Mach number Mach number (M or Ma) (; ) is a dimensionless quantity in fluid dynamics representing the ratio of flow velocity past a boundary to the local speed of sound. It is named after the Moravian physicist and philosopher Ernst Mach. : \mathrm = \f ...
to something much larger than the real Mach number, and compensating for this by raising the
viscosity The viscosity of a fluid is a measure of its resistance to deformation at a given rate. For liquids, it corresponds to the informal concept of "thickness": for example, syrup has a higher viscosity than water. Viscosity quantifies the int ...
as well in order to preserve the
Reynolds number In fluid mechanics, the Reynolds number () is a dimensionless quantity that helps predict fluid flow patterns in different situations by measuring the ratio between inertial and viscous forces. At low Reynolds numbers, flows tend to be dom ...
.


Simulation of mixtures

Simulating multiphase/multicomponent flows has always been a challenge to conventional CFD because of the moving and deformable
interfaces Interface or interfacing may refer to: Academic journals * ''Interface'' (journal), by the Electrochemical Society * '' Interface, Journal of Applied Linguistics'', now merged with ''ITL International Journal of Applied Linguistics'' * '' Int ...
. More fundamentally, the interfaces between different phases (liquid and vapor) or components (e.g., oil and water) originate from the specific interactions among fluid molecules. Therefore, it is difficult to implement such microscopic interactions into the macroscopic Navier–Stokes equation. However, in LBM, the particulate kinetics provides a relatively easy and consistent way to incorporate the underlying microscopic interactions by modifying the collision operator. Several LBM multiphase/multicomponent models have been developed. Here phase separations are generated automatically from the particle dynamics and no special treatment is needed to manipulate the interfaces as in traditional CFD methods. Successful applications of multiphase/multicomponent LBM models can be found in various complex fluid systems, including interface instability,
bubble Bubble, Bubbles or The Bubble may refer to: Common uses * Bubble (physics), a globule of one substance in another, usually gas in a liquid ** Soap bubble * Economic bubble, a situation where asset prices are much higher than underlying fund ...
/
droplet A drop or droplet is a small column of liquid, bounded completely or almost completely by free surfaces. A drop may form when liquid accumulates at the lower end of a tube or other surface boundary, producing a hanging drop called a pendant ...
dynamics,
wetting Wetting is the ability of a liquid to maintain contact with a solid surface, resulting from intermolecular interactions when the two are brought together. This happens in presence of a gaseous phase or another liquid phase not miscible with ...
on solid surfaces, interfacial slip, and droplet electrohydrodynamic deformations. A lattice Boltzmann model for simulation of gas mixture combustion capable of accommodating significant density variations at low-Mach number regime has been recently proposed. To this respect, it is worth to notice that, since LBM deals with a larger set of fields (as compared to conventional CFD), the simulation of reactive gas mixtures presents some additional challenges in terms of memory demand as far as large detailed combustion mechanisms are concerned. Those issues may be addressed, though, by resorting to systematic model reduction techniques.


Thermal lattice-Boltzmann method

Currently (2009), a thermal lattice-Boltzmann method (TLBM) falls into one of three categories: the multi-speed approach, the passive scalar approach, and the thermal energy distribution.


Derivation of Navier–Stokes equation from discrete LBE

Starting with the discrete lattice Boltzmann equation (also referred to as LBGK equation due to the collision operator used). We first do a 2nd-order Taylor series expansion about the left side of the LBE. This is chosen over a simpler 1st-order Taylor expansion as the discrete LBE cannot be recovered. When doing the 2nd-order Taylor series expansion, the zero derivative term and the first term on the right will cancel, leaving only the first and second derivative terms of the Taylor expansion and the collision operator: :f_i(\vec+\vec_i\delta_t,t+\delta_t) = f_i(\vec,t) + \frac (f_i^-f_i). For simplicity, write f_i(\vec,t) as f_i. The slightly simplified Taylor series expansion is then as follows, where ":" is the colon product between dyads: :\frac + \vec_i\cdot \nabla f_i + \left( \frac\vec_i\vec_i : \nabla\nabla f_i +\vec_i\cdot\nabla\frac + \frac\frac \right) = \frac(f_i^-f_i). By expanding the particle distribution function into equilibrium and non-equilibrium components and using the Chapman-Enskog expansion, where K is the Knudsen number, the Taylor-expanded LBE can be decomposed into different magnitudes of order for the Knudsen number in order to obtain the proper continuum equations: :f_i = f_i^\text + K f_i^\text, :f_i^\text = f_i^ + K f_i^+O(K^2). The equilibrium and non-equilibrium distributions satisfy the following relations to their macroscopic variables (these will be used later, once the particle distributions are in the "correct form" in order to scale from the particle to macroscopic level): :\rho = \sum_i f_i^\text, :\rho \vec = \sum_i f_i^\text \vec_i, :0 = \sum_i f_i^ \qquad \text k = 1,2, :0 = \sum_i f_i^ \vec_i. The Chapman-Enskog expansion is then: :\frac = K\frac + K^2\frac \qquad \text t_2(\text) \ll t_1(\text), :\frac = K\frac. By substituting the expanded equilibrium and non-equilibrium into the Taylor expansion and separating into different orders of K, the continuum equations are nearly derived. For order K^0: :\frac + \vec_i \nabla_1 f_i^\text = -\frac. For order K^1: :\frac + \frac + \vec_i \nabla f_i^ + \frac\vec_i\vec_i : \nabla\nabla f_i^\text +\vec_i \cdot \nabla\frac + \frac\frac = -\frac. Then, the second equation can be simplified with some algebra and the first equation into the following: :\frac + \left( 1 - \frac \right) \left \frac + \vec_i \nabla_1 f_i^ \right= -\frac. Applying the relations between the particle distribution functions and the macroscopic properties from above, the mass and momentum equations are achieved: :\frac + \nabla \cdot \rho \vec = 0, :\frac + \nabla \cdot \Pi = 0. The momentum flux tensor \Pi has the following form then: :\Pi_ = \sum_\vec_\vec_ \left f_i^ + \left( 1 - \frac \right) f_i^ \right where \vec_\vec_ is shorthand for the square of the sum of all the components of \vec_ (i. e. \textstyle\left(\sum_\vec_\right)^2 = \sum_\sum_\vec_\vec_), and the equilibrium particle distribution with second order to be comparable to the Navier–Stokes equation is: :f_i^\text = \omega_i\rho \left( 1 + \frac + \frac - \frac \right). The equilibrium distribution is only valid for small velocities or small
Mach number Mach number (M or Ma) (; ) is a dimensionless quantity in fluid dynamics representing the ratio of flow velocity past a boundary to the local speed of sound. It is named after the Moravian physicist and philosopher Ernst Mach. : \mathrm = \f ...
s. Inserting the equilibrium distribution back into the flux tensor leads to: : \Pi_^ = \sum_\vec_\vec_ f_i^ = p\delta_ + \rho u_x u_y, : \Pi_^ = \left( 1 - \frac \right) \sum_\vec_\vec_ f_i^ = \nu\left(\nabla_x \left( \rho \vec_y \right) + \nabla_y \left( \rho \vec_x \right)\right). Finally, the Navier–Stokes equation is recovered under the assumption that density variation is small: : \rho \left( \frac + \nabla_\cdot\vec_\vec_\right) = -\nabla_p + \nu\nabla_\cdot\left(\nabla_x \left( \rho \vec_y \right) + \nabla_y \left( \rho \vec_x \right)\right). This derivation follows the work of Chen and Doolen.


Mathematical equations for simulations

The continuous Boltzmann equation is an evolution equation for a single particle probability distribution function f(\vec,\vec_i,t) and the internal energy density distribution function g(\vec,\vec_i,t) (He et al.) are each respectively: :\partial_t f + (\vec\cdot \nabla) f + F\partial_v f = \Omega(f), :\partial_t g + (\vec\cdot \nabla) g + G\partial_v f = \Omega(g), where g(\vec,\vec_i,t) is related to f(\vec,\vec_i,t) by :g(\vec,\vec_i,t) = \fracf(\vec,\vec_i,t), F is an external force, \Omega is a collision integral, and \vec (also labeled by \vec in literature) is the microscopic velocity. The external force F is related to temperature external force G by the relation below. A typical test for one's model is the Rayleigh–Bénard convection for G. : F = \fracf^\text, : \vec = \beta g_0(T - T_)\vec. Macroscopic variables such as density \rho, velocity \vec, and temperature T can be calculated as the moments of the density distribution function: : \rho = \int f \, d\vec, : \rho\vec = \int \vecf \, d\vec, : \frac = \rho\epsilon = \int g \, d\vec. The lattice Boltzmann method discretizes this equation by limiting space to a lattice and the velocity space to a discrete set of microscopic velocities (i. e. \vec_i = (\vec_,\vec_)). The microscopic velocities in D2Q9, D3Q15, and D3Q19 for example are given as: :\vec_i = c\times \begin (0,0) & i = 0 \\ (1,0),(0,1),(-1,0),(0,-1) & i = 1,2,3,4 \\ (1,1),(-1,1),(-1,-1),(1,-1) & i = 5,6,7,8 \\ \end :\vec_i = c\times \begin (0,0,0) & i = 0 \\ (\plusmn 1,0,0),(0,\plusmn 1,0),(0,0,\plusmn 1) & i = 1,2,...,5,6 \\ (\plusmn1,\plusmn1,\plusmn1) & i = 7,8,...,13,14 \\ \end :\vec_i = c\times \begin (0,0,0) & i = 0 \\ (\plusmn 1,0,0),(0,\plusmn 1,0),(0,0,\plusmn 1) & i = 1,2,...,5,6 \\ (\plusmn1,\plusmn1,0),(\plusmn1,0,\plusmn1),(0,\plusmn1,\plusmn1) & i = 7,8,...,17,18 \\ \end The single-phase discretized Boltzmann equation for mass density and internal energy density are: :f_i(\vec+\vec_i\delta_t,t+\delta_t)-f_i(\vec,t) + F_i = \Omega(f), :g_i(\vec+\vec_i\delta_t,t+\delta_t)-g_i(\vec,t) + G_i = \Omega(g). The collision operator is often approximated by a BGK collision operator under the condition it also satisfies the conservation laws: :\Omega(f) = \frac (f_i^\text - f_i), :\Omega(g) = \frac (g_i^\text - g_i). In the collision operator f_i^\text is the discrete, . In D2Q9 and D3Q19, it is shown below for an incompressible flow in continuous and discrete form where ''D'', ''R'', and ''T'' are the dimension, universal gas constant, and absolute temperature respectively. The partial derivation for the continuous to discrete form is provided through a simple derivation to second order accuracy. :f^\text = \frace^ ::= \frace^e^ ::= \frace^\left(1+\frac+\frac-\frac+...\right) Letting c=\sqrt yields the final result: :f_i^=\omega_i\rho \left (1+\frac+\frac- \frac \right) :g^=\frace^ :\omega_i = \begin 4/9 & i = 0 \\ 1/9 & i = 1,2,3,4 \\ 1/36 & i = 5,6,7,8 \\ \end :\omega_i = \begin 1/3 & i = 0 \\ 1/18 & i = 1,2,...,5,6 \\ 1/36 & i = 7,8,...,17,18 \\ \end As much work has already been done on a single-component flow, the following TLBM will be discussed. The multicomponent/multiphase TLBM is also more intriguing and useful than simply one component. To be in line with current research, define the set of all components of the system (i. e. walls of porous media, multiple fluids/gases, etc.) \Psi with elements \sigma_j. :f_i^(\vec+\vec_i\delta_t,t+\delta_t)-f_i^(\vec,t) + F_i=\frac (f_i^(\rho^,v^)-f_i^) The relaxation parameter,\tau_f^\,\!, is related to the
kinematic viscosity The viscosity of a fluid is a measure of its resistance to deformation at a given rate. For liquids, it corresponds to the informal concept of "thickness": for example, syrup has a higher viscosity than water. Viscosity quantifies the int ...
,\nu_f^\,\!, by the following relationship: :\nu_f^ = (\tau_f^-0.5)c_s^2\delta_t. The moments of the f_i\,\! give the local conserved quantities. The density is given by :\rho=\sum_\sum_i f_i\,\! :\rho\epsilon =\sum_i g_i\,\! :\rho^=\sum_i f_i^\,\! and the weighted average velocity, \vec \,\!, and the local momentum are given by : \vec=\left (\sum_\frac\right)/\left(\sum_\frac\right) :\rho^ \vec = \sum_i f_i^ \vec_i. :v^ = \vec+ \frac\vec^ In the above equation for the equilibrium velocity v^\,\!, the \vec^\,\! term is the interaction force between a component and the other components. It is still the subject of much discussion as it is typically a tuning parameter that determines how fluid-fluid, fluid-gas, etc. interact. Frank et al. list current models for this force term. The commonly used derivations are Gunstensen chromodynamic model, Swift's free energy-based approach for both liquid/vapor systems and binary fluids, He's intermolecular interaction-based model, the Inamuro approach, and the Lee and Lin approach. The following is the general description for \vec^\,\! as given by several authors. \vec^ = -\psi^(\vec)\sum_H^(\vec,\vec')\sum_i\psi^(\vec+\vec_i)\vec_i \,\! \psi(\vec)\,\! is the effective mass and H(\vec,\vec')\,\! is Green's function representing the interparticle interaction with \vec'\,\! as the neighboring site. Satisfying H(\vec,\vec')=H(\vec',\vec)\,\! and where H(\vec,\vec')>0\,\! represents repulsive forces. For D2Q9 and D3Q19, this leads to H^(\vec,\vec') = \begin h^ & \left , \vec-\vec' \right , \le c \\ 0 & \left , \vec-\vec' \right , > c \\ \end H^(\vec,\vec') = \begin h^ & \left , \vec-\vec' \right , = c \\ h^/2 & \left , \vec-\vec' \right , =\sqrt \\ 0 & \text \\ \end The effective mass as proposed by Shan and Chen uses the following effective mass for a ''single-component, multiphase system''. The
equation of state In physics, chemistry, and thermodynamics, an equation of state is a thermodynamic equation relating state variables, which describe the state of matter under a given set of physical conditions, such as pressure, volume, temperature, or intern ...
is also given under the condition of a single component and multiphase. :\psi(\vec)=\psi(\rho^)=\rho_0^\left -e^ \right,\! :p=c_s^2 \rho+c_0h psi(\vec)2\,\! So far, it appears that \rho_0^\,\! and h^\,\! are free constants to tune but once plugged into the system's
equation of state In physics, chemistry, and thermodynamics, an equation of state is a thermodynamic equation relating state variables, which describe the state of matter under a given set of physical conditions, such as pressure, volume, temperature, or intern ...
(EOS), they must satisfy the thermodynamic relationships at the critical point such that (\partial P / \partial )_T=(\partial^2 P / \partial )_T=0\,\! and p=p_c\,\!. For the EOS, c_0\,\! is 3.0 for D2Q9 and D3Q19 while it equals 10.0 for D3Q15. It was later shown by Yuan and Schaefer that the effective mass density needs to be changed to simulate multiphase flow more accurately. They compared the Shan and Chen (SC), Carnahan-Starling (C–S), van der Waals (vdW), Redlich–Kwong (R–K), Redlich–Kwong Soave (RKS), and Peng–Robinson (P–R) EOS. Their results revealed that the SC EOS was insufficient and that C–S, P–R, R–K, and RKS EOS are all more accurate in modeling multiphase flow of a single component. For the popular isothermal Lattice Boltzmann methods these are the only conserved quantities. Thermal models also conserve energy and therefore have an additional conserved quantity: :\rho \theta + \rho u u =\sum_i f_i \vec_i \vec_i.


Applications

During the last years, the LBM has proven to be a powerful tool for solving problems at different length and time scales. Some of the applications of LBM include: * Porous Media flows * Biomedical Flows * Earth sciences (Soil filtration). * Energy Sciences (Fuel Cells).


External links


LBM Method

Entropic Lattice Boltzmann Method (ELBM)

dsfd.org: Website of the annual DSFD conference series (1986 -- now) where advances in theory and application of the lattice Boltzmann method are discussed

Website of the annual ICMMES conference on lattice Boltzmann methods and their applications


Further reading

* * * * * * * * *


Notes

{{DEFAULTSORT:Lattice Boltzmann Methods Computational fluid dynamics Lattice models