Anda di halaman 1dari 78

Review of Fluid Mechanics and Analysis Tools

Prabhu Ramachandran
Department of Aerospace Engineering IIT Bombay

1, May 2006

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

1 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

2 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

3 / 69

Fluids

What is a uid? Why is a uid different from a solid? Why is uid mechanics so different from solid mechanics? Depends on behavior of medium when a force is applied Does the medium have a particular preferred shape? Everything depends on context: conditions, timescale etc.

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

4 / 69

Fluid ow as a continuum
Simulating every molecule in a normal uid ow is impossible today (and also a colossal waste!) NA = 6.023 1023 and this is for one mole of a gas (22.4L at 273.15 K and 1 atm) Continuum hypothesis: an idealization to ease analysis Knudsen number: crude indicator of applicability of the continuum hypothesis Kn = Kn
L

: mean free path of molecules, L: length scale of uid motion 1 suggests continuum is valid The entire course focusses on this regime

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

5 / 69

Basic unknowns

Velocity: V(x, t ) Pressure: p(x, t ) Density: (x, t ) Temperature: T (x, t )

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

6 / 69

Physical principles

Conservation of mass Conservation of linear momentum Conservation of Energy (First law of thermodynamics) Equation of state Second law of thermodynamics Frame indifference: constitutive laws should not depend on observer

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

7 / 69

Viewpoints: Lagrangian, Eulerian description


Lagrangian:
move with the uid particle study change of particles properties particles position is a function of t

Eulerian:
focus on a xed point in space study change of property at the particular location notion of control volume is Eulerian space and time coordinates are independent

Eulerian derivative:

t (

)
D Dt

Lagrangian derivative:

t (

) + V grad( ) (chain rule!)

V is the velocity at the point in space being considered

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

8 / 69

Thermodynamics primer
Misnomer? Thermostatics? Zeroth law: equivalence of temperature Ideal uid: equation of state f (p, v , T ) = 0 Two properties (say p, v ) are sufcient to describe the state First law: E = Q + W Sign convention is such that: E = Q p v E is the internal energy of uid (function of the state of uid) W is work done on uid (anything which may be reduced to lifting a weight) Q is the energy transfer to the uid (due to a temperature difference) Heat is always a transfer, not a property! Adiabatic: no heat transfer Isothermal: no change in temperature (and internal energy)
Prabhu Ramachandran (IIT Bombay) Fluid mechanics CFD CEP 06 9 / 69

Thermodynamics: specic heats

Specic heat: Q = T = cp = cv = =
cp cv E p T p Q T Q T v v

Q T

for a reversible change


E v p T v p E T p

p + p + =

v + p v v +p
v T p

p =0

E = T v v =0 p p v adiabatic / v

isothermal

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

10 / 69

Entropy

Consider process (in a p v diagram) that is adiabatic and reversible Entropy, S : property which is constant along such processes Entropy for ideal gas is a function of two other state variables Consider: reversible transition from one equilibrium state to another T S = Q Second law: Adiabatic, irreversible change, S > 0 Reversible adiabatic process: isentropic Reversible: T S = E + p v

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

11 / 69

Thermodynamics: Energy, Enthalpy etc.


Internal energy, E , (ignoring chemical and other energies) is a f (T ) Total energy ET = E + V 2 /2 Enthalpy, H , dened as: H = E + pv H = E + p v + v p = T S + v p Helmholtz free energy: F = E TS Gibbs free energy: G = H TS F = p v S T Specic energy and specic total energy: e, eT eT = e + V 2 /2

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

12 / 69

Maxwells relations
E v E S p S v S v T p T = p
S

=T
v

=
v

=
p

T v T p S S p S v

=
p

=
v

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

13 / 69

Ideal gas

Equation of state pv = RT , R is the universal gas constant Cp , Cv are constants Cp Cv = R Cp /Cv = Cp , Cv intimately related to kinetic theory of gasses

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

14 / 69

Transport equations

Transport of a material property Consider a control volume Determine: rate of change of property inside volume Contribution due to ux Source terms These are related through physics

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

15 / 69

Transport equations (example of mass)

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

16 / 69

Forces acting on a uid


Body forces
Gravitational force Electromagnetic forces

F v , density, v volume element

Surface forces: Short range, contact forces, like friction


act on a surface and are tied to orientation of the surface obtained through the stress tensor, ij

Stress, i = ij nj , where nj is the surface normal It can be shown that the ij = ji Pressure: isotropic part of ij

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

17 / 69

Constitutive relations
Velocity gradient: L =
V x

= grad(V)

1 Symmetric part of velocity gradient: D = 2 (L + LT )

For a Navier-Stokes uid it is common to dene: = C This is called a constitutive equation More precisely: = p()I + div(D) + 2D , are the bulk and shear viscosities Frame indifference of a quantity: ensures consistency across reference frames Linearized strain as against D is not frame indifferent! Formulating constitutive relations requires great care Stokes formulation is frame indifferent

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

18 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

19 / 69

Governing equations (integral form)


Conservation of mass: (V) dv + t
V t dv

V d S = 0

Conservation of linear momentum: V(Vd S)+


S S

pd S = viscous forces+source terms

Conservation of energy: (eT ) dv + t (eT + p)V d S = heat ux + viscous terms + . . .


S

Equation of state: p = RT Second law of thermodynamics

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

20 / 69

Governing equations (differential form)


Conservation of mass:
t

+ div(V) = 0

Conservation of linear momentum: (Vi ) + div(ui V + p) = div(div(D) + 2D) + source terms t Conservation of energy: (eT ) + div((eT + p)V) = heat ux + viscous terms + . . . t Equation of state: p = RT Second law of thermodynamics

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

21 / 69

Variables: conserved, primitive and derived

1D conserved quantites can be written as, u = [, u , eT ]T Flux term: f = [u , u 2 + p, (eT + p)u ]T Conservation form of equations: u f + =0 t x Primitive variables: w = [, u , p]T Equations:
w t w + C x = 0

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

22 / 69

Classication of PDEs
Consider:
u t u u + A x + B x 2 = S (x , t , u )
2

In general this equation is parabolic Parabolic equations:


Characteristics are degenerate Information travels in one particular direction (downstream)

If Buxx is negligible, equation is hyperbolic Hyperbolic equations:


Characteristics are real and distinct Information propagates along these characteristics

Elliptic equations are also important (though not discussed at length here)
Characteristics are imaginary/complex Information propagates everywhere

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

23 / 69

Boundary conditions

Velocity BC
Velocity at innity (V ) No penetration on boundary No slip on boundary

, p , T Depending on nature of equations (parabolic, hyperbolic etc.) different conditions are needed

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

24 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

25 / 69

Non-dimensional numbers
Reynolds number: Ratio of inertial to viscous forces: Re = Mach number: M =
V a, UL

a is speed of sound

Strouhal number: S = fL U UL Peclet number: Pe = Prandtl number: Pr = u Froude number: Fr = gL


Qd k T TL3 Grashof number: Gr = g 2 TL3 Rayleigh number: Ra = g

Nusselt number: Nu =

= Gr Pr

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

26 / 69

Classication of uid ow

Steady:

X t

is neglected/negligible

Incompressible: is not (p) Inviscid: Viscous forces are neglected, Re is large Irrotational: Vorticity, = curlV is negligible Based on M :
Subsonic: M < 1 Transonic: M 1 Supersonic: M > 1 Hypersonic: M 1

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

27 / 69

Streamlines, streaklines, pathlines

Pathline: path of a particle starting at some point Streamline: an instantaneous curve, the tangent to which is the direction of V Streakline: curve traced by a collection of particles injected at a particular point For a steady ow all the three are the same

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

28 / 69

Incompressible Potential ow

Inviscid, incompressible and irrotational ow grad = V Governed by: 2 = 0 (from incompressibility) Elliptic equations Dene streamfunction in 2D such that (u , v ) =
y , x

Potential lines and streamfunction are conjugate to each other In 2D complex analysis can be used to elegantly analyze and study potential ows

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

29 / 69

Incompressible, viscous uid ow

Stress tensor and viscous forces depend on the constitutive model As an example consider a Navier-Stokes uid Governing equations: divV = 0 V 1 + V grad(V) = grad(p) + 2 V t Initial condition for V BC: no-slip and no-penetration on solid walls

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

30 / 69

Boundary layer and shear layers

Boundary layer:
Fluid sticks to the surface of boundary Viscosity impedes motion of nearby uid layers The boundary layer involves rotational ow and = 0

Shear layer
Sharp gradient of velocity between two adjacent layers Viscosity tends to equalize the layers Shear layer evolution: essentially the viscous evolution of a vortex sheet Always unsteady!

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

31 / 69

Compressible ow
Incompressible ow:
mass and momentum equations are somewhat decoupled information travels instantaneously only gradient of pressure: absolute pressure values are meaningless

Compressible ow: fundamentally different from incompressible ow Introduces a communication time scale Equations are hyperbolic in nature Information travels as waves along characteristics Zone of dependence, silence and action Leads to creation of shocks

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

32 / 69

Mach cone
Mach cone Zone of silence M>1 Zone of action Small perturbations sin = 1/M Influence of disturbance

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

33 / 69

Oblique Shock
Oblique shock Zone of silence Particle path M>1 > Influence of disturbance Zone of action wedge Small perturbations

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

34 / 69

Bow Shock
Mach angle

Bow shock

M>1 Blunt body

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

35 / 69

Why CFD?

Equations are non-linear PDEs No analytical solution for general case Complexities due to:
geometry boundary conditions physics

Experiments are costly and not always possible Necessitates numerical approach Numerics are non-trivial

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

36 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

37 / 69

Numbers and numbers


Number system on a computer not same as the mathematicians ideal number system a = b may be true mathematically but not numerically Integers and oating point numbers can overow and underow Only a nite set of numbers to represent an uncountable innity Floating point number: sign bit, signicand and exponent (nite bits) Epsilon of machine: smallest number when added to 1 changes it Errors: roundoff and truncation Watch out for catastrophic cancellation due to subtractions! Avoid cancellation when possible

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

38 / 69

The venerable Taylor series

Taylors series 1D: f (x ) = f (x0 ) + f (x0 )(x x0 ) + Taylors series in two variables: f (x , y ) = f (x0 , y0 ) +
j

f (x0 )(x x0 )2 2!

+ ...

1 j!

+ y x y

f (x , y )

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

39 / 69

Root nding

Bisection Newton Secant Regula-falsi

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

40 / 69

Polynomial Interpolation
Unique interpolating polynomial y = Pn (x ) = a0 + a1 x + a2 x 2 . . . + an x n Given (xi , yi ): solve linear system of equations Results in Vandermonde matrix which is singular Lagrange interpolating polynomial:
Dene:li (x ) = Then: pn (x ) =
x xj n i =j ;j =0 xi xj j

f (xj )lj (x ).

Newton form: pk +1 (x ) = pk (x ) + c (x x0 )(x x1 ) . . . (x xk ) Coefcients can be found efciently using divided differences
( ) Error: f (x ) Pn (x ) = (x x0 ) . . . (x xn ) f(n+1 )!
n +1

When interpolating it is best to use Chebychev nodes: (a + b ) a) + (b 2 2 cos(i /n)

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

41 / 69

Quadrature

Left and right rectangle rule Trapezoid rule:


b a

f (x )dx

f (a)+f (b) (b 2

a)
f (b ) 2

Composite formula: b f (a ) 2 + f (a + h) + . . . + f (b h) + a f (x )dx h


h Error (composite): E = 12 f ( )(b a),
2

Simpsons rule:

a+2h a

f (x )dx h 3 (f (a) + 4f (a + h) + f (a + 2h))


4 (4) ( )

h f Error (composite): E = (ba)90

Gaussian quadrature

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

42 / 69

Least squares
Best ts of a curve with linear coefcients p-norm of a vector: lp = ( l or max norm = max(xi ) Idea is to minimize error of the best tting curve Least squares: convenient to use l2 norm since it is easiest to minimize Weighted least squares: weight the different points suitably
i

|xi |p )1/p

Example
Straight line error =
n 1 i =0 (axi

+ b yi )2

Minimize by setting rst partial derivatives to zero: i 2xi (axi + b yi ) = 0 i 2(axi + b yi ) = 0 Simplifying results in the normal equations
Prabhu Ramachandran (IIT Bombay) Fluid mechanics CFD CEP 06 43 / 69

ODEs
dx dt

= x = f (x , t )
1 2 2! t x

Taylor series: x (t + t ) = x (t ) + t x (t ) +

(t ) + . . . +

1 m (m) (t ) m! t x

+ ...

Euler method: x (t + t ) x (t ) + t x (t ) = x (t ) + t f (x , t ) Euler is only rst order accurate Runge-Kutta second order method:
k1 = t f (x , t ) ; k2 = t f (x + k1 , t + t ) x (t + h) = x (t ) + (k1 + k2 )/2

Adams-Bashforth/Adams-Moulton methods use past values: t x (t + t ) = x (t ) + 24 (55f (t ) 59f (t t ) + 37f (t 2 t ) 9f (t 3 t )) Stiff systems of equations: disparate time scales: implicit schemes

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

44 / 69

Solution of linear systems of equations

Matrix multiplication with vector: a linear combination of the columns Matrix-matrix product: cij = aik bkj A composition of linear transformations Ax = b has unique solution if one of following holds:
A1 exists no non-zero y s.t. Ay = 0 As rows and columns are independent det (A) = 0

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

45 / 69

Solution of linear systems


Trangular systems:
Lower triangular: forward substitution Upper triangular: backward substitution

Gaussian elimination: systematic reduction to upper triangular form Intimately related to LU decomposition Small pivots relative to other elements in row: trouble! Scaled partial pivoting works for the most part Triangular/banded matrices: Simplied Gaussian elimination Diagonally dominant banded matrices are guaranteed to be well behaved

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

46 / 69

Ill-conditioned matrices

Induced matrix norms: ||A||M = maxx =0

||Ax || ||x ||

Sensitivity of the solution to small change in RHS: condition number


|| x || ||x || b|| ||A||||A1 || || ||b||

K (A) = ||A||||A1 || is the condition number K (A) 1 K (A) =


maxmag(A) minmag(A)

Ill-conditioned matrix is one where the equations are almost linearly dependent

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

47 / 69

Difference formulae
Forward difference: f (x + x ) f (x ) = + O ( x ) x x Backward difference: f (x ) f (x x ) = + O ( x ) x x Central difference: f (x + x ) f (x x ) = + O ( x 2 ) x 2 x

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

48 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

49 / 69

PDEs to FDEs
Discretize the domain (grid) Represent (discretize) the eld properties on the grid Use the difference formulae to obtain derivatives at grid points Results in a system of algebraic equations Formulation can be implicit Non-trivial geometry requires non-cartesian grids Transformation from a cartesian computational domain to the non-cartesian physical domain is needed Must worry about stability Advantage: very general and applicable to any PDE

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

50 / 69

PDEs to FVEs

Fundamentally tied to conservation laws Satises the integral equations Discretize the domain into volume elements (cells) Satisfy conservation laws on each volume element Flux exchanged from sides of volume/cell Always satises conservation laws Captures discontinuities

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

51 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

52 / 69

Errors: truncation and roundoff


Beware of Roundoff!
Severe and catastrophic cancellation! Watch out for of machine! Can use Richardson extrapolation and other techniques
f (x + x )f (x ) x

Truncation error arises from nite difference approximation and Taylor series
x ) f (x ) Forward difference: f (x ) = f (x + + x If FDE uses a forward difference: x 2 f

(x ) + . . .
x 2 f

actual equation being solved has additional this is the modied equation

(x ) term

More details on error, stability etc.: other lectures

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

53 / 69

Outline
1

Fluid mechanics Basics Governing equations Gory details Numerics An introduction Numerical uid mechanics Method of solution Errors and moded equations Alternative methods Particle methods: vortex methods

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

54 / 69

Governing equations in primitive variables


At , V = 0 Domain D
, are constant

DV Dt

divV = 0 2 = 1 gradp + V

V (r ) = 0 Boundary B

Initial condition: V (r , 0) = V0(r )

VB

n e

s e

n = VB e n. No-penetration: V e s = VB e s No-slip:V e

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

55 / 69

Traditional Computational Fluid Dynamics (CFD)


Traditional CFD uses a grid Discretize the domain Represent unknowns on grid Solve the discretized differential equations Grid generation can be non-trivial Boundary conditions at innity Need to discretize a larger region Numerical diffusion might be a problem

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

56 / 69

Traditional Computational Fluid Dynamics (CFD)


Traditional CFD uses a grid Discretize the domain Represent unknowns on grid Solve the discretized differential equations Grid generation can be non-trivial Boundary conditions at innity Need to discretize a larger region Numerical diffusion might be a problem

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

56 / 69

Traditional Computational Fluid Dynamics (CFD)


Traditional CFD uses a grid Discretize the domain Represent unknowns on grid Solve the discretized differential equations Grid generation can be non-trivial Boundary conditions at innity Need to discretize a larger region Numerical diffusion might be a problem

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

56 / 69

Vortex methods
Vorticity is the curl of the velocity eld Represent the ow in terms of vorticity Discretize the vorticity into vortex particles Track the resulting particles of vorticity as per a GDE

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

57 / 69

Vortex methods
Vorticity is the curl of the velocity eld Represent the ow in terms of vorticity Discretize the vorticity into vortex particles Track the resulting particles of vorticity as per a GDE

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

57 / 69

Governing equations in vorticity-velocity form


At , V = 0 Domain D , are constant

D Dt

divV = 0 = 2

=0

Initial condition: (r , 0) = 0(r )


(r ) = 0

n e

VB

s e

n = VB e n. No-penetration: V e s = VB e s No-slip:V e

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

58 / 69

Advantages and disadvantages of vortex methods


Advantages
Vortex methods are grid free and self-adaptive Ideal for unsteady, high-resolution simulations Intuitive solution procedure

Disadvantages
Complexities associated with interacting particles Implementation for general ows is non-trivial Techniques for compressible, multi-phase, non-Newtonian uids not well established 3D ows are not simple extensions of the 2D case

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

59 / 69

Advantages and disadvantages of vortex methods


Advantages
Vortex methods are grid free and self-adaptive Ideal for unsteady, high-resolution simulations Intuitive solution procedure

Disadvantages
Complexities associated with interacting particles Implementation for general ows is non-trivial Techniques for compressible, multi-phase, non-Newtonian uids not well established 3D ows are not simple extensions of the 2D case

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

59 / 69

Numerical Solution

Solve using a particle based scheme Discretize vorticity into Vortex Blobs Two-step scheme
Advection: D =0 Dt = 2 t

Diffusion:

No-penetration on solid walls No-slip condition: Creation of vorticity

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

60 / 69

Discretization of
Discretize the vorticity into Vortex Blobs (r , t ) =
i

(r ri (t ))i

2 j

Circulation i = i h2 (r ) is called a smoothing or cutoff function is an approximate Dirac distribution is the core radius

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

61 / 69

Advection

Vorticity is convected along with the ow BC: No-penetration on solid walls Requires determination of the velocity eld V (r , t ) = V + grad is found such that BC is satised

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

62 / 69

Diffusion

= 2

Random Vortex Method


Gaussian random displacement of particles Mean zero Variance 2 t O ( /N ) rate of convergence Reect/absorb particles striking solid surface

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

63 / 69

The vortex method algorithm


Blobs 1
1

Compute slip velocity on solid surfaces


Vortex blobs, sheets, free stream etc. Enforce the no-penetration BC

Slip Velocity

Blobs

2 3 4 5

Add vortex sheets to offset the slip Convect existing sheets and blobs Diffuse all the sheets and blobs Repeat from step 1

Sheets

3,4

Advect & Diffuse


Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

64 / 69

Re = 3000: Cd vs T

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

65 / 69

Re = 3000: Pressure and skin friction forces vs T

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

66 / 69

Re = 3000: Velocity in wake

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

67 / 69

Re = 3000: Vorticity distribution

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

68 / 69

Re = 3000: Vorticity distribution

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

68 / 69

Re = 3000: Vorticity distribution

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

68 / 69

Re = 3000: Vorticity distribution

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

68 / 69

Re = 3000: Vorticity distribution

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

68 / 69

Re = 3000: Vorticity distribution

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

68 / 69

Summary

Summary
Review of basic physics, thermodynamics for uid mechanics Overview of uid mechanics and equations Elementary numerical methods Introduction to numerical solution techniques for uid mechanics

Prabhu Ramachandran (IIT Bombay)

Fluid mechanics

CFD CEP 06

69 / 69

Anda mungkin juga menyukai