Mathematical Tripos: at The End of The Examination
Mathematical Tripos: at The End of The Examination
PAPER 1
STATIONERY REQUIREMENTS
Gold cover sheet
Green master cover sheet
Script paper
Rough paper
SECTION I
1I Number Theory
(a) State and prove the Chinese remainder theorem.
(b) Let N be an odd positive composite integer, and b a positive integer with
(b, N ) = 1. What does it mean to say that N is a Fermat pseudoprime to base b? Show
that 35 is a Fermat pseudoprime to base b if and only if b is congruent to one of 1, 6, 29
or 34 (mod 35).
2H Topics in Analysis
P∞ Let Tn be the nth Chebychev polynomial.
P∞ Suppose that γi > 0 for all i and that
i=1 γi converges. Explain why f = i=1 γi T3i is a well defined continuous function on
[−1, 1].
P
Show that, if we take Pn = ni=1 γi T3i , we can find points xk with
[You may use the equality H(X, Y ) = H(X|Y ) + H(Y ) and the inequality H(X|Y ) 6
H(X).]
State and prove Fano’s inequality.
(c) Let L and M be CFLs. Show that the concatenation LM is also a CFL.
5J Statistical Modelling
The Gamma distribution with shape parameter α > 0 and scale parameter λ > 0
has probability density function
λα α−1 −λy
f (y; α, λ) = y e for y > 0.
Γ(α)
Give the definition of an exponential dispersion family and show that the set of Gamma
distributions forms one such family. Find the cumulant generating function and derive
the mean and variance of the Gamma distribution as a function of α and λ.
6C Mathematical Biology
An animal population has annual dynamics, breeding in the summer and hibernating
through the winter. At year t, the number of individuals alive who were born a years ago
is given by na,t . Each individual of age a gives birth to ba offspring, and after the summer
has a probability µa of dying during the winter. [You may assume that individuals do not
give birth during the year in which they are born.]
Explain carefully why the following equations, together with initial conditions, are
appropriate to describe the system:
∞
X
n0,t = na,t ba
a=1
na+1,t+1 = (1 − µa )na,t ,
∞ a−1
!
X Y
φ(γ) = (1 − µi ) γ −a ba .
a=1 i=0
Explain why, for any reasonable set of parameters µi and bi , the equation φ(γ) = 1
has a unique solution. Explain also how φ(1) can be used to determine if the population will
grow or shrink.
[Hint: You might find the change of variable x = t(2 − t2 )−1/2 helpful in part (b).]
8E Classical Dynamics
(a) A mechanical system with n degrees of freedom has the Lagrangian L(q, q̇),
where q = (q1 , . . . , qn ) are the generalized coordinates and q̇ = dq/dt.
Suppose that L is invariant under the continuous symmetry transformation q(t) 7→
Q(s, t), where s is a real parameter and Q(0, t) = q(t). State and prove Noether’s theorem
for this system.
(b) A particle of mass m moves in a conservative force field with potential energy
V (r), where r is the position vector in three-dimensional space.
Let (r, φ, z) be cylindrical polar coordinates. V (r) is said to have helical symmetry
if it is of the form
V (r) = f (r, φ − kz) ,
for some constant k. Show that a particle moving in a potential with helical symmetry
has a conserved quantity that is a linear combination of angular and linear momenta.
9B Cosmology
[You may work in units of the speed of light, so that c = 1.]
By considering a spherical distribution of matter with total mass M and radius R
and an infinitesimal mass δm located somewhere on its surface, derive the Friedmann
equation describing the evolution of the scale factor a(t) appearing in the relation
R(t) = R0 a(t)/a(t0 ) for a spatially-flat FLRW spacetime.
Consider now a spatially-flat, contracting universe filled by a single component with
energy density ρ, which evolves with time as ρ(t) = ρ0 [a(t)/a(t0 )]−4 . Solve the Friedmann
equation for a(t) with a(t0 ) = 1.
where X and Z are the standard qubit Pauli operations and x, z ∈ {0, 1}.
(a) For any 1-qubit state |αi show that the 3-qubit state |αiC |β00 iAB of system
CAB can be expressed as
1
1 X
|αiC |β00 iAB = |βxz iCA |µxz iB ,
2
x,z=0
where the 1-qubit states |µxz i are uniquely determined. Show that |µ10 i = X |αi.
(b) In addition to |µ10 i = X |αi you may now assume that |µxz i = X x Z z |αi. Alice
and Bob are separated distantly in space and share a |β00 iAB state with A and B labelling
qubits held by Alice and Bob respectively. Alice also has a qubit C in state |αi whose
identity is unknown to her. Using the results of part (a) show how she can transfer the
state of C to Bob using only local operations and classical communication, i.e. the sending
of quantum states across space is not allowed.
(c) Suppose that in part (b), while sharing the |β00 iAB state, Alice and Bob are
also unable to engage in any classical communication, i.e. they are able only to perform
local operations. Can Alice now, perhaps by a modified process, transfer the state of C
to Bob? Give a reason for your answer.
SECTION II
11G Coding and Cryptography
What does it mean to say that C is a binary linear code of length n, rank k and
minimum distance d? Let C be such a code.
(a) Prove that n > d + k − 1.
Let x = (x1 , . . . , xn ) ∈ C be a codeword with exactly d non-zero digits.
(b) Prove that puncturing C on the non-zero digits of x produces a code C ′ of length
n − d, rank k − 1 and minimum distance d′ for some d′ > ⌈ d2 ⌉.
P
(c) Deduce that n > d + 16l6k−1 ⌈ 2dl ⌉.
> table(ice_cream)
score
price excellent good poor
high 12 8 10
low 7 9 14
medium 12 11 7
>
> ice_cream.counts = as.data.frame(xtabs(Freq ~ price + score-1, data=table(ice_cream)))
> glm.fit = glm(Freq ~ price + score,data=ice_cream.counts,family="poisson")
> summary(glm.fit)
Call:
glm(formula = Freq ~ price + score - 1, family = "poisson", data = ice_cream.counts)
Deviance Residuals:
1 2 3 4 5 6 7 8 9
0.5054 -1.1019 0.5054 -0.4475 -0.1098 0.5304 -0.1043 1.0816 -1.1019
Coefficients:
Estimate Std. Error z value Pr(>|z|)
pricehigh 2.335e+00 2.334e-01 10.01 <2e-16 ***
pricelow 2.335e+00 2.334e-01 10.01 <2e-16 ***
pricemedium 2.335e+00 2.334e-01 10.01 <2e-16 ***
scoregood -1.018e-01 2.607e-01 -0.39 0.696
scorepoor 3.892e-14 2.540e-01 0.00 1.000
---
Signif. codes: 0 ’***’ 0.001 ’**’ 0.01 ’*’ 0.05 ’.’ 0.1 ’ ’ 1
(a) Write down the generalised linear model fitted by the code above.
(b) Prove that the fitted values resulting from the maximum likelihood estimator of
the coefficients in this model are identical to those resulting from the maximum likelihood
estimator when fitting a Multinomial model which assumes the number of ice creams at
each price level is fixed.
(c) Using the output above, perform a goodness-of-fit test at the 1% level, specifying
the null hypothesis, the test statistic, its asymptotic null distribution, any assumptions of
the test and the decision from your test.
(d) If we believe that better ice creams are more expensive, what could be a more
powerful test against the model fitted above and why?
z 1−c F (a − c + 1, b − c + 1, 2 − c; z).
15B Cosmology
[You may work in units of the speed of light, so that c = 1.]
Consider a spatially-flat FLRW universe with a single, canonical, homogeneous
scalar field φ(t) with a potential V (φ). Recall the Friedmann equation and the Ray-
chaudhuri equation (also known as the acceleration equation)
2
ȧ 2 8πG 1 2
=H = φ̇ + V ,
a 3 2
ä 8πG 2
=− φ̇ − V .
a 3
φ̈ + 3H φ̇ + ∂φ V = 0 .
(b) Assuming the special case V (φ) = λφ4 , find φ(t), for some initial value φ(t0 ) = φ0
in the slow-roll approximation, i.e. assuming that φ̇2 ≪ 2V and φ̈ ≪ 3H φ̇.
(c) The number N of efoldings is defined by dN = d ln a. Using the chain rule,
express dN first in terms of dt and then in terms of dφ. Write the resulting relation
between dN and dφ in terms of V and ∂φ V only, using the slow-roll approximation.
(d) Compute the number N of efoldings of expansion between some initial value
φi < 0 and a final value φf < 0 (so that φ̇ > 0 throughout).
(e) Discuss qualitatively the horizon and flatness problems in the old hot big bang
model (i.e. without inflation) and how inflation addresses them.
e = (1 1 . . . 1)T .
(b) Suppose that G is strongly regular. Show that G has at most three distinct
eigenvalues.
(c) Conversely, suppose that G has precisely three distinct eigenvalues d, λ and µ.
Let A be the adjacency matrix of G and let
B = A2 − (λ + µ)A + λµI.
(ii) Find all the intertwining homomorphisms between the irreducible RG-modules.
Deduce that the conclusion of Schur’s lemma is false if we replace C by R.
(ii) if n is odd, the regular RG-module is a direct sum of one 1-dimensional irre-
ducible submodule and (n − 1)/2 (non-isomorphic) 2-dimensional irreducible
submodules.
(d) Let X be a normed vector space such that the closed unit ball B1 (0) is compact.
Prove that X is finite dimensional.
Show that this need not be the case if we drop the hypothesis that t 7→ f (t, n) is non-
decreasing, even if all the relevant limits exist.
Determine
(i) the irreducible components of V ,
(iii) for each irreducible component, the smooth points of that component, and
(i) Show that there exists a continuous function f : [0, +∞) → R such that
[ You may use the fact that for every two vectors u, v ∈ Rd such that
hu, ui = hv, vi there is an orthogonal matrix A such that Au = v. ]
(iii) Deduce that f takes values in (0, 1], and furthermore that there exists α > 0
such that f (r) = e−rα , for all r > 0.
[Standard properties of characteristic functions from the course may be used without
proof if clearly stated.]
Y = Xθ0 + ε
for an unknown θ0 ∈ Rp and ε random such that ε ∼ N (0, σ 2 In ) for some known σ 2 > 0.
(a) When p 6 n and X has rank p, compute the maximum likelihood estimator
θ̂M LE for θ0 . When p > n, what issue is there with the likelihood maximisation approach
and how many maximisers of the likelihood are there (if any)?
(b) For any λ > 0 fixed, we consider θ̂λ minimising
kY − Xθk22 + λkθk22
over Rp . Derive an expression for θ̂λ and show it is well defined, i.e., there is a unique
minimiser for every X, Y and λ.
Assume p 6 n and that X has rank p. Let Σ = X ⊤ X and note that Σ = V ΛV ⊤
for some orthogonal matrix V and some diagonal matrix Λ whose diagonal entries satisfy
Λ1,1 > Λ2,2 > . . . > Λp,p . Assume that the columns of X have mean zero.
(c) Denote the columns of U = XV by u1 , . . . , up . Show that they are sample
principal components, i.e., that their pairwise sample correlations are zero and that they
have sample variances n−1 Λ1,1 , . . . , n−1 Λp,p , respectively. [Hint: the sample covariance
between ui and uj is n−1 u⊤i uj .]
(i) M is a martingale.
(ii) For every stopping time τ , the stopped process M τ defined by Mnτ := Mn∧τ ,
n > 0, is a martingale.
(iii) E[Mn∧τ ] = E[M0 ] for all n > 0 and every stopping time τ .
[Hint: To show that (iii) implies (i) you might find it useful to consider the stopping time
(
n if ω ∈ A,
T (ω) :=
n + 1 if ω 6∈ A,
for any A ∈ Fn .]
ẋ = x2 − 1 ,
ẏ = kxy ,
where x = (x, y) ∈ R2 and k is a real constant. Answer the following for all values of k,
taking care over boundary cases (both in k and in x).
(v) For x0 = (0, y0 ), give the orbit of x0 (considering all y0 ∈ R). You should give
your answer in the form y = y(x, y0 , k), and specify the range of x.
Let M̃ = R2m = {(q̃, p̃)|q̃, p̃ ∈ Rm } be another phase space, equipped with its
standard Poisson bracket. Suppose that H̃ = H̃(q̃, p̃) is a Hamiltonian function for M̃ .
Define Q = (q1 , . . . , qn , q̃1 , . . . , q̃m ), P = (p1 , . . . , pn , p̃1 , . . . , p̃m ) and let the combined
phase space M = R2(n+m) = {(Q, P)} be equipped with the standard Poisson bracket.
(c) Show that if (M, H) and (M̃ , H̃) are both integrable, then so is (M, H), where
the combined Hamiltonian is given by:
(d) Consider the n−dimensional simple harmonic oscillator with phase space M and
Hamiltonian H given by:
1 1 1 1
H = p21 + . . . + p2n + ω12 q12 + . . . + ωn2 qn2 ,
2 2 2 2
where ωi > 0. Using the results above, or otherwise, show that (M, H) is integrable for
(q, p) 6= 0.
(e) Is it true that every bounded orbit of an integrable system is necessarily periodic?
You should justify your answer.
where α, β are constants. A theoretical calculation of the entropy S for T > Tc leads to
S = β log T + γ.
How can the value of the theoretically-obtained constant γ be verified using macroscopi-
cally measurable quantities?
36E Electrodynamics
A relativistic particle of charge q and mass m moves in a background electromagnetic
field. The four-velocity uµ (τ ) of the particle at proper time τ is determined by the equation
of motion,
duµ
m = qF µν uν .
dτ
Here F µν = ηνρ F µρ , where Fµν is the electromagnetic field strength tensor and Lorentz
indices are raised and lowered with the metric tensor η = diag{−1, +1, +1, +1}. In the
case of a constant, homogeneous field, write down the solution of this equation giving
uµ (τ ) in terms of its initial value uµ (0) .
[In the following you may use the relation, given below, between the components of
the field strength tensor Fµν , for µ, ν = 0, 1, 2, 3, and those of the electric and magnetic
fields E = (E1 , E2 , E3 ) and B = (B1 , B2 , B3 ),
1
Fi0 = −F0i = Ei , Fij = εijk Bk
c
for i, j = 1, 2, 3.]
Suppose that, in some inertial frame with spacetime coordinates x = (x, y, z) and
t, the electric and magnetic fields are parallel to the x-axis with magnitudes E and B
respectively. At time t = τ = 0 the 3-velocity v = dx/dt of the particle has initial value
v(0) = (0, v0 , 0). Find the subsequent trajectory of the particle in this frame, giving
coordinates x, y, z and t as functions of the proper time τ .
Find the motion in the x-direction explicitly, giving x as a function of coordinate
time t. Comment on the form of the solution at early and late times. Show that, when
projected onto the y-z plane, the particle undergoes circular motion which is periodic in
proper time. Find the radius R of the circle and proper time period of the motion ∆τ in
terms of q, m, E, B and v0 . The resulting trajectory therefore has the form of a helix
with varying pitch Pn := ∆xn /R where ∆xn is the distance in the x-direction travelled by
the particle during the n’th period of its motion in the y-z plane. Show that, for n ≫ 1,
2πEn
Pn ∼ A exp ,
cB
The contracted Bianchi identities ensure that the Einstein tensor satisfies
∇µ Gµν = 0 .
∇α Kβ + ∇β Kα = 0 .
∇ν ∇µ K α = Rα µνβ K β ,
∇µ ∇µ K α = −Rα β K β ,
(a) Write down the relevant components of the Navier-Stokes equations. By esti-
mating the size of the individual terms, simplify these equations when ε := h/R ≪ 1 and
Re := ρV h/µ ≪ 1.
(b) Explain briefly why it is reasonable to expect that the vertical velocity of the
air below the disc is a function of distance above the air table alone, and thus find the
steady pressure distribution below the disc. Hence show that
3πµV R
W = .
2ε3
39A Waves
The equation of state relating pressure p to density ρ for a perfect gas is given by
γ
p ρ
= ,
p0 ρ0
where p0 and ρ0 are constants, and γ > 1 is the specific heat ratio.
(a) Starting from the equations for one-dimensional unsteady flow of a perfect gas
of uniform entropy, show that the Riemann invariants,
2
R± = u ± (c − c0 )
γ−1
are constant on characteristics C± given by
dx
= u ± c,
dt
where u(x, t) is the velocity of the gas, c(x, t) is the local speed of sound, and c0 is a
constant.
(b) Such an ideal gas initially occupies the region x > 0 to the right of a piston in
an infinitely long tube. The gas and the piston are initially at rest. At time t = 0 the
piston starts moving to the left with path given by
(i) Solve for u(x, t) and ρ(x, t) in the region x > Xp (t) under the assumptions that
2c0
− γ−1 < Ẋp < 0 and that |Ẋp | is monotonically increasing, where dot indicates
a time derivative.
[It is sufficient to leave the solution in implicit form, i.e. for given x, t you
should not attempt to solve the C+ characteristic equation explicitly.]
(ii) Briefly outline the behaviour of u and ρ for times t > tc , where tc is the solution
2c0
to Ẋp (tc ) = − γ−1 .
END OF PAPER