Lecture Notes QFT Temp 13
Lecture Notes QFT Temp 13
Umut Gürsoy
1
2 CONTENTS
4 Interactions in QFT 42
6.2 Counterterms . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 67
8 Spinors 83
8.3 Chirality . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 86
Content: We will follow these notes for a first introduction to QFT. Our plan
will be to cover the following topics:
• QFT basics (Clash b/w QM and SR)
• Canonical Quantization
• Spinors
• Vector fields
• Path integrals
• Correlation functions
• Scattering
Reading material: In addition to my own collection over the years, these notes
are inspired mainly by two QFT textbooks by
• Srednicki, M.
• Schwartz, M
There are other excellent material which you can benefit from:
• Peskin, Schröder
• A. Zee
• Weinberg
5
6 CONTENTS
• D. Tong’s lectures
In general it is a good idea to use multiple sources and compare different ap-
proaches in studying an advanced subject like QFT. There are various different
but equivalent ways to approach an idea in physics. For example you can study
QM using wavefunctions, operators, path integrals etc. and a concept such as
uncertainty in QM has different manifestations in different approaches. It is
essential to know all for a full grasp of the subject. Even though the devel-
opment of QFT from early last century on has always been inspired by high
energy experiments, here I do not cover much experimental material. For these
you may want to follow Particle Physics I and II in the experimental physics
master’s program.
I try to be concise in these notes as we have to move quickly cover this vast
subject in a total of 20 hours. Therefore, I include a paragraph at the end of
each chapter with references for more detailed reading.
Chapter 1
1 See Landau & Lifshitz and A. Zee’s books for a detailed account.
7
8 CHAPTER 1. NEED FOR QFT
(i) State of the system at time t is represented by a vector in the Hilbert space
|ψ, ti ∈ H.
(ii) Observables are described by Hermitian operators Ô .
(iii) Measurement of an observable yields one of the (real) eigenvalues of the
operator Ô.
(iv) Time evolution of a state |ψ, ti is governed by the Schrödinger equation:
x0 = −x0 , xi = xi .
1.2. SPECIAL RELATIVITY 9
More generally, we define the metric tensor to raise and lower indices:
xµ = ηµν xν , xµ = η µν xν (1.3)
where we employ the Einstein’s summation convention where repeated indices
are summed. From this equation you can infer that the metric with the upper
indices is inverse of the one with lower indices:
ηµν η νβ = δµβ → η µν = η −1 µν . (1.4)
p~ˆ2
Ĥ = , p~ˆ = −i~∇ .
2m
then the position space Schrödinger equation can be written as
~2 2
i~∂t ψ(~x, t) = − ∇ ψ(~x, t)
2m
where we define the position wavefunction as ψ(~x, t) = h~x|ψ, ti. This equation
is obviously not invariant under Lorentz transformations because there are two
space derivatives and only one time derivative. A Lorentz transformation would
mix space and time and necessitates treatment of time and space on equal
footing.
Well, you may say this is what you should expect because you considered a
non-relativistic Hamiltonian. Then, let us try a special relativistic Hamiltonian,
again for a free particle:
p p~2
H= p~2 c2 + m2 c4 ' mc2 + + ...
2m
which contains the correct physics in the non-relativistic limit. Then, we have
the equation in position space as:
p
i~∂t ψ(~x, t) = −~2 c2 ∇2 + m2 c4 ψ(~x, t) (1.10)
= mc ψ(~x, t) + O(∇2 ) ,
which can be Taylor expanded for a wavefunction varying over space slower than
the scale set by 1/m.
Now, let us square the Schrodinger equation to circumvent (ii) (at least):
−~2 ∂t2 ψ(~x, t) = (−~2 c2 ∇2 + m2 c4 )ψ(~x, t) . (1.11)
1.3. FREE PARTICLE AS AN EXAMPLE 11
This is called the Klein-Gordon equation. We can easily see that it is Lorentz
invariant by changing the frame of reference by xµ → x̄µ = Λµ ν xν . The deriva-
tives ∂µ transform as ∂ µ → ∂¯µ = Λµ ν ∂ ν . Then using (1.7) ∂ 2 = ∂¯2 and the
Klein-Gordon equation remain the same if we identify
A field that transforms with this rule is called a scalar field. Note that this
transformation is trivial in the sense that the value of the field in any given
location remains the same. So equation (1.12) indeed seems to solve our problem
of finding a Lorentz invariant equation of motion.
It is not at all clear, however, whether the field ψ(x), when regarded as
a quantum mechanical wave-function ψ(x) = hx|ψi evolves unitarily in time.
Not clear because the Klein-Gordon equation, containing two time derivatives,
is certainly not of the Schrodinger form i~∂t |ψi = H |ψi which guarantees
unitary evolution for any hermitean H as the solution reads
i
|ψ(t0 )i = U (t0 − t) |ψ(t)i , U (t) ≡ e− ~ Ht . (1.14)
Thus, we still seem to find a clash between Lorentz invariance and axiom (iv)
of QM reviewed above. Inspecting (1.11), you see that a promising solution
to this problem would be to somehow find a Hermitean differential operator
O, different than the Hamiltonian with the square-root in (1.10), that satisfies
O2 = −~2 ∇2 + m2 c4 so that a solution to i~∂t ψ = Oψ would also solve (1.10).
This would be both Lorentz invariant and unitary by construction. No such
O exists, as it should involve a ∇ not contracted with another vector which
results in LHS being a scalar but RHS being a vector. A more sophisticated
thing to do would be to write O = ai ∂i + · · · and impose the coefficients ai
satisfy ai aj = δij and so on. Of course no such collection of ordinary numbers
exist, but a collection of matrices does. This is what we discuss next.
The problem of constructing such a first order in time, yet unitary, equation
was first addressed successfully by Dirac for the spin 1/2 particles (spinors).
Spinors can be in two distinct quantum states ψ1 = |↑i and ψ2 = |↓i. This allows
the hamiltonian carry an additional spinor index Hab such that the Schrödinger
equation s to i~∂t |ψa , ti = Hab |ψb , ti. Therefore H is now a matrix and could
solve the problem above. The most general Shrödinger equation first order in
12 CHAPTER 1. NEED FOR QFT
the derivatives and all vector indices contracted (to assure rotational invariance)
is then of the form (written in the position basis)
i~∂t ψa (~x, t) = −i~c(αj )ab ∂j + mc2 (β)ab ψb (~x, t) ,
where αi i = 1, 2, 3 and β are matrices with spinor indices. αi are much like
the Pauli matrices σ i but, as we see below, one should allow for a more general
possibility. The Hamiltonian written in a basis independent way is
Hab = cPj αj ab + mc2 (β)ab , (1.15)
The solution is
Now the equation in the position basis can be written succinctly as,
i~γ µ ∂µ − mc2 ψ(~x, t) = 0 , (1.18)
where we suppress the spin indices a for simplicity. This is called the Dirac
equation. It describes propagation of a particle with two spin states, called a
spin-1/2 particle.
In exercise 2 you will also show that the gamma matrices are traceless.
Therefore Hab is a 4×4 matrix with the eigenvalues {E↑ (p), E↓ (p), −E↑ (p), −E↓ (p)}.
This means that along with the desired energy eigenstates for the up and down
spins we get two more negative energy eigenvalues. This leads to instability of
the system as follows. If you now couple the system to external medium, that
is to say, if the Dirac particles can interact with the surroundings e.g. with
electromagnetic waves, then they can lose energy indefinitely.
Dirac sea: To solve this issue Dirac supposed that all the negative eigen-
states are filled. Pauli exclusion principle allows this assumption because, as we
2 This is necessary but not sufficient for Lorentz invariance. We will see later when we
study the representations of Lorentz algebra, that indeed the equation before squaring it is
already Lorentz invariant.
1.4. FUNDAMENTAL CLASH BETWEEN QM AND SR 13
will see later, spin-1/2 particles are necessarily fermions and as Pauli showed
a state of a fermion can be occupied only once. Dirac argues that we do not
observe the Dirac sea, as we only observe the difference in energy in an experi-
ment. As the Dirac sea is always there, before and after experiment, we cannot
observe it. But, it has the following consequence.
If we send in a strong photon, then we can create a hole in the Dirac sea,
as some particles inside the sea will be excited. So, Dirac postulated that for
every fermion with charge e there should be another fermion with charge −e.
For every electron there should be a positron. Dirac’s prediction of the positron
in 1927 was confirmed experimentally in 1932 leading to his Nobel prize.
The easiest way to see the clash between QM and SR mathematically, and
the easiest explanation, thereof, for the need for fields, is to recall the second
axiom of QM: Observables are represented by Hermitian operators: ~x, p~ etc.
However, there is no such operator for the time eigenvalue t which is only treated
as a label in the wave-function in QM. Thus, in QM, time (a label) and space (an
operator) is inherently separate and they transform differently under Lorentz
transformatoins making the entire formulation unsuitable.
Let us start with the first and consider time in quantum mechanics also as
an eigenvalue of an operator. Now all space and time are treated democratically
and one can introduce a space-time basis: h~x, t|ψi = ψ(t, ~x). But then how do
we characterize the evolution in time, if time is a basis vector. The answer
14 CHAPTER 1. NEED FOR QFT
t t
τ τ
x y
x y σ
Material for further reading: You can read in more detail about the notes
until here in Srednicki, part I sections 1 and 2, albeit presented in a different
order. I also recommend very much the introductory sections of A. Zee’s QFT
book discussing the motivation behind introducing quantum fields.
Chapter 2
In this course we will instead focus on the second method above, that is, we
will demote the position ~x from an operator (or eigenvalue of an operator) to a
label of the quantum state of the system. This second method is literally the
quantum field theory where we demote the position ~x to a label. Hence both
position and the time become merely labels of the quantum state of the system:
It will be more useful for us to work in the Heisenberg picture where the opera-
tors become time dependent instead of the states. We then define the quantum
field operator in space-time as ψ̂(~x, t) and its time evolution is given by
I stress that the space dependence, either in (2.1) or in (2.2) is not the same as
the space dependence of the wave function a single particle in the position basis.
Here the quantum state of the system depends on the position irrespective of
the basis it is evaluated in. Equivalently the quantum operators themselves
depends on the position rather than their expectation value as in the single
particle case: h~x| Ô |~xi = O(~x) where the RHS is a function, not an operator.
In quantum field theory we have Ô(x) as an operator instead. In other words,
the Hilbert space of the system is extended infinitely many times; it is now the
infinite tensor product of the single particle Hilbert space at every space point
~x. This point will become more clear in the example below.
In fact, this is not the first time you encounter the use of fields in quantum
mechanics. Non-relativistic quantum mechanics of N identical particles also
15
16CHAPTER 2. QUANTUM FIELDS AND CANONICAL QUANTIZATION
leads to a quantum field, and this formulation of many body quantum mechanics
is called the second quantization.
The Schrödinger equation in the position basis for N particles with equal
mass, moving in potential U (~x) and with interparticle potential V (~x − ~y ) reads,
X N 2
X N XN
~
i~∂t ψ = − ∇2j + U (~xj ) + V (~xj − ~xk ) ψ
j=1
2m j=1 k=1,j6=k
where the wave function depends on particle positions and time ψ = ψ(~x1 , ..., ~xN , t).
We can write down an abstract Schrödinger equation, cf. eq. (1.1) by defining
creation and annihilation operators at every space point ~x. We introduce an
harmonic oscillator at every ~x: a(~x) annihilates a particle at position ~x, whereas
a† (~x) creates a particle at this position. These creation and annihilation oper-
ators are called quantum fields. Then the commutation relations between the
quantum fields follow from generalisation of the single harmonic oscillator to a
field of harmonic oscillators:
Using these creation and annihilation operators, the Hamiltonian can be written
as
Z
~2 2
H = d3 xa† (~x) − ∇ + U (~x) a(~x) (2.4)
2m
Z
1
+ d3 x d3 yV (x − y)a† (x)a† (y)a(x)a(y) (2.5)
2
Note that the particle number N only enters in the state of system, eq. (2.6),
neither in the Hamiltonian (2.4) nor in the commutation relations (2.3b). This
means that this formalism is capable of describing any number of states — the
only thing you need to change is the number of creation operators (and the
number of integrals) in (2.6). Obviously the formalism can also be used when
the number N is not fixed but allowed to change in a process. We learn that the
use of quantum fields potentially solves the main problem in combining special
relativity with quantum mechanics, that I alluded to in the first page of chapter
2, namely the possibility to create many particles in sufficiently short increments
of time.
The Fourier transform of the quantum fields a(x) and a† (x) gives the annihila-
tion and creation operators in the momentum space:
Z
d3 x −i~p·~x
ã(~
p) = e a(~x) , (2.7)
(2π)3/2
similarly for a† (x). Then the hamiltonian above can be written in the momen-
tum space as
Z
p|2 †
|~
H = d3 p ã (~
p)ã(~
p) . (2.8)
2m
which is nothing but the operator that measures the total energy in the sys-
tem. To obtain
p a relativistic Hamiltonian, we can take the energy as relativistic
p|) = |~
E(|~ p|2 c2 + m2 c4 ).
In particular, the state with no particles is called the vacuum state and
denoted by |0i. It is defined as
p) |0i = 0,
ã(~ ∀~
p
Other states in the Hilbert space are obtained from the vacuum by acting with
creation operators:
ㆠ(~
p) |0i : one particle state
† †
ã (~ p2 ) |0i :
p1 )ã (~ two particle state ,
etc.
In passing we note that one can infer the statistics of the particle, whether
it is a fermion or a boson from the commutation relations. Commutators
a† (x)a† (x0 ) = a† (x0 )a† (x) result in Bose-Einstein statistics as they require
a symmetric wave-function in (2.6) whereas anti-commutators a† (x)a† (x0 ) =
−a† (x0 )a† (x)) lead to Fermi statistics.
Also, from now on I will be using the natural units in relativistic quantum
fields by setting ~ = c = 1.
from here on I will be denoting the scalar field by φ(x). As discussed above it
transforms trivially under Lorentz transformations: φ̄(x̄) = φ(x) where x̄ = Λx
is the transformed frame. In the absence of interactions the relativistic scalar
field obeys the Klein-Gordon equation (1.12) which we reproduce here:
−∂ 2 + m2 φ(x) = 0 . (2.9)
So far there is nothing quantum about this equation. It just describes propa-
gation of a classical scalar field. One strategy to obtain a quantum relativistic
scalar field is to promote this classical field to a quantum field φ(x) → φ̂(x).
But how do we do this?
As in classical mechanics the lagrangian depends on the field and its deriva-
tivesIn addition, we need a theory that preserves Lorentz transformations, thus
the dependence on the derivatives should be in the relativistic form ∂µ φ(x).
We can now use the facts i) it is a scalar, and ii) its variation should lead
to (2.9) to write down the most general langangian density as follows:
1 1
LKG (x) = − ∂µ φ∂ µ φ − m2 φ2 + Ω0 , (2.12)
2 2
2.1. SCALAR FIELD AS A PROTOTYPE 19
The first total derivative term gives no contribution as we require the fields
and its derivatives go to zero sufficiently facts as |x| → ∞. The second term
then gives us the Klein-Gordon equation, since it should vanish for an arbitrary
variation δφ(x).
A specific case is a real scalar field which means that φ(x) ∈ R for all x. This
is what we will assume in the rest of this chapter. The more general, complex
scalar field case will be discussed in the exercises. Demanding φ(x) real, we find
that b∗ (−~k) = a(~k) and f (~k) ∈ R. This yields
Z
d3 k ~ i~k·~x−iwt ~
φ(x) = a(k)e + a∗ (~k)e−ik·~x+iwt , (2.14)
f (|~k|)
after a simple change of variables. As mentioned above we determine f (|~k|)
by requiring that the integral measure in (2.14) is Lorentz invariant. We will
starting from a measure that we already know to be Lorentz invariant:
kµ →k̄µ
d4 k = dk 0 d3 k −−−−−→ dk̄ 0 d3 k̄ = |detΛ| dk 0 d3 k = dk 0 d3 k,
20CHAPTER 2. QUANTUM FIELDS AND CANONICAL QUANTIZATION
˜ = d3 k
dk , (2.15)
(2π)3 2w
as the Lorentz invariant integral measure. The resulting scalar field becomes:
Z
φ(x) = dk ˜ a(~k)ei~k·~x−iwt + a∗ (~k)e−i~k·~x+iwt
Z
= dk ˜ a(~k)eik·x + a∗ (~k)e−ik·x . (2.16)
Having found the lagrangian, we now obtain the hamiltonian for the classical
scalar field via the Legendre transformation. Recall that in classical mechanics
the Legendre transform from the Lagrangian L(qi , q̇i ) of a collection
P of degree
of freedom labelled by i to the hamiltonian is H(qi , pi ) = i pi q̇i − L(qi , q̇i ).
The generalised momenta are defined as pi = δL/δ q̇i . In classical field theory,
these notions are immediately generalised to fields1 :
Using (2.12) we find the canonical momentum for the Klein-Gordon field as
Π(x) = φ̇(x). Then the hamiltonian, that is the integral of the hamiltonian
1 You should think of discretising space by dividing it into little boxes and labelling these
boxes by i.
2.2. CANONICAL QUANTIZATION 21
to commutation relations2 :
Note that they are equal time commutators. That is, once they are defined at
a given time, say t = 0, their form do not change in any later time t. This is
obvious from the time evolution q̂(t) = exp(iHt)q̂(0) exp(−iHt), etc.
Easiest example is the real scalar field we discussed above. The canonical
position is given by the field φ(x) itself, see eq. (2.16). To promote this to
a quantum operator we need to promote the coefficients to operators acting
on a Hilbert space: a(~k) → â(~k) and a∗ (k) → a† (~k). These are precisely the
creation/annihilation operators defined in section 2.0.1, they destroy and create
a particle of momentum ~k out of the vacuum state. So the generalised position
is the quantum scalar field:
Z
φ̂(x) = dk ˜ â(~k)eik·x + ↠(~k)e−ik·x . (2.21)
Then one imposes the equal-time canonical commutation relations that gener-
alise (2.20) to fields3 :
Note that if we had a spin 1/2 system, commutators would become anticommu-
tators when we apply the canonical quantization {a(~k), a† (~k 0 )} = 2w(2π)3 δ 3 (~k−
~k 0 ).
we find Z
φ(x) |0i = ˜ −ik·x |ki .
dke (2.25)
where we used the commutation relations (2.23). This shows that indeed φ(x) |0i
represents position on the Fock space of QFT. We conclude that φ(x) acting on
the vacuum state creates a particle at the space-time point x. Since its position
is fixed, its momentum is arbitrary.
3 From now on I will drop the hats on the fields as it will be clear from the context whether
is the energy density of the vacuum. This term arises from using the commuta-
tion relations (2.23)
q in passing from (2.18) to (2.27). Recalling the dispersion
~
relation ω(k) = |~k|2 + m2 , we see that 0 is just the sum over the ground
states energy of harmonic oscillators. The system describes a collection of har-
monic oscillators of every ~k at every space point. Translation invariance then
gives rise to the volume factor in (2.27).
Note that the additive constant in (2.27) depends on the order as and a∗ s we
choose in (2.18) before quantization. This is called the ordering ambiguity and
it shows that the passage from classical to quantum mechanics is not unique.
However, this ambiguity does not show up in energy differences which is what
we typically measure e.g. the energy of an excited state with respect to the
vacuum energy4 . To fix the ordering ambiguity we will use the extra constant
Ω0 and set the ground state energy of the system to zero by choosing Ω0 = 0 .
Then the Hamiltonian becomes:
Z
H = dk ˜ ω(~k) a† (~k)a(~k). (2.29)
that is precisely the total energy of a free relativistic system. Compare this
with the non-relativistic counterpart (2.8). This is the answer we sought in the
beginning of this chapter: the relativistic Klein-Gordon field upon quantization
indeed describes a collection of relativistic free bosons. Furthermore, not only
the theory is Lorentz invariant but also it describes unitary evolution given by
the Hamiltonian (2.31). The issues associated with a relativistic Schrodinger
equation of a single particle that we discussed below equation (1.10) are all
resolved by enlarging the Hilbert space from a single particle to a field.
Let’s pause for a moment and discuss in more detail how the QFT solved
for us the problem of negative energy eigenstates of a relativistic quantum-
mechanical hamiltonian. If we were to interpret the modes in (2.21) as quantum-
mechanical wave-functions, we would again run into trouble with the negative
energy modes, but now we instead have “positive and negative frequency modes”
whose coefficients are creation and annihilation operators. This is essentially
4 It is important however then quantum fields are coupled to gravity, as the gravitational
force does depend on the energy of the fields they couple to.
24CHAPTER 2. QUANTUM FIELDS AND CANONICAL QUANTIZATION
saying that the would-be negative energy eigenstates are interpreted in QFT as
the absence of positive energy eigenstates. Think of holes in the Dirac see for
an analogy in condensed matter systems. Another way to see this is to compute
the commutator of the hamiltonian in (2.29) with the annihilation and creation
operators a, a† . One finds,
So QFT associates frequencies with the wrong sign with annihilation operators.
This extra minus sign is not coming from having negative energies but having
an annihilation operator. We will see later that this is not only a mathematical
trick to hide unwanted minus signs but also has observable consequences. In
particular when we assign an electric charge to particles, the terms with a† and
a in (2.21) will be associated with opposite charged particles. Thus given a type
of particle with a given mass and spin, QFT predicts existence of particles with
same mass and spin but with opposite electric charge. In this simple case of
real scalar field the particle is its own antiparticle. It is important to underline
this fact: when we act on the vacuum with the operator φ̂(x) we annihilate an
infinite collection of particles with all possible momenta. But this should not be
allowed in a theory that conserves charge unless one also creates a particle with
the same charge corresponding to each particle that is annihilated with specific
momentum, or alternatively, one also annihilates an anti-particle with charge
opposite to each particle that is annihilated with specific momentum.
Chapter 3
We have discussed the following two important points in the previous chap-
ters:
1. The need to pass from single particle to field to retain both Lorentz in-
variance and unitarity.
2. The method of canonical quantization of a field
In this chapter we introduce another basic tool in QFT, namely its description in
terms of path integrals. This is completely equivalent to the canonical methods,
yet has a great advantage over the former which will become clear when we
discuss interactions in the next chapter. Below, we will first introduce the
concept of path integrals in quantum mechanics, then generalize this to fields.
P2
H(P, Q) = + V (Q) , (3.1)
2m
where P and Q are the momentum and position operators respectively: P |pi =
p |pi, Q |qi = q |qi. A basic object we want to know is the probability amplitude
for this particle, a.k.a the propagator, to travel from point qi at time ti to qf at
time tf :
hqf , tf |qi , ti i = hqf | e−iH(tf −ti ) |qi i . (3.2)
Now divide the time interval T = tf − ti into N + 1 equal length pieces δt =
T /(N +1). In the end we will take the limit δt → 0, N → ∞ with T = (N +1)δt
25
26 CHAPTER 3. PATH INTEGRAL QUANTIZATION
We have
δt 2 2
e−iHδt = e−i 2m P e−iδtV (Q) eO(δt ) .
We can ignore the O(δt2 ) terms in the δt → 0 limit. Then we can evaluate this
piece by inserting a complete set of momentum eigenstates in between the two
exponentials:
Z ∞
δt 2
hq2 | e−iHδt |q1 i = dp1 hq2 | e−i 2m P |p1 i hp1 | e−iδtV (Q) |q1 i
−∞
Z ∞
dp1 −i δt p21 −iδtV (q1 ) ip1 (q2 −q1 )
= e 2m e e
−∞ 2π
Z ∞
dp1 −iH(p1 ,q1 )δt ip1 (q2 −q1 )
= e e
−∞ 2π
√
where we used hq|pi = exp(ipq)/ 2π. Gathering all, we have,
Z ∞ N
Y YN
dpj ipj (qj+1 −qj ) −iH(pj ,qj )δt
hqf , tf |qi , ti i = dqj e e (3.4)
−∞ j=1 j=0
2π
where the proportionality factor will be fixed in the exercise. It can be rigorously
proven that this limit exists and results in a smooth integral over paths between
two points in the case of a single variable e.g. q(t). In the next section we will
generalise this to a path integral over fields, which can also be proven to exist for
many QFTs (certainly for the theories we consider in these lectures). For more
complicated QFTs such as gauge theories e.g. the theory of strong interactions,
3.1. PATH INTEGRALS IN QUANTUM MECHANICS 27
QCD, validity of the path integral description is not doubted but this is not yet
rigorously proven.
Some comments:
Equation (3.6) is our first path integral formula. We will now derive a simpler
expression by performing the p-path integral in the particular case when H is
at most quadratic in p. To do this we go back to the discrete expression (3.4)
and we perform each of the pj integrals using Gaussian integration. Denote the
exponent by F (p) = f2 p2 + f1 p + f0 and rewrite it as F (p) = f2 (p − p∗ )2 + F (p∗ )
where p∗ is the saddle point F 0 (p∗ ) = 0. Then the result of each p integral is
Z ∞
dp iF (p) 1
e =p eiF (p∗ ) .
−∞ 2π −2iπF 00 (p∗ )
We will be interested in the special case where the coefficient f2 = F 00 (p∗ )/2 is
independent of q just like in the case of non-relativistic QM where f2 = 1/2m.
In this case the multiplicative factor is just a constant and it will contribute
to the definition of the q path integral. We are therefore only interested in the
exponential, which is given by p∗ q̇ − H(p∗ , q) in the δt → 0 limit, where p∗ is
determined from the equation
∂ ∂
(pq̇ − H(p, q)) =0 ⇒ q̇ = H(p∗ , q) .
∂p p=p∗ ∂p
This is precisely the Legendre transformation of the Hamiltonian, which means
that the exponential is precisely the Lagrangian of the theory L(qj , q̇j ). We
therefore arrive at our second expression for the path integral representation
which involves a single path integral over q:
Z q(tf )=qf R tf
hqf , tf |qi , ti i = Dq(t) ei ti dt L(q,q̇) . (3.7)
q(ti )=qi
Figure 3.1: Definition of the path integral for a quantum mechanical particle
between initial position qi and final position qf and initial and final times ti and
tf .
ψ(q, t) = hq, t|ψi = hq|ψ, ti = hq| e−iHt |ψi ⇒ hq, t| = hq| e−iHt
hence
|q, ti = e+iHt |qi . (3.8)
Then we have
This is now precisely the same form from which we derived the path integral
description. We can use the same trick to divide the intervals t1 − ti and tf − t1
into infinitesimal steps, inserting position and momentum eigenstates etc. This
leads to
Z q(tf )=qf R tf
hqf , tf | Q(t1 ) |qi , ti i = Dq(t) q(t1 ) ei ti dt L(q,q̇) . (3.9)
q(ti )=qi
3.1. PATH INTEGRALS IN QUANTUM MECHANICS 29
Note that the operator is replaced by its eigenvalue in the path integral. Obvi-
ously this can be immediately d to an arbitrary operator
Z q(tf )=qf R tf
hqf , tf | F [Q(t1 ), P (t1 )] |qi , ti i = Dq(t) F [q(t1 ), p(t1 )] ei ti dt L(q,q̇)
,
q(ti )=qi
(3.10)
following the same steps that lead to expression (3.6).
Now consider the situation where two operators inserted at different times
hqf , tf | Q(t1 )Q(t2 ) |qi , tt i. Since the path integral formalism is automatically
ordered in time, this expression can be represented in the path integral formalism
only for t1 > t2 . Introducing the time ordering symbol
A(t1 )B(t2 ) t1 > t2
T A(t1 )B(t2 ) = , (3.11)
B(t2 )A(t1 ) t2 > t1
we find that the path integral automatically yields the time-ordered two-point
or higher point functions:
Z q(tf )=qf R tf
hqf , tf | T Q(t1 )Q(t2 ) |qi , ti i = Dq(t) q(t1 )q(t2 ) ei ti dt L(q,q̇)
. (3.12)
q(ti )=qi
Time ordered correlation functions measure how two or more points in time
are correlated with each other. For example how a measurement at time t1 affects
another measurement at t2 etc. They constitute the basic observables both in
quantum mechanics and in quantum field theory. As we have discussed above the
2-point correlators describe the probability amplitude of propagation from one
point in time to another. This idea can easily be d to n-point correlators. As we
discuss later in the course, the basic observables in the high energy experiments,
the scattering amplitudes are determined by these correlation functions.
This is just a generalization of the ordinary derivation δji /δjj = δij to contin-
uous variables. Now we modify the Hamiltonian by adding the source terms:
This quantity can be obtained directly from the path integral by employing the
following trick. Suppose that the state at initial time is some generic state |ψi i:
Z
|ψi , ti i = dqi ψi (qi ) |qi , ti i .
where En denote the energy eigenvalues, we used (3.8) and assumed a discrete
energy spectrum for simplicity. Now, instead of taking the initial time to −∞
3.1. PATH INTEGRALS IN QUANTUM MECHANICS 31
where > 0 and infinitesimal. We managed to single out and project onto the
vacuum state because the energy of the vacuum state is defined to be 0 and all
the excited states have positive energies. We then find,
Z
lim |ψi , ti i = dqi ψi (qi )ψ0∗ (qi ) |0i = ci |0i ,
ti →−∞(1−i)
where cf = h0|ψf i. Now the limits ti → −∞(1 − i) and tf → +∞(1 − i) in
the path integral can be effectuated by replacing the time integral on the real
axis in the action in (3.6) or (3.7) by a contour C that is slightly tilted toward
the lower half plane, see figure 3.2. All in all we arrived at the result1
Z R
h0|0ij = (ci c∗f )−1 Dq(t) ei C dt (L+jq) , (3.19)
You may be confused that the LHS seems to depend on the choice of the initial
and the final states in the path integral but there is no inconcistency. There is
also a hidden multiplicative dependence coming from the boundary conditions
on the path integral. In particular for the choice2 which ψi and ψf are the
vacuum state, all the multiplicative factors drop out. Substituting this relation
in equation (3.19) we finally obtain
Z
Z0 [J] R
h0|0ij = , Z0 [J] ≡ Dq(t) ei C dt (L+jq) . (3.20)
Z0 [0]
Here the subscript 0 denotes a non-interacting theory i.e. with an Hamiltonian
that involves only terms up to and including quadratic order in the canonical
variables. Our final result (3.20) is a great simplification because the entire
1 From now on I present the result with only the position source j turned on. This is
immediately generalised to include the momentum source h using (3.6) instead of (3.7).
2 This is what we will assume from now on.
32 CHAPTER 3. PATH INTEGRAL QUANTIZATION
Im t
ϵ
Re t
ϵ
C
dependence on the initial and final states in the path integral disappeared in
this expression. They are all absorbed into the normalization of the vacuum
state. All of this happens thanks to the “i trick” we used above by rotating
the time integral infinitesimally into the lower half plane. This projects the
initial and final states in the path integral to the vacuum state.
All the notions we introduced in the previous section, path integrals, gener-
ating function, n-point correlators, vacuum-to-vacuum amplitude etc carry over
to quantum field theory. Here, however we define the path integral over field
configurations. This means that the propagation amplitude of a field from a
given field configuration φi (~x, ti ) at initial time ti to another field configuration
φf (~x, tf ) at final time tf is given by summing over all possible field paths in
the intermediate times which start and end on these configurations weighed by
exponential of the action.
Consider for example the free real scalar field. The Hamiltonian density for
this Klein-Gordon field is given by
1 2 1 1
H= Π + (∇φ)2 + m2 φ2 , (3.21)
2 2 2
where Π is the canonical momentum that is given by the variation Π = ∂L/∂ φ̇
of the Lagrangian density
1 1
L = − (∂φ)2 − m2 φ2 . (3.22)
2 2
To the path integral of the previous section to this field we replace q(t) → φ(~x, t),
p(t) → Π(~x, t) and j(t) → J(~x, t)
3.2. PATH INTEGRALS IN QFT 33
With these replacements the propagation amplitudes (3.6) and (3.7) become
Z Z φf R tf
dtd3 x(Πφ̇−H)
hφ(~x, tf )|φ(~x, ti )i = DΠ(x) Dφ(x)ei ti
(3.23)
φi
for tf > ti , recalling that path integral automatically orders in time, and,
Z φf R tf
dtd3 x L
hφ(~x, tf )|φ(~x, ti )i = Dφ(x)ei ti
. (3.24)
φi
where the contour is the same as in figure 3.2. Recall that in this final expression
we do not have to specify the boundary conditions on the φ path integral, as
the infinite past and future time limit with the slight tilt of contour C (see
fig. 4) automatically projects onto the vacuum state regardless of the boundary
conditions in time. Now the the vacuum-to-vacuum amplitude in the presence
of source can be obtained from the generating function by normalizing
Z0 [J]
h0|0iJ = , (3.26)
Z0 [0]
such that the transition between two vacuum states in the absence of any source
perturbing the Hamiltonian is unity.
Recall that we defined the quantum mechanics path integral over the par-
ticle trajectories q(t) by dividing the propagation time into infinitesimal time
intervals with length that we labelled by an index i, and performing the ordi-
nary integrals over the positions qi in these time intervals
Z N Z
Y
Dq(t) = N () dqi , (3.27)
i=1
This normalization is part of the definition of the path integral measure, makes
sure that the path integral is finite in the limit N → ∞, → 0 and it is
completely invisible in the observables such as correlation functions as it can be
absorbed in the normalization of the vacuum state.
t(i) = ti + i with ti being the initial time. The final time is tf = t(N + 1)
as before. We can also define this path integral by discretization, not only in
time, as in the QM example above, but also in space. Imagine that we confine
the space in which the field φ lives into a 3D box with volume V3 = L3 . We
then divide this cube into infinitesimal boxes of volume V /N 3 . Then the path
integral over field configurations is defined similar to above as,
Z YZ
Dφ(x) = dφ(xi ) (3.29)
i
where i labels the infinitesimal boxes of space-time with the total space-time
“volume” V4 = L3 T . We suppress a proportionality constant, analogous to
N () in eq. (3.28) in this definition, which we will not need as it will cancel out
in all the observables, see below.
in the simple case of a real scalar field with the Klein-Gordon action
Z
1
S=− d4 x ∂µ φ∂ µ φ + m2 φ2 . (3.31)
2
We will eventually set to 1 by normalization of the vacuum state but this will
serve as a nice and simple illustration of the computation. To avoid unnecessary
cluttering let’s assume T = L with the total space-time volume V4 = L4 . Then,
the fields in each space-time box φ(xi ) can be expanded in a discrete Fourier
series as,
1 X −ikn ·xi
φ(xi ) = e φ(kn ) , (3.32)
V4 n
with knµ = 2πnµ /L, nµ denoting a set of four integers. I will closely follow the
discussion in Peskin & Schroder, section 9.2. The Fourier coefficients φ(kn ) are
complex but they satisfy φ∗ (kn ) = φ(−kn ) as φ(xi ) are constraint to be real.
We can treat the real and imaginary parts of φ(kn ) for kn0 > 0 independent
(they become related to one another for negative and positive kn0 .), then we
change variables φ(xi ) → φ(kn ) which is a unitary transformation, see (3.32),
hence with unit Jacobian. Thus we can write
Z Y Z
Dφ(x) = dRe[φ(kn )]Im[φ(kn )] . (3.33)
0 >0
kn
This defines for us the path integral measure. Now, to determine the integrand,
substitute (3.32) in the action (3.31) and obtain
1 X
S=− (m2 + kn2 ) Re[φ(kn )]2 + Im[φ(kn )]2 . (3.34)
V4 0
kn >0
Now we will evaluate the path integral (3.30) using (3.33) and (3.34):
Y Z − Vi (m2 +kn
2
)Re[φ(kn )]2
Z
i 2 2 2
Z0 [0] = dRe[φ(kn )]e 4 dIm[φ(kn )]e− V4 (m +kn )Im[φ(kn )]
0 >0
kn
(3.35)
3.2. PATH INTEGRALS IN QFT 35
These are all Gaussian integrals and we know how to evaluate them when the
real part of the coefficient in the exponent is negative definite:
Z ∞
r
−ax2 π
dx e = , Re[a] > 0 . (3.36)
−∞ a
The exponents in (3.35) are not necessarily satisfy this. However, recall that,
to obtain the vacuum-to-vacuum transition amplitude we needed to integrate
over the contour C̃ in the momentum space (or over the contour C in time)
which is obtained by replacing kn0 → kn0 ei which means m2 + kn2 → m2 + kn2 − i
for infinitesimal which indeed makes sure that the integrals are convergent for
> 0. The result is
s s s
Y −iπV4 −iπV4 Y −iπV4
Z0 [0] = 2 2 2 2
= , (3.37)
0
m + kn m + kn n
m2 + kn2
kn >0
where in the last equation we removed the constraint kn0 > 0 noting that the
product is identical for kn0 > 0 and kn0 < 0. This result looks terribly divergent
and indeed it is. To see where the divergence comes from, you can take a
logarithm of (3.37), obtaining a sum over n. Clearly the divergence comes from
the high frequency-high momentum modes n 1. This is our first encounter of
what is called the “UV divergence” in QFT. Later in the class we will see how
to make sense of such divergences by renormalization. For the moment, we will
interpret this expression in the following formal manner.
To understand what (3.37) really is, let us consider a Gaussian integral over
an n-component vector ~v with indices vi :
YZ
I= dvi e−vi Bij vj , (3.38)
i
Im k0
k0
ϵ
Re k0
ϵ ˜
C
Figure 3.3: Definition of the contour C̃ in the complex frequency space that
defines the vacuum-to-vacuum amplitude.
where the contour of the k 0 integral is shown in fig. 5. We can now impose the
same physical requirement we imposed below equation (3.19), that the probabil-
ity amplitude for the system to remain in vacuum in the absence of any source
perturbing it is unity. Then, from equation (3.26) we obtain
( Z )
i ˜ J(−k)
d4 k J(k) ˜
h0|0iJ = exp . (3.48)
2 C̃ (2π)4 k 2 + m2
By a change of variables k 0 → k 0 ei we can put back the contour on the real
axis. Keeping track of the we find the following expression for the exponent
Z ∞ ˜ J(−k)
˜
J(k)
dk 0 d3 k ,
−∞ k 2 + m2 − i
where Z
d4 k eik(x−y)
∆(x − y) = . (3.50)
(2π)4 k 2 + m2 − i
38 CHAPTER 3. PATH INTEGRAL QUANTIZATION
This is called the Feynman propagator. Poles structure in the Feynman propa-
gator is shown in figure 3.4. The time ordered propagator for the Klein-Gordon
field obtained from the generating function is precisely the Feynman propagator:
1 1 ∂ 1 ∂
h0| T φ(x)φ(y) |0i = Z0 [J] = −i∆(x − y) . (3.51)
Z0 [0] i ∂J(x) i ∂J(y) J=0
We can further perform the k 0 integral in (3.50) by using the Cauchy’s integral
theorem
Z
1 f (z)
dz = f (z0 ) ,
2πi C0 z − z0
where the contour encloses the pole z0 . Using the pole structure shown in fig.
6 we find
Z Z
˜ ik(x−y) + iΘ(y 0 − x0 ) dke
∆(x − y) = iΘ(x0 − y 0 ) dke ˜ −ik(x−y) , (3.52)
Working out the same calculation that led to (3.51), we find the following
result for the higher point correlators:
• If there are odd number of φs then the result vanishes when we set J = 0
at the end of the calculation:
where the sum is over all different pairs. The result (3.53) and (3.54) is called
the Wick’s theorem.
The meaning of the effective potential becomes clear recalling that the generat-
ing function is, at the same time, the vacuum-to-vacuum transition amplitude,
h0|0iJ = lim h0| e−iH[J]T |0i = lim exp(−i∆E0 [J]T ) = exp(iW [J] − iW [0]) ,
T →∞ T →∞
(3.56)
where
R 4 H[J] is the hamiltonian corrected with the source term: H[J] = H−
d xJ(x)φ(x) and ∆E0 [J] is the change in the energy of the vacuum state
caused by addition of the source term. Therefore the effective potential measures
how much the vacuum energy is perturbed by adding an external source to the
theory.
The source term itself has a clear physical meaning. The generating function
can be written as the expectation value of the source term,
Z R 4 R 4
Z[J] = DφeiS ei d xJ(x)φ(x) = h0| ei d xJ(x)φ̂(x) |0i . (3.57)
The function J(x) then determines the amplitude of this collective excita-
tion. For example we can choose this collective excitation to be localised around
40 CHAPTER 3. PATH INTEGRAL QUANTIZATION
Let us determine how this perturbation modifies the energy of the vacuum
state by computing the effective potential W [J]. For a general source, by trans-
forming to Fourier space we have,
Z
1 1
∆W [J] = d4 k J˜∗ (k) 2 ˜ ,
J(k) (3.59)
2 k + m2 − i
where ∆W [J] ≡ W [J] − W [0], J˜ is the Fourier transform of J(x) and I used
J˜∗ (k) = J(−k) that comes from reality of J(x). For a source of the form above
˜
we have J(k) = J˜1 (k) + J˜2 (k) and there are four terms in (3.59) that arise from
˜
expanding J. These are W11 and W22 which correspond to self interaction of
J1 with J1 , self interaction of J2 with J2 and the cross interaction terms W12
and W21 between J1 and J2 . In general we are interested in how the excitations
interact with each other, hence the term we are after is the latter. This is
Z
1 1
∆W12 [J] = d4 k J˜1∗ (k) 2 J˜2 (k) , (3.60)
2 k + m2 − i
This expression makes a significant contribution when k 2 +m2 = 0, that is when
the dispersion relation is satisfied. Thus, we learn that the interactions in QFT
are carried by particles that correspond to the excitations of the field! In addition
to this “on-shell” contribution there are contributions from k 2 6= m2 , which are
smaller. These are the “off-shell” contributions or “virtual excitations”.
To calculate the shift in the energy in the vacuum due to this interaction
let us choose the sources as
J(x) = δ 3 (~x − ~x1 ) + δ 3 (~x − ~x2 ) .
This corresponds to test particles, that are infinitely massive as they are an-
chored to the space points ~x1 and ~x2 . Inserting the fourier transform
Z Z
˜ −ik·x 3 0 0 ~
4
Ji (k) = d xe δ (~x − ~xi ) = dx0 e+ik x e−ik·~xi
in (3.60) and carrying out the x0 integral which sets k 0 = 0, one easily finds
Z ~
1 d3 k e−ik·(~x1 −~x2 )
∆W12 [J] = T , (3.61)
2 (2π)3 |~k|2 + m2
where I ignored the i in the denominator as the real part of the denominator is
positive definite. The multiplicative
R factor T is the total time of the interaction
and it comes from the dx01 integral which factored out exactly.
Comparison to (3.56) shows that the shift in the energy of the vacuum due
to the interaction between the two test particles is (W21 contributes equally)
Z ~
d3 k e−ik·(~x1 −~x2 )
∆E12 [J] = − . (3.62)
(2π)3 |~k|2 + m2
3.2. PATH INTEGRALS IN QFT 41
This is the potential energy of two test particles that are interacting by exchang-
ing φ field excitations.
Two remarks:
Interactions in QFT
Interaction terms in quantum field theory are given by the terms higher
than quadratic order in the Lagrangian (or Hamiltonian). This can be un-
derstood as follows: As discussed in the previous section the quadratic terms
in the Lagrangian determine the propagator which describe propagation of a
point-like particle from one space time point to another. Particle interactions
on the other hand are described by exchange of another particle between two
particles. In order to exchange a particle the initial particle should emit one.
This emission process necessitates presence of at least 3 particles at the same
space-time point:incoming particle, emitted particle, outgoing particle. This
spacetime point which includes at least three particles is called an interaction
vertex. As the single-particle states are created and annihilated by the quantum
field φ(x), see e.g. (2.21), presence of an interaction vertex requires a cubic or
higher order term in the Lagrangian. These terms are called the interaction
terms.
1 1 g
L = − (∂φ(x))2 − m2 φ(x)2 + φ(x)3 . (4.1)
2 2 3!
Here g is a constant called the coupling constant and we inserted 3! for simplicity,
as will become clear below. To calculate the generating function of this theory
we will employ the following trick.
One can obtain a formal expression for the generating function with inter-
42
4.2. PERTURBATIVE EXPANSION AND FEYNMAN DIAGRAMS 43
Now we apply this trick to an interacting QFT with a generic interaction given
by a polynomial in φ(x). Denoting this polynomial Lint and the free, quadratic
part of the Lagrangian L0 we have
Z R 4
R 4 δ
Z[J] = Dφ(x)ei d x(L0 +Lint +Jφ+) = ei d xLint [−i δJ(x) ] Z0 [J] . (4.2)
As we have already calculated Z0 [J] in (3.49) (4.2) is the final expression for the
interacting generating function, at least formally. Unfortunately this expression
cannot be evaluated analytically in most of the cases and we will apply a pertur-
bative expansion to calculate. In particular we will expand the first exponential
in a Taylor expansion when the coupling constants are small. This perturba-
tive evaluation of the generating function is best described in the language of
Feynman diagrams that we turn to in the next section.
∞
X Z 3 !V X∞ Z P
1 ig δ 1 i
Z[J] ∝ d4 x −i 4 4
d yd zJ(y)∆(y − z)J(z) .
V! 3! δJ(x) P! 2
V =0 P =0
(4.3)
where the proportionality constant will be determined below. The letters P
and V stand for the number of propagators ∆ and vertices in this expression.
Now consider a specific term (P, V ) in the double sum. When the functional
derivatives hit the sources the leftover number of Js is given by
E = 2P − 3V . (4.4)
The letter E stands for the number of “external” sources. There are 3V func-
tional derivatives in this expression acting on 2P sources in 2P (2P −1) · · · (2P −
3V + 1) = 2P !/(2P − 3V )! combinations.
44 CHAPTER 4. INTERACTIONS IN QFT
vertex
δJ δJ δJ ⟺
Clearly all the contributions in this expression are of the same form, one δ/δJ
hitting one of the J∆J terms and the two other δ/δJ hitting the other J∆J,
see Fig. 4.1.
1
: i ∆(x − y)
R
: i d4 x J(x)
R
: ig d4 x
Figure 4.2: Feynman rules for the real scalar field with cubic interaction.
Before going further we make a note that there are two general classes of
graphs, the connected and disconnected Feynman graphs. The only contribution
to the E = V = 1 case was a connected one shown in Fig. 4.1. On the other
hand there were two connected and three disconnected contributions in the
E = V = 2 case, shown in Fig. 4.3. We will see below that the disconnected
graphs will not contribute to the n-point functions, hence we will be able to
ignore them. I show one more example of distinct connected Feynman graphs
46 CHAPTER 4. INTERACTIONS IN QFT
δJ δJ δJ δJ δJ δJ
δJ δJ δJ δJ δJ δJ
⟺
⟺
δJ δJ δJ δJ δJ δJ δJ δJ δJ δJ δJ δJ
δJ δJ δJ δJ δJ δJ
Figure 4.3: Five distinct contractions and the corresponding Feynman graph
contributions to the two point function at order O(g 2 ) that arise from the E =
2, V = 2 term in the generating function. The symmetry factors of these
contributions read from left to right, top to bottom are 4, 4, 8, 16 and 24.
4.2. PERTURBATIVE EXPANSION AND FEYNMAN DIAGRAMS 47
All in all, the result for the one point function which follows from the Feyn-
man rules on the table above, is,
Z
δ −i
h0| O(x) |0i = −iZ[0]−1 Z[J] = g∆(0) d4 z ∆(x − z) . (4.5)
δJ(x) J=0 2
In fact it is better to organise the expansion using the pair (E, V ), that is the
number of external sources and vertices, instead of the pair (P, V ) as in (4.3).
This is because we are eventually interested in computing the n-point correlators
that is obtained from the generating function by taking n functional derivatives
with respect to the sources J and setting J = 0 in the end. Clearly, the only
non-vanishing contributions to these n-point correlators would have n = E. If
we organize the expansion of Z[J] by E and V then we know that we only have
to consider the E = nth order terms (which are further distinguished by the
label V ). Furthermore, we define the perturbative expansion for a small value
of the coupling constant g, which makes possible to expand in the number of
vertices. In order to calculate an n-point correlator then one needs to calculate
all the Feynman graphs with E = n to the desired order in the number of
vertices.
With E = 1, V = 1 ⇒ P = 2
With E = 1, V = 3 ⇒ P = 5
With E = 2, V = 2 ⇒ P = 4
Figure 4.4: Some examples of connected Feynman diagrams with different num-
ber of external sources E and vertices V constructed using the Feynman rules.
Number of propagators follow using the formula (4.4). The top and bottom ex-
amples are worked out in more detail in figures 4.1 and 4.3 respectively, where
in the latter we also showed the disconnected contributions.
4.2. PERTURBATIVE EXPANSION AND FEYNMAN DIAGRAMS 49
Figure 4.5: Some examples of Feynman diagrams with their symmetry factors.
of each diagram by this factor which is called the symmetry factor. Therefore
each Feynman diagram has a symmetry factor associated to it. A useful obser-
vation is that this overcounting i.e. the match-up of derivatives with sources,
is represented by the symmetry of a diagram under the simultaneous exchange
of the legs in a vertex with the propagators that connect to these legs, and a
simultaneous exchange of two vertices and the endpoints of the propagators that
connect these two vertices. Some examples are presented in figure 4.4. As clear
from the explanation above and the examples in figure 4.5, the symmetry factor
is literally the number of permutations of vertices, propagators and external
sources that leave the diagram invariant. In more detail there are the following
types of permutations that contribute to the symmetry factor:
1. Swapping the endpoints of a propagator that starts and ends at the same
vertex. This gives a factor of 2.
2. Permuting the propagators that connect the same two vertices. This gives
a factor of p! if there are p propagators.
3. Permuting the vertices themselves (together with all the propagators and
sources that are connected to them). This gives v! if there are v vertices
that are swapped.
4. Permuting the external sources that are connected to the same internal
vertex (or to each other as in the case of 2 external sources connected to
each other by a propagator). This gives s! when there are s number of
identical source terms connected to the same vertex.
We noted above that they were generally two classes of graphs, connected
and disconnected. The connected diagrams are the ones we can trace a path
50 CHAPTER 4. INTERACTIONS IN QFT
through the diagram between any two points on it. A generic diagram, on the
other hand, consists of several disconnected pieces as we have seen above. These
arise in the sum (4.3) as a product of disconnected integrals. Another example
is given in figure 4.6. Therefore the most general diagram can be represented
by the following expression:
1 Y n
D{n1 ,n2 ,··· } = (CI ) I . (4.6)
SD
I
Here we label all possible connected Feynman diagrams with the index I, CI
represent their values including the symmetry factors, nI is the number of the
same diagram I appearing in the product, and SD is the symmetry factor as-
sociated with the product itself. The latter gives nI ! if there are nI identical
diagrams present in the sum. Generally it is given by
Y
SD = nI ! . (4.7)
I
Then the generating function (4.3) can be written in terms of the values corre-
sponding to the Feynman diagrams generically as follows:
!
X X Y (CI )nI X
Z[J] ∝ D{n1 ,n2 ,··· } = = exp CI , (4.8)
nI !
{n1 ,n2 ,··· } {n1 ,n2 ,··· } I I
where we exchanged the sum and the product in the last step and summed up
each of the sums over nI into exponentials. This is a remarkable result: the
generating function in general can be written as the exponential of sum over all
possible connected diagrams.
We are eventually interested in the n-point functions that are derived from
the vacuum-to-vacuum amplitude h0|0iJ = Z[J]/Z[0]. Now, there is a simple
way to express this normalisation condition in the expression above1 . In the
absence of any sources, Feynman diagrams only include the so called vacuum
diagrams, diagrams with no sources, that only involve closed loops, see figure 4.7.
Denoting the set of these vacuum diagrams by {0} the normalisation condition
above means
X
Z[0] = exp CI , (4.9)
I∈{0}
1 Note
that this is in general a different condition than the previous one h0|0i0 = 1 in (3.48)
because the vacuum state in the presence of interactions is generically different than the free
case. We denote both vacua by |0i with a slight abuse of notation.
4.3. FEYNMAN RULES IN THE MOMENTUM SPACE 51
Figure 4.7: Examples of vacuum diagrams. The symmetry factors from top left
to bottom right are S = 24 , 23 , 24 , 3! × 23 and 4! respectively.
where we denoted the log of the generating function as W [J], see section 3.2.4,
and ∆W [J] = W [J] − W [0]. We learn that the effective potential is the generat-
ing function for the connected n-point functions. This will be extremely useful in
determining the physical observables such as the scattering amplitudes in QFT.
The expression for ∆(x − y) is given in equation (3.50). Written in terms of the
effective potential we have
1 ∂ 1 ∂ ∂ ∂
h0| T φ(x1 )φ(x2 ) |0i = i∆W [J]+ ∆W [J] ∆W [J] ,
i ∂J(x1 ) i ∂J(x2 ) ∂J(x1 ) ∂J(x2 ) J=0
(4.12)
where we used the the normalization h0|0iJ=0 = 1 hence ∆W [0] = 0. Now,
the second term in (4.12) is proportional to the one-point function (6.1) which
52 CHAPTER 4. INTERACTIONS IN QFT
vanishes in the free case as one can directly see from the canonical expression of
the quantum field (2.21). We will require this one point function vanish also in
the fully interacting case as we will discuss in chapter 6. The motivation behind
this is that we want the creation operators to create a one-particle state, and
not a superposition of a one-particle state and the vacuum state. We want this
physical requirement also in the presence of interactions. So we will always set
Clearly the only non-vanishing contributions will come from Feynman diagrams
with two external sources. These contributions can be organised in an expansion
in g as usual and the lowest order contribution contains no vertices. Using the
Feynman rules in fig. 4.1 we find
Z
1
i∆W [J] = + · · · = −i d4 x1 d4 x2 J(x1 )∆(x1 − x2 )J(x2 ) + O(g 2 ) ,
2
(4.14)
where 1/2 comes from the symmetry factor. Now we take the variational deriva-
tives and we note that each variational derivative pins down an external vertex,
that is represented by a blob in the Feynman diagram, to a fixed point in space
time. Graphically we have
1 ∂ 1 ∂ 1 1
= (x1 x2 + x2 x1 ) = x1 x2 .
i ∂J(x1 ) i ∂J(x2 ) 2 2
(4.15)
This leads to a graphical representation of the two-point function
h0| T φ(x1 )φ(x2 ) |0i = x1 x2 + x1 x2 + x1 x2 + · · · (4.16)
where we also showed the g 2 contributions which arise from higher order terms
in (4.14) and the ellipsis represent O(g 4 ) contributions. All contributions to
the two point function beyond g 0 necessarily involve loops. Now let us take the
Fourier transform of this two point function. Consider the tree-level term first.
Using (3.50), we find
Z Z
0 0
h0| T φ(k)φ(k 0 ) |0i = −i d4 xe−ikx d4 x0 e−ik x ∆(x − x0 )
−i
= (2π)4 δ 4 (k + k 0 ) . (4.17)
k 2 + m2 − i
The overall delta function is nothing else but the statement that the momentum
carried by the particles at the two ends of the two-point function should be the
same, that is momentum is conserved. It is immediate to see that this overall
factor will be the same in all connected Feynman diagrams, as it just arises from
combination of the incoming and outgoing space-time integrals combined with
the exp{ik(x − y)} factors in the propagators.
k
i
k 2 + m2 i✏
ig
Figure 4.8: Momentum space Feynman rules for the real scalar field with cubic
interaction.
the symmetry factor of the diagram. For example the value of the first diagram
in the one-loop contribution in (4.16) is
Z
−g 2 1 1
(2π)4 δ 4 (k + k 0 ) 2 d4 k1 ,
(k + m2 − i)2 (k − k1 )2 + m2 − i k12 + m2 − i
and the second one-loop contribution (the “tadpole” diagram) is2
Z
4 4 0 −g 2 1 d4 k1
(2π) δ (k + k ) 2 .
(k + m2 − i)2 m2 − i k12 + m2 − i
The same prescription (label all propagators by a momentum, impose momen-
tum conservation at the vertices and include an overall factor of momentum
conservation) applies to higher point functions. In the general case the over-
all momentum conservation factor obviously becomes δ 4 (kin − kout ) where kin
and kout are the sum of all ingoing and outgoing momenta respectively. The
momentum space Feynman rules are summarized in figure 4.8.
Consider the 4-point function as another example. One finds two separate
type of contributions
∂ ∂ ∂ ∂
h0| T φ(x1 )φ(x2 )φ(x01 )φ(x02 ) |0i = i∆W [0]
∂J(x1 ) ∂J(x2 ) ∂J(x1 ) ∂J(x02 )
0
∂ ∂ ∂ ∂
+ i∆W [0] i∆W [0] + (x1 ↔ x01 ) + (x1 ↔ x02 )
∂J(x1 ) ∂J(x2 ) ∂J(x1 ) ∂J(x02 )
0
given in the first and the second lines, where we used the condition that the
one-point function, hence δW [0]/δJ(x) = 0. Let us first work out the second
line. The only non vanishing contributions in W in the second line involve two
external sources, the tree level contribution being the same as (4.14). In fact
the second line is nothing else but pairs of two-point functions. At the zeroth
order in g they look like this:
x1 x2
+ (x1 ↔ x01 ) + (x1 ↔ x02 ) . (4.18)
x01 x02
2 We will see later that this tadpole contribution is cancelled in the renormalized theory.
54 CHAPTER 4. INTERACTIONS IN QFT
There will of course be higher order g corrections on these two separate propa-
gators but they will always correspond to the disconnected contributions to the
4-point function. As we will see in the next section they play no role in the
scattering processes and we typically ignore such disconnected contributions in
calculation of experimental observables. They are there however, are physical
and represent processes with no interactions. Their contributions are completely
determined by the knowledge of the two-point functions we studied above.
The novel contribution is the fully connected piece that arises from the first
line above, (4.18). Only the terms with 4 external sources in W can contribute
to this. Graphically,
1 4
i∆W [J] = + O(g
x1 ), x’1 (4.19)
8
where the numerical factor is the symmetry factor x2
and the higher x’
order contri-
2
butions involve loops. As in the two-point function above, when the 4 functional
derivatives in (4.18) act onx1this they pin thex’external
1
sources to the indicated
x1 x’1
specific values. There are 4! = 24 different ways these derivatives can act and,
clearly, they produce only three distinct classes of Feynman diagrams shown
below x2 x’2
x2 x’2
x1 x’1
x1 x’1
x1 x’1
This product arise from the 4 external propagators that enter in the diagram
above.
Chapter 5
The crucial assumption we will make in the following is that the space-time re-
gion where we prepare the states and region where they interact with one another
are well separated. The region where the initial states are prepared and the final
states are observed are called the asymptotic region. In an experiment this is
where the particle beams are created and where the final states are captured
by the detectors. In theory we idealize the situation1 by taking the asymptotic
region at t → ±∞ and |~x| → ∞. Thus our initial and final states are created
by the creation operators of the free theory. This set-up makes sense because of
the following observation: A basic assumption of QFT is locality, in particular
interaction terms e.g. gφ3 (x) are local functions of fields. This means that, if
we assume that particles interact with each other somewhere at the origin of the
lab (this can always be chosen as the origin of the coordinate system using the
translation symmetry), then these particles should be very close to each other
there. But this means that they should be well separated in the asymptotic
1 This setup is perfectly suitable for the high energy experiments. To use the same descrip-
tion in a condensed matter system to describe scattering of electrons, holes and phonons etc
one has to assume that the mean free path of the particle-like excitations is sufficiently large.
This assumption typically fails in strongly correlated systems.
55
56CHAPTER 5. FROM THEORY TO EXPERIMENT: SCATTERING IN HIGH ENERGY PHYSICS
region t = ±∞, |~x| → ∞ since particles have finite momentum. That is, the
inter particle distance goes to infinity |~x1 − ~x2 | → ∞ in the asymptotic region.
Then, indeed it makes sense that they are free hence created and destroyed by
creation/annihilation operators of the free theory.
|ii = lim a† (k1 )a† (k2 ) |0i , |f i = lim a† (k10 )a† (k20 ) |0i . (5.2)
t→−∞ t→+∞
←→
where we define a derivative with double arrow as A ∂ B ≡ A∂B − (∂A)B.
We also indicate the time-dependence of the creation operator explicitly. This
equation is easy to obtain from the oscillator expansion (2.21).
Let us see how the on-particle states evolve in time by computing the time
|~
k−~k1 |2
Z
−
a†1 ≡ d3 kf1 (~k)a† (k) , f1 ∝ e 4σ 2 , (5.3)
where σ determines the spread of the wave-packet. Here I will simply assume that the particle
is well localized in momentum by taking the function f1 (~k) = δ 3 (~k − ~k1 ).. This corresponds
to the σ → 0 limit of the Gaussian. Use of a Gaussian wave-packet means that the particle
is also localised in space. You can see this by taking the Fourier transform of f1 (k) to obtain
f˜1 (x) ∝ exp −|x|2 σ .
5.1. LSZ REDUCTION FORMULA 57
where in the second step we used ω 2 = |~k|2 + m2 , which is part of the defini-
of a† (k, t) in (5.4): the exponential term reads ikx = −iωt + i~k · ~x with
tion q
ω = |~k|2 + m2 . This may be confusing as we obtained this dispersion relation
directly followed from the Klein-Gordon equation in the free theory. Does it
imply that the dispersion relation (a.k.a the mass-shell condition) in the free
and interacting theories the same? In fact, they are not. The dispersion rela-
tion can be read off from the poles of the two-point function in the interacting
theory, and indeed one finds a different pole structure as we briefly discuss in
the next section. The point here is that the exponent in (5.4) is chosen, again,
to make sure that it reduces to that of the free theory in the asymptotic regions.
Other than that it is a part of the definition. In the last step in (5.5) we did
an integration by parts where we wrote |~k|2 as −∇ ~ 2 exp(ikx) and moved the
derivatives onto φ. To see that this is justified, one should use the definition of
the one-particle creation operator with the Gaussian wave-packet (see Appendix
A). I will assume that this has indeed been done and the limit σ → 0 is taken
at the end of the computation and ignore such boundary terms.
As a consistency check we see that the RHS of this equation vanishes in the
free theory upon use of Klein-Gordon equation. Hence the one-particle states
do not change in time in the free theory, as one expects. However, the initial
and final states of the same momentum are different in the presence of some
scattering region
in space-time because the equation of motion now differs from
−∂ 2 + m2 φ(x) = 0 hence the RHS of (5.5) does not vanish. For example in
the real scalar theory above we have −∂ 2 + m2 φ(x) = gφ2 /2.
Using (5.5) we can derive a very useful formula that relates a one-particle
state created at t = −∞ to the same state captured at t = +∞:
Z +∞
† ~ † ~
a (k, +∞) − a (k, −∞) = dt ∂0 a† (~k, t)
−∞
Z
= −i d4 x eikx −∂ 2 + m2 φ(x) . (5.6)
This formula is valid in general when φ is an interacting field. We will now make
the assumption that the creation operator in the interacting theory is also given
in terms of the field as in equation (5.1). This is motivated with our discussion
above, that the interacting field approaches to the free field in the asymptotic
regions in space-time where the initial states are prepared and final states are
measured.
h0| T a(k10 , ∞)a(k20 , ∞)a† (k1 , −∞)a† (k2 , −∞) |0i , (5.8)
where T is the time-ordering symbol introduced in (3.11). Now use the equa-
tion (5.6) to rewrite a† (k1 , −∞) and a† (k2 , −∞) in terms of a† (k1 , +∞) and
a† (k2 , +∞) plus the integrals and use the hermitean conjugate of (5.6) to rewrite
a(k1 , ∞) and a(k2 , ∞) in terms of a(k1 , −∞) and a(k2 , −∞) plus the integrals,
then reorder these creation annihilation operators according to time-ordering.
One finds that all the annihilators are to the right of the creators inside the
bracket hence they destroy the vacuum states leaving only the contributions
from the integrals. This is a huge simplification and leads to our final result,
Z Z
0
hf |ii = in+n d4 x1 eik1 x1 −∂12 + m2 · · · d4 xn eikn xn −∂n2 + m2
Z 0 Z 0
4 0 −ik10 x01 0 0
d x1 e −∂1 + m · · · d4 x0n0 e−ikn0 xn0 −∂n20 + m2
2 2
where we presented the general result for the amplitude of n incoming initial one-
particle states scattering into n0 outgoing final particle states. This is called the
LSZ reduction formula named after Lehmann, Symanzik and Zimmermann, and
it is one of the fundamental equations of QFT. Its importance is clear: it relates
scattering matrices, hence experimental observables to the basic observables of
QFT namely the n-point functions.
The LSZ reduction formula when combined with the momentum space Feyn-
man rules that we derived in section 4.3 result in a very simple prescription for
the scattering amplitudes. Let us exemplify this in the 2 → 2 scattering ampli-
tude hf |ii = hk1 , k2 |k10 , k20 i. The relevant n-point function is the 4-point function
that we studied in section 4.3. First consider the disconnected contributions in
(4.18). Substituting it in the LSZ formula we find, for the leftmost diagram in
(4.18),
Z
0 0 0 0
hk1 , k2 |k10 , k20 idisconnected ∝ d4 x1 d4 x2 d4 x01 d4 x02 ei(k1 x1 +k2 x2 −k1 x1 −k2 x2 )
hk1 , k2 |k10 , k20 idisconnected ∝ (k12 + m2 )(k22 + m2 )δ 4 (k1 − k10 )δ 4 (k2 − k20 ) . (5.10)
substituting in the LSZ formula we discover a nice simplification: all the external
propagators are cancelled by the differential operators in (5.9). It is immediate
to see that this is a general result and hold for a general n → n0 scattering
amplitude in QFT. In fact the LSZ formula is called a reduction formula precisely
for this reason. The external legs always drop out of the scattering calculations
and the corresponding diagrams with external propagators removed are called
the amputated diagrams. The 2 → 2 scattering amplitude in the real scalar
theory with cubic interaction is then:
1 1 1
hk1 , k2 |k10 , k20 i = ig 2 (2π)4 δ 4 (k1 +k2 −k10 −k20 ) + + +· · · ,
m2 − s m2 − t m2 − u
(5.11)
where the ellipsis represent the higher order loop corrections and we defined the
so-called Mandelstam variables
1. Draw external lines for each incoming and outgoing particle with 4-momentum
labels ki . Put an arrow towards the vertex for the incoming and away from
the vertex for the outgoing.
3. Assign a 4-momentum for each internal line and use momentum conser-
vation at the vertices to label them.
4. The value of the diagram is obtained by using the momentum space Feyn-
man rules in figure 4.8.
5. Integrate over the momenta that are not fixed by momentum conserva-
tion (these arise in loop diagrams) with the measure d4 `i /(2π)4 for loop
momenta `i .
6. Divide by the symmetry factor for the loop diagrams (the other symmetry
factors which arise from the external legs are all removed already).
7. The scattering matrix iT is given by the sum over the values of all these
diagrams.
60CHAPTER 5. FROM THEORY TO EXPERIMENT: SCATTERING IN HIGH ENERGY PHYSICS
k10
k1
✓
k20 k2
Since the scattering amplitude is Lorentz invariant we can choose any frame
to evaluate it. A particularly useful frame for the scattering process is the
“center of mass” (CM) frame where the total incoming q and outgoing qmomentum
vanishes k1 + k2 = k1 + k2 = 0 and Ein = E1 +E2 = |k1 | + m1 + |~k1 |2 + m22 .
~ ~ ~ 0 ~0 ~ 2 2
Another parameter that enters in scattering is the angle θ between the “beam
3 All particles have the same mass m2 in the real scalar theory. However most of the
axis” that is the axis of the incoming momentum and the axis of the outgoing
momentum (see figure 5.1. The Lorentz-invariant analog of this parameter is
the Mandelstam t-variable:
0
t = −(k1 − k10 )2 = m21 + m12 − 2E1 E10 + 2|~k1 ||~k10 | cos θ . (5.16)
Another frame that is commonly used in scattering processes is the lab frame
(or ”fixed-target frame”) with has ~k2 = 0. In this frame the incoming particle
has q
1
|~k1 | = s2 − 2(m21 + m22 )s + (m21 − m22 )2 . (5.17)
2m2
Note also that the momentum of the incoming√ particle in the CM and lab frames
are related to each other by m2 |~k1 |lab = s|~k1 |CM .
We are now ready to calculate the scattering cross section that is the relevant
observable for the high-energy collisions. The probability for the scattering to
take place is
| hf |ii |2
P = , hf |ii = (2π)4 δ 4 (kin − kout )T . (5.18)
hf |f i hi|ii
The numerator is | hf |ii |2 = (2π)4 δ 4 (kin −kout )×(2π)
R 4
4 4
δ (0)|T |2 . To understand
4 4 4
the meaning of δ (0) write it as (2π) δ (0) = d x exp{i0} = vol × time where
vol. × time is the total volume of space-time which we take to infinity at the
end of the calculation. Using this and the norm of a single particle hk|ki =
(2π)3 2k 0 δ 3 (0) = 2k 0 vol we arrive at the following formula for the probability
of the 2 → 2 scattering to take place per unit time:
P (2π)4 δ 4 (kin − kout ) vol|T |2
Ṗ = = Q2 . (5.19)
4E1 E2 vol2 j=1 (2kj0 vol)
0
time
This is the probability of scattering into definite momenta kj0 per unit time.
To obtain the total probability of scattering we need to integrate this over the
final momenta. This integration can be performed by regularising space time
as a 3D box of side-length L and vol = L3 . The momenta become discrete
~k 0 = (2π/L)~nj by imposing periodic boundary conditions in this 3D box4 where
j
~nj = (nxj , nyj , nxj ) is a collection of integers. Then one should think of (5.19)
as the probability for a particular collection of outgoing momenta {~nj }. To
turn this discrete output into continuous and finally integrate over the outgoing
momenta we need the replacement
X L 3 X vol
Z
= −→ d3 k 0 .
2π (2π)3
~
n ~
k0
Q
This gives the multiplicative factor j vol/(2π)3 d3 kj0 leads to (5.19) and the
final result is given by
2
(2π)4 δ 4 (kin − kout ) 2 Y ˜ 0
Ṗ = |T | dk j , (5.20)
4E1 E2 vol j=1
4 Periodic boundary conditions are chosen for the sake of the argument, the final result
which we obtain by taking the continuum limit is independent of how we discretize the mo-
menta.
62CHAPTER 5. FROM THEORY TO EXPERIMENT: SCATTERING IN HIGH ENERGY PHYSICS
l
l’
}A
ρ
ρ’
v v’
Figure 5.2: Schema of two beams of incoming particles with densities ρ and ρ0 ,
lengths l and l0 and velocities v and v 0 in a scattering experiment. A denotes
the overlaping area of the beams.
Now, let us define the concept of a scattering cross section. Consider the
set-up of a scattering experiment in Fig. 5.2 where two beams are approaching
each other. Denote the total number of scattering events in this experiment by
Nscat . As clear from the setting Nscat is proportional to the density of particles
ρ and ρ0 in the beams (which we assume to be constant for simplicity), the
length of the beams l and l0 and the area A shared by the beams, see the figure.
The total cross section is defined as Nscat divided by all these parameters:
Nscat
σ= (5.21)
ρ ρ0 l l0 A
This is called a “section” because it has the dimension of an area. The number
of scattering events per unit time is proportional to Ṗ . Based on this scattering
probability we can define the differential cross section as the differential rate
Ṗ , given in (5.25) divided by the incident flux of particles where the total
flux of particles, in the lab frame where the target is at rest, is given by the
number of incident particles per unit volume rho times their speed v times the
total number of target particles that participate in the scattering N 0 = ρ0 l0 A.
Writing Nscat = Ṗ × ttot in (5.21) where ttot is the total time of the scattering
process, bringing ttot in the denominator and using v = l/ttot , one sees that
the differential cross section defined above is the same as the differential cross
section defined from (5.21).
Using the expression (5.25) and the aforementioned definition of the differ-
ential cross section it is straightforward to obtain the following expression (see
exercise) for the differential cross section for a 2→ 2 scattering per differential
solid angle dCM = sin θdθdφ in the CM frame:
dσ 1 |~k10 | 2
= |T | . (5.22)
dCM 64π 2 s |~k1 |
5.3. CROSS SECTIONS AND DECAY RATES 63
and,
Yn
1 ˜0.
dσ = √ |T |2 (2π)4 δ 4 (kin − kout ) dk j (5.26)
~
4|k1 |CM s j=1
The total cross section is obtained by integrating dσ taking into account the
0
Q if 0 there are ni identical
symmetry factor for the identical outgoing particles:
particles of type i then the symmetry factor is S ≡ i ni and one has,
Z
1
σ= dσ . (5.27)
S
Let us work out the 2 → 2 scattering in the real scalar theory with the
cubic interaction term. We will only consider the contribution of the tree level
diagrams to the scattering process, which provides a good approximation when
the coupling constant is sufficiently small g 1. We obtained the scattering
amplitude in (5.11) above which we reproduce here:
1 1 1
T = g2 + + + ··· . (5.28)
m2 − s m2 − t m2 − u
Using the formulae above t and u can be expressed in terms of the total center-
of-mass energy s and the scattering angle θ, see fig. (5.1). Then the scattering
amplitude is only a function of s and θ: T = T (s, θ).
where the angle dependence is hidden in the subleading terms suppressed in this
low momentum limit. What we learn from this is that the 2 → 2 scattering in
this theory is very isotropic in the non-relativistic limit. On the other hand, in
the extreme relativistic limit ~k1 | m that is s m2 one has
g2
T ≈ 2 3 + cos2 θ + O(m2 /s) , (5.30)
s sin θ
from which we learn that the extreme relativistic limit is sharply peaked in the
forward and backward directions θ = 0 and θ = π.
Using (5.27) we compute the total cross sections in the non-relativistic and
extreme relativistic limits
25g 4 79 s − 4m2
σ = 1− + ··· , (5.31)
1152πm6 60 m2
g4 7 m2
σ = 1 + + ··· , (5.32)
16πm2 s2 2 s
(5.33)
respectively.
Chapter 6
An introduction to
renormalization in QFT
where the factor of 1/2 comes from the symmetry factor of the diagram and the
propagator ∆(y − y) = ∆(0) comes from the propagator in the loop. The one-
point function is obtained from this by taking the functional derivative w.r.t.
the source:
Z
δ ∆(0)
h0| φ(x) |0i = −i Z[J] = −i g d4 y ∆(x − y) + O(g 2 ) , (6.1)
δJ(x) 2
65
66 CHAPTER 6. AN INTRODUCTION TO RENORMALIZATION IN QFT
Figure 6.1: (Left): Time-ordered (Feynman) Green’s function has no poles inside
the contour C which consists of the real and the imaginary axes and the infinite
semi circles (dashed). (Right): Vanishing of the integral on C means one can
rotate the integral on the real axis toward the one on the imaginary axis. This
operation is called the Wick rotation.
where the higher order contributions arise from Feynman diagrams with a single
source and higher number of vertices. This expression is divergent because the
factor in front ∆(0) is infinite. From (3.50) we have
Z
d4 k 1
∆(0) = .
(2π)4 k 2 + m2 − i
Recalling the pole structure of the propagator, shown in figure 3.4, we see that
we can rotate the integral of k 0 from −∞ to +∞ on the real axis to an integral
−i∞ to +i∞ on the imaginary axis. This is because, the contour C shown
in figure 6.1 does not contain any poles. Make then the change of variables
k 0 = ikE with k 2 = −(k 0 )2 + ~k · ~k = kE2
+ kx2 + ky2 + kz2 ≡ |k|2 defined a 4-
sphere with radius |k|. This rotation is called the Wick rotation. After the Wick
rotation, the integral can be written as
Z ∞
d|k| |k|3
∆(0) = iΩ3 ,
0 (2π) |k| + m2 − i
4 2
and then take ΛE → ∞ at the end of the calculation hoping that this diver-
gence does not show up in the observables. This is called the regularization
procedure. However, we need to be very careful with the way we regularize
the loop divergences: we should make sure that we preserve the symmetries of
the action in the regularization procedure. For instance the UV cut-off we just
6.2. COUNTERTERMS 67
R
= iY d4 x
Figure 6.2: The new Feynman rule associated to the linear counter-term.
describe destroys the Lorentz invariance of the theory, that maps to rotational
invariance in 4D in the Euclidean momentum space above. There are different
ways to regularize which respects the Lorentz symmetry: dimensional regular-
ization, Pauli-Villars regularization, differential regularization etc. Pauli-Villars
instructs us to add another hypothetical highly massive particle to the theory
and replace the propagator of the scalar field as
2
1 1 Λ2
→ 2 .
k 2 + m2 − i k + m2 − i k + Λ2 − i
2
The k-integral with this replacement is now finite. The result of the integral is
i
∆(0) → Λ2 . (6.2)
16π 2
We still need to take Λ → ∞ at the end of the calculation. The only thing
we achieved by this regularization is that we made the one-point function, and
the generating function in general well-defined at the expense of introducing
another parameter in the theory. The final results should not depend on this
unphysical cut-off Λ and the way to make that such an unphysical dependence
cancels out is called the renormalization procedure.
6.2 Counterterms
with E = 1, VY = 1, V = 0
with E = 1, VY = 1, V = 2
with E = 1, VY = 2, V = 1
1
Y = i g∆(0) . (6.4)
2
Therefore including a new vertex in the theory allows us to cancel the unwanted
divergences. The divergences that arise from loops in the Feynman graphs that
are higher order in g can similarly be cancelled by correcting Y to the desired
order.
1 1 1
Lct = − (Zφ − 1)∂ µ φ∂µ φ − (Zm − 1)m2 φ2 + (Zg − 1)gφ3 + Y φ , (6.5)
2 2 3!
where the coefficients Zf , Zm , Zg and Y are to be fixed below. We
parametrised these coefficients so that when added to the original La-
grangian, the total Lagrangian reads
1 1 1
Ltot = − Zφ ∂ µ φ∂µ φ − Zm m2 φ2 + Zg gφ3 + Y φ . (6.6)
2 2 3!
• The answer to ii) is: renormalization conditions. These are certain phys-
icality requirements that determine the counterterms solely by physical
requirements. We discuss them in the next section.
Now we will answer the question how to fix the counterterms unambiguously.
We will present the argument for the real scalar theory but the basic idea is the
same and applies to all interacting field theories. We need to determine the four
unknown coefficients Zφ , Zm , Zg and Y in (6.6). To do so, it is important to
consider a physical situation, e.g. a typical experiment to which we would apply
our quantum field theory and predict the outcome. We can consider for example
the 2 → 2 scattering experiment of the precious section. A crucial ingredient in
this experimental setup was that the asymptotic one-particle states as t → ±∞
were taken to be the eigenstates of the free Hamiltonian. This is discussed in the
beginning of the previous section. To make sure that these asymptotic states
are well defined we need the following three conditions on the one-particle state
operator a† (k, t) defined in (5.4)
70 CHAPTER 6. AN INTRODUCTION TO RENORMALIZATION IN QFT
Now using the space-time translation operator and the Poincare invariance of
the vacuum we have h0| φ(x) |0i = h0| e−iP̂ x φ(0)eiP̂ x |0i = h0| φ(0) |0i where we
used invariance of the vacuum state under translations i.e. P̂ |0i = 0. Thus one
has Z
~
h0| a (k, t) |0i = ω d3 x e−iωt+ik·~x h0| φ(0) |0i .
†
Note that h0| φ(0) |0i is a constant with no dependence on space-time. This ex-
pression vanishes in the limit t → ±∞ only if and only if this constant vanishes.
Thus we arrive at the condition:
This one-point function is just a Lorentz invariant number and called the vacuum
expectation value sometimes abbreviated as VeV. This can easily be set to zero
by making a field redefinition φ(x) → φ(x) − v. This shift is achieved by adding
the counterterm Y in section 6.2. Note that the condition (6.8) is the same as
the choice (6.4) which cancels the unwanted UV divergences that arise in the
one-point function at O(g). From the discussion above we learn that this choice
is not only required to cancel the divergences but also to ascertain well defined
asymptotic one-particle states in the theory. In particular the renormalization
condition (6.8) forbids a possible additional constant in (6.4). We learn that
the condition (6.8) fixes the value of the counterterm Y in (6.6) unambiguously.
Now, consider the second condition above, that hp| a† (k, t) |0i is properly
normalised. Using again (5.4) we find that this will have proper normalisa-
tion only if hp| φ(x) |0i has the proper normalisation asymptotically. We have
6.4. RENORMALIZATION CONDITIONS 71
hp| φ(x) |0i = hp| e−iP̂ x φ(0)eiP̂ x |0i = e−ipx hp| φ(0) |0i. Now, we know one case
where the proper normalization condition of one-particle states was indeed sat-
isfied: the free field. Then using the expression for the canonically quantized
free field, (2.21) in the LHS of the equation above, we find that, in that case,
the correct normalisation of the one-particle states is equivalent to
What can happen in the interacting case at most is that the RHS will not be
unity but another (infinite) constant. We conclude that this infinite constant
can be removed and the condition (6.9) can be satisfied also in the interacting
case by a rescaling the field φ. This is indeed what the counterterm Zφ in (6.6)
achieves. Therefore we learn that the condition (6.9) fixes the value of Zφ in
(6.6) unambiguously. The third condition above is in fact automatically satisfied
and it does not help fixing any counterterm. This is derived in Appendix A.
Second we have the overall magnitude of this peak which is clearly affected
by the “loop corrected” coupling constant Zg g in (6.6). Comparison of the
scattering cross obtained from the theory (6.6) with the actual experimental
value then fixes Zg . All these four conditions (6.8), (6.9) and the final two
above are called the renormalization conditions. They are sufficient to fix all the
counterterms and fix all the unknowns in the theory (6.6). One can now consider
a different scattering or decay process and (6.6) will make a precise prediction for
the outcome of this process. QFT — in particular QED — has been enormously
successful in this regard. I have to warn you that I oversimplified the discussion
in this section.
instance the intermediate propagator that gave rise to this pole becomes 1/(m2 −s+iσ) where
σ = O(g 2 ) arises from the loop corrections to this intermediate propagator. Therefore one
obtains a peak around s = m2 with the width determined by σ.
72 CHAPTER 6. AN INTRODUCTION TO RENORMALIZATION IN QFT
acquire dependence on the energy scale. This signifies the fact that the higher
order quantum corrections (loops) become more or less relevant depending on
the energy scale you probe the theory with. This is called the renormalization
group flow. In particular the dependence of the coupling constant on the so
called “renormalization scale” µ(you can think of the same as s) is given by the
so-called beta-function:
dg(µ)
= β(g) .
d log µ
For β(g) > 0 the coupling constant increases with the energy scale and the
theory becomes non-perturbative i.e. the perturbation theory in g breaks down
at some high energy scale. QED is an example of this type. For β(g) < 0
the theory becomes non-perturbative at low energies. QCD, the QFT of the
strong force which glues the quarks inside the atomic nuclei is an example of
this situation. Finally β(g) = 0 is a special case, called a fixed point of the
renormalization group flow, and the theory around such fixed points are typically
described by a conformal field theory. An example is the QFT corresponding to
a 2d spin system (Ising model) at criticality.
Chapter 7
Representations of the
Lorentz group and particles
x̄µ = Λµ ν xν ,
hence we say that φ transforms trivially, that is the field in the transformed
frame is the same as in the old frame. Here is an example of field that transforms
non-trivially: ∂µ φ(x). By taking the derivative of the expression above and
making a change of variables we find,
Λνµ ∂¯ν φ̄(x̄) = ∂µ φ(x) ⇒ ∂µ φ(x) → ∂µ φ(x) = (Λ−1 )νµ (∂ν φ)(Λ−1 x) .
(7.2)
This is a non-trivial transformation because not only the index of the field but
also the field itself transforms ∂µ φ → (Λ−1 )νµ ∂ν φ by a factor of Λ−1 . This
is called the covariant vector representation. In general a covariant vector Aµ
transform as
Aµ → (Λ−1 )νµ Aν .
Since contraction of this with a vector with an upper index B µ Aµ is a scalar,
we learn that the vectors with upper indices transform as
B µ → Λµν B ν .
73
74CHAPTER 7. REPRESENTATIONS OF THE LORENTZ GROUP AND PARTICLES
Let us first establish that the Lorentz transformations indeed form a group:
(i) If Λ and Λ0 are Lorentz transformations, then Λ00 = ΛΛ0 is also a Lorentz
transformation.
(ii) There exists an identity Λµν = δνµ
(iii) For ∀Λ, there exists an inverse Λ−1
(iv) Associativity: (Λ · Λ0 ) · Λ00 = Λ · (Λ0 · Λ00 ).
It is easy to show these properties using only the definition of a Lorentz trans-
formation:
ηµν Λµα Λνβ = ηαβ (7.4)
Let us denote a generic transformation rule as
DA → D̄A = LB
A (Λ)DB ,
−1
LB
A (Λ ) = (L−1 )B
A (Λ) . (7.6)
Representations can be worked out by expanding the group action near unity:
i ˆ µν )B ,
LB B
A (1 + δω) = δA + δωµν (M A (7.8)
2
where M µν are called the generators. They are a collection of N by N dimen-
sional matrices where N is called the dimension of the representation. They
should be anti-symmetric under the exchange of Lorentz indices.
[M µν , M ρσ ] = iη µρ M νσ − iη νρ M µσ + iη νσ M µρ − iη µσ M νρ (7.10)
1 1
δwµν M µν = δwi0 M 0i + δwij M ij = δηi K i − δθk J k . (7.12)
2 2
Decomposing the Lorentz algebra (7.10) into rotations and boosts we find
A very important result from the representation theory is that the repre-
sentations of a group algebra is in one-to-one correspondence with the repre-
sentations of the group elements that are continuously connected to the unit
transformation, that is, of the form (7.7). Generally the Lorentz group also
contain elements that are not connected to the identity transformation. They
are given by the parity and time-reversal transformations. For the moment we
ignore these elements–which we discuss parity and time-reversal in the appendix
B – and focus on the connected subgroup. For this subgroup it suffices to work
out the representations of the Lorentz algebra (7.10) or (7.13-7.15). Define
1 1
JiL ≡ (Ji − iKi ), JiR ≡ (Ji + iKi ) . (7.16)
2 2
From (7.13-7.15) we find that these combinations satisfy
[JiL , JjL ] = iijk JkL , [JiR , JjR ] = iijk JkR , [JiL , JjR ] = 0 , (7.17)
that is the algebra of two sets of SU(2)s. We already know the representations
of SU(2) algebra from a basic quantum mechanics course. A generic finite
dimensional representation of SU(2) is labelled by a non-negative (half)-integer
1 3
J = 0, , 1, , · · ·
2 2
and given by (2J + 1) × (2J + 1) dimensional matrices. These matrices have
2J + 1 eigenvalues that correspond to the value of J3 :
J3 : −J, −J + 1, · · · + J
In fact, these are the finite dimensional irreducible representations, usually ab-
breviated as an “irrep”. A more generic reducible representation is obtained by
tensor products of these. For example a 2(J + J 0 ) + 2 dimensional matrix that
can be put in a block diagonal form with 2J + 1 and 2J 0 + 1 dimensional blocks
is a reducible representation.
• Scalar, (0, 0): This is the trivial representation. According to the rule
above, it only contains a spin-zero state. The quantum field that is based
on this representation is nothing else but the scalar field φ(x) that we
studied above.
• Left and right handed Weyl spinors, ( 12 , 0) and (0, 12 ): These are spinor rep-
resentations that transforms as a 2 dimensional spinor under the left(right)
SU(2) and trivially under the right(left) SU(2) respectively. They only
contain a spin-1/2 state under rotations. The quantum field that is based
on these representation are called left(right)-handed Weyl spinor fields
and will be denoted by ψaL (x) (ψaR (x)). The index a = 1, 2 denotes the
components of the spinor with spins up and down respectively. These
representations play a key role in QFT and represent the massless spin
1/2 fields. The Dirac spinor ψa is obtained as a tensor sum of the left and
right handed Weyl spinors. Therefore these representations form the basis
of the largest class of elementary particles, electrons, muons, quarks etc.
• Self-dual and anti-self dual antisymmetric tensors, (1, 0) and (0, 1): These
are 3-dimensional representations that only contains a spin-one state under
rotations. The associated quantum field can be written as an antisymmet-
±
ric matrix and denoted by Bµν . Note that the property of antisymmetry
under exchange of space-time indices is preserved under Lorentz transfor-
mations. That is, the transformed matrix B̄µν = (Λ−1 )α µ (Λ
−1 β
)ν Bαβ is also
anti-symmetric as the Lorentz matrices are symmetric. Therefore the anti-
symmetry property is respected by the irreps, hence can be used to reduce
general reducible representations. An antisymmetric 4 by 4 matrix has 6
components whereas this representation is supposed to have 3. There is a
+ −
further decomposition of an antisymmetric matrix Bµν = Bµν +Bµν where
the individual components satisfy the duality and anti-duality conditions
Bµν+
= 21 µναβ (B + )αβ and Bµν
−
= − 12 µναβ (B − )αβ . Note that these dual-
ity properties are also invariant under Lorentz transformations, hence are
respected by irreducible representations. The field strength of the gauge
field Fµν = ∂µ Aν − ∂ν Aµ transforms as a sum of the B + and B − repre-
sentsations. They further play an important role in characterising certain
topological field configurations called instantons.
1 Thisdecomposition is not Lorentz invariant and holds only in a Lorentz center of mass
Lorentz frame. A Lorentz invariant way to decompose the spin states canpbe obtained by
introducing the 4-velocity of the Lorentz frame uµ = γ(1, ~v ) where γ = 1/ 1 − |~v |2 . Note
that u2 = −1 in our metric convention. Then the decomposition reads Aµ = −uµ u · A +
(Aµ + uµ u · A). The first component is spin-zero and the second one is spin-one.
78CHAPTER 7. REPRESENTATIONS OF THE LORENTZ GROUP AND PARTICLES
• Left and right-handed Rarita-Schwinger spinors, (1/2, 1) and (1, 1/2): These
are 6 dimensional representations that contain spin 1/2 and spin 3/2 states
each. The associated quantum fields possess one vector one and spinor in-
L R
dex and denoted as ψµ,a and ψµ,a . Here µ is a space-time vector index and
a = 1, 2 is a spinor index. This contains 4 x 2 = 8 components which are
further reduced to 6 by the gamma-tracelessness condition γ µ ψµ,a L,R
= 0
µ
that are two independent conditions, where γ is the Dirac-gamma ma-
trix. Note that this condition is preserved by the Lorentz transformations.
They play an important role in supergravity theories and represent the su-
persymmetric partner of the graviton, called the gravitino.
Reading the examples I listed above you should have noticed that the finite
dimensional irreps of the Lorentz group are in one-to-one correspondence with
the different type of elementary (also non-elementary) particles. Indeed, in gen-
eral we label particle excitations by their spin, their mass and their charge under
the various global symmetry groups such as the electric charge, hypercharge, lep-
ton number, baryon number etc. The most fundamental among these, in the
sense that it applies to all elementary particles is the mass and the spin. This
is indeed dictated by the Lorentz symmetry. There are other quantum numbers
that enter the labelling of a particle state, such as the 4-momentum pµ , spin
projected on some axis Ji etc. but these numbers are frame-dependent, they
change from one Lorentz frame to another. Only the Lorentz invariant labels
enter the classification, i.e. we do not say an electron is a particle with momen-
tum 2.5 MeV in some direction, we say it is a particle with mass 0.5 MeV and
spin 1/2. These invariant labels are indeed determined by the different finite
dimensional irreps of the Lorentz algebra as we discussed above.
The story is in fact more subtle. The reason for this subtlety is that in
a quantum theory we need to represent all symmetry operations by unitary
operators acting on the Hilbert space, because only unitary operators leave
the norm of a state invariant, hence preserve probabilities. That is, Lorentz
transformation acting on a quantum field in a specific representation is defined
by
φA (x) → φ̄A (x) = U (Λ)−1 φA U (Λ) = LB
A φB (Λ
−1
x) , (7.18)
7.4. REPRESENTING THE POINCARE GROUP IN QUANTUM MECHANICS79
First, let’s see how the translations (7.20) work out. When (7.20) applies to
(7.21) it acts on the creation and annihilation operators inside φ. From (7.19)
and the fact that |pi = a(p)† |0i we learn that
which immediately yields (7.20). At the same time it does not mess up the
transformation property under Lorentz because, similar to.(7.22) the Lorentz
generators act on the creation/annihilation operators as
dimensional representations of the Lorentz group. We will show this below. For
now, we can make the following precise definition of an elementary particle:
First we identify the “Casimir operators” of the Poincare group. These are
operators that are quadratic in the group generators with the essential property
that they commute with all of the generators of the group. The Poincare group
is generated by Lorentz generators M µν and space-time translations P µ . Its
algebra is given by
[M µν , M ρσ ] = iη µρ M νσ − iη νρ M µσ + iη νσ M µρ − iη µσ M νρ
[P µ , M ρσ ] = iη µσ P ρ − iη µρ P σ (7.24)
µ ρ
[P , P ] = 0.
It is easy to show, by using the Poincare algebra, that there are only two Casimir
operators: the mass and the spin,
1
M 2 = P µ Pµ , J 2 = W µ Wµ , Wµ = µνρσ M νρ P σ , (7.25)
2
where W µ is called the Pauil-Lubansky vector. These are invariant under both
translations and Lorentz transformations thus can be used to label represen-
tations. Clearly the first operator corresponds to the invariant mass of the
representation.
To figure out the value of the second operator it is easiest to work in a specific
Lorentz frame. Clearly the value should be independent of this frame choice.
One should distinguish two cases M 2 > 0 and M 2 = 0. For M 2 > 0 one can
always choose the rest frame P µ = (m, 0, 0, 0). Then one finds J 2 ∝ Ji Ji . This
is the total spin operator (up to a proportionality constant m2 ) whose eigenvalue
is j(j + 1) in a representation with spin j. Therefore we characterise a massive
Poincare representation by its mass M 2 and its total spin j. Both are conserved
under time evolution because both of the operators M 2 and J 2 commute with
the Hamiltonian P 0 . They are also clearly invariant under changes of Lorentz
frame.
7.5. WIGNER’S CONSTRUCTION OF UNITARY REPRESENTATIONS 81
This is the value of spin in the direction of motion. It is quantized for the finite
dimensional representations discussed above. For a massless scalar h = 0, for
a massless Weyl spinor it is h = ±1/2. For a massless vector, h = ±1, for the
graviton h = ±2 etc. It is conserved under time evolution because both P~ and
J~ commute with P 0 . It is invariant under changes of Lorentz frame only when
M 2 = 0. Physically this is because one can only change the spin in the direction
of motion by a boost that reverses the direction of motion, which is impossible
for massless particles.
Let’s see how this works in practice. Again, we have to distinguish the
massive and the massless cases. In the massive case we can go to the rest frame
P µ = (m, 0, 0, 0). This means that all the boosts are fixed, because a boost
would change this fixed momentum. But the rotation subgroup O(3) leaves it
invariant, and we need to identify the irrep under rotations. This O(3) is called
the “little group”. It turns out that in quantum mechanics the correct group to
use is SU (2) as above. Finite dimensional representations are just the usual spin
states labelled by the (half)-integers J = 0, 1/2, 1, · · · . In a given representation
J there are 2J + 1 states −J, −J + 1 · · · , +J. This representation is both finite
dimensional and unitary.
For example, the field representation Aµ (x) for a massive vector particle
works as follows. Determine the wave-function of a given state with momen-
tum p~ for J = 1. This wave function µi (p) should be labelled by an index
i = 1, 2, 3 that corresponds to −1, 0, +1. In the special frame, they should sat-
isfy pµ µi (p) = 0 by Wigner’s construction. One can also normalize them by
requiring i,µ µi = 1. They are called the polarization vectors. Then the generic
field representation can be obtained by coupling these wave-functions with the
82CHAPTER 7. REPRESENTATIONS OF THE LORENTZ GROUP AND PARTICLES
creation and annihilation operators as usual and summing over all i and p~:
Z
µ
A (x) = dp ˜ eip·x ai (p)µ (p) + e−ip·x a† (p)µ∗ (p) . (7.27)
i i i
The trick works: even though the individual finite dimensional representations
µi (p), i.e. the wave-functions, transform non-unitarily under the Lorentz trans-
formations,
µi (p) → µi (p) = Λµν Λji νj (Λ−1 p) (7.28)
— because the Λµν is a non-unitary matrix for the boosts — the infinite di-
mensional representation Aµ (x) transforms unitarily because the action of the
Poincare group on A is given in terms of its action on the basis of creation/annihilation
operators
U (Λ)−1 ai (p)U (Λ) = Λji aj (Λ−1 p), U (Λ)−1 a†i (p)U (Λ) = Λji a†j (Λ−1 p) ,
(7.29)
where Λji is a rotation generator and it is unitary. This means that the one-
particle states transform unitarily under the Lorentz transformations. Yet the
action (7.30) generates the desired transformation property of Aµ :
as you can easily show by using (7.30), (7.28) and a change of integration variable
p → Λ · p in (7.27).
In the massless case instead one fixes the boosts by choosing P µ = (ω, 0, 0, ω).
Then the little group is O(2) that are rotations on the xy plane. Finite dimen-
sional representations are given by (half)-integers and they are labelled by the
helicities h = 0, 1/2, 1, · · · . In a given representation there are only two states
s = +h, −h. This is a unitary representation. The infinite dimensional field
representation is determined by first obtaining the wave-functions associated to
these states for a given momentum, then coupling them to the corresponding
creation/annihilation operators and finally summing over the helicity states s
and momenta p~. For example the field representation for a massless left or
right Weyl spinor works as follows. The wave functions for each helicity state
and fixed momentum are the spin 1/2 particles denoted as usa (p) and the spin
1/2 anti-particles denoted as vas (p). Here s is the helicity index running over
s = −1/2, +1/2 and a = 1, 2 is the spin index. The field representation is given
by Z
ψa (x) = dpe ˜ ip·x as (p)us (p) + e−ip·x b† (p)v s (p) . (7.31)
a s a
Wigner’s trick works as before: even though the individual spinors usa (p) and
vas (p) transform non-unitarily, the creation/annihilation operators transform as
0 0
U (Λ)−1 as (p)U (Λ) = Λss as0 (Λ−1 p), U (Λ)−1 b†s (p)U (Λ) = Λss b†s0 (Λ−1 p) ,
where Λji is a rotation generator and it is unitary. Therefore, the spinor one-
particle states transform unitarily under the Lorentz group action.
Chapter 8
Spinors
The left and right Weyl representation correspond to the two dimensional rep-
resentations of the SU(2) x SU(2) algebra (7.17) in terms of Pauli’s σ matrices
on one of the SU(2)s and trivially in the other:
1
(JiL )ba ψbL = (σi )ba ψbL , (JiR )ba ψbL = 0 , (8.2)
2
1
(JiR )ba ψbR = (σi )ba ψbR , (JiL )ba ψbR = 0 . (8.3)
2
Expanding (8.1) for infinitesimal transformations we find the following infinites-
imal transformations on the fields
1 1
δψ L (x) = − (iθi +ηi )σi ψ L (Λ−1 x), δψ R (x) = (−iθi +ηi )σi ψ R (Λ−1 x) (8.4)
2 2
What is the simplest Lagrangian for these fields? We need to require that this
Lagrangian
83
84 CHAPTER 8. SPINORS
• is a Lorentz scalar ,
• is real ,
• contains a single derivative in the kinetic term.
The last requirement is based on our discussion in section 1.3.2. The second
requirement is non-trivial unlike in the case of the real scalar field, because —
as clear from the transformation properties (8.4) — components of ψ L,R are in
general complex numbers. The first requirement, Lorentz invariance, however
is the most powerful one in constructing Lagrangians.
First, consider the kinetic term for ψ L . To construct a Lorentz scalar that
contains a single derivative, one needs to contract ∂µ with another object that
contains a space-time derivative. One almost have such an object for the spinor
fields, that is the collection of the sigma matrices σ i . In fact, the following
combinations
σ µ = (1, ~σ ), σ µ = (1, −~σ ) , (8.5)
does the job, and the simplest kinetic terms for the Weyl spinors which satisfy
all the requirements above can be written as,
LR = iψ R† σ µ ∂µ ψ R , LL = iψ L† σ µ ∂µ ψ L . (8.6)
You should check explicitly, using (8.4) above, that they transform as a scalar
under Lorentz transformations.
Before we discuss the solutions to the Dirac lagrangian and discuss the
quantization of spinors, it is important to note some properties of the Dirac
gamma-matrices and the spinors. As we already noted in section 1.3.2, the γ
matrices satisfy the Dirac algebra
{γ µ , γ ν } = −2η µν . (8.12)
The Lorentz generators in the Dirac representation are given by
i µ ν
M µν ≡ S µν = [γ , γ ] . (8.13)
Dirac 4
You can easily check that they reduce to (8.4) for the left and the right compo-
nents. It is also straightforward to verify that Sµν satisfy the Lorentz algebra
using (8.12). Generators of rotations are given by the spatial components
k
1 σ 0
S ij = ijk (8.14)
2 0 σk
as expected. For example the upper(lower) components of both ψ L and ψ R
have spin +1/2 (-1/2) in the z-direction. The boost generators are given by
i σi 0
S i0 = (8.15)
2 0 −σ i
Using the hermiticity properties of the γ matrices (8.9)
γ i† = −γ i , γ 0† = +γ i , (8.16)
or directly from (8.14) and (8.15) that one finds that the spin generators are
hermitean whereas the boost generators are anti-hermitean:
S ij† = S ij , S i0† = −S i0 . (8.17)
This means that, as we alluded to in the previous sections, the boost trans-
formations on the Weyl and Dirac spinors are non-unitary. Because of this
non-unitarity, the simplest expression you would guess for a mass term i.e. ψ † ψ
is in fact not a Lorentz scalar:
ψ † ψ → ψ † exp iδωi0 S i0 − iδωij S ij exp iδωi0 S i0 + iδωij S ij ψ 6= ψ † ψ .
The boosts screw up the Lorentz invariance. However, noting that γ 0 satisfies
S i0 γ 0 = −γ 0 S i0 , S ii γ 0 = +γ 0 S ij ,
the desired minus sign can be generated in the combination ψ̄ψ where ψ̄ is
defined in (8.11). Indeed
ψ̄ψ = ψ † γ 0 ψ → ψ † γ 0 exp −iδωi0 S i0 − iδωij S ij exp iδωi0 S i0 + iδωij S ij ψ = ψ̄ψ .
Therefore the combination ψ̄ is essential in obtaining expressions that have well-
defined Lorentz transformation properties. For instance, the combination
ψ̄γ µ1 · · · γ µn ψ
transforms as a contravariant n-tensor. In particular ψ̄γ µ ∂µ ψ is a Lorentz scalar.
Thus the Dirac lagrangian in (8.10) is indeed the simplest Lorentz scalar that
can be constructed from ψ with both a kinetic and a mass term.
86 CHAPTER 8. SPINORS
8.3 Chirality
The fact that the Dirac representation of the Lorentz algebra (8.13) is re-
ducible is directly seen by the presence of an operator that commutes with all
generators. This generator is called the chirality and given by
γ 5 ≡ iγ 0 γ 1 γ 2 γ 3 . (8.18)
γ 5 ψ L = −ψ L , γ 5 ψ R = +ψ R . (8.20)
{γ 5 , γ µ } = 0 , ⇒ [Sµν , γ 5 ] = 0 . (8.21)
The Dirac equations are derived from (8.10) by taking variations with respect
to ψ and ψ̄. We find
(i∂/ − m) ψ = 0 , (8.23)
and the hermitean conjugate of this equation. Here we introduced the shorthand
notation ∂/ ≡ γ µ ∂µ . Multiplying both sides of (8.23) by (i∂/ + m) we learn that
ψ automatically satisfies the Klein-Gordon equation
∂ 2 − m2 ψ = 0 .
8.4. SOLUTIONS TO THE DIRAC LAGRANGIAN 87
The solution with p0 < 0 is obtained following the same steps. For the
generic solution we have
Z Z
ψ− (x) = dp˜ ṽs (~ ˜ vs (~
p)e+iωt+i~p·~x = dp p)e−ipx , (8.29)
Having found all the solutions we can now write down the most general
solution to (8.23) as follows:
2 Z
X
ψ= ˜ eipx us (~
dp p) + e−ipx vs (~
p)as (~ p)b∗s (~
p) , (8.34)
s=1
p
with p0 = ω = |~ p2 | + m2 and a(~p) and b(~
p) are arbitrary complex coeffi-
cients. These coefficients will be promoted to creation/annihilation operators
of one-particle states when we quantize the theory. This solution is an infinite
dimensional field representation of the Poincare algebra.
To get an idea about the spinor solutions let us consider the example of
a spinor moving in the z direction with momentum pz . The corresponding
solutions are
√
ω − pz 0
√
0 , u2 (pz ) = ω + pz ,
u1 (pz ) = √
ω + pz
0
√
0 ω − pz
√
0 ω − pz
√
ω + pz
v1 (pz ) = , v2 (pz ) = √ 0
0 − ω + pz ,
√
− ω − pz 0
where the components s = 1 and 2 correspond to spin up and down states
respectively. In the massless limit m → 0 the energy of the particle becomes
ω → |pz | thus pz = ±ω. These solutions become eigenstates of the helicity
operator (??) in both cases. Using (8.14) one can write the helicity operator as
~σ · p~
h= . (8.35)
p|
2|~
For example for pz = +ω we have
0 √0 √0 0
0 2ω 2ω 0
u1 → √
2ω , u2 → 0 ,
v1 →
0 , v2 → √
− 2ω ,
0 0 0 0
with helicity eigenvalues h = +1/2, −1/2, −1/2 and +1/2 respectively. We
observe that they coincide perfectly with the chirality eigenvalues which is −1
8.5. SPIN AND STATISTICS 89
for the left-handed components (upper two) and +1 for the right-handed com-
ponents (lower two). The same is true for the other case, pz = −ω. We learn
that the helicity and chirality eigenstates coincide in the massless limit. These
eigenvalues are also conserved under the time evolution in the massless limit.
using (8.14). We find that under a full 2π rotation the spinor picks up a minus
sign. Only a double rotation by 4π would get us back the same spinor.
Now consider the following setting: two spin-up states located o the x-axis
at ±x and rotate the system by π. Applying (8.36) for θ = π to both spin states
one generates an overall minus sign in the total state
But, since the two particles are identical we cold obtain the same final configura-
tion by exchanging the positions of the two states. That is to say, |ψ↑ (−x)ψ↑ (x)i =
− |ψ↑ (x)ψ↑ (−x)i , hence spinors should anti-commute:
This is opposite of fields with integer spin, in which case the particles have boson
statistics i.e. they commute.
We can now quantize the spinors using the canonical quantization method.
The canonical “position” field is ψ(x). We obtain the canonical “momentum”
field by varying the Dirac lagrangian Start with the Langrangian:
and obtain
δL
πψ = = iψ̄γ 0 . (8.39)
δ∂0 ψ
As demonstrated in the previous section we should impose the canonical equal
time anti-commutation relations:
{ψα (~x, t), πψ,β (~y , t)} = iδ 3 (~x − ~y )δαβ (8.40)
{ψα (~x, t), ψβ (~y , t)} = 0
{πψ,α (~x, t), πψ,β (~y , t)} = 0.
Then the question is how to write the general quantum spinor that solves the
Dirac equation (8.23). We determined the solutions in the previous section. The
most general solution is of the form (8.34) which I reproduce here:
2 Z
X
ψ= ˜ eipx us (~
dp p) + e−ipx vs (~
p)as (~ p)b∗s (~
p) . (8.41)
s=1
The annihilation operators are defined to annihilate the vacuum state, the state
with neither particles nor anti-particles:
p) |0i = 0 ,
as (~ p) |0i = 0
bs (~ ∀s , ∀~
p, (8.44)
We normalise the vacuum state as usual h0|0i = 1. The creation operators
create one-particle and one-anti-particle states out of the vacuum instead:
a†s (~
p) |0i = |p, s, +i , b†s (~
p) |0i = |p, s, −i , (8.45)
where I denote the particles by + and anti-particles by -.
and all the rest vanish. We can immediately see that the one-(anti)-particle
states are properly normalised, that is, the probability amplitudes are invariant
under Lorentz transformations
p), a†s0 (~
hp, s, +|p0 , s0 , +i = h0| {as (~ p0 )} |0i = (2π)3 δ 3 (~
p − p~0 )δss0 2ω , (8.48)
which is invariant under the Lorentz transformations. This already indicates
that our representation (8.42) is a unitary representation. As discussed at the
end of section 6, a general boost will act on the creation/annihilation operators
as (this directly follows from (??)):
0 0
U (η)−1 as (p)U (η) = Rss (η)as0 (Λ(η)−1 p), U (η)−1 b†s (p)U (η) = Rss b†s0 (Λ−1 p) ,
(8.49)
where R is a rotation matrix that represents how the spin of the particle ro-
tates, which depends on the orientation of the boost ~η . For example when
0 0
we boost along the spin direction then Rss = δss . It is straightforward to see
that this action, which is unitary on the basis states, when applied on the field
representations (8.42), (8.43) generates the desired spinor transformation law:
U (Λ)−1 ψa (x)U (Λ) = Lba (Λ)ψb (Λ−1 x) , (8.50)
which indeed demonstrates that going from finite dimensional spinor represen-
tations to the the infinite dimensional spinor field representation we managed to
represent the Lorentz group with a unitary action on the Hilbert space states.
The commutation relations (8.46), (8.47) and the oscillator expansions (8.42)
and (8.43) are sufficient to obtain the correlator of the spinor fields h0| ψ(x)ψ̄(y) |0i
etc. Using the definition of the vacuum state (8.44) we find
Z
h0| ψa (x)ψ̄b (y) |0i = ˜ ip(x−y) (−p/ + m)ab ,
dpe (8.51)
Z
h0| ψ̄b (x)ψa (y) |0i = ˜ −ip(x−y) (−p/ + m)ab ,
dpe (8.52)
(8.53)
where we use the completeness relations (exercise)
X
us (~
p)ūs (~
p) = −p/ + m . (8.54)
s
The other correlators just vanish h0| ψb (x)ψa (y) |0i = h0| ψ̄b (x)ψ̄a (y) |0i = 0. As
we discussed for the scalar fields the Feynman propagator is obtained by time
ordering of this correlator. However, there is one important difference in the
prescription for time ordering. Since spinors are fermions we need to take into
account the extra minus sign which arises when we reorder the two operators
inside the correlator:
ψa (t1 )ψb (t2 ) t1 > t2
T ψa (t1 )ψb (t2 ) = , (8.55)
−ψb (t2 )ψa (t1 ) t2 > t1
92 CHAPTER 8. SPINORS
This follows from doing the p0 integral as a contour integral and closing the
contour from above for x0 < y 0 and from below for y 0 < x0 . Using this identity
we obtain our final expression for the time-ordered spinor propagator:
Z
d4 p ip(x−y) (−p/ + m)ab
h0| T ψa (x)ψ̄b (y) |0i = −i e . (8.57)
(2π)4 p2 + m2 − i
A similar calculation shows that the others vanish:
h0| T ψa (x)ψb (y) |0i = h0| T ψ̄a (x)ψb (y) |0i = 0 . (8.58)
The generating function for the spinors is written as a path integral com-
pletely analogous to the scalar path integral we discussed above: integrating
over all canonical spinor field configurations from t = −∞ to ∞ (with a slight
tilt in the time-contour) yields the vacuum-to-vacuum amplitude with sources:
Z
Z(η̄, η) = DψDψ̄ ei d x{−ψ̄(−i∂/+m)ψ+η̄ψ+ψ̄η}
R 4
(8.59)
where η and η̄ are the sources for the ψ̄ and ψ fields respectively. The main
difference from the scalar fields is that these path integrals should now be de-
fined as Grassmann variables. Properties of Grassmann integrals are detailed
in section 43 of Srednicki (also in Statistical Field Theory). We will only need
the following modification of the functional derivatives here:
Z
δ
d4 y η̄(y)ψ(y) + ψ̄(y)η(y) = −ψ̄(x) (8.60)
δη(x)
Z
δ
d4 y η̄(y)ψ(y) + ψ̄(y)η(y) = +ψ(x) . (8.61)
δ η̄(x)
Now we can obtain the time-ordered spinor propagator directly from the gen-
erating function. Let us recall that the propagator, as it follows from the path
integral is nothing but inverse of the kinetic term operator in the lagrangian.
For example for the complex scalars we have:
Z
Z(J , J) = DφDφ† ei {−φ Oφ+J φ+φ J } ,
† † †
R
†
(8.62)
This expression in the momentum space becomes the literal inverse: For
Z
d4 p ip(x−y)
O(x, y) = e Õ(p)
(2π)4
The bottomline of this computation is that you can read off the time-ordered
propagator directly from the lagrangian without any computation, as inverse of
the kinetic term operator.
The same is true for the spinors. In this case the generating function is
given by (8.59) and the kinetic term operator is O = −i∂/ + m with the inverse
in the momentum space O−1 (p) = (−p/ + m)/(p2 + m2 − i) hence we obtain the
same expression as (8.57).
Chapter 9
The next irrep on our list in section 7.3 is (1/2,1/2). This representation
has 4 degrees of freedom, therefore it contains 4 fields when we represent it
using fields . Under rotations these 4 degrees of freedom will be decomposed
as 1+3, the first being a scalar (spin-0), the second a vector (spin-1). We
denote this collection of four fields by a space-time vector Aµ . We need to
find a lagrangian that represents the kinetic term for the 3-vector degrees of
freedom inside this Aµ , and this should be done in a Lorentz covariant way.
~ and just ignoring A0 would not work because this
Hence writing Aµ = (A0 , A)
separation is not invariant under Lorentz transformations which naturally mix
time and space components.
Let us begin with the most natural candidate, a direct generalization of the
scalar field:
1 m2
LA = − ∂µ Aν ∂ µ Aν − Aν Aν .
2 2
There are two issues with this lagrangian. Issue i): it leads to the equation of
motion (∂ 2 − m2 )Aµ (x) = 0. This EoM implies however that the components
of Aµ do not mix at all under time evolution, hence they decompose into four
scalar fields, A0 , · · · A3 . This is not a spin-1 representation but 4 times a spin-
0 representation. Issue ii): Upon quantization, we would write the oscillator
expansion, in analogy with the real scalar case as,
Z
Aµ (x) = dp ˜ aµ (p)eipx + a† (p)e−ipx ,
µ
where aµ (p) (a†µ (p)) with p2 + m2 = 0 destroys (creates) a particle with index
µ. Just as in the real scalar case these creation/annihilation operators should
94
9.1. LAGRANGIAN FOR THE VECTOR FIELD 95
|a†0 (p) |0i |2 = h0| a0 (p)a†0 (p) |0i = −(2π)3 2ωδ 3 (0) .
The norm is negative definite! This leads to negative probabilities which does
not make sense. This is an indication that the quantum theory that follows
from quantizing the lagrangian above is non-unitary.
Now multiply both sides with ∂ ν and choose a = −b and assume that m2 6= 0:
Then we obtain the constraint
m 2 ∂ ν Aν = 0 . (9.3)
and recognize the first term as the spin-1 part and the second as the spin-0 part,
we see that the constraint (9.3) allows us to set the second one to zero, making
sure that the field Aµ only contains the component with spin-1.
It also solves issue ii) we mentioned above. The problem with unitarity that
arose from the temporal component of the gauge field upon quantization is no
longer there because the constraint (9.3) relates the temporal component to the
spatial ones:
A0 (k) = −ki Ai /k 0 ,
which means that we do not need to quantize the A0 component independently.
Hence the negative norm states would not arise (at least at the tree level).
96 CHAPTER 9. VECTOR FIELDS AND GAUGE INVARIANCE
We saw that the choice of a = −b in (9.1) solves our problems. With the
standard normalization choice a = −1 we can write the lagrangian neatly as
1 1
LA = − F µν Fµν − m2 Aν Aν , (9.5)
4 2
where we introduced the antisymmetric tensor
Fµν = ∂µ Aν − ∂ν Aµ . (9.6)
For those of you who have studied electrodynamics in the tensor formalism will
recognize this as the tensor whose components are the electric and the magnetic
fields. This is not the theory of electromagnetism yet as we have a finite mass
term in (9.5). We will discuss QED in the next chapter. Using the constraint
(9.3) the equation of motion that follows from varying (9.5) with respect to Aν
(or just setting a = −b = −1 in (9.2) reads
∂ 2 − m 2 Aν = 0 , (9.7)
which still looks like the equation of motion for a collection of 4 scalars, but it
is not because of the constraint we should impose on the solutions. The general
solutions to (9.7) are of the same form as the scalar except that we now have
the index ν. We also have to take into account the fact that only the spin-1 of
the vector Aν survives due to the constraint. The situation resembles the case
of spinors which also satisfied the Klein-Gordon equation but then imposing the
Dirac equation on top of the solutions to the Klein-Gordon equation required
p) and vas (~
us to include the spinor solutions usa (~ p) which maps the spinor index
a to the spin-1/2 polarization index s. Here, for the massive spinor, we need
a solution which maps the space-time vector index ν to the spin-1 polarization
index λ. These solutions are called the polarization vectors and denoted by
λν (~
p). In analogy with spinors, we can now write the most general solution as,
Z 3
X
Aν (x) = ˜
dp p) + e−ipx aλ∗ (p)λ∗
eipx aλ (p)λν (~ ν (~
p) , (9.8)
λ=1
pµ λµ (~
p) = 0 , ∀λ . (9.9)
As a result of this constraint there are only three independent basis vectors
which we denote by λ = 1, 2, 3. This label corresponds to the 3 spin states in
the spin-1 representation of the rotation group. In this sense λ are analogous
to us and v s of the spinors. In this field representation there are 3 basis vectors
per given momentum p~. Therefore in total there are infinitely many basis states.
Upon quantization these states λ (~ p) will correspond to the basis vectors in the
Hilbert space.
We can obtain the lagrangian of the massless vector field directly from (9.5)
by taking the m2 → 0 limit:
1
LEM = − F µν Fµν , (9.11)
4
with the field strength Fµν defined in (9.6). You recognize this as the lagrangian
for the electromagnetic field. Indeed we interpret Aµ as the scalar and the
vector potentials of electrodynamics as A0 = −A0 = V the scalar potential
and A~ the vector potential. Then the electric and magnetic fields are given as
E~ = −∇V − ∂t A ~ and B~ =∇ ~ ×A ~ which can be written as
1
E i = ∂ 0 Ai − ∂ i A0 = F 0i Bi = ijk ∂j Ak = ijk F jk . (9.12)
2
Then we indeed obtain the lagrangian for the electromagnetic field from (9.11)
1 1 2
LEM = − 2F0i F0j η 00 δ ij + Fij Fkl δ ik δ jl = ~ − |B|
|E| ~ 2 . (9.13)
4 2
The equations of motion follow from setting the variation of (9.11) with respect
to Aν to zero and they read,
∂µ F µν = 0 . (9.14)
The individual components ν = 0 and ν = i give
~ ·E
∇ ~ =0 ~ ×B
∇ ~ = −∂t E
~
which just follows from the definition Fµν = ∂µ Aν −∂ν Aµ . Physically this means
that the total number of 6 components in the electric and magnetic fields are
not independent but they arise from an underlying gauge potential Aµ . Written
in components for µ = 0 and µ = i equation (9.15) indeed produce the two
other Maxwell’s equations
~ ·B
∇ ~ =0 ~ ×E
∇ ~ = ∂t B
~.
Therefore we can be sure that this is the correct theory to quantize to obtain
the quantum mechanical theory of light.
All aforementioned issues are solved at once by realizing that the lagrangian
(9.11) has the following continuous symmetry called the gauge symmetry:
where α(x) is non-singular and real, otherwise arbitrary. This means that two
vector fields Aν (x) and A0ν (x) which differ by gradient of a function are physi-
cally equivalent, and the system is said to be gauge invariant. From here on I
will call the massless vector field A the gauge field.
1. Lorentz gauge: ∂µ Aµ = 0 ,
9.5. GAUGE FIXING IN THE COULOMB GAUGE 99
2. Coulomb gauge: ∂i Ai = 0
3. Temporal gauge: A0 = 0 ,
etc. Of course, all the physical results such as scattering amplitudes, decay prob-
abilities etc. should be independent of the choice of gauge but certain gauges
have the advantage of making certain property of the theory manifest. For in-
stance the Lorentz gauge makes the Lorentz invariance manifest, the temporal
gauge makes the unitarity of the theory manifest, the Coulomb gauge simplifies
the canonical quantization etc.
Let us now work out the gauge-fixing procedure in the Coulomb gauge:
~ ·A
∇ ~ = 0. This can easily be reached by appropriately choosing α such that
~ ~
∇·A → ∇ ~ ·A~ + ∇2 α = 0, that is because, the Poisson equation ∇2 α = −∇~ ·A~
1
can always be solved The equations of motion (9.14) in the Coulomb gauge
when written in components read
−∇2 A0 + ∂t ∇ ~ ·A
~ = −∇2 A0 = 0 , (9.17)
and
∂ 2 Ai − ∂ i ∇~ ·A
~ − ∂t A0 = ∂ 2 Ai + ∂t ∂i A0 = 0 (9.18)
λ0 = 0 , pj λj = 0 ∀λ .
1 This is possible at least locally, up to possible global obstructions which we assume absent.
100 CHAPTER 9. VECTOR FIELDS AND GAUGE INVARIANCE
Now recall that for p2 = 0 one can go to a frame where the four-momentum reads
pµ = (ω, 0, 0, ω). Then it is immediate to see that there are only two linearly
independent solutions to these equations. Imposing normalization ∗µ µ = +1
one can choose them as
These two polarizations are called transverse. One can also solve the equations
above by a different choice, for example,
1 1
+
µ = √ (0, 1, i, 0) , −
µ = √ (0, 1, −i, 0) . (9.21)
2 2
With this choice the vector field is circularly polarized and they correspond to
the right-handed and left-handed helicity eigenstates respectively.
Canonical quantization of the theory proceeds by first fixing the gauge and
then promoting the Poisson brackets between the canonical position and canon-
ical momenta to commutators in this gauge. Therefore the quantized field will
look different for different gauge choices. Of course the physical quantities
should in the end be independent of this choice. Let us work out canonical
quantization of the gauge field in the Coulomb gauge.
We have seen that the Coulomb gauge constrains both the divergence of the
spatial components and the temporal component of the gauge field as
∂i Ai = 0 , A0 = 0 .
This is indeed the correct form when the gauge field Aj does not have to satisfy
any constraint. It would be inconsistent with the constraint ∂i Ai = 0 because
when we take ∂i of both sides we see that the LHS vanishes but the RHS
does not. In fact, the Coulomb constraint projects the gauge field to a certain
combination of its components with vanishing divergence. If we denote the
gauge field that satisfies the Coulomb constraint as AC
i then this projection can
be written as
C ∂i ∂j
Ai (x) = Pij (x)Aj (x), Pij (x) = δij − 2
∇
in the momentum space. Therefore the correct form of the commutator for the
gauge field AC
i which does satisfy the constraint is given by taking the projection
of both sides of (9.25) and reads,
∂i ∂j
C
Πi (~x, t), Aj (~y , t) = i δij − 2 δ 3 (~x − ~y ) . (9.26)
∇
The quantum field is obtained from the classical solution (9.19) as usual by
promoting the coefficients ai and ai∗ to annihilation and creation operators
respectively:
Z 2
X
Aν (x) = ˜
dp p) + e−ipx aλ† (p)λ∗
eipx aλ (p)λν (~ ν (~
p) , (9.27)
λ=1
λ0 = 0 pj λj = 0 ∀λ
Quantum vector fields can be studied using path integrals by formally writ-
ing down the path integral over all possible gauge field configurations just like
for scalars and spinors. The vacuum-to-vacuum transition amplitude for the
massless vector is
Z R 4 µ
Z[Jext ] = DAµ ei d x(LEM −Aµ Jext ) , (9.29)
where we introduced and “external current” that is a source for the gauge field
Aµ . To make sure that this defines vacuum-to-vacuum amplitude we have to
choose the tilted time contour in the complex plane as before.
This also makes sense from the point of view of counting the degrees of freedom.
In general we should introduce one source per degree of freedom. As we have
seen above, the gauge field has only 3 real degrees of freedom: one per each
component of Aµ minus the degree of freedom removed by gauge symmetry.
Therefore we need to couple it to 3 degrees of freedom in total which is precisely
µ
the case with Jext with the constraint (9.30).
However, there is another issue with (9.29). There is a new type of diver-
gence associated with this path integral which arises from the gauge symmetry:
As the action is invariant under a gauge transformation the value of the inte-
grand of the path integral is the same for any gauge field configurations Aµ and
A0µ that differ by ∂µ α for all choices of α. Since the path integral sums over
all possible configurations a particular value of the integrand that arises from
a particular configuration Aµ is counted infinitely many times, causing a diver-
gence. There is an elegant way to fix this issue by the so called Faddeev-Popov
procedure which I describe in Appendix C. For the sake of our discussion here it
suffices to proceed by introducing a lagrange multiplier to fix the gauge symme-
try inside the path integral. This can be done by introducing a term of the form
λG[A] where λ is a lagrange multiplier and G[A] = 0 some functional of Aµ .
That is, minimizing the lagrangian with respect to λ imposes the gauge-fixing
condition G[A] = 0 . We chose the Coulomb gauge to quantize the field in the
canonical formalism in the previous section. This gauge manifestly breaks the
Lorentz symmetry which is not a big issue in the canonical formalism as it treats
time and space differently by defining the time evolution with the Hamiltonian,
9.8. PHOTON PROPAGATOR 103
by defining the commutation relations at a fixed time slice etc. On the other
hand keeping the space-time symmetries e.g. Lorentz invariance manifest in
the path integral formalism is crucial as we derive all the associated conserved
charges, including the Hamiltonian from the invariance of the action. Thus it
makes more sense to use the Lorentz gauge ∂µ Aµ = 0 instead, so G[A] should
be proportional to ∂µ Aµ = 0. We also have to make sure that the kinetic term
in the full lagrangian which involves the time derivatives is positive definite for
stability. The simplest term to add then is a quadratic of the form −λ(∂ · A)2
with λ > 0. For historical reasons, one denotes this term as −(∂ · A)2 /2ξ and
the theory that is defined with this gauge fixing term is said to be in the “Rξ
gauge”. Thus, our generating function is
Z R 4 µν µ 2 µ
Z[Jext ] = DAµ ei d x(− 4 Fµν F − 2ξ (∂µ A ) −Aµ Jext ) .
1 1
(9.31)
One obtains the n-point functions of the gauge fields from this generating func-
tion by taking variational derivatives with respect to Jext as usual.
We can now derive the propagator of the photon directly from the path
integral (9.31). For this we use the method explained below equation (8.62):
Given any lagrangian density of a field φA with some generic indices A with the
quadratic part −φA OAB φB the propagator is given by
−1
h0| T φA (x)φB (y) |0i = −i OAB (x, y) . (9.32)
where the i in the denominator arises from the tilted time contour in the path
integral as usual. The fact that the photon propagator depends on the gauge
fixing parameter ξ seems disappointing at first. However, this dependence neatly
drops out of all physical quantities such as the scattering amplitudes and decay
2 This is the most general symmetric tensor consistent with Lorentz symmetry.
104 CHAPTER 9. VECTOR FIELDS AND GAUGE INVARIANCE
probabilities. One can easily see this by the fact that a scattering amplitude that
involves an external photon involves the external wave-function µ (k) contracted
with the propagator, that is, the propagator (9.34) will always appear contracted
with µ (k) in a physical observable, and the second term in (9.34) then drops out
of this quantity because of the Lorentz gauge condition k µ µ = 0, see (9.27). The
result that the gauge fixing procedure does not have any bearing on the physical
quantities in general is due to a general theorem, called the Ward identity which
shows that the second term in the numerator of the propagator (9.34) drops out
of all scattering amplitudes. I will not prove this identity in these introductory
lectures, see Peskin&Schroeder, or Schwartz for a good discussion.
Chapter 10
Quantum electrodynamics
∂µ F µν = J ν , (10.1)
∂ν J ν = 0 . (10.2)
This is just the statement that charge cannot be created or destroyed: if the
charge density in a region of space is increasing in time then it should be that
some charge is being transported by a current from outside. This is the conser-
vation of charge.
1
LEM = − F µν Fµν − Aµ J µ , (10.3)
4
whose variation with respect to Aµ now yields (10.1). This lagrangian is in-
variant under the gauge transformation Aµ → Aµ + ∂µ α despite the second
term. This is because an integration by parts in the second term yields α∂µ j µ
which vanishes by the continuity equation (10.2). In other words, if we want
to maintain gauge invariance in the presence of matter we need to require that
the charge current that couples to.the gauge field is conserved. The coupling of
matter to gauge fields in the form (10.3) is called the minimal coupling.
105
106 CHAPTER 10. QUANTUM ELECTRODYNAMICS
Then, we can minimally couple Dirac fermions to gauge field by taking the
µ
current in (10.3) to be JD . The resulting theory is called Quantum Electrody-
namics, QED for short:
1
LQED = − F µν Fµν + iψ̄∂/ψ − mψ̄ψ − e Aµ ψ̄γ µ ψ, . (10.6)
4
10.2. COVARIANT DERIVATIVES AND ‘GAUGING A SYMMETRY’ 107
This is the quantum theory of Dirac fermions interacting with the electromag-
netic force, and it is, as far as we know today, the most successful theory in
physics. Agreement of theory with experiment is unprecedented by any other
quantum or classical theory that we know today.
We note that the QED lagrangian (??) can be neatly written as follows
1
LQED = − F µν Fµν + iψ̄D
/ψ − mψ̄ψ , (10.7)
4
where we defined the covariant derivative
Dµ ≡ ∂µ − i e Aµ . (10.8)
The meaning of the covariant derivative becomes clear by considering the al-
ternative derivation of the Noether’s current above where we assumed a space-
time dependent symmetry transformation parameter α(x). In fact the gauge
transformation Aµ → Aµ + ∂µ α(x) is precisely what is required to make the
lagrangian (10.6) invariant under ψ → exp(iα(x))ψ , ψ̄ → exp(−iα(x))ψ̄.
This combined transformation is the gauge symmetry of the QED lagrangian:
Given any continuous global symmetry of the theory, one can try to gauge
it, i.e. one can promote the transformation parameter to a function of space-
time by including a gauge field and require that the transformation of the gauge
field cancels that of the derivative of the space-time dependent phase of the field
just as in the example above. A covariant derivative achieves this neatly as it
is precisely the combination that transforms covariantly:
Dµ ψ → eiα(x) Dµ ,
which means that once all the derivatives in the lagrangian are written in terms
of covariant derivatives it is guaranteed to be invariant. This procedure of
promoting ordinary derivatives to covariant derivatives is called gauging a global
symmetry. It works perfectly fine for all global continuous symmetries as long
108 CHAPTER 10. QUANTUM ELECTRODYNAMICS
p −i(−p/+m)
Spinors : = p2 +m2 −i
p −igµν
Photons : µ ν = p2 −i
Figure 10.1: Photon and spinor propagators in the momentum space. The
photon propagator is in the Feynman gauge ξ = 1.
as the symmetry is free of so-called anomalies. I will not dwell into anomalies
here, this will be a subject of a more advanced QFT course. It suffices here to
assume that there are no obstructions in gauging the electric U(1) symmetry of
the Dirac theory.
p
= ✏µ* (p) incoming photon
µ
p
= ✏⇤µ (p) outgoing photon
p µ
= ✏µ (p) incoming photon
µ
pp
= ✏ū⇤µs(p)
(p) incoming electron
outgoing photon
µ
pp
= ✏uµs(p)
(p) outgoing
incoming electron
photon
µ p s
= ū (p) incoming electron
p
= ✏⇤µ (p) outgoing photon
pp µ
= uv̄ss(p) incoming
= positron
outgoing electron
pp
== ūvss(p) incoming
outgoing positron
electron
p
= v̄ s (p) incoming positron
p s
Figure 10.2: Momentum = uFeynman
space (p) outgoing
rules for the electron
external states in QED,
p
photon, electron and positron. s Dot denotes the location where the external
= v (p) outgoing positron
particle is inserted in the diagram. Thick arrows indicate the direction of mo-
mentum flow. Note that the direction of the arrow coincides with the direction
of momentum for p
electron, but it
s is the opposite for the positron.
= v̄ (p) incoming positron
p
= v s (p) outgoing positron
= i e γµ
Figure 10.3: Momentum space Feynman rule for the QED vertex.
110 CHAPTER 10. QUANTUM ELECTRODYNAMICS
µ ν µ ν
k1 k2
k1 k2
p1 p1 − k1 p2
+p p1 − k1 p2
1
Figure 10.4: Two topologically distinct diagrams that contribute to the process
e− e+ → γ γ at the tree level.
XZ Z Z ←→
hψ| a†1 (t) |0i = −i d3
pψn∗ (p) 3
d kf1 (k) d3 x eikx ∂0 e−ipx An (p)
n
XZ 0
−k0 )t
= d3 pψn∗ (p)f1 (p)An (p)(p0 + k 0 )ei(p ,
n
where in the last line we performed the ~x integral and used the resulting delta-
p − ~k) to eliminate thep~k integral. The multipartticle
function δ 3 (~ p and single
particle energies are given by p0 = |~ p| + M 2 and k 0 = |~
p| + m2 where M is
the total mass of the multiparticle state |ψi, Clearly RM ≤ 2m > m hence p0 >
k 0 . Recall the Riemann-Lebesque lemma limt→±∞ d3 pF (p) exp(iz(p)t) = 0
for z(p) > 0 and F (p) has a compact support in p, or it can be defined as a limit
of a function with a compact support in p. The compact support can indeed
be assured by an appropriate choice of the function f1 (p) like the Gaussian in
(10.11). Then the proof is complete. Note that the proof extends to the delta-
function peaked creation operator we used in the text because delta function
can always be defined as a limit of a function with compact support.
10.4. PAIR ANNIHILATION 111
Tνµ = diag(−1, 1, 1, 1)
In order to obtain the anticommutators (8.46) and (8.47) between the spinor
creation and annihilation operators, we need to express the creation/annihilation
112 CHAPTER 10. QUANTUM ELECTRODYNAMICS
operators in terms of the fields ψ(x) and ψ̄(x). To do so, let us first prove the
so called “Gordon identities”:
p0 )γ µ us (~
2mūs0 (~ p0 ) [(p + p0 )µ − 2iM µν (p0 − p)ν ] us (~
p) = ūs0 (~ p) (10.12)
p0 )γ µ vs (~
−2mv̄s0 (~ p0 ) [(p + p0 )µ − 2iM µν (p0 − p)ν ] vs (~
p) = v̄s0 (~ p) . (10.13)
We start by writing
1 µ ν 1 µ ν
γµp
/= γ , γ + [γ , γ ] pν = −pµ − 2iM µν pν
2 2
0 µ 1 ν µ 1 ν µ
p/γ = γ , γ + [γ , γ ] p0ν = −p0µ + 2iM µν p0ν .
2 2
Equations (10.12) and (10.13) follow from adding these equations and using the
spinor equations of motion:
(p
/ + m)us (~
p) = 0, (−p
/ + m)vs (~
p) = 0, ūs (~
p)(p/ + m) = 0, v̄s (~
p)(−p/ + m) = 0 .
ūs0 (~
p)us (~
p) = 2mδss0 , v̄s0 (~ p) = −2mδss0 .
p)vs (~ (10.14)
We find:
p)γ µ us (~
ūs0 (~ p) = 2pµ δss0 , p)γ µ vs (~
v̄s0 (~ p) = 2pµ δss0 . (10.15)
and Z
bs (p) = d3 xe−ipx ψ̄(x)γ 0 vs (~
p) . (10.19)
The anticommutators (8.46) and (8.47) then immediately follows from (10.16),
(10.17), (10.19) and (10.18).