You are on page 1of 54

The Navier-Stokes Equation and 1D Pipe Flow

Simulation of Shocks in a Closed Shock Tube

1
Ville Vuorinen,D.Sc.(Tech.)
1
Department of Energy Technology, Internal Combustion Engine Research Group
Aalto University

Department of Energy Technology


Shock Waves in Experimental Fluid Dynamics
The Picture Below is a Schlieren Photograph of AK-47 Firing a Round

Matlab and PDE’s 2/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Shock Waves in 3D Computational Fluid Dynam-
ics
Supersonic Jet in a Crossflow (Courtesy of Kawai et al.)

Matlab and PDE’s 3/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.
The convection-diffusion (CD) equation is a linear PDE and it’s
behavior is well understood: convective transport and mixing.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.
The convection-diffusion (CD) equation is a linear PDE and it’s
behavior is well understood: convective transport and mixing.
However, many natural phenomena are non-linear which gives much
more degrees of freedom and complexity.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.
The convection-diffusion (CD) equation is a linear PDE and it’s
behavior is well understood: convective transport and mixing.
However, many natural phenomena are non-linear which gives much
more degrees of freedom and complexity.
Example 1: 1D flow of compressible gas in an exhaust pipe.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.
The convection-diffusion (CD) equation is a linear PDE and it’s
behavior is well understood: convective transport and mixing.
However, many natural phenomena are non-linear which gives much
more degrees of freedom and complexity.
Example 1: 1D flow of compressible gas in an exhaust pipe.
Example 2: 3D turbulent mixing and combustion in a combustion
engine.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.
The convection-diffusion (CD) equation is a linear PDE and it’s
behavior is well understood: convective transport and mixing.
However, many natural phenomena are non-linear which gives much
more degrees of freedom and complexity.
Example 1: 1D flow of compressible gas in an exhaust pipe.
Example 2: 3D turbulent mixing and combustion in a combustion
engine.
In this lecture we link the CD-equation to the compressible
Navier-Stokes equation.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Non-Linear vs Linear Partial Differential Equa-
tions
The pictures above were all examples of high speed Navier-Stokes
equation dynamics.
The convection-diffusion (CD) equation is a linear PDE and it’s
behavior is well understood: convective transport and mixing.
However, many natural phenomena are non-linear which gives much
more degrees of freedom and complexity.
Example 1: 1D flow of compressible gas in an exhaust pipe.
Example 2: 3D turbulent mixing and combustion in a combustion
engine.
In this lecture we link the CD-equation to the compressible
Navier-Stokes equation.
Finally, the 1D Euler equation is presented and we discuss its
numerical solution involving shock-waves in exhaust pipes of
combustion engines.

Matlab and PDE’s 4/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The General Form of Any Transport Phenomenon
Also the Navier-Stokes Equation is of This Form

The Convection-Diffusion Equation for the Quantity φ

temporal derivative
z}|{ convection term diffusion term source term
∂ρφ z }| { z }| { z }| {
+ ∇ · (uρφ) − ∇ · (ρν∇φ) = Sφ (φ)
∂t

φ convects and diffuses in a fluid (e.g. air,water...).


φ could represent e.g. concentration of soot particles in cigarette
smoke or water temperature in ocean currents etc.
ρ is the density of the fluid and u = u(x,y,z,t) the velocity field, and ν
the diffusivity (e.g. heat diffusivity) of φ.

Matlab and PDE’s 5/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Full, Compressible Navier-Stokes Equation

Motion of Gases at Sub- and Supersonic Flows

∂ρ ∂ρuj
+ = 0 (Conservation of Mass)
∂t ∂xj

∂ρui ∂(ρui uj ) ∂
+ = (−pδij + σij ) (Conservation of Momentum)
∂t ∂xj ∂xj

∂ρe ∂(uj (ρe + p)) ∂ ∂  ∂T 


+ = (σij ui )+ λ (Conservation of Energy)
∂t ∂xj ∂xj ∂xj ∂xj

Matlab and PDE’s 6/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Conservative vs Primitive Variables

Definition
The variables ρ, ρui and ρe are termed conservative because they
are conserved.

Matlab and PDE’s 7/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Conservative vs Primitive Variables

Definition
The variables ρ, ρui and ρe are termed conservative because they
are conserved.
Pressure, velocity and temperature (p, ui and T ) are termed
primitive variables.

Matlab and PDE’s 7/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Conservative vs Primitive Variables

Definition
The variables ρ, ρui and ρe are termed conservative because they
are conserved.
Pressure, velocity and temperature (p, ui and T ) are termed
primitive variables.

Reconstruction of Primitive Variables from Conservative


ui = ρui /ρ
T = (ρe − 0.5ρ(u21 + u22 + u23 ))/(cv ρ)
p = ρRT

Matlab and PDE’s 7/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Conservation of Mass
In the Absence of Nuclear Reactions

Conservation of Mass

temporal derivative convection of mass due to velocity


z}|{ z }| {
∂ρ ∂ρuj
+ = 0, j = 1, 2, 3
∂t ∂xj

Matlab and PDE’s 8/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Momentum is Conserved

Conservation of Momentum

temporal derivative convection of momentum pressure gradient and viscous terms


z }| { z }| { z }| {
∂ρui ∂(ρui uj ) ∂
+ = (−pδij + σij ) , i, j = 1, 2, 3
∂t ∂xj ∂xj

Matlab and PDE’s 9/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Energy is Conserved
But It May Transfer into Heat via Viscous Effects

Conservation of Energy

temporal derivative convection of pressure and energy viscous work heat diffusion
z}|{ z }| { z }| { z }| {
∂ρe ∂(uj (ρe + p))) ∂ ∂  ∂T 
+ = (σij ui ) + λ , j = 1, 2, 3
∂t ∂xj ∂xj ∂xj ∂xj

Matlab and PDE’s 10/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Energy is Conserved
But It May Transfer into Heat via Viscous Effects

Conservation of Energy

temporal derivative convection of pressure and energy viscous work heat diffusion
z}|{ z }| { z }| { z }| {
∂ρe ∂(uj (ρe + p))) ∂ ∂  ∂T 
+ = (σij ui ) + λ , j = 1, 2, 3
∂t ∂xj ∂xj ∂xj ∂xj

Note:
The energy ρe is the total energy i.e. ρe = ρ(cv T + 0.5|u|2 ). Thus all the
energy (at an arbitrary point) is expressed as a sum of kinetic and
thermodynamic energies.

Matlab and PDE’s 10/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Definitions (1)

Equation of State and Internal Energy of Gas

p = ρRT and e = cv T + 1/2u2


where
cv = specific heat,
e = e(x, y, z, t) = total energy per unit volume,
u2 = u(x, y, z, t)2 = velocity magnitude squared and
R = molar gas constant.

Matlab and PDE’s 11/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Definitions (2)

Speed of Sound
p
a= γRT
where a = speed of sound, R = molar gas constant, and γ = cp /cv =
adiabatic constant.

Matlab and PDE’s 12/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Definitions (3)

Mach Number

Ma = u/a
where u = local flow velocity. When Ma < 1 flow is subsonic, when
Ma = 1 flow is sonic (e.g. in converging nozzle), and when Ma > 1 flow
is supersonic.

Matlab and PDE’s 13/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Definitions (4)

Viscous Stress Tensor for Newtonian Fluids

2
σij = µτij − µ∇ · u,
3
∂ui ∂uj
where τij = + . The dynamic viscosity µ = ρν , where ν is the
∂xj ∂xi
kinematic viscosity.

Matlab and PDE’s 14/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations
The Inviscid NS-Equation (µ = 0)

The Euler Equations in 1D

∂ρ ∂ρu
+ =0
∂t ∂x

∂ρu ∂(ρu2 + p)
+ =0
∂t ∂x
∂ρe ∂(u(ρe + p))
+ =0
∂t ∂x

p = ρRT and e = cv T + 1/2u2

Matlab and PDE’s 15/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Solutions to the Euler Equations

The Euler Equations in 1D

The Euler equations are a very good model for 1D (and 3D!) flow
simulations where viscous effects are small which is often the case.

Matlab and PDE’s 16/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Solutions to the Euler Equations

The Euler Equations in 1D

The Euler equations are a very good model for 1D (and 3D!) flow
simulations where viscous effects are small which is often the case.
The Euler eqs contain discontinuities which are termed shocks if
p, T, ρ are all discontinuous.

Matlab and PDE’s 16/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Solutions to the Euler Equations

The Euler Equations in 1D

The Euler equations are a very good model for 1D (and 3D!) flow
simulations where viscous effects are small which is often the case.
The Euler eqs contain discontinuities which are termed shocks if
p, T, ρ are all discontinuous.
The Euler eqs contain discontinuities which are termed contact
discontinuities if only T is discontinuous.

Matlab and PDE’s 16/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Solutions to the Euler Equations

The Euler Equations in 1D

The Euler equations are a very good model for 1D (and 3D!) flow
simulations where viscous effects are small which is often the case.
The Euler eqs contain discontinuities which are termed shocks if
p, T, ρ are all discontinuous.
The Euler eqs contain discontinuities which are termed contact
discontinuities if only T is discontinuous.
The Euler eqs can be analyzed by eigenvalue analysis and it is seen
that information can propagate at velocities λ1 = u − a, λ2 = u and
λ3 = u + a.

Matlab and PDE’s 16/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Solutions to the Euler Equations

The Euler Equations in 1D

The Euler equations are a very good model for 1D (and 3D!) flow
simulations where viscous effects are small which is often the case.
The Euler eqs contain discontinuities which are termed shocks if
p, T, ρ are all discontinuous.
The Euler eqs contain discontinuities which are termed contact
discontinuities if only T is discontinuous.
The Euler eqs can be analyzed by eigenvalue analysis and it is seen
that information can propagate at velocities λ1 = u − a, λ2 = u and
λ3 = u + a.
For example in a fully supersonic flows λi > 0, i = 1, 2, 3 so that
information can not propagate upstream the flow.

Matlab and PDE’s 16/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Pressure and T in a 1D Closed Shock Tube Using
Lax-Wendroff (1st Order vs 2nd Order) Method
CD=contact discontinuity; SD=shock discontinuity

Matlab and PDE’s 17/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Pressure Field in 1D Closed Shock Tube vs Time

Matlab and PDE’s 18/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Temperature Field in 1D Closed Shock Tube vs
Time

Matlab and PDE’s 19/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Numerical Solution of the Euler Equations
The Simplest Approach: the Explicit Euler Time-Integration Method

∂ρ ρk − ρkn
≈ n+1
∂t ∆t

∂ρu (ρu)kn+1 − (ρu)kn



∂t ∆t

∂ρe (ρe)kn+1 − (ρe)kn



∂t ∆t

Note: again k is the space index and n the time index.


Note: do not confuse the Euler time integration method with Euler
equations although ’Euler’ refers to the same scientist.

Matlab and PDE’s 20/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Numerical Solution of the Euler Equations
Central Differences for the Spatial Derivatives

∂ρu (ρu)k+1
n − (ρu)k−1
n

∂x 2∆x

∂(ρu2 + p) (ρu2 + p)k+1


n − (ρu2 + p)k−1
n

∂x 2∆x

∂u(ρe + p) (u(ρe + p))k+1


n − (u(ρe + p))k−1
n

∂x 2∆x

Note: again k is the space index and n the time index.


Note: do not confuse the Euler time integration method with Euler
equations although ’Euler’ refers to the same scientist.

Matlab and PDE’s 21/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations Have to Be Stabilized with
Numerical Viscosity
We Add Artificial Viscosity Terms to RHS of the
Equations

∂ρ ∂ρu ∂2ρ
+ =γ 2
∂t ∂x ∂x

∂ρu ∂(ρu2 + p) ∂ 2 ρu
+ =γ
∂t ∂x ∂x2

∂ρe ∂(u(ρe + p)) ∂ 2 ρe


+ =γ 2
∂t ∂x ∂x

p = ρRT and e = cv T + 1/2u2

Matlab and PDE’s 22/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations Have to Be Stabilized with
Numerical Viscosity
The artificial viscosity γ > 0 and it smoothes sharp shock fronts and
allows numerical stability.

Matlab and PDE’s 23/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations Have to Be Stabilized with
Numerical Viscosity
The artificial viscosity γ > 0 and it smoothes sharp shock fronts and
allows numerical stability.
The practical role of extra terms is low-pass filtering of the
high-frequency components (i.e. small wiggles) from numerical
solution.

Matlab and PDE’s 23/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations Have to Be Stabilized with
Numerical Viscosity
The artificial viscosity γ > 0 and it smoothes sharp shock fronts and
allows numerical stability.
The practical role of extra terms is low-pass filtering of the
high-frequency components (i.e. small wiggles) from numerical
solution.
If γ = 0 a simulation will not run for many timesteps.

Matlab and PDE’s 23/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations Have to Be Stabilized with
Numerical Viscosity
The artificial viscosity γ > 0 and it smoothes sharp shock fronts and
allows numerical stability.
The practical role of extra terms is low-pass filtering of the
high-frequency components (i.e. small wiggles) from numerical
solution.
If γ = 0 a simulation will not run for many timesteps.
The small wiggles tend to grow exponentially and blow up the
solution.

Matlab and PDE’s 23/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Euler Equations Have to Be Stabilized with
Numerical Viscosity
The artificial viscosity γ > 0 and it smoothes sharp shock fronts and
allows numerical stability.
The practical role of extra terms is low-pass filtering of the
high-frequency components (i.e. small wiggles) from numerical
solution.
If γ = 0 a simulation will not run for many timesteps.
The small wiggles tend to grow exponentially and blow up the
solution.
It is easy to show that ’good’ limits for γ are (roughly)
∆x2 ∆x2
≤ γ ≤ where larger γ gives smoother solutions
10π 2 ∆t π 2 ∆t
(∆x =grid spacing and ∆t = timestep size).

Matlab and PDE’s 23/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The Second Derivative (1D Laplacian) is Dis-
cretized as Follows

Example: the Momentum Term

∂ 2 ρu (ρu)nk+1 − 2(ρu)kn + (ρu)nk−1



∂x2 ∆x2

Matlab and PDE’s 24/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.
To simplify a bit, here we explain one way of modeling a wall.

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.
To simplify a bit, here we explain one way of modeling a wall.
Say, in a 1D pipe flow with closed ends we first set zero derivative
(gradient) for p and T by e.g. p(1)=p(2) and T(1)=T(2).

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.
To simplify a bit, here we explain one way of modeling a wall.
Say, in a 1D pipe flow with closed ends we first set zero derivative
(gradient) for p and T by e.g. p(1)=p(2) and T(1)=T(2).
Then, e.g. rho(1)=p(1)/(R*T(1)).

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.
To simplify a bit, here we explain one way of modeling a wall.
Say, in a 1D pipe flow with closed ends we first set zero derivative
(gradient) for p and T by e.g. p(1)=p(2) and T(1)=T(2).
Then, e.g. rho(1)=p(1)/(R*T(1)).
For a wall the velocity ’reflects back’ so e.g. U(1)=-U(2).

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.
To simplify a bit, here we explain one way of modeling a wall.
Say, in a 1D pipe flow with closed ends we first set zero derivative
(gradient) for p and T by e.g. p(1)=p(2) and T(1)=T(2).
Then, e.g. rho(1)=p(1)/(R*T(1)).
For a wall the velocity ’reflects back’ so e.g. U(1)=-U(2).
Thus, e.g. rhoU(1)=rho*U(1) and similarly for rhoe(1) =
rho(1)*(Cv*T(1) + 0.5*U(1)*U(1)) .

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Boundary Conditions (BCs)

Modeling of boundaries is a crucial part of CFD-simulations e.g.


wall, inflow, outflow.
To simplify a bit, here we explain one way of modeling a wall.
Say, in a 1D pipe flow with closed ends we first set zero derivative
(gradient) for p and T by e.g. p(1)=p(2) and T(1)=T(2).
Then, e.g. rho(1)=p(1)/(R*T(1)).
For a wall the velocity ’reflects back’ so e.g. U(1)=-U(2).
Thus, e.g. rhoU(1)=rho*U(1) and similarly for rhoe(1) =
rho(1)*(Cv*T(1) + 0.5*U(1)*U(1)) .
From this kind of BCs a back and forth bouncing pulse results.

Matlab and PDE’s 25/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Matlab Implementation

The folder /demos2012/shocktube/ shows demo files in which the


Explicit Euler method is applied for the Euler equations.
SolveEulerEquation1D.m is the solver which can be executed by
command »SolveEulerEquation1D.
The files PlottingFigure.m, SurfaceAnimation.m and
DrawingSurface.m show how graphs can be drawn, surface motion
be animated etc. Look at the end of these files to see how .png
pictures can be saved.

Matlab and PDE’s 26/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Summary

An introduction to Navier-Stokes equation was given.

Matlab and PDE’s 27/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Summary

An introduction to Navier-Stokes equation was given.


The Euler equations are a simpler case of the NS-eqs (µ = 0),
The Euler equations have discontinuities solutions e.g. shocks.

Matlab and PDE’s 27/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Summary

An introduction to Navier-Stokes equation was given.


The Euler equations are a simpler case of the NS-eqs (µ = 0),
The Euler equations have discontinuities solutions e.g. shocks.
We tested how increased viscosity allows numerical capturing of
shock waves via ’low pass filtering of wiggles i.e. small wavelengths’.

Matlab and PDE’s 27/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
Summary

An introduction to Navier-Stokes equation was given.


The Euler equations are a simpler case of the NS-eqs (µ = 0),
The Euler equations have discontinuities solutions e.g. shocks.
We tested how increased viscosity allows numerical capturing of
shock waves via ’low pass filtering of wiggles i.e. small wavelengths’.
Again, the demonstrated Euler time integration method is not used
in practive but it is a copy-paste type effort to extend the method to
Runge-Kutta methods which are very robust and much used also in
3D realistic flows.

Matlab and PDE’s 27/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube
The End

Thank you

Questions?

Matlab and PDE’s 28/28


Ville Vuorinen Simulation Course, 2012
Aalto University Simulation of Shocks in a Closed Shock Tube

You might also like