SlideShare a Scribd company logo
1 of 64
Download to read offline
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 the free-stream flow of
the fluid, and the interaction of the fluid (liquids and gases) with surfaces defined by boundary
conditions. With high-speed supercomputers, better solutions can be achieved, and are often
required to solve the largest and most complex problems. Ongoing research yields software
that improves the accuracy and speed of complex simulation scenarios such as transonic or
turbulent flows. Initial validation of such software is typically performed using experimental
apparatus such as wind tunnels. In addition, previously performed analytical or empirical
analysis of a particular problem can be used for comparison. A final validation is often
performed using full-scale testing, such as flight tests.
CFD is applied to a wide range of research and engineering problems in many fields of study
and industries, including aerodynamics and aerospace analysis, hypersonics, weather
simulation, natural science and environmental engineering, industrial system design and
analysis, biological engineering, fluid flows and heat transfer, engine and combustion analysis,
and visual effects for film and games.
A computer simulation of high
velocity air flow around the Space
Shuttle during re-entry
A simulation of the Hyper-X scramjet
vehicle in operation at Mach-7
The fundamental basis of almost all CFD problems is the Navier–Stokes equations, which
define many single-phase (gas or liquid, but not both) fluid flows. These equations can be
simplified by removing terms describing viscous actions to yield the Euler equations. Further
simplification, by removing terms describing vorticity yields the full potential equations.
Finally, for small perturbations in subsonic and supersonic flows (not transonic or hypersonic)
these equations can be linearized to yield the linearized potential equations.
Historically, methods were first developed to solve the linearized potential equations. Two-
dimensional (2D) methods, using conformal transformations of the flow about a cylinder to
the flow about an airfoil were developed in the 1930s.[1][2]
One of the earliest type of calculations resembling modern CFD are those by Lewis Fry
Richardson, in the sense that these calculations used finite differences and divided the
physical space in cells. Although they failed dramatically, these calculations, together with
Richardson's book Weather Prediction by Numerical Process,[3]
set the basis for modern CFD
Background and history
and numerical meteorology. In fact, early CFD calculations during the 1940s using ENIAC used
methods close to those in Richardson's 1922 book.[4]
The computer power available paced development of three-dimensional methods. Probably
the first work using computers to model fluid flow, as governed by the Navier–Stokes
equations, was performed at Los Alamos National Lab, in the T3 group.[5][6]
This group was led
by Francis H. Harlow, who is widely considered one of the pioneers of CFD. From 1957 to late
1960s, this group developed a variety of numerical methods to simulate transient two-
dimensional fluid flows, such as particle-in-cell method,[7]
fluid-in-cell method,[8]
vorticity
stream function method,[9]
and marker-and-cell method.[10]
Fromm's vorticity-stream-function
method for 2D, transient, incompressible flow was the first treatment of strongly contorting
incompressible flows in the world.
The first paper with three-dimensional model was published by John Hess and A.M.O. Smith of
Douglas Aircraft in 1967.[11]
This method discretized the surface of the geometry with
panels, giving rise to this class of programs being called Panel Methods. Their method itself
was simplified, in that it did not include lifting flows and hence was mainly applied to ship hulls
and aircraft fuselages. The first lifting Panel Code (A230) was described in a paper written by
Paul Rubbert and Gary Saaris of Boeing Aircraft in 1968.[12]
In time, more advanced three-
dimensional Panel Codes were developed at Boeing (PANAIR, A502),[13]
Lockheed
(Quadpan),[14]
Douglas (HESS),[15]
McDonnell Aircraft (MACAERO),[16]
NASA (PMARC)[17]
and
Analytical Methods (WBAERO,[18]
USAERO[19]
and VSAERO[20][21]
). Some (PANAIR, HESS and
MACAERO) were higher order codes, using higher order distributions of surface singularities,
while others (Quadpan, PMARC, USAERO and VSAERO) used single singularities on each
surface panel. The advantage of the lower order codes was that they ran much faster on the
computers of the time. Today, VSAERO has grown to be a multi-order code and is the most
widely used program of this class. It has been used in the development of many submarines,
surface ships, automobiles, helicopters, aircraft, and more recently wind turbines. Its sister
code, USAERO is an unsteady panel method that has also been used for modeling such things
as high speed trains and racing yachts. The NASA PMARC code from an early version of
VSAERO and a derivative of PMARC, named CMARC,[22]
is also commercially available.
In the two-dimensional realm, a number of Panel Codes have been developed for airfoil
analysis and design. The codes typically have a boundary layer analysis included, so that
viscous effects can be modeled. Richard Eppler developed the PROFILE code, partly with
NASA funding, which became available in the early 1980s.[23]
This was soon followed by Mark
Drela's XFOIL code.[24]
Both PROFILE and XFOIL incorporate two-dimensional panel codes,
with coupled boundary layer codes for airfoil analysis work. PROFILE uses a conformal
transformation method for inverse airfoil design, while XFOIL has both a conformal
transformation and an inverse panel method for airfoil design.
An intermediate step between Panel Codes and Full Potential codes were codes that used
the Transonic Small Disturbance equations. In particular, the three-dimensional WIBCO
code,[25]
developed by Charlie Boppe of Grumman Aircraft in the early 1980s has seen heavy
use.
A simulation of the SpaceX Starship
during re-entry
Developers turned to Full Potential codes, as panel methods could not calculate the non-
linear flow present at transonic speeds. The first description of a means of using the Full
Potential equations was published by Earll Murman and Julian Cole of Boeing in 1970.[26]
Frances Bauer, Paul Garabedian and David Korn of the Courant Institute at New York University
(NYU) wrote a series of two-dimensional Full Potential airfoil codes that were widely used,
the most important being named Program H.[27]
A further growth of Program H was
developed by Bob Melnik and his group at Grumman Aerospace as Grumfoil.[28]
Antony
Jameson, originally at Grumman Aircraft and the Courant Institute of NYU, worked with David
Caughey to develop the important three-dimensional Full Potential code FLO22[29]
in 1975.
Many Full Potential codes emerged after this, culminating in Boeing's Tranair (A633) code,[30]
which still sees heavy use.
The next step was the Euler equations, which promised to provide more accurate solutions of
transonic flows. The methodology used by Jameson in his three-dimensional FLO57 code[31]
(1981) was used by others to produce such programs as Lockheed's TEAM program[32]
and
IAI/Analytical Methods' MGAERO program.[33]
MGAERO is unique in being a structured
cartesian mesh code, while most other such codes use structured body-fitted grids (with the
exception of NASA's highly successful CART3D code,[34]
Lockheed's SPLITFLOW code[35]
and Georgia Tech's NASCART-GT).[36]
Antony Jameson also developed the three-dimensional
AIRPLANE code[37]
which made use of unstructured tetrahedral grids.
In the two-dimensional realm, Mark Drela and Michael Giles, then graduate students at MIT,
developed the ISES Euler program[38]
(actually a suite of programs) for airfoil design and
analysis. This code first became available in 1986 and has been further developed to design,
analyze and optimize single or multi-element airfoils, as the MSES program.[39]
MSES sees
wide use throughout the world. A derivative of MSES, for the design and analysis of airfoils in
a cascade, is MISES,[40]
developed by Harold Youngren while he was a graduate student at
MIT.
The Navier–Stokes equations were the ultimate target of development. Two-dimensional
codes, such as NASA Ames' ARC2D code first emerged. A number of three-dimensional codes
were developed (ARC3D, OVERFLOW, CFL3D are three successful NASA contributions),
leading to numerous commercial packages.
Recently CFD methods have gained traction for modeling the flow behavior of granular
materials within various chemical processes in engineering. This approach has emerged as a
cost-effective alternative, offering a nuanced understanding of complex flow phenomena
while minimizing expenses associated with traditional experimental methods.[41][42]
CFD can be seen as a group of computational methodologies (discussed below) used to
solve equations governing fluid flow. In the application of CFD, a critical step is to decide
which set of physical assumptions and related equations need to be used for the problem at
hand.[43]
To illustrate this step, the following summarizes the physical
assumptions/simplifications taken in equations of a flow that is single-phase (see multiphase
flow and two-phase flow), single-species (i.e., it consists of one chemical species), non-
reacting, and (unless said otherwise) compressible. Thermal radiation is neglected, and body
forces due to gravity are considered (unless said otherwise). In addition, for this type of flow,
the next discussion highlights the hierarchy of flow equations solved with CFD. Note that
some of the following equations could be derived in more than one way.
Hierarchy of fluid flow
equations
Conservation laws (CL): These are the
most fundamental equations
considered with CFD in the sense that,
for example, all the following
equations can be derived from them.
For a single-phase, single-species,
compressible flow one considers the
conservation of mass, conservation of
linear momentum, and conservation of
energy.
Continuum conservation laws (CCL):
Start with the CL. Assume that mass,
momentum and energy are locally
conserved: These quantities are
conserved and cannot "teleport" from
one place to another but can only
move by a continuous flow (see
continuity equation). Another
interpretation is that one starts with
the CL and assumes a continuum
medium (see continuum mechanics).
The resulting system of equations is
unclosed since to solve it one needs
further relationships/equations: (a)
constitutive relationships for the
viscous stress tensor; (b) constitutive
relationships for the diffusive heat flux;
(c) an equation of state (EOS), such as
the ideal gas law; and, (d) a caloric
equation of state relating temperature
with quantities such as enthalpy or
internal energy.
Compressible Navier-Stokes equations
(C-NS): Start with the CCL. Assume a
Newtonian viscous stress tensor (see
Newtonian fluid) and a Fourier heat flux
(see heat flux).[44][45] The C-NS need to
be augmented with an EOS and a
caloric EOS to have a closed system of
equations.
Incompressible Navier-Stokes
equations (I-NS): Start with the C-NS.
Assume that density is always and
everywhere constant.[46] Another way
to obtain the I-NS is to assume that the
Mach number is very small[46][45] and
that temperature differences in the
fluid are very small as well.[45] As a
result, the mass-conservation and
momentum-conservation equations
are decoupled from the energy-
conservation equation, so one only
needs to solve for the first two
equations.[45]
Compressible Euler equations (EE):
Start with the C-NS. Assume a
frictionless flow with no diffusive heat
flux.[47]
Weakly compressible Navier-Stokes
equations (WC-NS): Start with the C-
NS. Assume that density variations
depend only on temperature and not on
pressure.[48] For example, for an ideal
gas, use , where is a
conveniently-defined reference
pressure that is always and everywhere
constant, is density, is the specific
gas constant, and is temperature. As
a result, the WC-NS do not capture
acoustic waves. It is also common in
the WC-NS to neglect the pressure-
work and viscous-heating terms in the
energy-conservation equation. The WC-
NS are also called the C-NS with the
low-Mach-number approximation.
Boussinesq equations: Start with the C-
NS. Assume that density variations are
always and everywhere negligible
except in the gravity term of the
momentum-conservation equation
(where density multiplies the
gravitational acceleration).[49] Also
assume that various fluid properties
such as viscosity, thermal conductivity,
and heat capacity are always and
everywhere constant. The Boussinesq
equations are widely used in
microscale meteorology.
Compressible Reynolds-averaged
Navier–Stokes equations and
compressible Favre-averaged Navier-
Stokes equations (C-RANS and C-
FANS): Start with the C-NS. Assume
that any flow variable , such as
density, velocity and pressure, can be
represented as , where
is the ensemble-average[45] of any flow
variable, and is a perturbation or
fluctuation from this average.[45][50]
is not necessarily small. If is a
classic ensemble-average (see
Reynolds decomposition) one obtains
the Reynolds-averaged Navier–Stokes
equations. And if is a density-
weighted ensemble-average one
obtains the Favre-averaged Navier-
Stokes equations.[50] As a result, and
depending on the Reynolds number, the
range of scales of motion is greatly
reduced, something which leads to
much faster solutions in comparison to
solving the C-NS. However, information
is lost, and the resulting system of
equations requires the closure of
various unclosed terms, notably the
Reynolds stress.
Ideal flow or potential flow equations:
Start with the EE. Assume zero fluid-
particle rotation (zero vorticity) and
zero flow expansion (zero
divergence).[45] The resulting flowfield
is entirely determined by the
geometrical boundaries.[45] Ideal flows
can be useful in modern CFD to
initialize simulations.
Linearized compressible Euler
equations (LEE):[51] Start with the EE.
Assume that any flow variable , such
as density, velocity and pressure, can
be represented as , where
is the value of the flow variable at
some reference or base state, and
is a perturbation or fluctuation from
this state. Furthermore, assume that
this perturbation is very small in
comparison with some reference value.
Finally, assume that satisfies "its
own" equation, such as the EE. The LEE
and its many variations are widely used
in computational aeroacoustics.
Sound wave or acoustic wave
equation: Start with the LEE. Neglect all
gradients of and , and assume
that the Mach number at the reference
or base state is very small.[48] The
resulting equations for density,
momentum and energy can be
manipulated into a pressure equation,
giving the well-known sound wave
equation.
Shallow water equations (SW):
Consider a flow near a wall where the
wall-parallel length-scale of interest is
much larger than the wall-normal
length-scale of interest. Start with the
EE. Assume that density is always and
everywhere constant, neglect the
velocity component perpendicular to
the wall, and consider the velocity
parallel to the wall to be spatially-
constant.
Boundary layer equations (BL): Start
with the C-NS (I-NS) for compressible
(incompressible) boundary layers.
Assume that there are thin regions next
to walls where spatial gradients
perpendicular to the wall are much
larger than those parallel to the wall.[49]
Bernoulli equation: Start with the EE.
Assume that density variations depend
only on pressure variations.[49] See
Bernoulli's Principle.
Steady Bernoulli equation: Start with
the Bernoulli Equation and assume a
steady flow.[49] Or start with the EE and
assume that the flow is steady and
integrate the resulting equation along a
streamline.[47][46]
Stokes Flow or creeping flow
equations: Start with the C-NS or I-NS.
Neglect the inertia of the flow.[45][46]
Such an assumption can be justified
when the Reynolds number is very low.
As a result, the resulting set of
equations is linear, something which
simplifies greatly their solution.
Two-dimensional channel flow
equation: Consider the flow between
two infinite parallel plates. Start with
the C-NS. Assume that the flow is
steady, two-dimensional, and fully
developed (i.e., the velocity profile
does not change along the streamwise
direction).[45] Note that this widely-
used fully-developed assumption can
be inadequate in some instances, such
as some compressible, microchannel
flows, in which case it can be
supplanted by a locally fully-developed
assumption.[52]
One-dimensional Euler equations or
one-dimensional gas-dynamic
equations (1D-EE): Start with the EE.
Assume that all flow quantities depend
only on one spatial dimension.[53]
Fanno flow equation: Consider the flow
inside a duct with constant area and
adiabatic walls. Start with the 1D-EE.
Assume a steady flow, no gravity
effects, and introduce in the
momentum-conservation equation an
empirical term to recover the effect of
wall friction (neglected in the EE). To
close the Fanno flow equation, a model
for this friction term is needed. Such a
closure involves problem-dependent
assumptions.[54]
Rayleigh flow equation. Consider the
flow inside a duct with constant area
and either non-adiabatic walls without
volumetric heat sources or adiabatic
walls with volumetric heat sources.
Start with the 1D-EE. Assume a steady
flow, no gravity effects, and introduce
in the energy-conservation equation an
empirical term to recover the effect of
wall heat transfer or the effect of the
heat sources (neglected in the EE).
In all of these approaches the same basic procedure is followed.
Methodology
During preprocessing
The geometry and physical
bounds of the problem can be
defined using computer aided
design (CAD). From there, data
can be suitably processed
(cleaned-up) and the fluid volume
(or fluid domain) is extracted.
The volume occupied by the fluid
is divided into discrete cells (the
mesh). The mesh may be uniform
or non-uniform, structured or
unstructured, consisting of a
combination of hexahedral,
tetrahedral, prismatic, pyramidal or
polyhedral elements.
The physical modeling is defined –
for example, the equations of fluid
motion + enthalpy + radiation +
species conservation
Boundary conditions are defined.
This involves specifying the fluid
behaviour and properties at all
bounding surfaces of the fluid
domain. For transient problems,
the initial conditions are also
defined.
The simulation is started and the
equations are solved iteratively as a
steady-state or transient.
Finally a postprocessor is used for the
analysis and visualization of the
resulting solution.
Discretization methods
The stability of the selected discretisation is generally established numerically rather than
analytically as with simple linear problems. Special care must also be taken to ensure that the
discretisation handles discontinuous solutions gracefully. The Euler equations and Navier–
Stokes equations both admit shocks, and contact surfaces.
Some of the discretization methods being used are:
Finite volume method
The finite volume method (FVM) is a common approach used in CFD codes, as it has an
advantage in memory usage and solution speed, especially for large problems, high Reynolds
number turbulent flows, and source term dominated flows (like combustion).[55]
In the finite volume method, the governing partial differential equations (typically the Navier-
Stokes equations, the mass and energy conservation equations, and the turbulence
equations) are recast in a conservative form, and then solved over discrete control volumes.
This discretization guarantees the conservation of fluxes through a particular control volume.
The finite volume equation yields governing equations in the form,
where is the vector of conserved variables, is the vector of fluxes (see Euler equations
or Navier–Stokes equations), is the volume of the control volume element, and is the
surface area of the control volume element.
Finite element method
The finite element method (FEM) is used in structural analysis of solids, but is also applicable
to fluids. However, the FEM formulation requires special care to ensure a conservative
solution. The FEM formulation has been adapted for use with fluid dynamics governing
equations.[56][57]
Although FEM must be carefully formulated to be conservative, it is much
more stable than the finite volume approach.[58]
However, FEM can require more memory and
has slower solution times than the FVM.[59]
In this method, a weighted residual equation is formed:
where is the equation residual at an element vertex , is the conservation equation
expressed on an element basis, is the weight factor, and is the volume of the
element.
Finite difference method
The finite difference method (FDM) has historical importance[57]
and is simple to program. It
is currently only used in few specialized codes, which handle complex geometry with high
accuracy and efficiency by using embedded boundaries or overlapping grids (with the solution
interpolated across each grid).
where is the vector of conserved variables, and , , and are the fluxes in the , , and
directions respectively.
Spectral element method
Spectral element method is a finite element type method. It requires the mathematical
problem (the partial differential equation) to be cast in a weak formulation. This is typically
done by multiplying the differential equation by an arbitrary test function and integrating over
the whole domain. Purely mathematically, the test functions are completely arbitrary - they
belong to an infinite-dimensional function space. Clearly an infinite-dimensional function space
cannot be represented on a discrete spectral element mesh; this is where the spectral
element discretization begins. The most crucial thing is the choice of interpolating and
testing functions. In a standard, low order FEM in 2D, for quadrilateral elements the most
typical choice is the bilinear test or interpolating function of the form
. In a spectral element method however, the interpolating
and test functions are chosen to be polynomials of a very high order (typically e.g. of the 10th
order in CFD applications). This guarantees the rapid convergence of the method.
Furthermore, very efficient integration procedures must be used, since the number of
integrations to be performed in numerical codes is big. Thus, high order Gauss integration
quadratures are employed, since they achieve the highest accuracy with the smallest number
of computations to be carried out. At the time there are some academic CFD codes based on
the spectral element method and some more are currently under development, since the new
time-stepping schemes arise in the scientific world.
Lattice Boltzmann method
The lattice Boltzmann method (LBM) with its simplified kinetic picture on a lattice provides a
computationally efficient description of hydrodynamics. Unlike the traditional CFD methods,
which 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 mesh. In this
method, one works with the discrete in space and time version of the kinetic evolution
equation in the Boltzmann Bhatnagar-Gross-Krook (BGK) form.
Vortex method
The vortex method, also Lagrangian Vortex Particle Method, is a meshfree technique for the
simulation of incompressible turbulent flows. In it, vorticity is discretized onto Lagrangian
particles, these computational elements being called vortices, vortons, or vortex particles.[60]
Vortex methods were developed as a grid-free methodology that would not be limited by the
fundamental smoothing effects associated with grid-based methods. To be practical,
however, vortex methods require means for rapidly computing velocities from the vortex
elements – in other words they require the solution to a particular form of the N-body
problem (in which the motion of N objects is tied to their mutual influences). This
breakthrough came in the 1980s with the development of the Barnes-Hut and fast multipole
method (FMM) algorithms. These paved the way to practical computation of the velocities
from the vortex elements.
Software based on the vortex method offer a new means for solving tough fluid dynamics
problems with minimal user intervention. All that is required is specification of problem
geometry and setting of boundary and initial conditions. Among the significant advantages of
this modern technology;
It is practically grid-free, thus
eliminating numerous iterations
associated with RANS and LES.
All problems are treated identically. No
modeling or calibration inputs are
required.
Time-series simulations, which are
crucial for correct analysis of
acoustics, are possible.
The small scale and large scale are
accurately simulated at the same time.
Boundary element method
In the boundary element method, the boundary occupied by the fluid is divided into a surface
mesh.
High-resolution discretization schemes
High-resolution schemes are used where shocks or discontinuities are present. Capturing
sharp changes in the solution requires the use of second or higher-order numerical schemes
that do not introduce spurious oscillations. This usually necessitates the application of flux
limiters to ensure that the solution is total variation diminishing.
Turbulence models
In computational modeling of turbulent flows, one common objective is to obtain a model
that can predict quantities of interest, such as fluid velocity, for use in engineering designs of
the system being modeled. For turbulent flows, the range of length scales and complexity of
phenomena involved in turbulence make most modeling approaches prohibitively expensive;
the resolution required to resolve all scales involved in turbulence is beyond what is
computationally possible. The primary approach in such cases is to create numerical models
to approximate unresolved phenomena. This section lists some commonly used
computational models for turbulent flows.
Turbulence models can be classified based on computational expense, which corresponds to
the range of scales that are modeled versus resolved (the more turbulent scales that are
resolved, the finer the resolution of the simulation, and therefore the higher the
computational cost). If a majority or all of the turbulent scales are not modeled, the
computational cost is very low, but the tradeoff comes in the form of decreased accuracy.
In addition to the wide range of length and time scales and the associated computational
cost, the governing equations of fluid dynamics contain a non-linear convection term and a
non-linear and non-local pressure gradient term. These nonlinear equations must be solved
numerically with the appropriate boundary and initial conditions.
Reynolds-averaged Navier–Stokes
External aerodynamics of the DrivAer (http
s://www.mw.tum.de/en/aer/research-group
s/automotive/drivaer/) model, computed
using URANS (top) and DDES (bottom)
A simulation of aerodynamic package
of a Porsche Cayman (987.2)
Reynolds-averaged Navier–Stokes (RANS) equations are the oldest approach to turbulence
modeling. An ensemble version of the governing equations is solved, which introduces new
apparent stresses known as Reynolds stresses. This adds a second order tensor of unknowns
for which various models can provide different levels of closure. It is a common
misconception that the RANS equations do not apply to flows with a time-varying mean flow
because these equations are 'time-averaged'. In fact, statistically unsteady (or non-
stationary) flows can equally be treated. This is sometimes referred to as URANS. There is
nothing inherent in Reynolds averaging to preclude this, but the turbulence models used to
close the equations are valid only as long as the time over which these changes in the mean
occur is large compared to the time scales of the turbulent motion containing most of the
energy.
RANS models can be divided into two broad approaches:
Boussinesq hypothesis
This method involves using an
algebraic equation for the Reynolds
stresses which include determining the
turbulent viscosity, and depending on
the level of sophistication of the
model, solving transport equations for
determining the turbulent kinetic energy
and dissipation. Models include k-ε
(Launder and Spalding),[61] Mixing
Length Model (Prandtl),[62] and Zero
Equation Model (Cebeci and Smith).[62]
The models available in this approach
are often referred to by the number of
transport equations associated with
the method. For example, the Mixing
Length model is a "Zero Equation"
model because no transport equations
are solved; the is a "Two
Equation" model because two
transport equations (one for and one
for ) are solved.
Reynolds stress model (RSM)
This approach attempts to actually
solve transport equations for the
Reynolds stresses. This means
introduction of several transport
equations for all the Reynolds stresses
and hence this approach is much more
costly in CPU effort.
Large eddy simulation
Volume rendering of a non-premixed swirl
flame as simulated by LES
Large eddy simulation (LES) is a technique in which the smallest scales of the flow are
removed through a filtering operation, and their effect modeled using subgrid scale models.
This allows the largest and most important scales of the turbulence to be resolved, while
greatly reducing the computational cost incurred by the smallest scales. This method
requires greater computational resources than RANS methods, but is far cheaper than DNS.
Detached eddy simulation
Detached eddy simulations (DES) is a modification of a RANS model in which the model
switches to a subgrid scale formulation in regions fine enough for LES calculations. Regions
near solid boundaries and where the turbulent length scale is less than the maximum grid
dimension are assigned the RANS mode of solution. As the turbulent length scale exceeds
the grid dimension, the regions are solved using the LES mode. Therefore, the grid resolution
for DES is not as demanding as pure LES, thereby considerably cutting down the cost of the
computation. Though DES was initially formulated for the Spalart-Allmaras model (Spalart et
al., 1997), it can be implemented with other RANS models (Strelets, 2001), by appropriately
modifying the length scale which is explicitly or implicitly involved in the RANS model. So
while Spalart–Allmaras model based DES acts as LES with a wall model, DES based on other
models (like two equation models) behave as a hybrid RANS-LES model. Grid generation is
more complicated than for a simple RANS or LES case due to the RANS-LES switch. DES is a
non-zonal approach and provides a single smooth velocity field across the RANS and the LES
regions of the solutions.
IDDES Simulation of the Karel
Motorsports BMW. This is a type of
DES simulation completed in
OpenFOAM. The plot is coefficient of
pressure.
Direct numerical simulation
Direct numerical simulation (DNS) resolves the entire range of turbulent length scales. This
marginalizes the effect of models, but is extremely expensive. The computational cost is
proportional to .[63]
DNS is intractable for flows with complex geometries or flow
configurations.
Coherent vortex simulation
The coherent vortex simulation approach decomposes the turbulent flow field into a
coherent part, consisting of organized vortical motion, and the incoherent part, which is the
random background flow.[64]
This decomposition is done using wavelet filtering. The approach
has much in common with LES, since it uses decomposition and resolves only the filtered
portion, but different in that it does not use a linear, low-pass filter. Instead, the filtering
operation is based on wavelets, and the filter can be adapted as the flow field evolves. Farge
and Schneider tested the CVS method with two flow configurations and showed that the
coherent portion of the flow exhibited the energy spectrum exhibited by the total flow,
and corresponded to coherent structures (vortex tubes), while the incoherent parts of the
flow composed homogeneous background noise, which exhibited no organized structures.
Goldstein and Vasilyev[65]
applied the FDV model to large eddy simulation, but did not assume
that the wavelet filter eliminated all coherent motions from the subfilter scales. By
employing both LES and CVS filtering, they showed that the SFS dissipation was dominated
by the SFS flow field's coherent portion.
PDF methods
Probability density function (PDF) methods for turbulence, first introduced by Lundgren,[66]
are based on tracking the one-point PDF of the velocity, , which gives the
probability of the velocity at point being between and . This approach is
analogous to the kinetic theory of gases, in which the macroscopic properties of a gas are
described by a large number of particles. PDF methods are unique in that they can be applied
in the framework of a number of different turbulence models; the main differences occur in
the form of the PDF transport equation. For example, in the context of large eddy simulation,
the PDF becomes the filtered PDF.[67]
PDF methods can also be used to describe chemical
reactions,[68][69]
and are particularly useful for simulating chemically reacting flows because
the chemical source term is closed and does not require a model. The PDF is commonly
tracked by using Lagrangian particle methods; when combined with large eddy simulation, this
leads to a Langevin equation for subfilter particle evolution.
Vorticity confinement method
The vorticity confinement (VC) method is an Eulerian technique used in the simulation of
turbulent wakes. It uses a solitary-wave like approach to produce a stable solution with no
numerical spreading. VC can capture the small-scale features to within as few as 2 grid cells.
Within these features, a nonlinear difference equation is solved as opposed to the finite
difference equation. VC is similar to shock capturing methods, where conservation laws are
satisfied, so that the essential integral quantities are accurately computed.
Linear eddy model
The Linear eddy model is a technique used to simulate the convective mixing that takes
place in turbulent flow.[70]
Specifically, it provides a mathematical way to describe the
interactions of a scalar variable within the vector flow field. It is primarily used in one-
dimensional representations of turbulent flow, since it can be applied across a wide range of
length scales and Reynolds numbers. This model is generally used as a building block for more
complicated flow representations, as it provides high resolution predictions that hold across a
large range of flow conditions.
Two-phase flow
Simulation of bubble horde using
volume of fluid method
The modeling of two-phase flow is still under development. Different methods have been
proposed, including the Volume of fluid method, the level-set method and front tracking.[71][72]
These methods often involve a tradeoff between maintaining a sharp interface or conserving
mass . This is crucial since the evaluation of the density, viscosity and surface tension is
based on the values averaged over the interface.
Solution algorithms
Discretization in the space produces a system of ordinary differential equations for unsteady
problems and algebraic equations for steady problems. Implicit or semi-implicit methods are
generally used to integrate the ordinary differential equations, producing a system of (usually)
nonlinear algebraic equations. Applying a Newton or Picard iteration produces a system of
linear equations which is nonsymmetric in the presence of advection and indefinite in the
presence of incompressibility. Such systems, particularly in 3D, are frequently too large for
direct solvers, so iterative methods are used, either stationary methods such as successive
overrelaxation or Krylov subspace methods. Krylov methods such as GMRES, typically used
with preconditioning, operate by minimizing the residual over successive subspaces generated
by the preconditioned operator.
Multigrid has the advantage of asymptotically optimal performance on many problems.
Traditional solvers and preconditioners are effective at reducing high-frequency components
of the residual, but low-frequency components typically require many iterations to reduce. By
operating on multiple scales, multigrid reduces all components of the residual by similar
factors, leading to a mesh-independent number of iterations.
For indefinite systems, preconditioners such as incomplete LU factorization, additive Schwarz,
and multigrid perform poorly or fail entirely, so the problem structure must be used for
effective preconditioning.[73]
Methods commonly used in CFD are the SIMPLE and Uzawa
algorithms which exhibit mesh-dependent convergence rates, but recent advances based on
block LU factorization combined with multigrid for the resulting definite systems have led to
preconditioners that deliver mesh-independent convergence rates.[74]
Unsteady aerodynamics
CFD made a major break through in late 70s with the introduction of LTRAN2, a 2-D code to
model oscillating airfoils based on transonic small perturbation theory by Ballhaus and
associates.[75]
It uses a Murman-Cole switch algorithm for modeling the moving shock-
waves.[26]
Later it was extended to 3-D with use of a rotated difference scheme by
AFWAL/Boeing that resulted in LTRAN3.[76][77]
Biomedical engineering
Simulation of blood flow in a human
aorta
CFD investigations are used to clarify the characteristics of aortic flow in details that are
beyond the capabilities of experimental measurements. To analyze these conditions, CAD
models of the human vascular system are extracted employing modern imaging techniques
such as MRI or Computed Tomography. A 3D model is reconstructed from this data and the
fluid flow can be computed. Blood properties such as density and viscosity, and realistic
boundary conditions (e.g. systemic pressure) have to be taken into consideration. Therefore,
making it possible to analyze and optimize the flow in the cardiovascular system for different
applications.[78]
CPU versus GPU
Traditionally, CFD simulations are performed on CPUs.[79]
In a more recent trend, simulations are also performed on GPUs. These typically contain
slower but more processors. For CFD algorithms that feature good parallelism performance
(i.e. good speed-up by adding more cores) this can greatly reduce simulation times. Fluid-
implicit particle[80]
and lattice-Boltzmann methods[81]
are typical examples of codes that
scale well on GPUs.
Blade element theory
Boundary conditions in fluid dynamics
Cavitation modelling
Central differencing scheme
See also
Computational
magnetohydrodynamics
Discrete element method
Finite element method
Finite volume method for unsteady
flow
Fluid animation
Immersed boundary method
Lattice Boltzmann methods
List of finite element software
packages
Meshfree methods
Moving particle semi-implicit method
Multi-particle collision dynamics
Multidisciplinary design optimization
Numerical methods in fluid mechanics
Shape optimization
Smoothed-particle hydrodynamics
Stochastic Eulerian Lagrangian method
Turbulence modeling
Visualization (graphics)
Wind tunnel
1. Milne-Thomson, Louis Melville (1973).
Theoretical Aerodynamics. Courier
Corporation. ISBN 978-0-486-61980-4.
References
2. McMurtry, Patrick A.; Gansauge, Todd C.;
Kerstein, Alan R.; Krueger, Steven K. (April
1993). "Linear eddy simulations of mixing
in a homogeneous turbulent flow".
Physics of Fluids A: Fluid Dynamics. 5 (4):
1023–1034.
Bibcode:1993PhFlA...5.1023M (https://ui.
adsabs.harvard.edu/abs/1993PhFlA...5.1
023M) . doi:10.1063/1.858667 (https://d
oi.org/10.1063%2F1.858667) .
3. Richardson, L. F.; Chapman, S. (1965).
Weather prediction by numerical process.
Dover Publications.
4. Hunt, J.C.R. (January 1998). "Lewis Fry
Richardson and his contributions to
mathematics, meteorology, and models of
conflict". Annual Review of Fluid
Mechanics. 30 (1): xiii–xxxvi.
Bibcode:1998AnRFM..30D..13H (https://u
i.adsabs.harvard.edu/abs/1998AnRFM..3
0D..13H) .
doi:10.1146/annurev.fluid.30.1.0 (https://
doi.org/10.1146%2Fannurev.fluid.30.1.0) .
5. "The Legacy of Group T-3" (https://www.la
nl.gov/orgs/t/t3/history.shtml#early) .
Retrieved March 13, 2013.
6. Harlow, Francis H. (April 2004). "Fluid
dynamics in Group T-3 Los Alamos
National Laboratory" (https://zenodo.org/r
ecord/1259097) . Journal of
Computational Physics. 195 (2): 414–
433. Bibcode:2004JCoPh.195..414H (http
s://ui.adsabs.harvard.edu/abs/2004JCoP
h.195..414H) .
doi:10.1016/j.jcp.2003.09.031 (https://do
i.org/10.1016%2Fj.jcp.2003.09.031) .
7. Harlow, Francis Harvey; Evans, Martha;
Richtmyer, Robert D. (1955). A Machine
Calculation Method for Hydrodynamic
Problems. Los Alamos Scientific
Laboratory of the University of California.
hdl:2027/mdp.39015095283399 (https://
hdl.handle.net/2027%2Fmdp.390150952
83399) . OCLC 1288309947 (https://ww
w.worldcat.org/oclc/1288309947) .
8. Gentry, Richard A; Martin, Robert E; Daly,
Bart J (August 1966). "An Eulerian
differencing method for unsteady
compressible flow problems". Journal of
Computational Physics. 1 (1): 87–118.
Bibcode:1966JCoPh...1...87G (https://ui.a
dsabs.harvard.edu/abs/1966JCoPh...1...8
7G) . doi:10.1016/0021-9991(66)90014-3
(https://doi.org/10.1016%2F0021-9991%
2866%2990014-3) .
9. Fromm, Jacob E.; Harlow, Francis H. (July
1963). "Numerical Solution of the
Problem of Vortex Street Development".
The Physics of Fluids. 6 (7): 975–982.
Bibcode:1963PhFl....6..975F (https://ui.ad
sabs.harvard.edu/abs/1963PhFl....6..975
F) . doi:10.1063/1.1706854 (https://doi.o
rg/10.1063%2F1.1706854) .
10. Harlow, Francis H.; Welch, J. Eddie
(December 1965). "Numerical Calculation
of Time-Dependent Viscous
Incompressible Flow of Fluid with Free
Surface". The Physics of Fluids. 8 (12):
2182–2189. Bibcode:1965PhFl....8.2182H
(https://ui.adsabs.harvard.edu/abs/1965
PhFl....8.2182H) . doi:10.1063/1.1761178
(https://doi.org/10.1063%2F1.1761178) .
11. Hess, J.L.; Smith, A.M.O. (1967).
"Calculation of potential flow about
arbitrary bodies". Progress in Aerospace
Sciences. 8: 1–138.
Bibcode:1967PrAeS...8....1H (https://ui.ad
sabs.harvard.edu/abs/1967PrAeS...8....1
H) . doi:10.1016/0376-0421(67)90003-6
(https://doi.org/10.1016%2F0376-0421%
2867%2990003-6) .
12. Rubbert, P.; Saaris, G. (1972). "Review and
evaluation of a three-dimensional lifting
potential flow computational method for
arbitrary configurations". 10th Aerospace
Sciences Meeting. doi:10.2514/6.1972-
188 (https://doi.org/10.2514%2F6.1972-1
88) .
13. Carmichael, R.; Erickson, L. (1981). "PAN
AIR - A higher order panel method for
predicting subsonic or supersonic linear
potential flows about arbitrary
configurations". 14th Fluid and Plasma
Dynamics Conference.
doi:10.2514/6.1981-1255 (https://doi.or
g/10.2514%2F6.1981-1255) .
14. Youngren, H.; Bouchard, E.; Coopersmith,
R.; Miranda, L. (1983). "Comparison of
panel method formulations and its
influence on the development of
QUADPAN, an advanced low-order
method". Applied Aerodynamics
Conference. doi:10.2514/6.1983-1827 (ht
tps://doi.org/10.2514%2F6.1983-1827) .
15. Hess, J.; Friedman, D. (1983). "Analysis of
complex inlet configurations using a
higher-order panel method". Applied
Aerodynamics Conference.
doi:10.2514/6.1983-1828 (https://doi.or
g/10.2514%2F6.1983-1828) .
41. Jop, Pierre; Forterre, Yoël; Pouliquen,
Olivier (June 2006). "A constitutive law for
dense granular flows" (https://www.natur
e.com/articles/nature04801) . Nature.
441 (7094): 727–730. arXiv:cond-
mat/0612110 (https://arxiv.org/abs/cond-
mat/0612110) .
Bibcode:2006Natur.441..727J (https://ui.a
dsabs.harvard.edu/abs/2006Natur.441..7
27J) . doi:10.1038/nature04801 (https://
doi.org/10.1038%2Fnature04801) .
ISSN 1476-4687 (https://www.worldcat.or
g/issn/1476-4687) .
42. Biroun, Mehdi H.; Mazzei, Luca (June
2024). "Unchannelized granular flows:
Effect of initial granular column geometry
on fluid dynamics" (https://doi.org/10.101
6/j.ces.2024.119997) . Chemical
Engineering Science. 292: 119997.
doi:10.1016/j.ces.2024.119997 (https://d
oi.org/10.1016%2Fj.ces.2024.119997) .
ISSN 0009-2509 (https://www.worldcat.or
g/issn/0009-2509) .
43. Ferziger, J. H. and Peric, M. (2002).
Computational methods for fluid
dynamics. Springer-Verlag.
44. "Navier-Stokes equations" (https://www.cf
d-online.com/Wiki/Navier-Stokes_equatio
ns) . Retrieved 2020-01-07.
45. Panton, R. L. (1996). Incompressible Flow.
John Wiley and Sons.
46. Landau, L. D. and Lifshitz, E. M. (2007).
Fluid Mechanics. Elsevier.
47. Fox, R. W. and McDonald, A. T. (1992).
Introduction to Fluid Mechanics. John
Wiley and Sons.
48. Poinsot, T. and Veynante, D. (2005).
Theoretical and numerical combustion. RT
Edwards.
49. Kundu, P. (1990). Fluid Mechanics.
Academic Press.
50. "Favre averaged Navier-Stokes equations"
(https://www.cfd-online.com/Wiki/Favre_a
veraged_Navier-Stokes_equations) .
Retrieved 2020-01-07.
51. Bailly, C., and Daniel J. (2000). "Numerical
solution of acoustic propagation
problems using Linearized Euler
Equations". AIAA Journal. 38 (1): 22–29.
Bibcode:2000AIAAJ..38...22B (https://ui.a
dsabs.harvard.edu/abs/2000AIAAJ..38...
22B) . doi:10.2514/2.949 (https://doi.org/
10.2514%2F2.949) .
52. Harley, J. C. and Huang, Y. and Bau, H. H.
and Zemel, J. N. (1995). "Gas flow in
micro-channels". Journal of Fluid
Mechanics. 284: 257–274.
Bibcode:1995JFM...284..257H (https://ui.
adsabs.harvard.edu/abs/1995JFM...284..
257H) .
doi:10.1017/S0022112095000358 (http
s://doi.org/10.1017%2FS0022112095000
358) . S2CID 122833857 (https://api.sem
anticscholar.org/CorpusID:122833857) .
53. "One-dimensional Euler equations" (http
s://home.cscamm.umd.edu/centpack/ex
amples/euler1d.htm) . Retrieved
2020-01-12.
54. Cavazzuti, M. and Corticelli, M. A. and
Karayiannis, T. G. (2019). "Compressible
Fanno flows in micro-channels: An
enhanced quasi-2D numerical model for
laminar flows" (https://doi.org/10.1016%2
Fj.tsep.2019.01.003) . Thermal Science
and Engineering Progress. 10: 10–26.
doi:10.1016/j.tsep.2019.01.003 (https://d
oi.org/10.1016%2Fj.tsep.2019.01.003) .
hdl:11392/2414220 (https://hdl.handle.ne
t/11392%2F2414220) .
55. Patankar, Suhas V. (1980). Numerical
Heat Transfer and Fluid FLow.
Hemisphere Publishing Corporation.
ISBN 978-0891165224.
56. "Detailed Explanation of the Finite
Element Method (FEM)" (https://www.co
msol.com/multiphysics/finite-element-me
thod) . www.comsol.com. Retrieved
2022-07-15.
57. Anderson, John David (1995).
Computational Fluid Dynamics: The
Basics with Applications (https://books.g
oogle.com/books?id=phG_QgAACAAJ) .
McGraw-Hill. ISBN 978-0-07-113210-7.
58. Surana, K.A.; Allu, S.; Tenpas, P.W.; Reddy,
J.N. (February 2007). "k-version of finite
element method in gas dynamics: higher-
order global differentiability numerical
solutions". International Journal for
Numerical Methods in Engineering. 69 (6):
1109–1157.
Bibcode:2007IJNME..69.1109S (https://u
i.adsabs.harvard.edu/abs/2007IJNME..6
9.1109S) . doi:10.1002/nme.1801 (http
s://doi.org/10.1002%2Fnme.1801) .
S2CID 122551159 (https://api.semanticsc
holar.org/CorpusID:122551159) .
59. Huebner, K.H.; Thornton, E.A.; and Byron,
T.D. (1995). The Finite Element Method
for Engineers (Third ed.). Wiley
Interscience.
60. Cottet, Georges-Henri; Koumoutsakos,
Petros D. (2000). Vortex Methods: Theory
and Practice. Cambridge, UK: Cambridge
Univ. Press. ISBN 0-521-62186-0.
61. Launder, B.E.; D.B. Spalding (1974). "The
Numerical Computation of Turbulent
Flows". Computer Methods in Applied
Mechanics and Engineering. 3 (2): 269–
289. Bibcode:1974CMAME...3..269L (http
s://ui.adsabs.harvard.edu/abs/1974CMA
ME...3..269L) . doi:10.1016/0045-
7825(74)90029-2 (https://doi.org/10.101
6%2F0045-7825%2874%2990029-2) .
62. Wilcox, David C. (2006). Turbulence
Modeling for CFD (3 ed.). DCW Industries,
Inc. ISBN 978-1-928729-08-2.
63. Pope, S.B. (2000). Turbulent Flows.
Cambridge University Press. ISBN 978-0-
521-59886-6.
64. Farge, Marie; Schneider, Kai (2001).
"Coherent Vortex Simulation (CVS), A
Semi-Deterministic Turbulence Model
Using Wavelets". Flow, Turbulence and
Combustion. 66 (4): 393–426.
doi:10.1023/A:1013512726409 (https://d
oi.org/10.1023%2FA%3A101351272640
9) . S2CID 53464243 (https://api.semanti
cscholar.org/CorpusID:53464243) .
65. Goldstein, Daniel; Vasilyev, Oleg (1995).
"Stochastic coherent adaptive large eddy
simulation method". Physics of Fluids A.
24 (7): 2497.
Bibcode:2004PhFl...16.2497G (https://ui.a
dsabs.harvard.edu/abs/2004PhFl...16.24
97G) . CiteSeerX 10.1.1.415.6540 (http
s://citeseerx.ist.psu.edu/viewdoc/summa
ry?doi=10.1.1.415.6540) .
doi:10.1063/1.1736671 (https://doi.org/1
0.1063%2F1.1736671) .
66. Lundgren, T.S. (1969). "Model equation for
nonhomogeneous turbulence". Physics of
Fluids A. 12 (3): 485–497.
Bibcode:1969PhFl...12..485L (https://ui.a
dsabs.harvard.edu/abs/1969PhFl...12..48
5L) . doi:10.1063/1.1692511 (https://doi.
org/10.1063%2F1.1692511) .
67. Colucci, P.J.; Jaberi, F.A; Givi, P.; Pope, S.B.
(1998). "Filtered density function for large
eddy simulation of turbulent reacting
flows". Physics of Fluids A. 10 (2): 499–
515. Bibcode:1998PhFl...10..499C (http
s://ui.adsabs.harvard.edu/abs/1998PhF
l...10..499C) . doi:10.1063/1.869537 (http
s://doi.org/10.1063%2F1.869537) .
68. Fox, Rodney (2003). Computational
models for turbulent reacting flows.
Cambridge University Press. ISBN 978-0-
521-65049-6.
69. Pope, S.B. (1985). "PDF methods for
turbulent reactive flows". Progress in
Energy and Combustion Science. 11 (2):
119–192. Bibcode:1985PrECS..11..119P
(https://ui.adsabs.harvard.edu/abs/1985
PrECS..11..119P) . doi:10.1016/0360-
1285(85)90002-4 (https://doi.org/10.101
6%2F0360-1285%2885%2990002-4) .
70. Krueger, Steven K. (1993). "Linear Eddy
Simulations Of Mixing In A Homogeneous
Turbulent Flow" (https://zenodo.org/recor
d/1232081) . Physics of Fluids. 5 (4):
1023–1034.
Bibcode:1993PhFlA...5.1023M (https://ui.
adsabs.harvard.edu/abs/1993PhFlA...5.1
023M) . doi:10.1063/1.858667 (https://d
oi.org/10.1063%2F1.858667) .
71. Hirt, C.W; Nichols, B.D (January 1981).
"Volume of fluid (VOF) method for the
dynamics of free boundaries". Journal of
Computational Physics. 39 (1): 201–225.
Bibcode:1981JCoPh..39..201H (https://ui.
adsabs.harvard.edu/abs/1981JCoPh..39..
201H) . doi:10.1016/0021-
9991(81)90145-5 (https://doi.org/10.101
6%2F0021-9991%2881%2990145-5) .
72. Unverdi, Salih Ozen; Tryggvason, Grétar
(May 1992). "A front-tracking method for
viscous, incompressible, multi-fluid flows".
Journal of Computational Physics. 100
(1): 25–37.
Bibcode:1992JCoPh.100...25U (https://ui.
adsabs.harvard.edu/abs/1992JCoPh.10
0...25U) . doi:10.1016/0021-
9991(92)90307-K (https://doi.org/10.101
6%2F0021-9991%2892%2990307-K) .
hdl:2027.42/30059 (https://hdl.handle.ne
t/2027.42%2F30059) .
73. Benzi, Michele; Golub, Gene H.; Liesen,
Jörg (May 2005). "Numerical solution of
saddle point problems". Acta Numerica.
14: 1–137. Bibcode:2005AcNum..14....1B
(https://ui.adsabs.harvard.edu/abs/2005
AcNum..14....1B) .
CiteSeerX 10.1.1.409.4160 (https://citese
erx.ist.psu.edu/viewdoc/summary?doi=1
0.1.1.409.4160) .
doi:10.1017/S0962492904000212 (http
s://doi.org/10.1017%2FS0962492904000
212) . S2CID 122717775 (https://api.sem
anticscholar.org/CorpusID:122717775) .
74. Elman, Howard; Howle, V.E.; Shadid, John;
Shuttleworth, Robert; Tuminaro, Ray
(January 2008). "A taxonomy and
comparison of parallel block multi-level
preconditioners for the incompressible
Navier–Stokes equations" (https://digital.li
brary.unt.edu/ark:/67531/metadc90233
2/) . Journal of Computational Physics.
227 (3): 1790–1808.
Bibcode:2008JCoPh.227.1790E (https://u
i.adsabs.harvard.edu/abs/2008JCoPh.22
7.1790E) . doi:10.1016/j.jcp.2007.09.026
(https://doi.org/10.1016%2Fj.jcp.2007.09.
026) . S2CID 16365489 (https://api.sema
nticscholar.org/CorpusID:16365489) .
75. Adamson, M.R. (January 2006).
"Biographies". IEEE Annals of the History
of Computing. 28 (1): 99–103.
doi:10.1109/MAHC.2006.5 (https://doi.or
g/10.1109%2FMAHC.2006.5) .
76. Jameson, Antony (May 1974). "Iterative
solution of transonic flows over airfoils
and wings, including flows at mach 1".
Communications on Pure and Applied
Mathematics. 27 (3): 283–309.
doi:10.1002/cpa.3160270302 (https://do
i.org/10.1002%2Fcpa.3160270302) .
77. Borland, C.J., "XTRAN3S - Transonic
Steady and Unsteady Aerodynamics for
Aeroelastic Applications,"AFWAL-TR-85-
3214, Air Force Wright Aeronautical
Laboratories, Wright-Patterson AFB, OH,
January, 1986
80. Wu, Kui; Truong, Nghia; Yuksel, Cem;
Hoetzlein, Rama (May 2018). "Fast Fluid
Simulations with Sparse Volumes on the
GPU". Computer Graphics Forum. 37 (2):
157–167. doi:10.1111/cgf.13350 (https://
doi.org/10.1111%2Fcgf.13350) .
S2CID 43945038 (https://api.semanticsch
olar.org/CorpusID:43945038) .
81. "Intersect 360 HPC application Support"
(http://www.nvidia.com/content/intersect-
360-HPC-application-support.pdf) (PDF).
Anderson, John D. (1995).
Computational Fluid Dynamics: The
Basics With Applications.
Notes

More Related Content

Similar to Computational fluid dynamics - Wikipedia.pdf

Effect of spikes integrated to airfoil at supersonic
Effect of spikes integrated to airfoil at supersonicEffect of spikes integrated to airfoil at supersonic
Effect of spikes integrated to airfoil at supersonic
eSAT Publishing House
 
CFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDER
CFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDERCFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDER
CFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDER
AM Publications
 
Technical paper chapter 2
Technical paper chapter 2Technical paper chapter 2
Technical paper chapter 2
Ali_kamal
 
ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...
ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...
ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...
ektagupta161191
 

Similar to Computational fluid dynamics - Wikipedia.pdf (20)

Computational Fluid Dynamics (CFD) Analysis of Natural Convection of Converge...
Computational Fluid Dynamics (CFD) Analysis of Natural Convection of Converge...Computational Fluid Dynamics (CFD) Analysis of Natural Convection of Converge...
Computational Fluid Dynamics (CFD) Analysis of Natural Convection of Converge...
 
CFD For Offshore Applications
CFD For Offshore ApplicationsCFD For Offshore Applications
CFD For Offshore Applications
 
Effect of spikes integrated to airfoil at supersonic speed
Effect of spikes integrated to airfoil at supersonic speedEffect of spikes integrated to airfoil at supersonic speed
Effect of spikes integrated to airfoil at supersonic speed
 
Effect of spikes integrated to airfoil at supersonic
Effect of spikes integrated to airfoil at supersonicEffect of spikes integrated to airfoil at supersonic
Effect of spikes integrated to airfoil at supersonic
 
Computational Fluid Dynamics
Computational Fluid DynamicsComputational Fluid Dynamics
Computational Fluid Dynamics
 
Pros and-cons-of-cfd-and-physical-flow-modeling
Pros and-cons-of-cfd-and-physical-flow-modelingPros and-cons-of-cfd-and-physical-flow-modeling
Pros and-cons-of-cfd-and-physical-flow-modeling
 
Simulation and Experiment Study of Flow Field of Flow channel for Rectangular...
Simulation and Experiment Study of Flow Field of Flow channel for Rectangular...Simulation and Experiment Study of Flow Field of Flow channel for Rectangular...
Simulation and Experiment Study of Flow Field of Flow channel for Rectangular...
 
CFD Analysis of ATGM Configurations -- Zeus Numerix
CFD Analysis of ATGM Configurations --  Zeus NumerixCFD Analysis of ATGM Configurations --  Zeus Numerix
CFD Analysis of ATGM Configurations -- Zeus Numerix
 
FINAL REPORT-desktop
FINAL REPORT-desktopFINAL REPORT-desktop
FINAL REPORT-desktop
 
[Mason] transonic aerodynamics of airfoils and wings
[Mason] transonic aerodynamics of airfoils and wings[Mason] transonic aerodynamics of airfoils and wings
[Mason] transonic aerodynamics of airfoils and wings
 
Determination of shock losses and pressure losses in ug mine openings (1)
Determination of shock losses and pressure losses in ug mine openings (1)Determination of shock losses and pressure losses in ug mine openings (1)
Determination of shock losses and pressure losses in ug mine openings (1)
 
Determination of shock losses and pressure losses in ug mine openings
Determination of shock losses and pressure losses in ug mine openingsDetermination of shock losses and pressure losses in ug mine openings
Determination of shock losses and pressure losses in ug mine openings
 
WHAT IS COMPUTATIONAL FLUID DYNAMICS (CFD)
WHAT IS COMPUTATIONAL FLUID DYNAMICS (CFD)WHAT IS COMPUTATIONAL FLUID DYNAMICS (CFD)
WHAT IS COMPUTATIONAL FLUID DYNAMICS (CFD)
 
CFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDER
CFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDERCFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDER
CFD and EXPERIMENTAL ANALYSIS of VORTEX SHEDDING BEHIND D-SHAPED CYLINDER
 
Bauldree - FINAL VERSION
Bauldree - FINAL VERSIONBauldree - FINAL VERSION
Bauldree - FINAL VERSION
 
Air Pollution Modeling – An Overview
Air Pollution Modeling – An OverviewAir Pollution Modeling – An Overview
Air Pollution Modeling – An Overview
 
Technical paper chapter 2
Technical paper chapter 2Technical paper chapter 2
Technical paper chapter 2
 
July 8th 2014 - Presentation by Mario Caponnetto: "CFD method for foil design"
July 8th 2014 - Presentation by Mario Caponnetto: "CFD method for foil design"July 8th 2014 - Presentation by Mario Caponnetto: "CFD method for foil design"
July 8th 2014 - Presentation by Mario Caponnetto: "CFD method for foil design"
 
Numerical simulation of wind flow over complex terrain (yangon city)
Numerical simulation of wind flow over complex terrain (yangon city)Numerical simulation of wind flow over complex terrain (yangon city)
Numerical simulation of wind flow over complex terrain (yangon city)
 
ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...
ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...
ApproachtothevoidfractiondistributionwithinahydraulicjumpinatypifiedUSBRIIsti...
 

Recently uploaded

1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
AldoGarca30
 
Query optimization and processing for advanced database systems
Query optimization and processing for advanced database systemsQuery optimization and processing for advanced database systems
Query optimization and processing for advanced database systems
meharikiros2
 
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak HamilCara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Kandungan 087776558899
 
scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...
scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...
scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...
HenryBriggs2
 
Introduction to Robotics in Mechanical Engineering.pptx
Introduction to Robotics in Mechanical Engineering.pptxIntroduction to Robotics in Mechanical Engineering.pptx
Introduction to Robotics in Mechanical Engineering.pptx
hublikarsn
 
"Lesotho Leaps Forward: A Chronicle of Transformative Developments"
"Lesotho Leaps Forward: A Chronicle of Transformative Developments""Lesotho Leaps Forward: A Chronicle of Transformative Developments"
"Lesotho Leaps Forward: A Chronicle of Transformative Developments"
mphochane1998
 
Digital Communication Essentials: DPCM, DM, and ADM .pptx
Digital Communication Essentials: DPCM, DM, and ADM .pptxDigital Communication Essentials: DPCM, DM, and ADM .pptx
Digital Communication Essentials: DPCM, DM, and ADM .pptx
pritamlangde
 

Recently uploaded (20)

Computer Graphics Introduction To Curves
Computer Graphics Introduction To CurvesComputer Graphics Introduction To Curves
Computer Graphics Introduction To Curves
 
8086 Microprocessor Architecture: 16-bit microprocessor
8086 Microprocessor Architecture: 16-bit microprocessor8086 Microprocessor Architecture: 16-bit microprocessor
8086 Microprocessor Architecture: 16-bit microprocessor
 
Basic Electronics for diploma students as per technical education Kerala Syll...
Basic Electronics for diploma students as per technical education Kerala Syll...Basic Electronics for diploma students as per technical education Kerala Syll...
Basic Electronics for diploma students as per technical education Kerala Syll...
 
HAND TOOLS USED AT ELECTRONICS WORK PRESENTED BY KOUSTAV SARKAR
HAND TOOLS USED AT ELECTRONICS WORK PRESENTED BY KOUSTAV SARKARHAND TOOLS USED AT ELECTRONICS WORK PRESENTED BY KOUSTAV SARKAR
HAND TOOLS USED AT ELECTRONICS WORK PRESENTED BY KOUSTAV SARKAR
 
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
 
Introduction to Geographic Information Systems
Introduction to Geographic Information SystemsIntroduction to Geographic Information Systems
Introduction to Geographic Information Systems
 
HOA1&2 - Module 3 - PREHISTORCI ARCHITECTURE OF KERALA.pptx
HOA1&2 - Module 3 - PREHISTORCI ARCHITECTURE OF KERALA.pptxHOA1&2 - Module 3 - PREHISTORCI ARCHITECTURE OF KERALA.pptx
HOA1&2 - Module 3 - PREHISTORCI ARCHITECTURE OF KERALA.pptx
 
Theory of Time 2024 (Universal Theory for Everything)
Theory of Time 2024 (Universal Theory for Everything)Theory of Time 2024 (Universal Theory for Everything)
Theory of Time 2024 (Universal Theory for Everything)
 
Query optimization and processing for advanced database systems
Query optimization and processing for advanced database systemsQuery optimization and processing for advanced database systems
Query optimization and processing for advanced database systems
 
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak HamilCara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
 
fitting shop and tools used in fitting shop .ppt
fitting shop and tools used in fitting shop .pptfitting shop and tools used in fitting shop .ppt
fitting shop and tools used in fitting shop .ppt
 
Signal Processing and Linear System Analysis
Signal Processing and Linear System AnalysisSignal Processing and Linear System Analysis
Signal Processing and Linear System Analysis
 
scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...
scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...
scipt v1.pptxcxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxxx...
 
Introduction to Robotics in Mechanical Engineering.pptx
Introduction to Robotics in Mechanical Engineering.pptxIntroduction to Robotics in Mechanical Engineering.pptx
Introduction to Robotics in Mechanical Engineering.pptx
 
NO1 Top No1 Amil Baba In Azad Kashmir, Kashmir Black Magic Specialist Expert ...
NO1 Top No1 Amil Baba In Azad Kashmir, Kashmir Black Magic Specialist Expert ...NO1 Top No1 Amil Baba In Azad Kashmir, Kashmir Black Magic Specialist Expert ...
NO1 Top No1 Amil Baba In Azad Kashmir, Kashmir Black Magic Specialist Expert ...
 
"Lesotho Leaps Forward: A Chronicle of Transformative Developments"
"Lesotho Leaps Forward: A Chronicle of Transformative Developments""Lesotho Leaps Forward: A Chronicle of Transformative Developments"
"Lesotho Leaps Forward: A Chronicle of Transformative Developments"
 
Worksharing and 3D Modeling with Revit.pptx
Worksharing and 3D Modeling with Revit.pptxWorksharing and 3D Modeling with Revit.pptx
Worksharing and 3D Modeling with Revit.pptx
 
Digital Communication Essentials: DPCM, DM, and ADM .pptx
Digital Communication Essentials: DPCM, DM, and ADM .pptxDigital Communication Essentials: DPCM, DM, and ADM .pptx
Digital Communication Essentials: DPCM, DM, and ADM .pptx
 
UNIT 4 PTRP final Convergence in probability.pptx
UNIT 4 PTRP final Convergence in probability.pptxUNIT 4 PTRP final Convergence in probability.pptx
UNIT 4 PTRP final Convergence in probability.pptx
 
Post office management system project ..pdf
Post office management system project ..pdfPost office management system project ..pdf
Post office management system project ..pdf
 

Computational fluid dynamics - Wikipedia.pdf

  • 1. 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 the free-stream flow of the fluid, and the interaction of the fluid (liquids and gases) with surfaces defined by boundary conditions. With high-speed supercomputers, better solutions can be achieved, and are often required to solve the largest and most complex problems. Ongoing research yields software that improves the accuracy and speed of complex simulation scenarios such as transonic or turbulent flows. Initial validation of such software is typically performed using experimental apparatus such as wind tunnels. In addition, previously performed analytical or empirical analysis of a particular problem can be used for comparison. A final validation is often performed using full-scale testing, such as flight tests. CFD is applied to a wide range of research and engineering problems in many fields of study and industries, including aerodynamics and aerospace analysis, hypersonics, weather simulation, natural science and environmental engineering, industrial system design and analysis, biological engineering, fluid flows and heat transfer, engine and combustion analysis, and visual effects for film and games.
  • 2. A computer simulation of high velocity air flow around the Space Shuttle during re-entry A simulation of the Hyper-X scramjet vehicle in operation at Mach-7 The fundamental basis of almost all CFD problems is the Navier–Stokes equations, which define many single-phase (gas or liquid, but not both) fluid flows. These equations can be simplified by removing terms describing viscous actions to yield the Euler equations. Further simplification, by removing terms describing vorticity yields the full potential equations. Finally, for small perturbations in subsonic and supersonic flows (not transonic or hypersonic) these equations can be linearized to yield the linearized potential equations. Historically, methods were first developed to solve the linearized potential equations. Two- dimensional (2D) methods, using conformal transformations of the flow about a cylinder to the flow about an airfoil were developed in the 1930s.[1][2] One of the earliest type of calculations resembling modern CFD are those by Lewis Fry Richardson, in the sense that these calculations used finite differences and divided the physical space in cells. Although they failed dramatically, these calculations, together with Richardson's book Weather Prediction by Numerical Process,[3] set the basis for modern CFD Background and history
  • 3. and numerical meteorology. In fact, early CFD calculations during the 1940s using ENIAC used methods close to those in Richardson's 1922 book.[4] The computer power available paced development of three-dimensional methods. Probably the first work using computers to model fluid flow, as governed by the Navier–Stokes equations, was performed at Los Alamos National Lab, in the T3 group.[5][6] This group was led by Francis H. Harlow, who is widely considered one of the pioneers of CFD. From 1957 to late 1960s, this group developed a variety of numerical methods to simulate transient two- dimensional fluid flows, such as particle-in-cell method,[7] fluid-in-cell method,[8] vorticity stream function method,[9] and marker-and-cell method.[10] Fromm's vorticity-stream-function method for 2D, transient, incompressible flow was the first treatment of strongly contorting incompressible flows in the world. The first paper with three-dimensional model was published by John Hess and A.M.O. Smith of Douglas Aircraft in 1967.[11] This method discretized the surface of the geometry with panels, giving rise to this class of programs being called Panel Methods. Their method itself was simplified, in that it did not include lifting flows and hence was mainly applied to ship hulls and aircraft fuselages. The first lifting Panel Code (A230) was described in a paper written by Paul Rubbert and Gary Saaris of Boeing Aircraft in 1968.[12] In time, more advanced three- dimensional Panel Codes were developed at Boeing (PANAIR, A502),[13] Lockheed (Quadpan),[14] Douglas (HESS),[15] McDonnell Aircraft (MACAERO),[16] NASA (PMARC)[17] and Analytical Methods (WBAERO,[18] USAERO[19] and VSAERO[20][21] ). Some (PANAIR, HESS and MACAERO) were higher order codes, using higher order distributions of surface singularities, while others (Quadpan, PMARC, USAERO and VSAERO) used single singularities on each surface panel. The advantage of the lower order codes was that they ran much faster on the computers of the time. Today, VSAERO has grown to be a multi-order code and is the most widely used program of this class. It has been used in the development of many submarines, surface ships, automobiles, helicopters, aircraft, and more recently wind turbines. Its sister code, USAERO is an unsteady panel method that has also been used for modeling such things as high speed trains and racing yachts. The NASA PMARC code from an early version of VSAERO and a derivative of PMARC, named CMARC,[22] is also commercially available. In the two-dimensional realm, a number of Panel Codes have been developed for airfoil analysis and design. The codes typically have a boundary layer analysis included, so that viscous effects can be modeled. Richard Eppler developed the PROFILE code, partly with NASA funding, which became available in the early 1980s.[23] This was soon followed by Mark Drela's XFOIL code.[24] Both PROFILE and XFOIL incorporate two-dimensional panel codes, with coupled boundary layer codes for airfoil analysis work. PROFILE uses a conformal
  • 4. transformation method for inverse airfoil design, while XFOIL has both a conformal transformation and an inverse panel method for airfoil design. An intermediate step between Panel Codes and Full Potential codes were codes that used the Transonic Small Disturbance equations. In particular, the three-dimensional WIBCO code,[25] developed by Charlie Boppe of Grumman Aircraft in the early 1980s has seen heavy use. A simulation of the SpaceX Starship during re-entry Developers turned to Full Potential codes, as panel methods could not calculate the non- linear flow present at transonic speeds. The first description of a means of using the Full Potential equations was published by Earll Murman and Julian Cole of Boeing in 1970.[26] Frances Bauer, Paul Garabedian and David Korn of the Courant Institute at New York University (NYU) wrote a series of two-dimensional Full Potential airfoil codes that were widely used, the most important being named Program H.[27] A further growth of Program H was developed by Bob Melnik and his group at Grumman Aerospace as Grumfoil.[28] Antony Jameson, originally at Grumman Aircraft and the Courant Institute of NYU, worked with David Caughey to develop the important three-dimensional Full Potential code FLO22[29] in 1975. Many Full Potential codes emerged after this, culminating in Boeing's Tranair (A633) code,[30] which still sees heavy use. The next step was the Euler equations, which promised to provide more accurate solutions of transonic flows. The methodology used by Jameson in his three-dimensional FLO57 code[31] (1981) was used by others to produce such programs as Lockheed's TEAM program[32] and IAI/Analytical Methods' MGAERO program.[33] MGAERO is unique in being a structured cartesian mesh code, while most other such codes use structured body-fitted grids (with the exception of NASA's highly successful CART3D code,[34] Lockheed's SPLITFLOW code[35] and Georgia Tech's NASCART-GT).[36] Antony Jameson also developed the three-dimensional AIRPLANE code[37] which made use of unstructured tetrahedral grids.
  • 5. In the two-dimensional realm, Mark Drela and Michael Giles, then graduate students at MIT, developed the ISES Euler program[38] (actually a suite of programs) for airfoil design and analysis. This code first became available in 1986 and has been further developed to design, analyze and optimize single or multi-element airfoils, as the MSES program.[39] MSES sees wide use throughout the world. A derivative of MSES, for the design and analysis of airfoils in a cascade, is MISES,[40] developed by Harold Youngren while he was a graduate student at MIT. The Navier–Stokes equations were the ultimate target of development. Two-dimensional codes, such as NASA Ames' ARC2D code first emerged. A number of three-dimensional codes were developed (ARC3D, OVERFLOW, CFL3D are three successful NASA contributions), leading to numerous commercial packages. Recently CFD methods have gained traction for modeling the flow behavior of granular materials within various chemical processes in engineering. This approach has emerged as a cost-effective alternative, offering a nuanced understanding of complex flow phenomena while minimizing expenses associated with traditional experimental methods.[41][42] CFD can be seen as a group of computational methodologies (discussed below) used to solve equations governing fluid flow. In the application of CFD, a critical step is to decide which set of physical assumptions and related equations need to be used for the problem at hand.[43] To illustrate this step, the following summarizes the physical assumptions/simplifications taken in equations of a flow that is single-phase (see multiphase flow and two-phase flow), single-species (i.e., it consists of one chemical species), non- reacting, and (unless said otherwise) compressible. Thermal radiation is neglected, and body forces due to gravity are considered (unless said otherwise). In addition, for this type of flow, the next discussion highlights the hierarchy of flow equations solved with CFD. Note that some of the following equations could be derived in more than one way. Hierarchy of fluid flow equations
  • 6. Conservation laws (CL): These are the most fundamental equations considered with CFD in the sense that, for example, all the following equations can be derived from them. For a single-phase, single-species, compressible flow one considers the conservation of mass, conservation of linear momentum, and conservation of energy. Continuum conservation laws (CCL): Start with the CL. Assume that mass, momentum and energy are locally conserved: These quantities are conserved and cannot "teleport" from one place to another but can only move by a continuous flow (see
  • 7. continuity equation). Another interpretation is that one starts with the CL and assumes a continuum medium (see continuum mechanics). The resulting system of equations is unclosed since to solve it one needs further relationships/equations: (a) constitutive relationships for the viscous stress tensor; (b) constitutive relationships for the diffusive heat flux; (c) an equation of state (EOS), such as the ideal gas law; and, (d) a caloric equation of state relating temperature with quantities such as enthalpy or internal energy. Compressible Navier-Stokes equations (C-NS): Start with the CCL. Assume a
  • 8. Newtonian viscous stress tensor (see Newtonian fluid) and a Fourier heat flux (see heat flux).[44][45] The C-NS need to be augmented with an EOS and a caloric EOS to have a closed system of equations. Incompressible Navier-Stokes equations (I-NS): Start with the C-NS. Assume that density is always and everywhere constant.[46] Another way to obtain the I-NS is to assume that the Mach number is very small[46][45] and that temperature differences in the fluid are very small as well.[45] As a result, the mass-conservation and momentum-conservation equations are decoupled from the energy-
  • 9. conservation equation, so one only needs to solve for the first two equations.[45] Compressible Euler equations (EE): Start with the C-NS. Assume a frictionless flow with no diffusive heat flux.[47] Weakly compressible Navier-Stokes equations (WC-NS): Start with the C- NS. Assume that density variations depend only on temperature and not on pressure.[48] For example, for an ideal gas, use , where is a conveniently-defined reference pressure that is always and everywhere constant, is density, is the specific
  • 10. gas constant, and is temperature. As a result, the WC-NS do not capture acoustic waves. It is also common in the WC-NS to neglect the pressure- work and viscous-heating terms in the energy-conservation equation. The WC- NS are also called the C-NS with the low-Mach-number approximation. Boussinesq equations: Start with the C- NS. Assume that density variations are always and everywhere negligible except in the gravity term of the momentum-conservation equation (where density multiplies the gravitational acceleration).[49] Also assume that various fluid properties such as viscosity, thermal conductivity,
  • 11. and heat capacity are always and everywhere constant. The Boussinesq equations are widely used in microscale meteorology. Compressible Reynolds-averaged Navier–Stokes equations and compressible Favre-averaged Navier- Stokes equations (C-RANS and C- FANS): Start with the C-NS. Assume that any flow variable , such as density, velocity and pressure, can be represented as , where is the ensemble-average[45] of any flow variable, and is a perturbation or fluctuation from this average.[45][50] is not necessarily small. If is a classic ensemble-average (see
  • 12. Reynolds decomposition) one obtains the Reynolds-averaged Navier–Stokes equations. And if is a density- weighted ensemble-average one obtains the Favre-averaged Navier- Stokes equations.[50] As a result, and depending on the Reynolds number, the range of scales of motion is greatly reduced, something which leads to much faster solutions in comparison to solving the C-NS. However, information is lost, and the resulting system of equations requires the closure of various unclosed terms, notably the Reynolds stress. Ideal flow or potential flow equations: Start with the EE. Assume zero fluid-
  • 13. particle rotation (zero vorticity) and zero flow expansion (zero divergence).[45] The resulting flowfield is entirely determined by the geometrical boundaries.[45] Ideal flows can be useful in modern CFD to initialize simulations. Linearized compressible Euler equations (LEE):[51] Start with the EE. Assume that any flow variable , such as density, velocity and pressure, can be represented as , where is the value of the flow variable at some reference or base state, and is a perturbation or fluctuation from this state. Furthermore, assume that this perturbation is very small in
  • 14. comparison with some reference value. Finally, assume that satisfies "its own" equation, such as the EE. The LEE and its many variations are widely used in computational aeroacoustics. Sound wave or acoustic wave equation: Start with the LEE. Neglect all gradients of and , and assume that the Mach number at the reference or base state is very small.[48] The resulting equations for density, momentum and energy can be manipulated into a pressure equation, giving the well-known sound wave equation.
  • 15. Shallow water equations (SW): Consider a flow near a wall where the wall-parallel length-scale of interest is much larger than the wall-normal length-scale of interest. Start with the EE. Assume that density is always and everywhere constant, neglect the velocity component perpendicular to the wall, and consider the velocity parallel to the wall to be spatially- constant. Boundary layer equations (BL): Start with the C-NS (I-NS) for compressible (incompressible) boundary layers. Assume that there are thin regions next to walls where spatial gradients
  • 16. perpendicular to the wall are much larger than those parallel to the wall.[49] Bernoulli equation: Start with the EE. Assume that density variations depend only on pressure variations.[49] See Bernoulli's Principle. Steady Bernoulli equation: Start with the Bernoulli Equation and assume a steady flow.[49] Or start with the EE and assume that the flow is steady and integrate the resulting equation along a streamline.[47][46] Stokes Flow or creeping flow equations: Start with the C-NS or I-NS. Neglect the inertia of the flow.[45][46] Such an assumption can be justified
  • 17. when the Reynolds number is very low. As a result, the resulting set of equations is linear, something which simplifies greatly their solution. Two-dimensional channel flow equation: Consider the flow between two infinite parallel plates. Start with the C-NS. Assume that the flow is steady, two-dimensional, and fully developed (i.e., the velocity profile does not change along the streamwise direction).[45] Note that this widely- used fully-developed assumption can be inadequate in some instances, such as some compressible, microchannel flows, in which case it can be
  • 18. supplanted by a locally fully-developed assumption.[52] One-dimensional Euler equations or one-dimensional gas-dynamic equations (1D-EE): Start with the EE. Assume that all flow quantities depend only on one spatial dimension.[53] Fanno flow equation: Consider the flow inside a duct with constant area and adiabatic walls. Start with the 1D-EE. Assume a steady flow, no gravity effects, and introduce in the momentum-conservation equation an empirical term to recover the effect of wall friction (neglected in the EE). To close the Fanno flow equation, a model
  • 19. for this friction term is needed. Such a closure involves problem-dependent assumptions.[54] Rayleigh flow equation. Consider the flow inside a duct with constant area and either non-adiabatic walls without volumetric heat sources or adiabatic walls with volumetric heat sources. Start with the 1D-EE. Assume a steady flow, no gravity effects, and introduce in the energy-conservation equation an empirical term to recover the effect of wall heat transfer or the effect of the heat sources (neglected in the EE). In all of these approaches the same basic procedure is followed. Methodology
  • 20. During preprocessing The geometry and physical bounds of the problem can be defined using computer aided design (CAD). From there, data can be suitably processed (cleaned-up) and the fluid volume (or fluid domain) is extracted. The volume occupied by the fluid is divided into discrete cells (the mesh). The mesh may be uniform or non-uniform, structured or unstructured, consisting of a combination of hexahedral, tetrahedral, prismatic, pyramidal or polyhedral elements.
  • 21. The physical modeling is defined – for example, the equations of fluid motion + enthalpy + radiation + species conservation Boundary conditions are defined. This involves specifying the fluid behaviour and properties at all bounding surfaces of the fluid domain. For transient problems, the initial conditions are also defined. The simulation is started and the equations are solved iteratively as a steady-state or transient. Finally a postprocessor is used for the analysis and visualization of the
  • 22. resulting solution. Discretization methods The stability of the selected discretisation is generally established numerically rather than analytically as with simple linear problems. Special care must also be taken to ensure that the discretisation handles discontinuous solutions gracefully. The Euler equations and Navier– Stokes equations both admit shocks, and contact surfaces. Some of the discretization methods being used are: Finite volume method The finite volume method (FVM) is a common approach used in CFD codes, as it has an advantage in memory usage and solution speed, especially for large problems, high Reynolds number turbulent flows, and source term dominated flows (like combustion).[55] In the finite volume method, the governing partial differential equations (typically the Navier- Stokes equations, the mass and energy conservation equations, and the turbulence equations) are recast in a conservative form, and then solved over discrete control volumes. This discretization guarantees the conservation of fluxes through a particular control volume. The finite volume equation yields governing equations in the form, where is the vector of conserved variables, is the vector of fluxes (see Euler equations or Navier–Stokes equations), is the volume of the control volume element, and is the surface area of the control volume element.
  • 23. Finite element method The finite element method (FEM) is used in structural analysis of solids, but is also applicable to fluids. However, the FEM formulation requires special care to ensure a conservative solution. The FEM formulation has been adapted for use with fluid dynamics governing equations.[56][57] Although FEM must be carefully formulated to be conservative, it is much more stable than the finite volume approach.[58] However, FEM can require more memory and has slower solution times than the FVM.[59] In this method, a weighted residual equation is formed: where is the equation residual at an element vertex , is the conservation equation expressed on an element basis, is the weight factor, and is the volume of the element. Finite difference method The finite difference method (FDM) has historical importance[57] and is simple to program. It is currently only used in few specialized codes, which handle complex geometry with high accuracy and efficiency by using embedded boundaries or overlapping grids (with the solution interpolated across each grid). where is the vector of conserved variables, and , , and are the fluxes in the , , and directions respectively.
  • 24. Spectral element method Spectral element method is a finite element type method. It requires the mathematical problem (the partial differential equation) to be cast in a weak formulation. This is typically done by multiplying the differential equation by an arbitrary test function and integrating over the whole domain. Purely mathematically, the test functions are completely arbitrary - they belong to an infinite-dimensional function space. Clearly an infinite-dimensional function space cannot be represented on a discrete spectral element mesh; this is where the spectral element discretization begins. The most crucial thing is the choice of interpolating and testing functions. In a standard, low order FEM in 2D, for quadrilateral elements the most typical choice is the bilinear test or interpolating function of the form . In a spectral element method however, the interpolating and test functions are chosen to be polynomials of a very high order (typically e.g. of the 10th order in CFD applications). This guarantees the rapid convergence of the method. Furthermore, very efficient integration procedures must be used, since the number of integrations to be performed in numerical codes is big. Thus, high order Gauss integration quadratures are employed, since they achieve the highest accuracy with the smallest number of computations to be carried out. At the time there are some academic CFD codes based on the spectral element method and some more are currently under development, since the new time-stepping schemes arise in the scientific world. Lattice Boltzmann method The lattice Boltzmann method (LBM) with its simplified kinetic picture on a lattice provides a computationally efficient description of hydrodynamics. Unlike the traditional CFD methods, which 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 mesh. In this method, one works with the discrete in space and time version of the kinetic evolution equation in the Boltzmann Bhatnagar-Gross-Krook (BGK) form. Vortex method The vortex method, also Lagrangian Vortex Particle Method, is a meshfree technique for the simulation of incompressible turbulent flows. In it, vorticity is discretized onto Lagrangian
  • 25. particles, these computational elements being called vortices, vortons, or vortex particles.[60] Vortex methods were developed as a grid-free methodology that would not be limited by the fundamental smoothing effects associated with grid-based methods. To be practical, however, vortex methods require means for rapidly computing velocities from the vortex elements – in other words they require the solution to a particular form of the N-body problem (in which the motion of N objects is tied to their mutual influences). This breakthrough came in the 1980s with the development of the Barnes-Hut and fast multipole method (FMM) algorithms. These paved the way to practical computation of the velocities from the vortex elements. Software based on the vortex method offer a new means for solving tough fluid dynamics problems with minimal user intervention. All that is required is specification of problem geometry and setting of boundary and initial conditions. Among the significant advantages of this modern technology; It is practically grid-free, thus eliminating numerous iterations associated with RANS and LES. All problems are treated identically. No modeling or calibration inputs are required. Time-series simulations, which are crucial for correct analysis of acoustics, are possible.
  • 26. The small scale and large scale are accurately simulated at the same time. Boundary element method In the boundary element method, the boundary occupied by the fluid is divided into a surface mesh. High-resolution discretization schemes High-resolution schemes are used where shocks or discontinuities are present. Capturing sharp changes in the solution requires the use of second or higher-order numerical schemes that do not introduce spurious oscillations. This usually necessitates the application of flux limiters to ensure that the solution is total variation diminishing. Turbulence models In computational modeling of turbulent flows, one common objective is to obtain a model that can predict quantities of interest, such as fluid velocity, for use in engineering designs of the system being modeled. For turbulent flows, the range of length scales and complexity of phenomena involved in turbulence make most modeling approaches prohibitively expensive; the resolution required to resolve all scales involved in turbulence is beyond what is computationally possible. The primary approach in such cases is to create numerical models to approximate unresolved phenomena. This section lists some commonly used computational models for turbulent flows. Turbulence models can be classified based on computational expense, which corresponds to the range of scales that are modeled versus resolved (the more turbulent scales that are resolved, the finer the resolution of the simulation, and therefore the higher the
  • 27. computational cost). If a majority or all of the turbulent scales are not modeled, the computational cost is very low, but the tradeoff comes in the form of decreased accuracy. In addition to the wide range of length and time scales and the associated computational cost, the governing equations of fluid dynamics contain a non-linear convection term and a non-linear and non-local pressure gradient term. These nonlinear equations must be solved numerically with the appropriate boundary and initial conditions. Reynolds-averaged Navier–Stokes External aerodynamics of the DrivAer (http s://www.mw.tum.de/en/aer/research-group s/automotive/drivaer/) model, computed using URANS (top) and DDES (bottom) A simulation of aerodynamic package of a Porsche Cayman (987.2) Reynolds-averaged Navier–Stokes (RANS) equations are the oldest approach to turbulence modeling. An ensemble version of the governing equations is solved, which introduces new apparent stresses known as Reynolds stresses. This adds a second order tensor of unknowns for which various models can provide different levels of closure. It is a common misconception that the RANS equations do not apply to flows with a time-varying mean flow because these equations are 'time-averaged'. In fact, statistically unsteady (or non- stationary) flows can equally be treated. This is sometimes referred to as URANS. There is nothing inherent in Reynolds averaging to preclude this, but the turbulence models used to
  • 28. close the equations are valid only as long as the time over which these changes in the mean occur is large compared to the time scales of the turbulent motion containing most of the energy. RANS models can be divided into two broad approaches: Boussinesq hypothesis This method involves using an algebraic equation for the Reynolds stresses which include determining the turbulent viscosity, and depending on the level of sophistication of the model, solving transport equations for determining the turbulent kinetic energy and dissipation. Models include k-ε (Launder and Spalding),[61] Mixing Length Model (Prandtl),[62] and Zero Equation Model (Cebeci and Smith).[62] The models available in this approach are often referred to by the number of
  • 29. transport equations associated with the method. For example, the Mixing Length model is a "Zero Equation" model because no transport equations are solved; the is a "Two Equation" model because two transport equations (one for and one for ) are solved. Reynolds stress model (RSM) This approach attempts to actually solve transport equations for the Reynolds stresses. This means introduction of several transport equations for all the Reynolds stresses and hence this approach is much more costly in CPU effort.
  • 30. Large eddy simulation Volume rendering of a non-premixed swirl flame as simulated by LES Large eddy simulation (LES) is a technique in which the smallest scales of the flow are removed through a filtering operation, and their effect modeled using subgrid scale models. This allows the largest and most important scales of the turbulence to be resolved, while greatly reducing the computational cost incurred by the smallest scales. This method requires greater computational resources than RANS methods, but is far cheaper than DNS. Detached eddy simulation Detached eddy simulations (DES) is a modification of a RANS model in which the model switches to a subgrid scale formulation in regions fine enough for LES calculations. Regions near solid boundaries and where the turbulent length scale is less than the maximum grid dimension are assigned the RANS mode of solution. As the turbulent length scale exceeds the grid dimension, the regions are solved using the LES mode. Therefore, the grid resolution for DES is not as demanding as pure LES, thereby considerably cutting down the cost of the computation. Though DES was initially formulated for the Spalart-Allmaras model (Spalart et al., 1997), it can be implemented with other RANS models (Strelets, 2001), by appropriately modifying the length scale which is explicitly or implicitly involved in the RANS model. So while Spalart–Allmaras model based DES acts as LES with a wall model, DES based on other models (like two equation models) behave as a hybrid RANS-LES model. Grid generation is more complicated than for a simple RANS or LES case due to the RANS-LES switch. DES is a non-zonal approach and provides a single smooth velocity field across the RANS and the LES regions of the solutions.
  • 31. IDDES Simulation of the Karel Motorsports BMW. This is a type of DES simulation completed in OpenFOAM. The plot is coefficient of pressure. Direct numerical simulation Direct numerical simulation (DNS) resolves the entire range of turbulent length scales. This marginalizes the effect of models, but is extremely expensive. The computational cost is proportional to .[63] DNS is intractable for flows with complex geometries or flow configurations. Coherent vortex simulation The coherent vortex simulation approach decomposes the turbulent flow field into a coherent part, consisting of organized vortical motion, and the incoherent part, which is the random background flow.[64] This decomposition is done using wavelet filtering. The approach has much in common with LES, since it uses decomposition and resolves only the filtered portion, but different in that it does not use a linear, low-pass filter. Instead, the filtering operation is based on wavelets, and the filter can be adapted as the flow field evolves. Farge and Schneider tested the CVS method with two flow configurations and showed that the coherent portion of the flow exhibited the energy spectrum exhibited by the total flow, and corresponded to coherent structures (vortex tubes), while the incoherent parts of the flow composed homogeneous background noise, which exhibited no organized structures. Goldstein and Vasilyev[65] applied the FDV model to large eddy simulation, but did not assume that the wavelet filter eliminated all coherent motions from the subfilter scales. By employing both LES and CVS filtering, they showed that the SFS dissipation was dominated by the SFS flow field's coherent portion.
  • 32. PDF methods Probability density function (PDF) methods for turbulence, first introduced by Lundgren,[66] are based on tracking the one-point PDF of the velocity, , which gives the probability of the velocity at point being between and . This approach is analogous to the kinetic theory of gases, in which the macroscopic properties of a gas are described by a large number of particles. PDF methods are unique in that they can be applied in the framework of a number of different turbulence models; the main differences occur in the form of the PDF transport equation. For example, in the context of large eddy simulation, the PDF becomes the filtered PDF.[67] PDF methods can also be used to describe chemical reactions,[68][69] and are particularly useful for simulating chemically reacting flows because the chemical source term is closed and does not require a model. The PDF is commonly tracked by using Lagrangian particle methods; when combined with large eddy simulation, this leads to a Langevin equation for subfilter particle evolution. Vorticity confinement method The vorticity confinement (VC) method is an Eulerian technique used in the simulation of turbulent wakes. It uses a solitary-wave like approach to produce a stable solution with no numerical spreading. VC can capture the small-scale features to within as few as 2 grid cells. Within these features, a nonlinear difference equation is solved as opposed to the finite difference equation. VC is similar to shock capturing methods, where conservation laws are satisfied, so that the essential integral quantities are accurately computed. Linear eddy model The Linear eddy model is a technique used to simulate the convective mixing that takes place in turbulent flow.[70] Specifically, it provides a mathematical way to describe the interactions of a scalar variable within the vector flow field. It is primarily used in one- dimensional representations of turbulent flow, since it can be applied across a wide range of length scales and Reynolds numbers. This model is generally used as a building block for more complicated flow representations, as it provides high resolution predictions that hold across a large range of flow conditions.
  • 33. Two-phase flow Simulation of bubble horde using volume of fluid method The modeling of two-phase flow is still under development. Different methods have been proposed, including the Volume of fluid method, the level-set method and front tracking.[71][72] These methods often involve a tradeoff between maintaining a sharp interface or conserving mass . This is crucial since the evaluation of the density, viscosity and surface tension is based on the values averaged over the interface. Solution algorithms Discretization in the space produces a system of ordinary differential equations for unsteady problems and algebraic equations for steady problems. Implicit or semi-implicit methods are generally used to integrate the ordinary differential equations, producing a system of (usually) nonlinear algebraic equations. Applying a Newton or Picard iteration produces a system of linear equations which is nonsymmetric in the presence of advection and indefinite in the presence of incompressibility. Such systems, particularly in 3D, are frequently too large for direct solvers, so iterative methods are used, either stationary methods such as successive overrelaxation or Krylov subspace methods. Krylov methods such as GMRES, typically used with preconditioning, operate by minimizing the residual over successive subspaces generated by the preconditioned operator. Multigrid has the advantage of asymptotically optimal performance on many problems. Traditional solvers and preconditioners are effective at reducing high-frequency components of the residual, but low-frequency components typically require many iterations to reduce. By
  • 34. operating on multiple scales, multigrid reduces all components of the residual by similar factors, leading to a mesh-independent number of iterations. For indefinite systems, preconditioners such as incomplete LU factorization, additive Schwarz, and multigrid perform poorly or fail entirely, so the problem structure must be used for effective preconditioning.[73] Methods commonly used in CFD are the SIMPLE and Uzawa algorithms which exhibit mesh-dependent convergence rates, but recent advances based on block LU factorization combined with multigrid for the resulting definite systems have led to preconditioners that deliver mesh-independent convergence rates.[74] Unsteady aerodynamics CFD made a major break through in late 70s with the introduction of LTRAN2, a 2-D code to model oscillating airfoils based on transonic small perturbation theory by Ballhaus and associates.[75] It uses a Murman-Cole switch algorithm for modeling the moving shock- waves.[26] Later it was extended to 3-D with use of a rotated difference scheme by AFWAL/Boeing that resulted in LTRAN3.[76][77] Biomedical engineering Simulation of blood flow in a human aorta CFD investigations are used to clarify the characteristics of aortic flow in details that are beyond the capabilities of experimental measurements. To analyze these conditions, CAD models of the human vascular system are extracted employing modern imaging techniques
  • 35. such as MRI or Computed Tomography. A 3D model is reconstructed from this data and the fluid flow can be computed. Blood properties such as density and viscosity, and realistic boundary conditions (e.g. systemic pressure) have to be taken into consideration. Therefore, making it possible to analyze and optimize the flow in the cardiovascular system for different applications.[78] CPU versus GPU Traditionally, CFD simulations are performed on CPUs.[79] In a more recent trend, simulations are also performed on GPUs. These typically contain slower but more processors. For CFD algorithms that feature good parallelism performance (i.e. good speed-up by adding more cores) this can greatly reduce simulation times. Fluid- implicit particle[80] and lattice-Boltzmann methods[81] are typical examples of codes that scale well on GPUs. Blade element theory Boundary conditions in fluid dynamics Cavitation modelling Central differencing scheme See also
  • 36. Computational magnetohydrodynamics Discrete element method Finite element method Finite volume method for unsteady flow Fluid animation Immersed boundary method Lattice Boltzmann methods List of finite element software packages Meshfree methods Moving particle semi-implicit method Multi-particle collision dynamics Multidisciplinary design optimization
  • 37. Numerical methods in fluid mechanics Shape optimization Smoothed-particle hydrodynamics Stochastic Eulerian Lagrangian method Turbulence modeling Visualization (graphics) Wind tunnel 1. Milne-Thomson, Louis Melville (1973). Theoretical Aerodynamics. Courier Corporation. ISBN 978-0-486-61980-4. References
  • 38. 2. McMurtry, Patrick A.; Gansauge, Todd C.; Kerstein, Alan R.; Krueger, Steven K. (April 1993). "Linear eddy simulations of mixing in a homogeneous turbulent flow". Physics of Fluids A: Fluid Dynamics. 5 (4): 1023–1034. Bibcode:1993PhFlA...5.1023M (https://ui. adsabs.harvard.edu/abs/1993PhFlA...5.1 023M) . doi:10.1063/1.858667 (https://d oi.org/10.1063%2F1.858667) . 3. Richardson, L. F.; Chapman, S. (1965). Weather prediction by numerical process. Dover Publications.
  • 39. 4. Hunt, J.C.R. (January 1998). "Lewis Fry Richardson and his contributions to mathematics, meteorology, and models of conflict". Annual Review of Fluid Mechanics. 30 (1): xiii–xxxvi. Bibcode:1998AnRFM..30D..13H (https://u i.adsabs.harvard.edu/abs/1998AnRFM..3 0D..13H) . doi:10.1146/annurev.fluid.30.1.0 (https:// doi.org/10.1146%2Fannurev.fluid.30.1.0) . 5. "The Legacy of Group T-3" (https://www.la nl.gov/orgs/t/t3/history.shtml#early) . Retrieved March 13, 2013.
  • 40. 6. Harlow, Francis H. (April 2004). "Fluid dynamics in Group T-3 Los Alamos National Laboratory" (https://zenodo.org/r ecord/1259097) . Journal of Computational Physics. 195 (2): 414– 433. Bibcode:2004JCoPh.195..414H (http s://ui.adsabs.harvard.edu/abs/2004JCoP h.195..414H) . doi:10.1016/j.jcp.2003.09.031 (https://do i.org/10.1016%2Fj.jcp.2003.09.031) .
  • 41. 7. Harlow, Francis Harvey; Evans, Martha; Richtmyer, Robert D. (1955). A Machine Calculation Method for Hydrodynamic Problems. Los Alamos Scientific Laboratory of the University of California. hdl:2027/mdp.39015095283399 (https:// hdl.handle.net/2027%2Fmdp.390150952 83399) . OCLC 1288309947 (https://ww w.worldcat.org/oclc/1288309947) .
  • 42. 8. Gentry, Richard A; Martin, Robert E; Daly, Bart J (August 1966). "An Eulerian differencing method for unsteady compressible flow problems". Journal of Computational Physics. 1 (1): 87–118. Bibcode:1966JCoPh...1...87G (https://ui.a dsabs.harvard.edu/abs/1966JCoPh...1...8 7G) . doi:10.1016/0021-9991(66)90014-3 (https://doi.org/10.1016%2F0021-9991% 2866%2990014-3) . 9. Fromm, Jacob E.; Harlow, Francis H. (July 1963). "Numerical Solution of the Problem of Vortex Street Development". The Physics of Fluids. 6 (7): 975–982. Bibcode:1963PhFl....6..975F (https://ui.ad sabs.harvard.edu/abs/1963PhFl....6..975 F) . doi:10.1063/1.1706854 (https://doi.o rg/10.1063%2F1.1706854) .
  • 43. 10. Harlow, Francis H.; Welch, J. Eddie (December 1965). "Numerical Calculation of Time-Dependent Viscous Incompressible Flow of Fluid with Free Surface". The Physics of Fluids. 8 (12): 2182–2189. Bibcode:1965PhFl....8.2182H (https://ui.adsabs.harvard.edu/abs/1965 PhFl....8.2182H) . doi:10.1063/1.1761178 (https://doi.org/10.1063%2F1.1761178) . 11. Hess, J.L.; Smith, A.M.O. (1967). "Calculation of potential flow about arbitrary bodies". Progress in Aerospace Sciences. 8: 1–138. Bibcode:1967PrAeS...8....1H (https://ui.ad sabs.harvard.edu/abs/1967PrAeS...8....1 H) . doi:10.1016/0376-0421(67)90003-6 (https://doi.org/10.1016%2F0376-0421% 2867%2990003-6) .
  • 44. 12. Rubbert, P.; Saaris, G. (1972). "Review and evaluation of a three-dimensional lifting potential flow computational method for arbitrary configurations". 10th Aerospace Sciences Meeting. doi:10.2514/6.1972- 188 (https://doi.org/10.2514%2F6.1972-1 88) . 13. Carmichael, R.; Erickson, L. (1981). "PAN AIR - A higher order panel method for predicting subsonic or supersonic linear potential flows about arbitrary configurations". 14th Fluid and Plasma Dynamics Conference. doi:10.2514/6.1981-1255 (https://doi.or g/10.2514%2F6.1981-1255) .
  • 45. 14. Youngren, H.; Bouchard, E.; Coopersmith, R.; Miranda, L. (1983). "Comparison of panel method formulations and its influence on the development of QUADPAN, an advanced low-order method". Applied Aerodynamics Conference. doi:10.2514/6.1983-1827 (ht tps://doi.org/10.2514%2F6.1983-1827) . 15. Hess, J.; Friedman, D. (1983). "Analysis of complex inlet configurations using a higher-order panel method". Applied Aerodynamics Conference. doi:10.2514/6.1983-1828 (https://doi.or g/10.2514%2F6.1983-1828) .
  • 46. 41. Jop, Pierre; Forterre, Yoël; Pouliquen, Olivier (June 2006). "A constitutive law for dense granular flows" (https://www.natur e.com/articles/nature04801) . Nature. 441 (7094): 727–730. arXiv:cond- mat/0612110 (https://arxiv.org/abs/cond- mat/0612110) . Bibcode:2006Natur.441..727J (https://ui.a dsabs.harvard.edu/abs/2006Natur.441..7 27J) . doi:10.1038/nature04801 (https:// doi.org/10.1038%2Fnature04801) . ISSN 1476-4687 (https://www.worldcat.or g/issn/1476-4687) .
  • 47. 42. Biroun, Mehdi H.; Mazzei, Luca (June 2024). "Unchannelized granular flows: Effect of initial granular column geometry on fluid dynamics" (https://doi.org/10.101 6/j.ces.2024.119997) . Chemical Engineering Science. 292: 119997. doi:10.1016/j.ces.2024.119997 (https://d oi.org/10.1016%2Fj.ces.2024.119997) . ISSN 0009-2509 (https://www.worldcat.or g/issn/0009-2509) . 43. Ferziger, J. H. and Peric, M. (2002). Computational methods for fluid dynamics. Springer-Verlag. 44. "Navier-Stokes equations" (https://www.cf d-online.com/Wiki/Navier-Stokes_equatio ns) . Retrieved 2020-01-07. 45. Panton, R. L. (1996). Incompressible Flow. John Wiley and Sons.
  • 48. 46. Landau, L. D. and Lifshitz, E. M. (2007). Fluid Mechanics. Elsevier. 47. Fox, R. W. and McDonald, A. T. (1992). Introduction to Fluid Mechanics. John Wiley and Sons. 48. Poinsot, T. and Veynante, D. (2005). Theoretical and numerical combustion. RT Edwards. 49. Kundu, P. (1990). Fluid Mechanics. Academic Press. 50. "Favre averaged Navier-Stokes equations" (https://www.cfd-online.com/Wiki/Favre_a veraged_Navier-Stokes_equations) . Retrieved 2020-01-07.
  • 49. 51. Bailly, C., and Daniel J. (2000). "Numerical solution of acoustic propagation problems using Linearized Euler Equations". AIAA Journal. 38 (1): 22–29. Bibcode:2000AIAAJ..38...22B (https://ui.a dsabs.harvard.edu/abs/2000AIAAJ..38... 22B) . doi:10.2514/2.949 (https://doi.org/ 10.2514%2F2.949) .
  • 50. 52. Harley, J. C. and Huang, Y. and Bau, H. H. and Zemel, J. N. (1995). "Gas flow in micro-channels". Journal of Fluid Mechanics. 284: 257–274. Bibcode:1995JFM...284..257H (https://ui. adsabs.harvard.edu/abs/1995JFM...284.. 257H) . doi:10.1017/S0022112095000358 (http s://doi.org/10.1017%2FS0022112095000 358) . S2CID 122833857 (https://api.sem anticscholar.org/CorpusID:122833857) . 53. "One-dimensional Euler equations" (http s://home.cscamm.umd.edu/centpack/ex amples/euler1d.htm) . Retrieved 2020-01-12.
  • 51. 54. Cavazzuti, M. and Corticelli, M. A. and Karayiannis, T. G. (2019). "Compressible Fanno flows in micro-channels: An enhanced quasi-2D numerical model for laminar flows" (https://doi.org/10.1016%2 Fj.tsep.2019.01.003) . Thermal Science and Engineering Progress. 10: 10–26. doi:10.1016/j.tsep.2019.01.003 (https://d oi.org/10.1016%2Fj.tsep.2019.01.003) . hdl:11392/2414220 (https://hdl.handle.ne t/11392%2F2414220) . 55. Patankar, Suhas V. (1980). Numerical Heat Transfer and Fluid FLow. Hemisphere Publishing Corporation. ISBN 978-0891165224.
  • 52. 56. "Detailed Explanation of the Finite Element Method (FEM)" (https://www.co msol.com/multiphysics/finite-element-me thod) . www.comsol.com. Retrieved 2022-07-15. 57. Anderson, John David (1995). Computational Fluid Dynamics: The Basics with Applications (https://books.g oogle.com/books?id=phG_QgAACAAJ) . McGraw-Hill. ISBN 978-0-07-113210-7.
  • 53. 58. Surana, K.A.; Allu, S.; Tenpas, P.W.; Reddy, J.N. (February 2007). "k-version of finite element method in gas dynamics: higher- order global differentiability numerical solutions". International Journal for Numerical Methods in Engineering. 69 (6): 1109–1157. Bibcode:2007IJNME..69.1109S (https://u i.adsabs.harvard.edu/abs/2007IJNME..6 9.1109S) . doi:10.1002/nme.1801 (http s://doi.org/10.1002%2Fnme.1801) . S2CID 122551159 (https://api.semanticsc holar.org/CorpusID:122551159) . 59. Huebner, K.H.; Thornton, E.A.; and Byron, T.D. (1995). The Finite Element Method for Engineers (Third ed.). Wiley Interscience.
  • 54. 60. Cottet, Georges-Henri; Koumoutsakos, Petros D. (2000). Vortex Methods: Theory and Practice. Cambridge, UK: Cambridge Univ. Press. ISBN 0-521-62186-0. 61. Launder, B.E.; D.B. Spalding (1974). "The Numerical Computation of Turbulent Flows". Computer Methods in Applied Mechanics and Engineering. 3 (2): 269– 289. Bibcode:1974CMAME...3..269L (http s://ui.adsabs.harvard.edu/abs/1974CMA ME...3..269L) . doi:10.1016/0045- 7825(74)90029-2 (https://doi.org/10.101 6%2F0045-7825%2874%2990029-2) . 62. Wilcox, David C. (2006). Turbulence Modeling for CFD (3 ed.). DCW Industries, Inc. ISBN 978-1-928729-08-2.
  • 55. 63. Pope, S.B. (2000). Turbulent Flows. Cambridge University Press. ISBN 978-0- 521-59886-6. 64. Farge, Marie; Schneider, Kai (2001). "Coherent Vortex Simulation (CVS), A Semi-Deterministic Turbulence Model Using Wavelets". Flow, Turbulence and Combustion. 66 (4): 393–426. doi:10.1023/A:1013512726409 (https://d oi.org/10.1023%2FA%3A101351272640 9) . S2CID 53464243 (https://api.semanti cscholar.org/CorpusID:53464243) .
  • 56. 65. Goldstein, Daniel; Vasilyev, Oleg (1995). "Stochastic coherent adaptive large eddy simulation method". Physics of Fluids A. 24 (7): 2497. Bibcode:2004PhFl...16.2497G (https://ui.a dsabs.harvard.edu/abs/2004PhFl...16.24 97G) . CiteSeerX 10.1.1.415.6540 (http s://citeseerx.ist.psu.edu/viewdoc/summa ry?doi=10.1.1.415.6540) . doi:10.1063/1.1736671 (https://doi.org/1 0.1063%2F1.1736671) . 66. Lundgren, T.S. (1969). "Model equation for nonhomogeneous turbulence". Physics of Fluids A. 12 (3): 485–497. Bibcode:1969PhFl...12..485L (https://ui.a dsabs.harvard.edu/abs/1969PhFl...12..48 5L) . doi:10.1063/1.1692511 (https://doi. org/10.1063%2F1.1692511) .
  • 57. 67. Colucci, P.J.; Jaberi, F.A; Givi, P.; Pope, S.B. (1998). "Filtered density function for large eddy simulation of turbulent reacting flows". Physics of Fluids A. 10 (2): 499– 515. Bibcode:1998PhFl...10..499C (http s://ui.adsabs.harvard.edu/abs/1998PhF l...10..499C) . doi:10.1063/1.869537 (http s://doi.org/10.1063%2F1.869537) . 68. Fox, Rodney (2003). Computational models for turbulent reacting flows. Cambridge University Press. ISBN 978-0- 521-65049-6.
  • 58. 69. Pope, S.B. (1985). "PDF methods for turbulent reactive flows". Progress in Energy and Combustion Science. 11 (2): 119–192. Bibcode:1985PrECS..11..119P (https://ui.adsabs.harvard.edu/abs/1985 PrECS..11..119P) . doi:10.1016/0360- 1285(85)90002-4 (https://doi.org/10.101 6%2F0360-1285%2885%2990002-4) . 70. Krueger, Steven K. (1993). "Linear Eddy Simulations Of Mixing In A Homogeneous Turbulent Flow" (https://zenodo.org/recor d/1232081) . Physics of Fluids. 5 (4): 1023–1034. Bibcode:1993PhFlA...5.1023M (https://ui. adsabs.harvard.edu/abs/1993PhFlA...5.1 023M) . doi:10.1063/1.858667 (https://d oi.org/10.1063%2F1.858667) .
  • 59. 71. Hirt, C.W; Nichols, B.D (January 1981). "Volume of fluid (VOF) method for the dynamics of free boundaries". Journal of Computational Physics. 39 (1): 201–225. Bibcode:1981JCoPh..39..201H (https://ui. adsabs.harvard.edu/abs/1981JCoPh..39.. 201H) . doi:10.1016/0021- 9991(81)90145-5 (https://doi.org/10.101 6%2F0021-9991%2881%2990145-5) .
  • 60. 72. Unverdi, Salih Ozen; Tryggvason, Grétar (May 1992). "A front-tracking method for viscous, incompressible, multi-fluid flows". Journal of Computational Physics. 100 (1): 25–37. Bibcode:1992JCoPh.100...25U (https://ui. adsabs.harvard.edu/abs/1992JCoPh.10 0...25U) . doi:10.1016/0021- 9991(92)90307-K (https://doi.org/10.101 6%2F0021-9991%2892%2990307-K) . hdl:2027.42/30059 (https://hdl.handle.ne t/2027.42%2F30059) .
  • 61. 73. Benzi, Michele; Golub, Gene H.; Liesen, Jörg (May 2005). "Numerical solution of saddle point problems". Acta Numerica. 14: 1–137. Bibcode:2005AcNum..14....1B (https://ui.adsabs.harvard.edu/abs/2005 AcNum..14....1B) . CiteSeerX 10.1.1.409.4160 (https://citese erx.ist.psu.edu/viewdoc/summary?doi=1 0.1.1.409.4160) . doi:10.1017/S0962492904000212 (http s://doi.org/10.1017%2FS0962492904000 212) . S2CID 122717775 (https://api.sem anticscholar.org/CorpusID:122717775) .
  • 62. 74. Elman, Howard; Howle, V.E.; Shadid, John; Shuttleworth, Robert; Tuminaro, Ray (January 2008). "A taxonomy and comparison of parallel block multi-level preconditioners for the incompressible Navier–Stokes equations" (https://digital.li brary.unt.edu/ark:/67531/metadc90233 2/) . Journal of Computational Physics. 227 (3): 1790–1808. Bibcode:2008JCoPh.227.1790E (https://u i.adsabs.harvard.edu/abs/2008JCoPh.22 7.1790E) . doi:10.1016/j.jcp.2007.09.026 (https://doi.org/10.1016%2Fj.jcp.2007.09. 026) . S2CID 16365489 (https://api.sema nticscholar.org/CorpusID:16365489) .
  • 63. 75. Adamson, M.R. (January 2006). "Biographies". IEEE Annals of the History of Computing. 28 (1): 99–103. doi:10.1109/MAHC.2006.5 (https://doi.or g/10.1109%2FMAHC.2006.5) . 76. Jameson, Antony (May 1974). "Iterative solution of transonic flows over airfoils and wings, including flows at mach 1". Communications on Pure and Applied Mathematics. 27 (3): 283–309. doi:10.1002/cpa.3160270302 (https://do i.org/10.1002%2Fcpa.3160270302) . 77. Borland, C.J., "XTRAN3S - Transonic Steady and Unsteady Aerodynamics for Aeroelastic Applications,"AFWAL-TR-85- 3214, Air Force Wright Aeronautical Laboratories, Wright-Patterson AFB, OH, January, 1986
  • 64. 80. Wu, Kui; Truong, Nghia; Yuksel, Cem; Hoetzlein, Rama (May 2018). "Fast Fluid Simulations with Sparse Volumes on the GPU". Computer Graphics Forum. 37 (2): 157–167. doi:10.1111/cgf.13350 (https:// doi.org/10.1111%2Fcgf.13350) . S2CID 43945038 (https://api.semanticsch olar.org/CorpusID:43945038) . 81. "Intersect 360 HPC application Support" (http://www.nvidia.com/content/intersect- 360-HPC-application-support.pdf) (PDF). Anderson, John D. (1995). Computational Fluid Dynamics: The Basics With Applications. Notes