Waves

We will now begin to consider perturbations to our equations. Here, we consider small, stable perturbations. The standard recipe is to break our fluid properties (v,ρ,P,Φ,) into 0th order +1st order pieces. We will assume that the first order pieces are than the 0th order pieces. The word for this is linear perturbation theory.

Here is a note on notation. We will have something like:

v=v0+v1

where the subscript refers to the order, i.e., v1v0. This means:

  • v=v0+v1

  • P=P0+P1

  • ρ=ρ0+ρ1

  • Φ=Φ0+Φ1

Note

The thermal behavior of the perturbations P1, ρ1 need to behave the same way was the 0th order counterpart. An example is the equation of state – an atmosphere might be isothermal, but the perturbations can be adiabatic.

Sound Waves: The Simplest Case

Consider a static, uniform (unperturbed) medium. We will ignore gravity. Thus, all we have is pressure for the physics.

In this case,

v=v1
P=P0constant+P1
ρ=ρ0constant+ρ1
Φ=0

We now plug these into our fluid equations.

Zeroth Order Equations

The 0th order fluid equations are:

The Continuity Equation

ρt+(ρv0)=0

This is satisfied trivially. This tells us nothing.

Euler Equation

v0t+=0=1ρ0P0=0

This is also satisfied trivially.

First Order Equations

Continuity Equation

ρ1t+(ρ0v1)=0

Euler Equation

v1t=1ρ0P1

Note that the advection term is 0 to first order.

This is simply two coupled equations which we can solve! But, before that, we will introduce a new quantity, the sound speed vs.

Sound Speed

v2s=Pρ=P1ρ1

where this measures how pressure changes with density.

Combining the continuity and the euler equation together by taking the time derivative of the first equation:

2ρ1t22P1=ρ1t2v2s2ρ1=0

where we have assumed that the sound speed is a constant. This is a trivial waves equation! We have solved this in our childhood:

ρ1(r,t)=d3kei(krωt)ρ1(k)

The solution is thus just a relationship between k and ω. This gives a dispersion relation for a free wave:

ω2+v2sk2=0ω2=v2sk2

For completeness, we have:

The Group Velocity

v_g \equiv \frac{\partial \omega}{\partial k} = v_s

The Phase Velocity

v_{phase} \equiv \frac{\omega}{k} = v_s

For sound waves, these are independent of the wavenumber k. When this is the case, we say we have “non-dispersive waves.”

What about perturbed fluid velocities/other quantities?

We can use our solution for ρ and the Euler Equation above to get:

vt=v2sρ0ρ1 Fourier v2sρ0(ik)ρ1

We can show that:

v1=v2sρ0kωρ0=ωkˆkρ1ρ0

Note that the perturb quantites v1,ρ, and P are all in phase.

Fourier Transforms and Conceptual Review

Note that FTs are nice since we term finite difference problems into algebraic problems. This is awesome numerically!

We have some density perturbation. This gives us a pressure gradient and thus a force. This force accelerates the fluid element. This perturbed velocity further induces a density perturbation, leading to sound wave propagation!

Some Numbers and Notes About Sound Speed

Isothermal Sound Speed

Isothermal Sound Speed:

v2s=(Pρ)T

Remember that the ideal gas has: P=ρμmpkbT. This makes:

vs=kbTμmp

Adiabatic Sound Speed

v2s(Pρ)S

The adiabatic ideal gas has P=κργ. Taking the derivative, we have:

v2s=γPρ=γkbTμmp

This gives:

vs=γkbTμmp=gammavisothermals

Which one of these speeds are relevant?

Examples of Air Sound Speed
  • Adiabatic: (A useful thing to know: kbT140 eV at room temperature air)

    • Has vadiabatics=751/40 eV28.8109 eV c330 m/s

  • Isothermal:

    • Has visothermals280 m/s.

The data is closer to the adiabatic case.

Examples of Water Sound Speed
  • This is closer to vs1500 m/s !

Examples of Sound Speed in Iron
  • This is closer to vs5 km/s.

Gravity Waves

Let’s look at water waves on the surface of Earth with the same spirit as in sound waves.

fig7

Consider a single fluid of constant density ρ0 in equilibrium (v0=0. ) This means that the Euler Equation is:

1ρ0P=Φ0=g

Thus:

1ρ0P0z=gP0=ρ0gz+ constant

Perturbed Equations

We have v=v0+v1=v1, P=P0+P1, ρ=ρ0= constant, incompressible, and ρ1=0 since it is incompressible. Note that Φ=g due to the external gravitational field of Earth. Φ1=0 means that the self-gravity of the water is negligible. The linearized, 1st order fluid equations are thus:

Continuity Equation

Remember from before that the incompressible condition implies:

v1=0

Note we chose our coodinates (considering waves travelling along x-axis) such that this equation is:

xv1x+zv1z=0$.

Euler Equation

We have:

v1t=1ρ0P1

Let’s write out the components:

tv1x=1ρ0xP1
tv1z=1ρ0zP1

We can choose to solve for P or v, and we choose P first. We can use the equation from the Contunity Equation (by take the partial derivative) to get:

0=t(v1xt+v1zt)=1ρ0(2x2+2z2)P1

This is:

(2x2+2z2)P1=0

This is a Laplace Equation in 2D. This has solutions! Because we are looking for waves along x, we have the ansatz:

P1(x,z,t)ei(kxωt)f(z)

Plug this into the Laplace Equation, and we get:

k2f+fz2=0f(z)e±kz

All the action will now come from the boundary conditions. We can write:

P1(x,z,t)=Aei(kxωt)(ekz+Bekz)
v1z(x,z,t)=Akρ0iωei(kxωt)(ekzBekz)

where the second equation for v1z comes from the 2nd Euler Equation above and where we have gone into Fourier Space.

Boundary Conditions

1. z=H, the bottom of the sea. Here, we have:

v1z(z=H)=0

This condition implies that Be2kH. Immediately, we have:

P1(x,z,t)=Aei(kxωt)ekH(2cosh[k(z+H)])

Similarly,

v1z=Akρ0iωei(kxωt)ekH2sinh(k(z+H))

2. At the surface of the (free aka no force) air-water interface (z=0 for our coordinates). Let’s introduce the fluid displacement vector ξ(r,t) defined such that:

dξdtv

The vertical displacement is thus:

dξzdt=v1zeiωtξz=v1ziω

which we actually hav aen equation for in 1. .

Note that saying we have a “free air water interface” is the same as saying we have “constant pressure along fluid element.” This translates to a condition:

P1+ξP0=0 if surface tension is unimportant

Continuing from last time…

Now, let’s recall we have, from the unperturbed equations:

P0=ρgz+const.

When we impose the first boundary condition at the bottom of the sea, we get:

P1=Aei(kxωt)ekH2cosh(k(z+H))

We went to the Euler equation, and got:

v1z=Akρ0iωei(kxωt)2sinh(k(z+H))

We then introduced the fluid displacement ξ such that dξ/dtv1ξz=v1ziω=Akρ0ω2ei(kxωt)ekh2sinh(k(z+H)).

When we impose the second boundary condition (at the air-water interface), and if we assume that we have no surface tension, we have:

P1+ξP0=0 at z=0

At z=0, we thus have (recalling that P0=ρ0gz):

P1ρ0gξz|z=0=0

We have expressions for all this stuff (P1 and ξz from above)! The only significant pieces give:

cosh(kH)=kgω2sinh(kH)

Note that this is a dispersion relation! We thus have:

ω2=gktanh(kH)

This is the dispersion relation for surface water waves under no external forces at the boundaries.

Some notes from above: Eulerian vs. Lagrangian Perturbations

Let’s come back to :

P1+ξP0=0 at z=0

What does this mean? Where does this come from?

An Eulerian perturbation looks like:

P(r,t)=P0(r)+P1(r,t)

This is what we have been doing so far. The Lagrangian perturbation looks at the perturbation along the fluid element as it is traveling. This looks like:

P(r+ξ,t)=P0(r)+P1,Lagrangian(r,t)

We can thus relate the two pictures:

P1,Lagrangian=P(r+ξ,t)P0(r)

We taylor expand:

P1,Lagrangian=P(r,t)+ξPP0(r)

The first and third term are just Eulerian perturbations!

P1,Lagrangian=P1(r,t)Eulerian+ξP0+O(ξ2)+

The extra piece of our perturbation then pops out, and that’s why we had that at the boundary from before.

**This means that we are requiring the pressure to be constant along a fluid element, not just at a fixed r. ** This is another way of saying we are force-free along the fluid element.

The Dispersion Relation

The disperion relation derived above is fascinating. Let’s play around in different regimes. Let’s consider λH and λH for the two interesting limits.

1. Deep Water Limit: Hλ.

In this limit, our intuition tells us that we don’t really care about H because the waves are too small to feel the ground. Recall that:

tanhx=exexex+exx1tanhx=1

Thus our disperion relation is:

ω2=gkω=gk

This is a dispersive wave – different wavelengths travel with different speeds. How can we see this? Well the phase velocity is:

vphase=ωkg/k
vgroup=dω/dk→=12g/k

Shorter wave length disturbances travel more slowly.

2. Shallow Water Limit: Hλ.

tanhxx1x

Our dispersion relation becomes:

ω=gHk

This is equite intuitive – when we have long wavelengths compared to H, we shoild know about H! It shows up, whereas before it disappeared. Note that:

vphase=gH=vgroup

Which is independent of k! All waves travel at the same speed, making this non-dispersive. A wave packet does not spread apart as it travels along the surface. This is the limit that matters for tsunamis. As you move toward the shore, H decreases.

Plugging in Numbers for Tsunamis

These behave as shallow water gravity waves. Typically λ many kilometers . The average depth of the Pacific Ocean is around 4 km. We know g=9.8 m/s2. In this case:

vphase=vgroup=1040,000200 m/s700km/hr440 mph

It takes roughly 10-20 hours to cross the Pacific!

Capillary Waves

This is the case when surface tension is non-negligible. We will do this in Problem Set 3. In this case, we have:

P1+ξP0=T2ξzx2|z=0

where the negative sign is downward, and T is a constant for surface tension.

Shock Waves

Shocks are fundamentally discontinuous. We will look in front of and behind these shocks, and relate these two systems with boundary conditions. This builds up to the jump conditions.

Shocks are characterized by sudden changes in the fluid properties. We introduce the Mach number.

Mach Number

Machvvs
fig8

We can see that we get a Mach cone, with the shock fronts shown in blue in the Figure above. The angle of the shock front α is given by:

sinα=vsv=1M

The region within the cone is in causal contact. We say that interior to the cone is shocked, and outside the cone is ambient/pre-shock.

fig9

We now want to examine interior and exterior to this shock front.

Shocks – Jump Conditions (Rankine-Hugoniot Relations)

These describe boundary conditions across shocks (in the frame of shocks).

Let’s imagine two regions separated by a shock boundary. On the left is pre-shock with P1, ρ1, and v1. The right side is post-shock, with P2, ρ2 and v2. The shock is contained within a box of Δx width. Typically cold, fast flow gets shocked to hot, slow flow, with:

  • v1>v2

  • ρ1<ρ2

  • P1<P2

In this box around the shock front, we have:

1. Mass Conservation (Starting with Continuity Equation)

ρt+x(ρvx)=0

We can integrate over x:

tρdx0 bc mass flux in = mass flux out+ρvx|x=Δx/2ρvx|x=Δx/2=0

Thus:

Jump Condition 1

Mass flux in is equal to the mass flux out.

ρ2v2=ρ1v1

2. Momentum Conservation (Conservative Form of Euler Equation)

t(ρvi)=jTijρiΦ

The momentum flux Tij term is:

momentum flux=TijPδij+ρvivj

Momentum cannot accumulate at the boundary, so momentum flux in has to equal the momentum flux out. The one dimensional form of this is:

P2+ρ2v22=P1+ρ1v21
sum of thermal and ram pressure in=sum of thermal and ram pressure out

Shocks convert ram pressure into thermal pressure, preserving the sum.

3. Energy Conservation ()

We had:

Et+[(E+P)v]f=ρ˙Qcool+ρΦt

For adiabatic shocks ˙Qcool0. When this is the case, we have

energy flux in=energy flux out

And thus:

(12v21+Φ1+ϵ1+P1ρ1)ρ1v1=(12v22+Φ2+ϵ2+P2ρ2)ρ2v2

Note that our first equation tells us that the ρv terms cancel out. Also, Φ1=Φ2. This gives us:

12v21+ϵ1+P1ρ1=12v22+ϵ2+P2ρ2

Our three jump conditions are thus:

Note

ρ2v2=ρ1v1

Note

P2+ρ2v22=P1+ρ1v21

Note

12v21+ϵ1+P1ρ1=12v22+ϵ2+P2ρ2

Note that the internal energy is ϵ in the above equations.

Example: Adiabatic, Ideal Gas

Under these assumptions, recall the polytropic relation:

P=Kργ

And the internal energy per unit mass:

ϵ=1γ1Pρϵ+Pρ=γγ1Pρ

And our sound speed:

v2s=Pρ=γPρ

If we additionally assume that γ is constant across shocks, we can simplify the 3rd jump condition. This becomes (for adibatic ideal gases, remember):

12v21+γγ1P1ρ1=12v22+γγ1P2ρ2

Re-writing this in terms of vs:

12v21+1γ1v2s,1=12v22+1γ1v2s,2

Re-writing our jump conditions once more (which is very, very tedious) in a way which removes v1 and v2. The trick that makes things much quicker is to define:

jρ1v1ρ2v2

Then, re-write the second jump condition as:

j2ρ1+P1=j2ρ2+P2j2=P2P11ρ11ρ2

We can now re-write the third jump condition in terms of j. Lots of tedious work leads to:

ρ2ρ1=v1v2=(γ1)P1+(γ+1)P2(γ+1)P1+(γ1)P2

Lastly, we want to express everything in terms of the pre-shock (upstream) Mach number since we often can’t measure post-shock (downstream) conditions. Recall that:

M1v1vs,1adiabatic ideal gasM21=v21ρ1γP1

For convenience, let’s define xv2v1ρ1ρ2 from jump condition 1. Using JC2:

P2=P1+ρv21ρ2v22=ρ1v1v2ρ1v21x

Thus:

P2=P1+ρ1v21=γM21P1(1x)

And thus:

P2=P1[1+γM21(1x)]

And thus:

P2P1=1+γM21(1x)

One last step – use this expression along with our most recently boxed equation (in class, we called this JC3’), which gives:

v1v2=1x=(γ1)+(γ+1)[1+γM21(1x)](γ+1)+(γ1)[1+γM21(1x)]

The right hand side can be simplified:

1x=2+(γ+1)M21(1x)2+(γ1)M21(1x)

And:

2+(γ1)M21(1x)=2x+(γ+1)M21(1x)x

Collecting terms:

(1x)(x)=0

which has solutions:

x=1 No shock solution! (when M1<1)
v1v2=ρ2ρ1=γ+1γ1+2M21 (when M1>1)

We can also find, skipping the math, from Jump Condition 2:

P2P1=2γM21(γ1)γ+1

We can also derive the post-shock Mach number:

M22=(γ1)M21+22γM21(γ1)

We can show that, if M1>1, then M2<1. The post-shock is always subsonic. For completeness, we can relate the temperatures as well:

T2T1=P2P1ρ1ρ2=(2γM21(γ1))(γ1+2M21)(γ+1)2
Checking the Limits and the Physics

Let’s take the (1) no shock limit (x=1,v1=v2,P1=P2,....) and the (2) strong shock limit (M11).

1. No shock – uninteresting.

2. Strong Shock:

ρ2ρ1=v1v2γ+1γ1=4 for γ53 or 6 for γ75

Let’s look at pressure, now. When M11, we reach:

P2P12γM21γ+1≫≫1

Pressure is not capped! Note that for air:

P2P1=1.2M21 for air

Temperature is also not capped, and we will see this on Problem Set 3.

Blast Waves

Here, we consider strong shocks generated by explosions. This is interesting because we have a self-similar solution, the Sedov-Taylor Similarity Solution, which was used in WWII by the Russians.

Consider a star exploding isotropically with a shock front of thickness D traveling with velocity v1. Outside the shock is ρ1, and inside the thin shell, we will assume has ρ2 density, the same density internal to the shock. We assume vacuum interior the shocked shell.

fig10

If we zoom in on the box, we basically have our pre and post-shock picture from above!

fig11
  • In the pre-shock fluid’s rest frame, the post-sock speed is v2v1v2=v1(1γ1γ+1)=2γ+1v1.

  • We also assume that most mass within R is swept into a shell of thickness D:

43πR3ρ1=4πR2Dρ2

And thus:

D=R3ρ1ρ2

Note that we actaully know the strong-shock ratio of densities:

D=R3γ1γ+1γ=5/30.08RDR

Shell of Shocked Gas

The shell of shocked gas is moving at speed v1=˙R(t) in the frame of the pre-shock fluid. The shell’s kinetic energy is:

Ekin=12mv21=12(43πR3ρ1)˙R2Eρ1R5t2

The shell’s internal energy:

Eint=1γ1P2VshellE1γ12γ+1v21ρ143πR3Eρ1R5t2

Both the internal energy and the kinetic energy thus give us:

R=A(Eρ1)1/5t2/5

This is the blast-wave scaling relationship. The radius doesn’t depend linearly on time, instead it scales with time to the 2-5ths. This only holds for adiabatic explosions, by the way. It also doesn’t hold in the very beginning of the explosion.

The Sedov Phase

Let’s recall a few conditions we had from above. Recall the picture of a spherical shell expanding from a spherical star. Inside the shell of width D, we are post-shock. Outside this expanding shell, we have pre-shock conditions.

For strong shocks (M11 ), we had:

v1v2=ρ2ρ1γ53γ+1γ1

And also

P2P12γγ+1M21M21=v21ρ1γP1

We saw last time that the shell expands in the Sedov Phase:

R(t)=A(Eρ1)1/5t2/5

Usually, you don’t enter this phase right away – typically at first, v is constant. Then, we start to lose energy, and as we plow material into the shell, this scaling (called the Sedov-Taylor phase), takes over.

Examples of Blast Waves

1. Atomic Bomb

We had around 6 kg of plutonium in a 4000 kg metal container. Let’s estimate the explosion energy. The energy source in this case is nuclear fission:

EffissionMplut.c2(104)6103(31010)21021 ergs

Initially, the ejecta are:

E12Mv2ejectavesc2Em21021 ergs4000 kg2×107cms

Now let’s calculate the radius of the mushroom cloud (the shock-front!):

R(t)((1)E1021 ergs103gcm3ρ1(t1 ms)2)1/5(1021103106)1/5

And thus:

R(t)(30 m)(E1021 ergs103gcm3ρ1(t1 ms)2)1/5

2. Supernova

ESN1051 ergs12Mv2ejecta

M in this case, has M10M1034 g. Immediately, we can calculate:

vejec2105110325108cms5000kms

Doing the exactly the same thing above, knowing ρ1=ρISM1H atomcm3:

R(t)=(E1051 ergs1024gcm3ρ1(t1 year)2)1/51018 cm0.3 pc

Thus, R0.3pc at 1 year old.

Sedov-Taylor Self-Similar Solution and the Strucutre of Blast Waves

What if we want to know the radial profile of the blast wave? Let’s examine the post-shock radial profile for a 1D spherical shock. What is ρ(r,t),P(r,t),v(r,t) behind a shock front?

In the Sedov phase, we can define a dimensionless radius ξrR(t). In this case, we have R(t) as a characteristic length scale for shocks in the explosion. We will now look for Ansatz for self-similar solution of the form:

ρ(r,t)=ρ2˜ρ(ξ)
P(r,t)=P2˜P(ξ)
v(r,t)in unshocked gas rest frame=v2˜v(ξ)

where the \tilde functions are dimensionless.

These definitions allow us to change variables in the fluid equations, like:

(t,rξ)

When we do this, our fluid equations become only functions of ξ (since time is embedded in R(t)). After tons of algebra, we can find the solutions for these three functions. Here are what these look like:

fig12