Book 6
Book 6
Small Oscillations
X ∂U 1 X ∂2U
U (q1 , . . . , qN ) = U (qi0 ) + ηi + ηi ηj + ... .
i ∂qi 0 2 ij ∂qi ∂qj 0
1X ∂2U
U ({qi }) = Aij ηi ηj , with Aij = . (5.1)
2 ij ∂qi ∂qj 0
123
124 CHAPTER 5. SMALL OSCILLATIONS
P
The kinetic energy T = 12 Mij η̇i η̇j is already second order in the small
variations from equilibrium, so we may evaluate Mij , which in general can
depend on the coordinates qi , at the equilibrium point, ignoring any higher
order changes. Thus Mij is a constant. Thus both the kinetic and potential
energies are quadratic forms in the displacement η, which we think of as a
vector in N -dimensional space. Thus we can write the energies in matrix
form
1 1
T = η̇ T · M · η̇, U = η T · A · η. (5.2)
2 2
A and M are real symmetric matrices, and because any displacement corre-
sponds to positive kinetic and nonnegative potential energies, they are pos-
itive (semi)definite matrices, meaning that all their eigenvalues are greater
than zero, except that A may also have eigenvalues equal to zero (these
are directions in which the stability is neutral to lowest order, but may be
determined by higher order terms in the displacement).
Lagrange’s equation of motion
d ∂L ∂L d
0= − = M · η̇ + A · η = M · η̈ + A · η (5.3)
dt ∂ η̇i ∂ηi dt
is not necessarily diagonal in the coordinate η. We shall use the fact that
any real symmetric matrix can be diagonalized by a similarity transforma-
tion with an orthogonal matrix to reduce the problem to a set of independant
harmonic oscillators. While both M and A can be diagonalized by an orthog-
onal transformation, they can not necessarily be diagonalized by the same
one, so our procedure will be in steps:
2. Scale the x coordinates to reduce the mass matrix to the identity ma-
trix. The new coordinates will be called y.
Let us do this in more detail. We are starting with the coordinates η and
the real symmetric matrices A and M , and we want to solve the equations
M · η̈ + A · η = 0. In our first step, we use the matrix O1 , which linear
algebra guarantees exists, that makes m = O1 · M · O1−1 diagonal. Note O1 is
P P
time-independent, so defining xi = j O1 ij ηj also gives ẋi = j O1 ij η̇j , and
1 T
T = η̇ · M · η̇
2
1 T −1
= η̇ · O1 · m · O1 · η̇
2
1 T
= η̇ · O1T · m · (O1 · η̇)
2
1
= (O1 · η̇)T · m · (O1 · η̇)
2
1 T
= ẋ · m · ẋ.
2
Similarly the potential energy becomes U = 12 xT · O1 · A · O1−1 · x. We know
that the matrix m is diagonal, and the diagonal elements mii are all strictly
√
positive. To begin the second step, define the diagonal matrix Sij = mii δij
P
and new coordinates yi = Sii xi = j Sij xj , or y = S·x. Now m = S 2 = S T ·S,
so T = 12 ẋT · m · ẋ = 12 ẋT · S T · S · ẋ = 12 (S · ẋ)T · S · ẋ = 12 ẏ T · ẏ. In terms of
y, the potential energy is U = 12 y T · B · y, where
B = S −1 · O1 · A · O1−1 · S −1
Then
1 X ˙2 1X 2 2
T = ξ , U= ω ξ , ξ¨j + ωj2 ξj = 0,
2 j j 2 j j j
ξj = Re aj eiωj t ,
q = q0 + O1−1 · S −1 · O2−1 · ξ.
2
2 2
Figure 5.1: Some simple molecules in their equilibrium positions.
Example: CO2
Consider first the CO2 molecule. As it is a molecule, there must be a position
of stable equilibrium, and empirically we know it to be collinear and sym-
metric, which one might have guessed. We will first consider only collinear
motions of the molecule. If the oxygens have coordinates q1 and q2 , and the
carbon q3 , the potential depends on q1 − q3 and q2 − q3 in the same way, so
128 CHAPTER 5. SMALL OSCILLATIONS
1 1
U = k(q3 − q1 − b)2 + k(q2 − q3 − b)2
2 2
1 1 1
T = mO q̇1 + mO q̇2 + mC q̇32 .
2 2
2 2 2
We gave our formal solution in terms of displacements from the equilibrium
position, but we now have a situation in which there is no single equilibrium
position, as the problem is translationally invariant, and while equilibrium
has constraints on the differences of q’s, there is no constraint on the center
of mass. We can treat this in two different ways:
1. Explicitly fix the center of mass, eliminating one of the degrees of free-
dom.
First we follow the first method. We can always work in a frame where
the center of mass is at rest, at the origin. Then mO (q1 + q2 ) + mC q3 = 0
is a constraint, which we must eliminate. We can do so by dropping q3
as an independant degree of freedom, and we have, in terms of the two
displacements from equilibrium η1 = q1 + b and η2 = q2 − b, q3 = −(η1 +
η2 )mO /mC , and
1 1 1 mO
T = mO (η̇12 + η̇22 ) + mC η̇32 = mO η̇12 + η̇22 + (η̇1 + η̇2 )2
2 2 2 mC
1 m2O 1 + mC /mO 1 η̇1
= ( η̇1 η̇2 ) .
2 mC 1 1 + mC /mO η̇2
Now T is not diagonal, or more precisely M isn’t. We must find the orthog-
onal matrix O1 such that O1 · M · O1−1 is diagonal. We may assume it to be
a rotation, which can only be
cos θ − sin θ
O=
sin θ cos θ
5.1. SMALL OSCILLATIONS ABOUT STABLE EQUILIBRIUM 129
1 1
T = mO (η̇12 + η̇22 ) + mC η̇32
2 2
1 h i
U = k (η1 − η3 ) + (η2 − η3 )2 .
2
2
T is already diagonal, so O1 = 1I, x = η. In the second step S is the diagonal
√ √ √
matrix with S11 = S22 = mO , S33 = mC , and yi = mO ηi for i = 1, 2,
5.1. SMALL OSCILLATIONS ABOUT STABLE EQUILIBRIUM 131
√
and y3 = mC η3 . Then
!2 !2
1 y1 y3 y2 y3
U = k √ −√ + √ −√
2 mO mC mO mC
1 k h √ i
= mC y12 + mC y22 + 2mO y32 − 2 mO mC (y1 + y2 )y3 .
2 mO mC
Thus the matrix B is
√
mC 0 − mO mC
√
B= 0 m − mO mC ,
√ √ C
− mO mC − mO mC 2mO
√ √ √
which is singular, as it annihilates the vector y T = ( mO , mO , mC ),
which corresponds to η T = (1, 1, 1), i.e. all the nuclei are moving by the same
amount, or the molecule is translating rigidly. Thus this vector corresponds
to a zero eigenvalue of U , and a harmonic oscillation of zero frequency. This is
free motion3 , η = η0 +vt. The other two modes can be found by diagonalizing
the matrix, and will be as we found by the other method.
Transverse motion
What about the transverse motion? Consider the equilibrium position of
the molecule to lie in the x direction, and consider small deviations in the z
direction. The kinetic energy
1 1 1
T = mO ż1 + mO ż22 + mC ż32 .
2 2 2
is already diagonal, just as for
the longitudinal modes in the sec-
ond method. Any potential en-
ergy must be due to a resistance
to bending, so to second order,
U ∝ (ψ − θ)2 ∼ (tan ψ − tan θ)2 = θ 2
ψ
[(z2 −z3 )/b+(z1 −z3 )/b]2 = b−2 (z1 +
z2 − 2z3 )2 . 1
Note that the potential energy is proportional to the square of a single linear
3
To see that linear motion is a limiting case of harmonic motion as ω → 0, we need to
choose the complex coefficient to be a function of ω, A(ω) = x0 − iv0 /ω, with x0 and v0
real. Then x(t) = limω→0 Re A(ω)eiωt = x0 + v0 limω→0 sin(ωt)/ω = x0 + v0 t
132 CHAPTER 5. SMALL OSCILLATIONS
This implies ψj (ω) = 0 except when the matrix Aij − ω 2 Mij is singular,
det (Aij − ω 2 Mij ) = 0, which gives a discrete set of angular frequencies
ω1 . . . ωN , and for each ωj an eigenvector ψj .
4
See problem 5.3.
134 CHAPTER 5. SMALL OSCILLATIONS
we find X
−ω 2 Mij − iωRij + Aij ψj = f˜i .
j
Except for at most 2N values of ω the matrix multiplying ψj will have a non-
zero determinant and will be invertible, allowing us to find the response ψj
to the fourier component of the driving force, f˜i . Those values of ω for which
the determinant vanishes, and the vector ψj which the matrix annihilates,
correspond to damped modes that we would see if the driving force were
removed.
f˜(ω)
x̃(ω) = .
ω02 − ω 2 − 2iρω
As x(t) and f (t) are real-valued functions of time, the fourier transforms
must satisfy x̃∗ (ω) = x̃(−ω), f˜∗ (ω) = f˜(−ω), and the steady state solution
is
Z ∞ Z ∞
−iωt ∗ iωt
x(t) = dω x̃(ω)e + x̃ (ω)e = 2 Re dωx̃(ω)e−iωt
0 0
Z ∞ f˜(ω)
= 2 Re dω e−iωt . (5.4)
0 ω02 − ω 2 − 2iρω
5.2. OTHER INTERACTIONS 135
with amplitude
2a
A =
ω02 − ωex
2 − 2iρω
ex
2|a|
= q .
2
(ω02 − ωex
2 ) + 4ρ2 ω 2
ex ρ
are defined at each point in space. In Chapter 8 we will discuss more in-
teresting and involved cases such as the electromagnetic field, where at each
point in space we have E ~ and B
~ as degrees of freedom, though not without
constraints.
The loaded string we will consider is a light string under tension τ stretched
between two fixed points a distance ` apart, say at x = 0 and x = `. On
the string, at points x = a, 2a, 3a, . . . , na, are fixed n particles each of mass
m, with the first and last a distance a away from the fixed ends. Thus
` = (n + 1)a. We will consider only small transverse motion of these masses,
using yi as the transverse displacement of the i’th mass, which is at x = ia.
We assume all excursions from the equilibrium positions yi = 0 are small, and
in particular that the difference in successive displacements yi+1 − yi a.
Thus we are assuming that the angle made by each segment of the string,
θi = tan−1 [(yi+1 − yi )/a] 1. Working to first order in the θ’s in the equa-
tions of motion, and second order for the Lagrangian, we see that restricting
our attention to transverse motions and requiring no horizontal motion forces
taking the tension τ to be constant along the string. The transverse force on
the i’th mass is thus
yi+1 − yi yi−1 − yi τ
Fi = τ +τ = (yi+1 − 2yi + yi−1 ).
a a a
The potential energy U (y1 , . . . , yn ) then satisfies
∂U τ
= − (yi+1 − 2yi + yi−1 )
∂yi a
so
U (y1 , . . . , yi , . . . , yn )
Z yi
τ
= dyi (2yi − yi+1 − yi−1 ) + F (y1 , . . . , yi−1 , yi+1 , . . . , yn )
0 a
τ 2
= yi − (yi+1 + yi−1 )yi + F (y1 , . . . , yi−1 , yi+1 , . . . , yn )
a
τ
= (yi+1 − yi )2 + (yi − yi−1 )2 + F 0 (y1 , . . . , yi−1 , yi+1 , . . . , yn )
2a
Xn
τ
= (yi+1 − yi )2 + constant.
i=0 2a
The F and F 0 are unspecified functions of all the yj ’s except yi . In the last
expression we satisfied the condition for all i, and we have used the convenient
definition y0 = yn+1 = 0. We can and will drop the arbitrary constant.
138 CHAPTER 5. SMALL OSCILLATIONS
P
The kinetic energy is T = 12 m n1 ẏi2 .
Before we continue with the analysis of this problem, let us note that
another physical setup also leads to the same Lagrangian. Consider a one
dimensional lattice of identical atoms with a stable equilibrium in which they
are evenly spaced, with interactions between nearest neighbors. Let ηi be the
longitudinal displacement of the i’th atom from its equilibrium position. The
P
kinetic energy is simply T = 12 m n1 η̇i2 . As the interatomic distance differs
from its equilibrium position by ηi+1 − ηi , the interaction potential of atoms
i and i + 1 can be approximated by U (ηi+1 , ηi ) ≈ 12 k(ηi+1 − ηi )2 . We have
in effect atoms separated by springs of spring constant k, and we see that
if k = τ /a, we get the same Lagrangian for longitudinal oscillations of this
lattice as we had for the transverse oscillations of the loaded string.
P
As the kinetic energy is simply T = 12 m n1 ẏi2 , the mass matrix is already
proportional to the identity matrix and we do not need to go through the
first two steps of our general process. The potential energy U = 12 y T · A · y
has a non-diagonal n × n matrix
−2 1 0 0 ··· 0 0
1 −2 1 0 · · · 0 0
τ
0 1 −2 1 · · · 0 0
A = − .. .. .. .. . . .. .. .
a . . . . . . .
0 0 0 0 · · · −2 1
0 0 0 0 · · · 1 −2
and we wind up with the wave equation for transverse waves on a massive
string
∂ 2y 2
2∂ y
− c = 0,
∂t2 ∂x2
where s
τ
c= .
ρ
Solving this wave equation is very simple. For the fixed boundary condi-
tions y(x) = 0 at x = 0 and x = `, the solution is a fourier expansion
∞
X
y(x, t) = Re Bp eickp t sin kp x,
p=1
where kp ` = pπ. Each p represents one normal mode, and there are an
infinite number as we would expect because in the continuum limit there are
an infinite number of degrees of freedom.
We have certainly not shown that y(x) = B sin kx is a normal mode for
the problem with finite n, but it is worth checking it out. This corresponds
to a mode with yj = B sin kaj, on which we apply the matrix A
X τ
(A · y)i = Aij yj = − (yi+1 − 2yi + yi−1 )
j a
τ
= − B (sin(kai + ka) − 2 sin(kai) + sin(kai − ka))
a
τ
= − B(sin(kai) cos(ka) + cos(kai) sin(ka) − 2 sin(kai)
a
+ sin(kai) cos(ka) − cos(kai) sin(ka))
τ
= B (2 − 2 cos(ka)) sin(kai)
a
2τ
= (1 − cos(ka)) yi .
a
So we see that it is a normal mode, although the frequency of oscillation
s s
2τ τ sin(ka/2)
ω= (1 − cos(ka)) = 2
am ρ a
q
differs from k τ /ρ except in the limit a → 0 for fixed k.
The wave numbers k which index the normal modes are restricted by
the fixed ends to the discrete set k = pπ/` = pπ/(n + 1)a, for p ∈ Z, i.e. p is
5.4. FIELD THEORY 141
an integer. This is still too many (∞) for a system with a finite number of
degrees of freedom. The resolution of this paradox is that not all different k’s
correspond to different modes. For example, if p0 = p + 2m(n + 1) for some
integer m, then k 0 = k + 2πm/a, and sin(k 0 aj) = sin(kaj + 2mπ) = sin(kaj),
so k and k 0 represent the same normal mode. Also, if p0 = 2(n + 1) − p,
k 0 = (2π/a)−k, sin(k 0 aj) = sin(2π −kaj) = − sin(kaj), so k and k 0 represent
the same normal mode, with opposite phase. Finally p = n + 1, k = π/a
gives yj = B sin(kaj) = 0 for all j and is not a normal mode. This leaves as
independent only p = 1, ..., n, the right number of normal modes for a system
with n degrees of freedom.
The angular frequency of the p’th normal mode
r
τ pπ
ωp = 2 sin
ma 2(n + 1)
ture of the crystal, are called opti- Fig. 5.3. Frequencies of oscillation
cal modes. of the loaded string.
This Lagrangian, however, will not be of much use until we figure out what is
meant by varying it with respect to each dynamical degree of freedom or its
corresponding velocity. In the discrete case we have the canonical momenta
Pi = ∂L/∂ ẏi , where the derivative requires holding all ẏj fixed, for j 6= i, as
P
well as all yk fixed. This extracts one term from the sum 12 ρ aẏi2 , and this
would appear to vanish in the limit a → 0. Instead, we define the canonical
momentum as a density, Pi → aP (x = ia), so
1 ∂ X
P (x = ia) = lim a L(y(x), ẏ(x), x)|x=ai .
a ∂ ẏi i
1 ∂ δ
lim → ,
a→0 a ∂ ẏi δ ẏ(x)
1 ∂
and similarly for a ∂yi
, which act on functionals of y(x) and ẏ(x) by
As θ << 1, we can replace cos θ by 1 and sin θ with tan θ = ∂y/∂x, and
then from the first equation we see that ∂τ /∂x is already small, so we can
consider τ as constant in the second equation, which gives
!
∂y ∂y
τ − − ρg∆x = ρ∆xÿ,
∂x x+∆x
∂x x
or
∂2y
τ − ρg = ρÿ.
∂x2
This agrees with Eq. 5.7 if we drop the gravity term, which we had not
included in our discussion of the loaded string.
5
P
To be clear: jPij dSj is the force exerted by the back side of the surface element on
R
~ is an outward normal, the force on the volume is − P Pij dSj ,
the front side, so if dS S j
and a pressure corresponds to P = +pδij . This agrees with Symon ([17]) but has a reversed
sign from Taylor’s ([18]) Σ = −P.
146 CHAPTER 5. SMALL OSCILLATIONS
behave suitably under rotations. Here we are generalizing the idea that a
vector cannot be defined in terms of pure scalars, and a scalar can depend on
vectors only through a scalar product. A symmetric tensor consists of a piece,
its trace, which behaves like a scalar, and a traceless piece, called the de-
viatoric part, which behaves differently, as an irreducible representation6 .
The only possible linear relationships are thus
1 1
Tr P = −α Tr S; Pij − δij Tr P = −β Sij − δij Tr S . (5.8)
3 3
These are known as the generalized Hooke’s law for an elastic solid.
The tensor stress and strain we have described here are perhaps not as fa-
miliar as some other relations met in more elementary courses. First consider
the bulk modulus B, the inverse of the ratio of the fractional decrease in
volume to the isotropic pressure which causes it. Here the stress and strain
tensors are both multiples of the identity, P = +pδij and d~η = −cd~x, so
S = −cδij and c = p/α. For a linear contraction ~x → ~x − c~x the volume will
contract by ∆V = −3cV . Therefore the
p p α
bulk modulus B := = = .
−dV /V 3c 3
In this vector form we imply that the first index of P is matched to that
of F~ surf , while the second index is paired with that of dS ~ and summed
over. Gauss’s law tells us that this is the integral over the volume V of the
divergence, but we should take care that this divergence dots the derivative
with the second index, that is
Z X
∂
Fisurf = − Pij (~r)dV.
V j ∂xj
This equation is called the Navier equation. We can rewrite this in terms of
the shear modulus G and the bulk modulus B:
∂ 2 ~η (~r) ~ r) + B + G ∇(
~ ∇~ · ~η ) + G∇2 ~η .
ρ(~r) 2
= E(~
∂t 3
Fluids
In discussing the motion of pieces of a solid, we specified which piece of the
material was under consideration by its “original” or “reference” position ~r,
from which it might be displaced by a small amount ~η (~r). So ~r is actually a
label for a particular hunk of material. This is called the material descrip-
tion. It is not very useful for a fluid, however, as any element of the fluid
may flow arbitrarily far from some initial position. It is more appropriate to
consider ~r as a particular point of space, and ρ(~r, t) or ~v (~r, t) or T (~r, t) as
the density or velocity or temperature of whatever material happens to be
at point ~r at the time t. This is called the spatial description.
If we wish to examine how some physical property of the material is chang-
ing with time, however, the physical processes which cause change do so on a
particular hunk of material. For example, the concentration of a radioactive
substance in a hunk of fluid might change due to its decay rate or due to its
diffusion, understandable physical processes, while the concentration at the
point ~r may change just because new fluid is at the point in question. In
describing the physical processes, we will need to consider the rate of change
for a given hunk of fluid. Thus we need the stream derivative, which involves
the difference of the property (say c) at the new position ~r 0 = ~r + ~v ∆t at
time t + ∆t and that at the old ~r, t. Thus
The forces on a fluid are different from that in a solid. The volume force
is of the same nature, the most common being F~ vol = −ρgêz dV , and the
5.4. FIELD THEORY 151
pressure piece of the stress, Pp = +p1I is also the same. Thus we can expect
part of the force of the form F~ = (−ρgêz − ∇ ~ · 1Ip)dV = dV (−ρgêz − ∇p).
~
A static fluid can not experience a shear force. So there will be no shear
component of the stress due to a deviatoric part of the strain. But there can
be stress due to the velocity of the fluid. Of course a uniformly moving fluid
will not be stressed, but if the velocity varies from point to point, stress could
be produced. Considering first derivatives, the nine components of ∂vi /∂xj
have a scalar piece ∇~ · ~v , an antisymmetric piece, and a traceless symmetric
piece, each transforming differently under rotations. Thus for an isotropic
fluid the stress may have a piece
!
∂vi ∂vj ~ · ~v 1I
Pij = −µ + − ν∇
∂xj ∂xi
in addition to the scalar, pressure, piece p1I. The coefficient µ is called the
viscosity. The piece proportional to ∇ ~ · ~v may be hard to see relative to the
pressure term, and is not usually included7
~ v , is in fact just the fractional rate of
The scalar component of ∂vi /∂xj , ∇·~
change of the volume. To see that, consider the surface S which bounds the
material in question. If a small piece of that surface is moving with velocity
~v , it is adding volume to the material at a rate ~v · dS,~ so
I Z
dV ~ ~ · ~v dV.
= ~v · dS = ∇
dt S V
7
Tietjens ([19]), following Stokes, assumes the trace of P is independent of the “velocity
of dilatation” ∇~ · ~v , which requires ν = −2µ/3. But Prandtl and Tietjens [12] drop the
~ ~
∇(∇ · ~v ) term in (5.10) entirely, equivalent to taking ν = −µ.
152 CHAPTER 5. SMALL OSCILLATIONS
Z X ∂ 2 vi X ∂ 2 vj
−
∂p dV
= +µ 2
+ (µ + ν)
V ∂xi j ∂x j j ∂x i x j
where the last equality is by Gauss’ law. This can be rewritten in vector
form: Z
~
F surf = ~ + µ∇2~v + (µ + ν)∇(
−∇p ~ ∇
~ · ~v dV
V
Adding in F~ vol = −ρgêz dV and setting this equal to ρ dV d~v /dt, we find
d~v ∂~v (~r, t) ~ v (~r, t)
= + ~v · ∇~ (5.10)
dt ∂t
1~ µ µ + ν ~ ~
= −gêz − ∇p(~ r, t) + ∇2~v (~r, t) + ∇ ∇ · ~v (~r, t) .
ρ ρ ρ
This is the Navier-Stokes equation for a viscous fluid. For an inviscid fluid,
one with a negligible viscosity (µ = ν = 0), this reduces to the simpler Euler’s
equation
∂~v (~r, t) ~ v (~r, t) = −gêz − 1 ∇p(~
~ r, t).
+ ~v · ∇~ (5.11)
∂t ρ
If we assume the fluid is inviscid and incompressible, so ρ is constant,
and also make the further simplifying assumption that we are looking at a
steady-state flow, for which ~v and p at a fixed point do not change, the partial
derivatives ∂/∂t vanish, and ∇ ~ · ~v = 0. Then Euler’s equation becomes
Exercises
5.1 Three springs connect two masses to each other and to immobile walls, as
shown. Find the normal modes and frequencies of oscillation, assuming the system
remains along the line shown.
2
5.2 Consider the motion, in a fixed vertical plane, of a double pendulum consist-
ing
of two masses attached to each other and to a fixed
point by inextensible strings of length L. The upper
mass has mass m1 and the lower mass m2 . This is all in
a laboratory with the ordinary gravitational forces near
the surface of the Earth.
5.3 (a) Show that if three mutually gravitating point masses are at the vertices
of an equilateral triangle which is rotating about an axis normal to the plane of
the triangle and through the center of mass, at a suitable angular velocity ω, this
motion satisfies the equations of motion. Thus this configuration is an equilibrium
in the rotating coordinate system. Do not assume the masses are equal.
(b) Suppose that two stars of masses M1 and M2 are rotating in circular orbits
about their common center of mass. Consider a small mass m which is approx-
imately in the equilibrium position described above (which is known as the L5
point). The mass is small enough that you can ignore its effect on the two stars.
154 CHAPTER 5. SMALL OSCILLATIONS
Analyze the motion, considering specifically the stability of the equilibrium point
as a function of the ratio of the masses of the stars.
5.4 In considering the limit of a loaded string we found that in the limit a →
0, n → ∞ with ` fixed, the modes with fixed integer p became a smooth excitation
y(x, t) with finite wavenumber k and frequency ω = ck.
Now consider the limit with q := n+1−p fixed as n → ∞. Calculate the expression
for yj in that limit. This will not have a smooth limit, but there is nonetheless a
sense in which it can be described by a finite wavelength. Explain what this is,
and give the expression for yj in terms of this wavelength.
5.5 Consider the Navier equation ignoring the volume force, and show that
a) a uniform elastic material can support longitudinal waves. At what speed do
they travel?
b) an uniform elastic material can support transverse waves. At what speed do
they travel?
c) Granite has a density of 2700 kg/m3 , a bulk modulus of 4 × 1010 N/m2 and a
shear modulus of 2.5 × 1010 N/m2 . If a short spike of transverse oscillations arrives
25 seconds after a similar burst of longitudinal oscillations, how far away was the
explosion that caused these waves?