Consider the amplitude for a free particle to propagate from x0 to x:
U(t)=⟨x∣e−iHt∣x0⟩
In the nonrelativisitic quantum mechanics, we have E=2mp2≡2mp⋅p (we will replace Hamiltonian operator by its eigen value), so
U(t)=⟨x∣e−i(2mp2)t∣x0⟩=Using completeness relation, ∫(2π)3d3p∣p⟩⟨p∣=1^=∫(2π)3d3p⟨x∣e−i(2mp2)t∣p⟩⟨p∣∣x0⟩=(2π)31∫d3pe−i(2mp2)t⟨x∣p⟩⟨x0∣p⟩†where, e−i(2mp2)t is just a number.=Using ⟨x∣p⟩=eip⋅x.=(2π)31∫d3pe−i(2mp2)teip⋅(x−x0).=Using Gaussian integral property,∫−∞∞e−ax2+bx+cdx=aπe4ab2+c.=(2π)31(2mitπ)3exp(4(2mit)i2(x−x0)2)=(2π)3/2−3(itm)3/2exp(4iti2(x−x0)22m)=(2πitm)3/2eim(x−x0)2/2t.
Some notes on completeness relations from a functional analysis point of view
Completeness relation allows us to define the inner product. Let’s understand it with an example using position space. It can be done in momentum space as well.
→ For a single free particle moving in n-dimensional Euclidean (flat) manifold Rn, we can have a complete orthonormal set of position basis vectors {∣x⟩}. So, we can define
⟨x∣y⟩∫Rndnx∣x⟩⟨x∣=δ(x,y),=1^.
We can identify the Hilbert spaceH of such a system with the square-integrable complex-valued functions L2(Rn,C) with the inner product
where ϕx≡ϕ(x):=⟨ϕ∣x⟩ is the position basis coefficient, and same for ψx. Thus, ψx∗=(⟨ψ∣x⟩)∗=⟨x∣ψ⟩. The unique existence of their spaces is guaranteed by the Riesz representation theorem.
I showed you how the completeness relation is used to define the inner product. It was possible because the position basis localized the state of a particle. But, this naive notion of position basis is not viable for fields (or differential forms) in Riemannian manifold (M,g) where the metric g is not necessarily flat. It would be out of the scope of this note to further discuss the issue but, I will at least give you short reason.
→ Suppose our ϕ is a k-forms in the space of differentials k-forms Ωk(M). Due to the Hodge duality, we can find (n−k)-forms ∗ϕ∈Ωn−k(M) such that ϕ↔∗ϕ where
The duality is up to a sign. i.e. ∗∗ϕ=(−1)k(n−k)ϕ. The inner product of k-forms is defined as
(ϕ,ψ)=∫Mϕ∧∗ψ=Using above definitions, we get∫Mϕi1…ikdxi1∧…∧dxik∧(∗ϕ)ik+1…indxik+1∧…∧dxin=∫Mϕi1…ik(∗ϕ)ik+1…indxi1∧…∧dxik∧dxik+1∧…∧dxin=∫Mϕi1…ik(∗ϕ)ik+1…indxi1∧…∧dxin
and has a tensorial structure. It’s not easy to define a localized field. So, it is an open question of how to define it. Fortunately, with the quantum field theory that we learn from this book, our background metric is flat. So, we don’t have to worry about this issue. But, in quantum gravity, it’s an important question!
13P4B2
This expression is nonzero for all x and t, indicating that a particle can propagate between any two points in an arbitrarily short time. In a relativistic theory, this conclusion would signal a violation of causality.
Just for fun!
To see the output of the below script in the output cell in Jupyter Notebook, you need to add %%manim QFT13P4B2 at the top of the cell.
python
# Require: manim. See https://docs.manim.community/en/stable/installation/conda.html# Usage: manim QFT13P4B2.py QFT13P4B2# Usage to generate medium quality gif: manim -qm --format=gif QFT13P4B2.py QFT13P4B2frommanimimport*importnumpyasnpclassQFT13P4B2(Scene):
defconstruct(self):
# Write the U(t) equation = MathTex("U(t) = \\left(\\frac{m}{2\\pi i t}\\right)^{3/2} e^{i m (\\vec{x} - \\vec{x}_{0})^{2}/2t} \\quad \\forall~ x, t~?")
self.play(Write(equation))
# Move the U(t) to the upper left corner self.play(equation.animate.to_corner(UL))
# Write a text particle_type = Text("Consider a free (point) particle:", t2c={'particle':RED}).scale(0.7).next_to(equation, 2*DOWN).shift(1.5*LEFT)
self.play(Write(particle_type))
# Show how the particles moves from x_0 to x where white line is the displacement. free_particle = Dot(color=RED).next_to(particle_type, 2.5*DOWN).shift(2*LEFT)
initial_position = MathTex("\\vec{x}_{0}").next_to(free_particle, 0.1*LEFT).scale(0.7) # label the initial position self.play(Write(initial_position))
particle_path= VMobject()
particle_path.set_points_as_corners([free_particle.get_center(), free_particle.get_center()])
defupdate_particle_path(particle_path):
previous_particle_path = particle_path.copy()
previous_particle_path.add_points_as_corners([free_particle.get_center()])
particle_path.become(previous_particle_path)
particle_path.add_updater(update_particle_path)
self.add(particle_path, free_particle)
self.play(free_particle.animate.shift(11*RIGHT))
final_position = MathTex("\\vec{x}\\equiv\\vec{x}_t").next_to(free_particle, 0.1*RIGHT).scale(0.7) # label the final position self.play(Write(final_position))
# Define the distance travelled by the particle. Assume Bohr radius distance_travel = MathTex("\\text{Let } ||\\vec{x}-\\vec{x}_{0}|| = 5.29 \\times 10^{-11}\\text{meters (i.e. Bohr radius) \\& } m = 1 \\text{ some mass unit}").next_to(particle_path, DOWN).scale(0.6)
self.play(Write(distance_travel))
# Evaluate the ratio (x - x_0)/c x_c_ratio = MathTex("\\text{So}, \\frac{||\\vec{x}-\\vec{x}_{0}||}{c} = \\frac{5.29 \\times 10^{-11}}{3 \\times 10^8} = 1.76333 \\times 10^{-19}\\text{ seconds}").next_to(distance_travel, DOWN).scale(0.6)
self.play(Write(x_c_ratio))
# Write again the U(t) with t < (x - x_0)/c equation_t = MathTex("\\text{So, taking } t < \\frac{||\\vec{x}-\\vec{x}_{0}||}{c}\\text{ in } U(t) = \\left(\\frac{m}{2\\pi i t}\\right)^{3/2} e^{i m (\\vec{x} - \\vec{x}_{0})^{2}/2t}")
equation_t.next_to(x_c_ratio, 3*DOWN).scale(0.7)
self.play(Write(equation_t))
self.wait(.5)
# Evaluate U(t) for t in [1e-18, 1e-20] < (x - x_0)/c t = np.linspace(1e-18, 1e-20, 15)
U_t = (1/(2*np.pi*1j*t))**(3/2) * np.exp(1j * (5.29e-11)**2/(2*t))
for i inrange(0, len(t)):
sign ="+"if U_t[i].imag >=0else"-" equation_te = MathTex("\\therefore~ U("+str(f"{t[i]:.5e}".replace('e', ' \\times 10^{')) +"}"+") = "+str(f"{U_t[i].real:.5e}".replace('e', ' \\times 10^{')) +"}"+ sign +str(f"{abs(U_t[i].imag):.5e}".replace('e', ' \\times 10^{'))+"}"+"i")
equation_te.next_to(x_c_ratio, 3*DOWN).scale(0.7)
self.play(Transform(equation_t, equation_te), run_time=.5)
framebox = SurroundingRectangle(equation_te, buff=0.1, color=RED)
if i ==0:
self.play(Create(framebox))
self.remove(equation_te)
In special relativity, any motion of a particle from x0 to x in a time t faster than the speed of light violates causality (i.e. t<c∣∣x−x0∣∣ where c is the speed of light). This is because there is another inertial frame of reference in which the particle arrives at x at a time earlier than the time at which it leaves x0. Since the propagator U(t) is non-zero for t<c∣∣x−x0∣∣, this means that the same particle can be in two places at the same time. This is a violation of causality and is not allowed in special relativity theory. We will come back to this point later on pages 28-29 in the book.
13P4E8
… . In analogy with the non-relativistic case, we have
Before we proceed, we do a transformation of momentum space in spherical (also called polar) coordinates(p,θ,ϕ), and the volume element spanning from p to p+dp, θ to θ+dθ and ϕ to ϕ+dϕ is given by the determinant of the Jacobian matrix of partial derivatives. i.e.
… with looking at its asymptotic behavior for x2≫t2 (well outside the light-cone), using the method of stationary phase. The function px−tp2+m2 has a stationary point at p=imx/x2−t2. Plugging in this value for p, we find that, upto a rational function of x and t, U(t)∼e−mx2−t2.
Instead of transforming the above integral (defined in 13P4E8) to momentum space, we can also use the idea of stationary phase approximation to evaluate the integral.
Our objective here is to evaluate the integral into the asymptotic expansion from a stationary phase point up to the leading term of the contribution. This is the main idea of the “method of stationary phase”.
Before proceeding, let’s briefly review the method of the stationary phase.
We consider the asymptotic expansion (as λ→∞) of integral(s) of the form:
I(λ)=∫abexp{iλϕ(t)}f(t)dt
where ϕ(t)∈R is the phase function and f(t) is an amplitude function; similar like in the Fourier integral.
Don’t be confused I(λ) with Riemann–Lebesgue lemma. But, this is a useful tool in QFT which we will see its usage later. For example, in asymptotic state calculation using LSZ reduction formula for computing S-matrix.
If f and ϕ are infinitely differentiable (C∞), and ϕ is monotonic on [a,b], then an infinite asymptotic expansion of the above integral I(λ) can be obtained via the integration-by-parts procedure. If the first derivative of ϕ vanishes at c then, c is a stationary point of ϕ.
If the derivative of a function ϕ at point c is equal to zero or undefined then, such a point is called critical point.
So, the aim is to find the leading term of the contribution to the asymptotic expansion from such a stationary point. If λ→∞ then, there will be a rapid oscillation of the real and imaginary parts of exp{iλϕ}. This rapid oscillation will cancel out the contribution of an infinite expansion, in turn, it tends to decrease the value of Ic(λ). You should note that how large λ is, there exists a neighborhood of c though-out which (λ×ϕ) does not change rapidly. Thus, the cancellation of the oscillations will be less effective in this neighborhood. So, the contribution of the asymptotic expansion from the stationary point c will be dominant. This is the idea of method of stationary phase. Thus, the integral I(λ) can be approximated by the stationary phase approximation as I(λ)≈Ic(λ) and given by
I(λ)≈exp{iλϕ(c)}f(c)λ∣ϕ′′(c)∣2πexp{4πiμ}
where μ:=sgn(ϕ′′(c)) (i.e. (overall) sign of the second derivative of ϕ at c).
Now, let’s apply the above idea to our problem. We have,
U(t)=(2π)31∫d3pei(p⋅x−tp2+m2)e−ip⋅x0,
the phase function of U(t) is, ϕ(p)=p⋅x−tp2+m2.
To be consistent with the book’s text, we use p instead of c to denote the stationary point (i.e. p is variable, and p is a point for evaluation). The stationary point can be achieved by solving dpdϕ(p)p=p=0. See the “vector derivative cheat sheet” if you’re reluctant to do it. We proceed
such that x>t. Since we want to do asymptotic expansion, we fine-tune p such that (x2−t2)→∞⟹x2≫t2. This means the asymptotic expansion holds only when x2≫t2. The inequality (≫) can be accounted for by re-defining ϕ as new ϕ:=λϕ (see below). I’m using the same symbol ϕ for new and old ϕ to account for inequality. Note that it does not influence the calculation because we want to see if the observable exists well outside the light-cone. Thus, the new ϕ will have a rapid oscillation. So, the Ip(λ) becomes Ip such that
I≈exp{iϕ(p)}f(p)∣ϕ′′(p)∣2πexp{4πiμ}.
Keep in mind that we are only going to compute ϕ(p)∣p=p and we show U(t) does not vanish (which we already know from 13P4E8). Let’s move forward,
Thus the propagation amplitude is small but nonzero outside the light-cone, and causality is still violated.
Noether Theorem
17E(2.11)-(2.12)
Consider infinitesimal form L(x)→L′(x)=L(x)+αΔL(x). Note that L(x) and L mean the same. So, αΔL=L′−L:=δL. We can write:
αΔL=δL=Using the definition of the partial derivative.=∂ϕ∂Lδϕ+(∂(∂μϕ)∂L)δ(∂μϕ)=Using eqn (2.9) i.e. δϕ=αΔϕ and δ(∂μϕ)=∂μ(δϕ)=∂μ(αΔϕ)=∂ϕ∂L(αΔϕ)+(∂(∂μϕ)∂L)∂μ(αΔϕ)=Using chain rule in the red colored equation.=α∂ϕ∂L(Δϕ)+∂μ(∂(∂μϕ)∂L(αΔϕ))−∂μ(∂(∂μϕ)∂L)(αΔϕ)=α∂μ(∂(∂μϕ)∂LΔϕ)+α[∂ϕ∂L−∂μ(∂(∂μϕ)∂L)]Δϕ(2.11)=Green colored equation is EOM (2.3) equals to 0.=α∂μ(∂(∂μϕ)∂LΔϕ)
Comparing the above result with eqn (2.10). We get ΔL=∂μJμ(x). i.e.
The blue-colored equation is defined as current. The eqn (2.12) means the divergence of current vanishes.
If the symmetry involves more than one field (say ϕ1,ϕ2,…,ϕ(n)), the first term of the eqn (2.12) for jμ(x) should be replaced by a sum of such terms, one for each field. i.e.
Note: Einstein’s convention means we sum over repeated indices. These indices we call dummy indices, as you can relabel them as you like. We will use Einstein’s convention most of the time unless it needs explicit form.
18P2B0
… so we conclude that the current jμ=∂μϕ.
Given L=21(∂μϕ)2≡21(∂μϕ)(∂μϕ) and ϕ→ϕ+α so deformation of field Δϕ=1 i.e. we only rescale our field ϕ by scale α. Our Lagrangian is scale invariance (a symmetry) because ∂μα=0. Thus, we demand one conservation law because of Noether’s theorem. Note we assume Jμ=0. Hence, the current is
Given the Lagrangian for complex scalar field,
L=∣∂μϕ∣2−m2∣ϕ∣2≡(∂μϕ)(∂μϕ∗)−m2ϕϕ∗(2.14)
… the transformation ϕ→eiαϕ; for an infinitesimal transformation with O(α2) we have
Comparing above results with ϕ→ϕ′=ϕ+αΔϕ and ϕ→ϕ∗′=ϕ∗+αΔϕ∗ respectively. We get Δϕ=iϕ and Δϕ∗=−iϕ∗(2.15).
… conserved Noether current is
jμ=i=1∑n∂(∂μϕi)∂LΔϕi−JμSince, Jμ=0=∂(∂μϕ)∂LΔϕ+∂(∂μϕ∗)∂LΔϕ∗=∂(∂μϕ)∂[(∂μϕ)(∂μϕ∗)−m2ϕϕ∗](iϕ)+∂(∂μϕ∗)∂[(∂μϕ)(∂μϕ∗)−m2ϕϕ∗](−iϕ∗)=Note that ∂(∂μϕ)∂(ϕϕ∗)=0. Also, ϕ and ϕ∗ are independent fields.Using Leibniz product rule.=(∂μϕ∗)(iϕ)−(∂μϕ)gμν∂(∂μϕ∗)∂(∂νϕ∗)(iϕ∗)=i[(∂μϕ∗)ϕ−ϕ∗(∂μϕ)gμνδμν]=i[(∂μϕ∗)ϕ−ϕ∗(∂μϕ)](2.16)
18P2B3
… the divergence of this current vanishes by using the Klein-Gordon equation. i.e.
∂μjμ=i[∂μ{(∂μϕ∗)ϕ}−∂μ{ϕ∗(∂μϕ)}]=Using product rule.=i[(∂μ∂μϕ∗)ϕ+(∂μϕ∗)(∂μϕ)−(∂μϕ∗)(∂μϕ)−ϕ∗(∂μ∂μϕ)]=∂μ∂μ≡∂μ∂μ:=□2 called as d’Alembertian, and(∂μϕ∗)(∂μϕ)≡(∂μϕ∗)(∂μϕ)≡∣∂μϕ∣2.=i[(□2ϕ∗)ϕ−ϕ∗(□2ϕ)]=Using Euler-Lagrange EOM: ∂ϕ∂L−∂μ(∂(∂μϕ)∂L)=0or, −m2ϕ∗−∂μ∂μϕ∗=0∴(□2+m2)ϕ∗=0 is Klein-Gordon eqn.(2.7)or, □2ϕ∗=−m2ϕ∗×ϕ both sides∴(□2ϕ∗)ϕ=−m2ϕ∗ϕ≡−m2∣ϕ∣2Similarly, ∂ϕ∗∂L−∂μ(∂(∂μϕ∗)∂L)=0or, −m2ϕ−∂μ[∂μϕ∂(∂μϕ∗)∂(∂μϕ∗)]=0or, −m2ϕ−∂μ[∂μϕgμν∂(∂μϕ∗)∂(∂νϕ∗)]=0or, −m2ϕ−∂μ[∂νϕδμν]=0or, −m2ϕ−∂μ∂μϕ=0or, □2ϕ=−m2ϕ×ϕ∗ from left∴ϕ∗□2ϕ=−m2∣ϕ∣2Substituting the acquired identities.=i[−m2∣ϕ∣2+m2∣ϕ∣2]=0.
Note: we’re using the d’Alembertian operator (or simply d’Alembertian) as □2 but other books might write just □.
19E(2.17)-(2.19)
Noether’s theorem can also be applied to spacetime transformations such as translations and rotations. We can describe the infinitesimal translation xμ→xμ−aμ alternatively as a transformation of the field configuration ϕ(x)→ϕ(x+a)=ϕ(x)+aμ∂μϕ(x).
This and previously (2.9), we did infinitesimal transformations of the fields as a Taylor expansion up to the first order in fields and their derivatives.
We can write δϕ(x):=ϕ(x+a)−ϕ(x)=aμ∂μϕ(x).
The Lagrangian is also a scalar, so it must transform in the same way: L→L+aμ∂μL≡L+aν∂μ(δμνL).
aν∂μ(δμνL)∴aν=δL(x)=Since, L≡L(ϕ(x),∂μϕ(x)). we write∂ϕ∂Lδϕ+(∂(∂μϕ)∂L)δ(∂μϕ)=∂ϕ∂Lδϕ+(∂(∂μϕ)∂L)∂μ(δϕ)=Substituting δϕ=aν∂νϕ, and using Leibniz product rule:∂ϕ∂L(aν∂νϕ)+∂μ(∂(∂μϕ)∂L(aν∂νϕ))−∂μ(∂(∂μϕ)∂L)(aν∂νϕ)=Since, aν is just a constant, i.e. not a function of x. So,We can take aν out of the derivative. We getaν[∂ϕ∂L−∂μ(∂(∂μϕ)∂L)]∂νϕ+aν∂μ(∂(∂μϕ)∂L∂νϕ)=Red color expression is zero due to Euler-Lagrange eqn.∂μ[∂(∂μϕ)∂L∂νϕ−δμνL]=0.
The blue color expression is defined as Noether conserved 4-currents Tμν.
Tμν:=∂(∂μϕ)∂L∂νϕ−Lδμν(2.17)
This is precisely the stress-energy tensor, also called the energy-momemtum tensor, of the field ϕ.
Now, we are going to prove equations (2.18) (that Hamiltonian density H equals to T00) and (2.19) (that momentum density Π times the velocity of the field ϕ equals to T0i). We start from
Tμρ≡gρνTμν=gρν(∂(∂μϕ)∂L∂νϕ−Lδμν).
Note that the metric tensor gρν:=diag(+1,−1,−1,−1) else 0. So,
T00=g00(∂(∂0ϕ)∂L∂0ϕ−Lδ00)=Substituting the canonical momentum π:=∂ϕ˙∂L givesπϕ˙−Lis a Legendre transformation for Hamiltonian formulation.=H.
The conserved charge associated with time translation (i.e. x0→x0−a0) is the Hamiltonian (i.e. total energy of the system): H=∫Hd3x≡∫T00d3x.(2.18)
Similarly,
T0i=giν(∂(∂0ϕ)∂L∂νϕ−Lδ0i)Note that ν∈(0,1,2,3) but, i∈(1,2,3).=For ν=i⟹gii=−1, but i=ν⟹giν=0. So,gii(∂ϕ˙∂L∂iϕ−Lδ0i)=Since, δ0i=0. So,−π∂iϕ
The conserved charges (phural due to 3 conserved charges) associated with spatial translations (i.e. xi→xi−ai) are the physical momenta (not to be confused with the canonical momentum): Pi=−∫π∂iϕd3x≡∫T0id3x.(2.19)