Navier-Stokes equations

From Wikipedia, the free encyclopedia

Continuum mechanics
General
Solid mechanics
Fluid mechanics

The Navier-Stokes equations, named after Claude-Louis Navier and George Gabriel Stokes, are a set of equations that describe the motion of fluid substances such as liquids and gases. These equations establish that changes in momentum (acceleration) of fluid particles are simply the product of changes in pressure and dissipative viscous forces (similar to friction) acting inside the fluid. These viscous forces originate in molecular interactions and dictate how sticky (viscous) a fluid is. Thus, the Navier-Stokes equations are a dynamical statement of the balance of forces acting at any given region of the fluid.

They are one of the most useful sets of equations because they describe the physics of a large number of phenomena of academic and economic interest. They are used to model weather, ocean currents, water flow in a pipe, motion of stars inside a galaxy, and flow around an airfoil (wing). They are also used in the design of aircraft and cars, the study of blood flow, the design of power stations, the analysis of the effects of pollution, etc. Coupled with Maxwell's equations they can be used to model and study magnetohydrodynamics.

A variety of computer programmes (both commercial and academic) have been developed to solve the Navier-Stokes equations using various numerical methods. This approach is collectively called Computational Fluid Dynamics or CFD.

The Navier-Stokes equations are differential equations which describe the motion of a fluid. These equations, unlike algebraic equations, do not seek to establish a relation among the variables of interest (e.g. velocity and pressure), rather they establish relations among the rates of change or fluxes of these quantities. In mathematical terms these rates correspond to their derivatives. Thus, the Navier-Stokes equations for the most simple case of an ideal fluid with zero viscosity states that acceleration (the rate of change of velocity) is proportional to the derivative of internal pressure.

This means that solutions of the Navier-Stokes equations for a given physical problem must be sought with the help of calculus. In practical terms only the simplest cases can be solved in this way and their exact solution is known. These cases often involve non-turbulent flow in steady state (flow does not change with time) in which the viscosity of the fluid is large or its velocity is small (small Reynolds number).

For more complex situations, such as global weather systems like El Niño or lift in a wing, solutions of the Navier-Stokes equations must be found with the help of computers. This is a field of sciences by its own called computational fluid dynamics.

Even though turbulence is an everyday experience, it is extremely difficult to find solutions for this class of problems. A $1,000,000 prize was offered in May 2000 by the Clay Mathematics Institute to whoever makes substantial progress toward a mathematical theory which will help in the understanding of this phenomenon.

Contents

[edit] Basic assumptions

The Navier-Stokes equations are based on the assumption that the fluid, at the scale of interest, is a continuum, i.e., is not made up of discrete particles. Another necessary assumption is that all the fields of interest like pressure, velocity, density, temperature and so on are differentiable (i.e. no phase transitions).

The equations are derived from the basic principles of conservation of mass, momentum, and energy. For that matter, sometimes it is necessary to consider a finite arbitrary volume, called a control volume, over which these principles can be applied. This finite volume is denoted by Ω and its bounding surface \partial \Omega. The control volume can remain fixed in space or can move with the fluid.

[edit] The substantive derivative

Changes in properties of a moving fluid can be measured in two different ways. One can measure a given property by either carrying out the measurement on a fixed point in space as particles of the fluid pass by, or by following a parcel of fluid along its streamline. The derivative of a field with respect to a fixed position in space is called the spatial derivative while the derivative following a moving parcel is called the substantive derivative.

The substantive derivative is defined as the operator:

\frac{D}{Dt}(\star ) \ \stackrel{\mathrm{def}}{=}\  \frac{\partial(\star )}{\partial t} + \mathbf{v}\cdot\nabla (\star )

where \mathbf{v} is the velocity of the fluid. The first term on the right-hand side of the equation is the ordinary Eulerian derivative (i.e. the derivative on a fixed reference frame) whereas the second term represents the changes brought about by the moving fluid. This effect is referred to as advection.

For example, the measurement of changes in wind velocity in the atmosphere can be obtained with the help of an anemometer in a weather station or by mounting it on a weather balloon. The anemometer in the first case is measuring the velocity of all the moving particles passing through a fixed point in space, whereas in the second case the instrument is measuring changes in velocity as it moves with the fluid.

[edit] Conservation laws

The Navier-Stokes equations are derived from conservation principles of:

Additionally, it is necessary to assume a constitutive relation or state law for the fluid.

In its most general form, a conservation law states that the rate of change of an extensive property L defined over a control volume must equal what is lost through the boundaries of the volume carried out by the moving fluid plus what is created/consumed by sources and sinks inside the control volume. This is expressed by the following integral equation:

\frac{d}{dt}\int_{\Omega} L \; d\Omega = -\int_{\partial\Omega} L\mathbf{v\cdot n} d\partial\Omega+ \int_{\Omega} Q d\Omega

Where v is the velocity of the fluid and Q represents the sources and sinks in the fluid.

If the control volume is fixed in space then this integral equation can be expressed as

\frac{d}{d t} \int_{\Omega}  L d\Omega = -\int_{\Omega} \nabla\cdot ( L\mathbf{v} ) d\Omega + \int_{\Omega} Q d\Omega

The divergence theorem was used in the derivation of this last equation in order to express the first term on the right-hand side in the interior of the control volume. Thus:

\frac{d}{dt}\int_{\Omega} L d\Omega = - \int_{\Omega} (\nabla\cdot ( L\mathbf{v} ) - Q) d\Omega

The expression above is valid for Ω, which is a control volume that remains fixed in space. Because Ω is invariant in time, it is possible to swap the "\frac{d}{dt}" and "\int_{\Omega}^{} d\Omega" operators. And as the expression is valid for all domains, we can additionally drop the integral.

Introducing the substantive derivative, we get when Q = 0 (no sources or sinks):

\frac{\partial}{\partial t} L + \nabla\cdot\left(L \mathbf{v} \right) = \frac{D}{Dt}L + L \left(\nabla\cdot \mathbf{v}\right) = 0

For a quantity which isn't space-dependent (so that it doesn't have to be integrated over space), D/Dt gives the right comoving time rate of change.

[edit] Equation of continuity

Conservation of mass is written:

\frac{\partial \rho}{\partial t} +  \nabla\cdot\left(\rho\mathbf{v}\right) = 0
\frac{\partial \rho}{\partial t} + \rho\nabla\cdot\mathbf{v} + \mathbf{v} \cdot \nabla \rho =0
\frac{D \rho}{D t} + \rho \nabla \cdot \mathbf{v} = 0

where ρ is the mass density (mass per unit volume), and v is the velocity of the fluid.

In the case of an incompressible fluid, ρ does not vary along a pathline and the equation reduces to:

\nabla\cdot\mathbf{v} = 0

[edit] Conservation of momentum

Conservation of momentum is expressed in a manner similar to the continuity equation, with vector components of the momentum replacing density, and with a source term to represent forces acting on the fluid. We replace ρ in the continuity equation with the net momentum per unit volume along a particular direction, ρvi, where vi is the ith component of the velocity, i.e. the velocity along the x, y, or z direction.

\frac{\partial}{\partial t}\left(\rho v_i \right) + \nabla \cdot (\rho v_i \mathbf{v}) =   \rho f_i .

ρfi is the ith component of the force acting on the fluid (actually the force per unit volume). Common forces encountered include gravity and pressure gradients. This can also be expressed as:

\frac{\partial}{\partial t}\left(\rho\mathbf{v}\right) + \nabla\cdot(\rho\mathbf{v}\otimes\mathbf{v}) = \rho \mathbf{f}

\mathbf{v}\otimes\mathbf{v} is a tensor, the \otimes representing the tensor product.

Simplifying it further using the continuity equation, this becomes:

\rho\frac{D v_i}{D t}=\rho f_i

which is often written as

\rho\frac{D\mathbf{v}}{D t}=\rho \mathbf{f}

In which we recognise the usual F=ma.

[edit] The equations

[edit] General form

[edit] The form of the equations

The general form of the Navier-Stokes equations for the conservation of momentum is:

\rho\frac{D\mathbf{v}}{D t} = \nabla \cdot\mathbb{P} + \rho\mathbf{f}

where ρ is the fluid density, v is the velocity vector, and f is the body force vector. The tensor \mathbb{P} represents the surface forces applied on a fluid particle (the comoving stress tensor). Unless the fluid is made up of spinning degrees of freedom like vortices, \mathbb{P} is a symmetric tensor. In general, we have the form:

\mathbb{P} = \begin{pmatrix} \sigma_{xx} &  \tau_{xy} & \tau_{xz} \\ \tau_{yx} &  \sigma_{yy} & \tau_{yz} \\ \tau_{zx} &  \tau_{zy} & \sigma_{zz} \end{pmatrix} = - \begin{pmatrix} p&0&0\\ 0&p&0\\ 0&0&p \end{pmatrix} +  \begin{pmatrix} \sigma_{xx}+p &  \tau_{xy} & \tau_{xz} \\ \tau_{yx} & \sigma_{yy}+p & \tau_{yz} \\ \tau_{zx} &  \tau_{zy} & \sigma_{zz}+p \end{pmatrix}

where the σ are normal stresses, τ tangential stresses (shear stresses), and p is static pressure, associated with the isotropic part of the stress tensor.

The trace σxx + σyy + σzz is always -3p by definition (unless we have bulk viscosity) regardless of whether or not the fluid is in equilibrium.

Finally, we have:

\rho\frac{D\mathbf{v}}{D t} = -\nabla p + \nabla \cdot\mathbb{T} + \rho\mathbf{f}

where \mathbb{T} is the traceless part of \mathbb{P}.

These equations are still incomplete. To complete them, one must make hypotheses on the form of \mathbb{P}, that is, one needs a constitutive law for the stress tensor as shown below.

The flow is assumed to be differentiable and continuous, allowing the conservation laws to be expressed as partial differential equations. In the case of incompressible flow (constant density), the variables to be solved for are the velocity components and the pressure. The three components of the Navier-Stokes equations plus the conservation of mass (continuity equation) conform a closed system of well-posed partial differential equations for these variables, that can be solved , in principle, for suitable boundary conditions. In the case of compressible flow the density becomes another unknown of the system, and can be determined suplementing the system with an equation of state. An equation of state usually involves the temperature of the fluid, so that the equation for conservation of energy must also be solved, coupled with the previous ones. These equations are non-linear, and analytical solutions in closed form are known only for cases with very simple boundary conditions.

The equations can be converted to Wilkinson equations for the secondary variables vorticity and stream function. Solution depends on the fluid properties (such as viscosity, specific heats, and thermal conductivity), and on the boundary conditions of the domain of study.

[edit] Special forms

Those are certain usual simplifications of the problem for which sometimes solutions are known.

[edit] Newtonian fluids

Main article: Newtonian fluid

In Newtonian fluids the following assumption holds:

p_{ij}=-p\delta_{ij}+\mu\left(\frac{\partial v_i}{\partial x_j}+\frac{\partial v_j}{\partial x_i}-\frac{2}{3}\delta_{ij}\nabla\cdot\mathbf{v}\right)

where

μ is the viscosity of the fluid.
δij is the Kronecker delta (1 for i=j; 0 for i \ne j).

To see how to "derive" this, we first note that in equilibrium, pij=-pδij. For a Newtonian fluid, the deviation of the comoving stress tensor from this equilibrium value is linear in the gradient of the velocity. It obviously can't depend upon the velocity itself because of Galilean covariance. In other words, pij+pδij is linear in \partial_i v_j. The fluids that we are considering here are rotationally invariant (i.e., they are not liquid crystals). pij+pδij decomposes into a traceless symmetric tensor and a trace. Similarly, \partial_i v_j decomposes into a traceless symmetric tensor, a trace and an antisymmetric tensor. Any linear map from the latter to the former has to map the antisymmetric part to zero (Schur's lemma) and has two coefficients corresponding to the traceless symmetric part and the trace part. The traceless symmetric part of \partial_i v_j is \partial_i v_j +\partial_j v_i - \frac{2}{d} \delta_{ij}\partial_k v_k where d is the number of spatial dimensions and the trace part is \delta_{ij} \partial_k v_k. Therefore, the most general rotationally invariant linear map is given by

p_{ij}+p\delta_{ij}=\mu\left(\partial_i v_j+\partial_j v_i -\frac{2}{d}\delta_{ij}\nabla\cdot\mathbf{v}\right)+\mu_B \delta_{ij} \nabla\cdot \mathbf{v}

for some coefficients μ and μB. μ is called the shear viscosity and μB is called the bulk viscosity. It is an empirical observation that the bulk viscosity is negligible for most fluids of interest, which is why it is often dropped. This explains the factor of −2/3 appearing in this equation. This factor has to be modified in 1 or 2 spatial dimensions.

\rho \left(\frac{\partial \mathbf{v}}{\partial t}+ ( \mathbf{v} \cdot \nabla ) \mathbf{v}\right)=\rho \mathbf{f}-\nabla p +\mu\left(\nabla ^2 \mathbf{v}+\frac{1}{3}\nabla\left(\nabla\cdot \mathbf{v}\right)\right)
\rho \left(\frac{\partial v_i}{\partial t}+v_j\frac{\partial v_i}{\partial x_j}\right)=\rho f_i-\frac{\partial p}{\partial x_i}+\mu\left(\frac{\partial ^2 v_i}{\partial x_j \partial x_j}+\frac{1}{3}\frac{\partial ^2 v_j}{\partial x_i \partial x_j}\right)

where we have used the Einstein summation convention.

When written-out in full it becomes clear how complex these equations really are (but only if we insist on writing every single component out explicitly):

Conservation of momentum:

\rho \cdot \left({\partial u \over \partial t}+ u {\partial u \over \partial x}+ v {\partial u \over \partial y}+ w {\partial u \over \partial z}\right) = k_x -{\partial p \over \partial x} + {\partial \over \partial x} \left[ \mu \cdot \left(2 \cdot {\partial u \over \partial x}-\frac{2}{3}\cdot (\nabla \cdot \mathbf{v}) \right) \right] + {\partial \over \partial y}\left[\mu \cdot \left({\partial u \over \partial y} + {\partial v \over \partial x}  \right) \right] + {\partial \over \partial z}\left[\mu \cdot \left({\partial w \over \partial x} + {\partial u \over \partial z}  \right) \right]
\rho \cdot \left({\partial v \over \partial t}+ u {\partial v \over \partial x}+ v {\partial v \over \partial y}+ w {\partial v \over \partial z}\right) = k_y -{\partial p \over \partial y} + {\partial \over \partial y} \left[ \mu \cdot \left(2 \cdot {\partial v \over \partial y}-\frac{2}{3}\cdot (\nabla \cdot \mathbf{v}) \right) \right] + {\partial \over \partial z}\left[\mu \cdot \left({\partial v \over \partial z} + {\partial w \over \partial y}  \right) \right] + {\partial \over \partial x}\left[\mu \cdot \left({\partial u \over \partial y} + {\partial v \over \partial x}  \right) \right]
\rho \cdot \left({\partial w \over \partial t}+ u {\partial w \over \partial x}+ v {\partial w \over \partial y}+ w {\partial w \over \partial z}\right) = k_z -{\partial p \over \partial z} + {\partial \over \partial z} \left[ \mu \cdot \left(2 \cdot {\partial w \over \partial z}-\frac{2}{3}\cdot (\nabla \cdot \mathbf{v}) \right) \right] + {\partial \over \partial x}\left[\mu \cdot \left({\partial w \over \partial x} + {\partial u \over \partial z}  \right) \right] + {\partial \over \partial y}\left[\mu \cdot \left({\partial v \over \partial z} + {\partial w \over \partial y}  \right) \right]

Conservation of mass:

{\partial \rho \over \partial t} + {\partial (\rho \cdot u) \over \partial x}+{\partial (\rho \cdot v) \over \partial y}+{\partial (\rho \cdot w) \over \partial z}=0

Since density is an unknown another equation is required.

Conservation of energy:

\rho \left({\partial e \over \partial t}+ u {\partial e \over \partial x}+ v {\partial e \over \partial y}+ w {\partial e \over \partial z}\right) = \left( {\partial \over \partial x} \left(\lambda \cdot {\partial T \over \partial x} \right) + {\partial \over \partial y} \left(\lambda \cdot {\partial T \over \partial y} \right) + {\partial \over \partial z} \left(\lambda \cdot {\partial T \over \partial z} \right) \right) - p \cdot \left( \nabla \cdot \mathbf{v} \right) + \mathbf{k} \cdot \mathbf{v} + \rho \cdot \dot{q}_s + \mu \cdot \Phi

Where:

\Phi = 2 \cdot \left[ \left({\partial u \over \partial x} \right)^2+\left({\partial v \over \partial y}\right)^2+\left({\partial w \over \partial z}\right)^2 \right] + \left({\partial v \over \partial x}+{\partial u \over \partial y} \right)^2 + \left({\partial w \over \partial y}+{\partial v \over \partial z} \right)^2 + \left({\partial u \over \partial z}+{\partial w \over \partial x} \right)^2 -\frac{2}{3} \cdot \left({\partial u \over \partial x}+{\partial v \over \partial y}+{\partial w \over \partial z} \right)^2

Φ is sometimes referred to as "viscous dissipation". Φ can often be neglected unless dealing with extreme flows such as high supersonic and hypersonic flight (e.g., hypersonic planes and atmospheric reentry).

Assuming an ideal gas:

e = c_p \cdot T - \frac{p}{\rho}

The above is a system of six equations and six unknowns (u, v, w, T, e and ρ).

[edit] Bingham fluids

Main article: Bingham plastic

In Bingham fluids, we have something slightly different:

\tau_{ij}=\tau_0 + \mu\frac{\partial v_i}{\partial x_j},\;\frac{\partial v_i}{\partial x_j}>0

Those are fluids capable of bearing some shear before they start flowing. Some common examples are toothpaste and Silly Putty.

[edit] Power-law fluid

Main article: Power-law fluid

It is an idealised fluid for which the shear stress, τ, is given by

\tau = K \left( \frac {\partial u} {\partial y} \right)^n

This form is useful for approximating all sorts of general fluids.

[edit] Incompressible fluids

Main article: Incompressible fluid

The Navier-Stokes equations are

\rho\frac{Du_i}{Dt}=\rho f_i-\frac{\partial p}{\partial x_i}+\frac{\partial}{\partial x_j}\left[ 2\mu\left(e_{ij}-\frac{\Delta\delta_{ij}}{3}\right)\right]

for momentum conservation and

\nabla\cdot\mathbf{v}=0

for conservation of mass.

where

ρ is the density,
ui (i = 1,2,3) the three components of velocity,
fi body forces (such as gravity),
p the pressure,
μ the dynamic viscosity, of the fluid at a point;
e_{ij}=\frac{1}{2}\left(\frac{\partial u_i}{\partial x_j}+\frac{\partial u_j}{\partial x_i}\right);
Δ = eii is the divergence,
δij is the Kronecker delta.

If μ is uniform over the fluid, the momentum equation above simplifies to

\rho\frac{Du_i}{Dt}=\rho f_i-\frac{\partial p}{\partial x_i} +\mu \left(   \frac{\partial^2u_i}{\partial x_j\partial x_j}+                                                                                                                                         \frac{1}{3}\frac{\partial\Delta}{\partial x_i}\right)

(if μ = 0 but the fluid is compressible, the resulting equations are known as the Euler equations; there, the emphasis is on compressible flow and shock waves).

If now in addition ρ is assumed to be constant we obtain the following system:

\rho \left({\partial v_x \over \partial t}+ v_x {\partial v_x \over \partial x}+ v_y {\partial v_x \over \partial y}+ v_z {\partial v_x \over \partial z}\right)= \mu \left[{\partial^2 v_x \over \partial x^2}+{\partial^2 v_x \over \partial y^2}+{\partial^2 v_x \over \partial z^2}\right]-{\partial p \over \partial x} +\rho g_x
\rho \left({\partial v_y \over \partial t}+ v_x {\partial v_y \over \partial x}+ v_y {\partial v_y \over \partial y}+ v_z {\partial v_y \over \partial z}\right)= \mu \left[{\partial^2 v_y \over \partial x^2}+{\partial^2 v_y \over \partial y^2}+{\partial^2 v_y \over \partial z^2}\right]-{\partial p \over \partial y} +\rho g_y
\rho \left({\partial v_z \over \partial t}+ v_x {\partial v_z \over \partial x}+ v_y {\partial v_z \over \partial y}+ v_z {\partial v_z \over \partial z}\right)= \mu \left[{\partial^2 v_z \over \partial x^2}+{\partial^2 v_z \over \partial y^2}+{\partial^2 v_z \over \partial z^2}\right]-{\partial p \over \partial z} +\rho g_z

Continuity equation (assuming incompressibility):

{\partial v_x \over \partial x}+{\partial v_y \over \partial y}+{\partial v_z \over \partial z}=0

[edit] Cylindrical Coordinates


The Navier-Stokes Continuity equation for cylindrical coordinates is:

{\partial u_r \over \partial r}+ {u_r \over \ r} + {1 \over \ r} {\partial u_\theta \over \partial \theta}+ {\partial u_z \over \partial z}=0

The Navier-Stokes equations for cylindrical coordinates are:

r momentum:

\rho \left( {\partial u_r \over \partial t} + u_r {\partial u_r \over \partial r}    + {u_\theta \over r} {\partial u_r \over \partial \theta} + u_z {\partial u_r \over \partial z}-{u^2_\theta \over r} \right)=
- {\partial P \over \partial r} +\mu \left({\partial^2 u_z \over \partial r^2} +{1 \over r} {\partial u_z \over \partial r}  - {u_r \over r^2} + {1 \over r^2} {\partial^2 u_r \over \partial \theta^2} + {\partial^2 u_r \over \partial z^2} - {2 \over r^2}{\partial u_\theta \over \partial \theta} \right)+F_r

Theta momentum:

\rho \left({ \partial u_\theta \over \partial t} + u_r {\partial u_\theta \over \partial r} + {u_r u_\theta \over r} + {u_\theta \over r} {\partial u_\theta \over \partial \theta} + u_z {\partial u_\theta \over \partial z} \right) =
-{1 \over r}{\partial P \over \partial \theta} +\mu \left(  { {\partial^2 u_\theta \over \partial r^2} } +{1 \over r}{\partial u_\theta \over \partial r} - {u_\theta \over r^2} + {1 \over r^2} {\partial^2 u_\theta \over \partial \theta^2} + {\partial^2 u_\theta \over \partial z^2} + {2 \over r^2}{\partial u_r \over \partial \theta} \right)+F_\theta

z momentum:

\rho \left({ \partial u_z \over \partial t} + u_r {\partial u_z \over \partial r} + {u_\theta \over r} {\partial u_z \over \partial \theta} + u_z {\partial u_z \over \partial z} \right) =
-{\partial P \over \partial z} +\mu \left( {\partial^2 u_z \over \partial r^2} + {1 \over r}  { {\partial u_z \over \partial r} } + {1 \over r^2} {\partial^2 u_z \over \partial \theta^2} + {\partial^2 u_z \over \partial z^2} \right)+F_z


Simplified version of the N-S equations. Adapted from Incompressible Flow, second edition by Ronald Panton

Note that the Navier-Stokes equations can only describe fluid flow approximately and that, at very small scales or under extreme conditions, real fluids made out of mixtures of discrete molecules and other material, such as suspended particles and dissolved gases, will produce different results from the continuous and homogeneous fluids modelled by the Navier-Stokes equations. Depending on the Knudsen number of the problem, statistical mechanics may be a more appropriate approach. However, the Navier-Stokes equations are useful for a wide range of practical problems, providing their limitations are borne in mind.

[edit] See also

[edit] References

    • Inge L. Rhyming Dynamique des fluides, 1991 PPUR
    • A.D. Polyanin, A.M. Kutepov, A.V. Vyazmin, and D.A. Kazenin, Hydrodynamics, Mass and Heat Transfer in Chemical Engineering, Taylor & Francis, London, 2002. ISBN 0-415-27237-8

    [edit] External links


    General subfields within physics
    v  d  e

    Classical mechanics | Electromagnetism | Thermodynamics | General relativity | Quantum mechanics 

    Particle physics | Condensed matter physics | Atomic, molecular, and optical physics