Scattering is the process where a wave or particle collides with some object. An understanding of the scattering process allows one to look at objects that may not be easily observed: for example, in the Rutherford scattering experiment, the behaviour of particles scattering off gold foil led him to realise that most of the positive charges were concentrated in the centre of the atom, rather than being spread throughout the whole atom, as was the consensus in the 1900s.[1]
As such, the framework of scattering theory is particularly important in quantum mechanics, where direct observation is difficult – at times impossible. Rather, by throwing known particles at an unknown object, and studying how it interacts with them, one reconstructs the properties of the object itself.
In the first two chapters of Quantum Mechanics III, we were introduced to a formulation of the scattering theory under the Schrödinger framework. This formulation is non-relativistic: it takes the energy of a free particle to be
Here, we looked at the Dirac equation, a relativistic framework that marries quantum mechanics with special relativity – now
In this report, we are interested in extending the non-relativistic scattering theory into the relativistic realm using the Dirac Hamiltonian, building upon the material established in the course notes.[2]
The free, single-electron Dirac Hamiltonian is given by
where
The square of the Dirac Hamiltonian in the position representation, which will be useful later, is
From here, operators are to be understood as given in the position representation. Considering the dimensionality of the Dirac matrices, the wavefunction
The plane wave eigenstates are§
with
The scattering formulation from Chapter 0 of PH4401 still stands for the Dirac Hamiltonian without any modification needed, as no “illegal” moves have been made with regards to the wavefunction now being a four-component vector.
Therefore, given a Hamiltonian
Since the form of the Green's function (denoted
we can try swapping out the free-particle Hamiltonian with the appropriate Dirac operators:
Note that the
Instead of deriving the above, we will instead show that this is correct by applying the Hamiltonian to both sides of the equation:
As the one-, two-, and three-dimensional Green's functions in the Schrödinger case have already been found in the course notes, it makes sense to equate Equation
Since the relativistic energy of the incident particle is related to its momentum by
we place this back into Equation
Here Equation
By repeatedly placing Equation
This is no different from the Born series, and we find that
Similar to the notes, we are interested in investigating the 1D potential barrier. We begin by writing the explicit forms of the equations we will need.
Unlike the general 3D case, only two anti-commutating matrices are needed. Therefore, we can stick to the Pauli matrices, and choose
Using Equation
Far from the scatterer, we use the approximation
Notice that apart from the oscillatory factor, the only terms with any dependence on
This can be further applied to Equation
To avoid complications in this matter, we will stick to the situation where a positive energy particle incident from the left scatters off a potential.
Consider an incident particle from the left:
note that it is normalised§ so that
The reflectance (
Where we have used Equation
The expressions in Equation
In order to perform numerical analysis and cross-check the validity of our Green's function, we will choose the step potential barrier
Computational units
1st2nd3rd4th5th6th7th8th9th10th11th12th13th14th15th16th17th18th19th20th order estimate of reflectance and transmittance with barrier size
We notice the same behaviour as in the notes, where the approximation is better with smaller potentials, and it converges into the true value as the energy becomes larger. Now, if we increase the barrier size to
1st2nd3rd4th5th6th7th8th9th10th11th12th13th14th15th16th17th18th19th20th order estimate of reflectance and transmittance with barrier size
The approximation becomes worse, and convergence takes longer (note the difference in the range of
1st2nd3rd4th5th6th7th8th9th10th11th12th13th14th15th16th17th18th19th20th order estimate of reflectance and transmittance energy
1st2nd3rd4th5th6th7th8th9th10th11th12th13th14th15th16th17th18th19th20th order estimate of reflectance and transmittance energy
It can be seen that the approximation holds for
We conclude this report by noting the limitations of this approach: firstly, by focusing on elastic scattering, we have mechanisms like pair-production. This means that phenomena like the Klein paradox, where the potential is large enough to create electron-positron pairs, causing the reflectance and transmittance to deviate from the elastic scattering case.[4]
For an eigenstate of the free Dirac Hamiltonian, we find that it has the same form as the Schrödinger equation of an eigenstate (four Schrödinger equations for each component of
So, the wavefunction is similarly seperable into
Furthermore, the eigenstates of the Dirac Hamiltonian should also share a similar
where
The eigenequation is now
Hence we have
The conditions are required to prevent singular values for the denominator
Denoting a right/left moving plane wave with positive energy as
while the normalisation of a plane wave
Our initial approach was to code Equation scipy.integrate.nquad
to perform the RT_int
.
While this worked, the computation time increased rapidly with each order. We came up with an alternative approach, where the integration domain is split according to its polarity, and the integral in each subdomain worked out analytically. The intermediate steps for this calculation is documented in Non-numerical Integration Of Reflectance/Transmittance, while the function RT_int2
is laid out in the Non-numerical Integration Approach. RT_int
and RT_int2
are drop-in replacements of each other.
The transmittance and reflectance is the analytical solution given in the reference[5].
from scipy import *
# When having several arrays as arguments,
# resizes them so they have the same length
def uniformise(*args):
args = list(args)
lengths = unique([1 if isscalar(arg) else len(arg) for arg in args])
# Valid only if there are at most two unique lengths,
# one of them being 1
if len(lengths) <= 2 and min(lengths) == 1:
N = max(lengths)
for i in range(len(args)):
if isscalar(args[i]) or len(args[i]) == 1:
args[i] = repeat(args[i], N)
else:
raise ValueError("multiple independent variables")
return tuple(args)
# Define the Green's function
def G0(x0, x1, E):
# We hijack infinity as an infinitesimal,
# we we keep the sign, then set it to 0
sgn = sign(x0)
if isinf(x0):
x0 = 0
k = sqrt(E**2 - 1)
return exp(
1j*k*(abs(x0)-sgn*x1)
)/2j * array([
[(E+1)/k, sgn],
[sgn, (E-1)/k]
])
# Define the initial wave function
def psi_i(x, E):
k = sqrt(E**2 - 1)
return exp(1j*k*x)/sqrt(E+1)*array([E+1, k])
# Define the reflectance/transmittance
def RT_theory(E, V, a, isT = True):
E, V, a = uniformise(E, V, a)
K = sqrt((V-E+1)/(V-E-1)*(E+1)/(E-1))
A = 4*K**2
B = (1-K**2)**2*sin(2*sqrt( (V-E)**2 - 1 )*a)**2
return ( (A if isT else B)/(A + B) ).real
RT_int
and RT_int2
In the definitions of both functions, we store the result of each integrand in the global variable calcedIntegrand
. This is due to the repeated integrals in each order (the fourth order includes the third order integral includes the second order integral…).
from scipy.integrate import nquad
def RT_int(E, V, a, order=1, isT=True):
global calcedIntegrand
def integrand(*x):
# The argument comes in the form
# (x0, x1, x2,… xn, E, V, j, real, n),
# so we reassign them to forms that make sense
x = list(x)
n = x.pop()
if len(x) != n + 4:
raise ValueError("invalid number of arguments")
else:
real = x.pop()
j = x.pop()
V = x.pop()
E = x.pop()
# Include the "0th-order" infinitesimal term
x = [-inf, inf][isT] + x
# Since V(x) = V, we'll just stack the
# V's in front and the Green's functions together
Gtot = eye(2)
for k in range(n):
Gtot = Gtot @ G0(x[k], x[k+1], E)
_integrand = V**n * Gtot @ psi_i(x[n], E)
return _integrand[j].real if real else _integrand[j].imag
# Initialise the given arguments, and an empty array
E, V, a = uniformise(E, V, a)
RT = zeros(len(E))
# Loop through all unique values of E
for i in range(len(E)):
calcedIntegral = 0.
# nquad only allows functions with float (real) outputs,
# hence we need to split the wavefunction up into
# its two components (j=0,1), and further into its
# real and imaginary parts
for j in range(2):
for real in [True, False]:
integral = 0.
# There's an extra initial wavefunction to be
# included for the transmittance
if isT:
if real:
integral = psi_i(0., E[i])[j].real
else:
integral = psi_i(0., E[i])[j].imag
for n in arange(order)+1:
# Unique key for the inputs of the
# integrands we're calculating
keyIntegrand = f"{['R', 'T'][isT]}\
E{E[i]}V{V[i]}a{a[i]}n{n},{2*j + real}"
if not "calcedIntegrand" in globals():
calcedIntegrand = {}
# Proceed to do numerical integration
# only if a cached value doesn't exist
if not keyIntegrand in calcedIntegrand:
# The limits are (-a, a), (-a, a)…
# n times.
calcedIntegrand[keyIntegrand] = nquad(
integrand,
tile([-a[i], a[i]], [n,1]),
args = (
E[i],
V[i],
j,
real,
n
)
)[0]
integral += calcedIntegrand[keyIntegrand]
# \({|[a+ib, c+id]|}^2 = a^2 + b^2 + c^2 + d^2\), so we'll
# sum up the squares of the individual
# components (which we already know to
# be real since nquad only returns floats)
calcedIntegral += integral**2
RT[i] += calcedIntegral
return RT/E/2.
from functools import reduce
import itertools
def RT_int2(E, V, a, order=1, isT=True):
# Similar to above
global calcedIntegrand
E, V, a = uniformise(E, V, a)
k = sqrt(E**2 - 1.)
RT = zeros(len(E))
for i in range(len(E)):
calcedIntegral = psi_i(0., E[i]) if isT else 0.
for n in arange(order)+1:
keyIntegrand = f"{['R', 'T'][isT]}E{E[i]}V{V[i]}a{a[i]}n{n}"
if not "calcedIntegrand" in globals():
calcedIntegrand = {}
if not keyIntegrand in calcedIntegrand:
calcedIntegrand[keyIntegrand] = 0.
# Loop through all possible domains, given by \({\{+, -\}}^n\)
for sgnList in itertools.product([-1,1], repeat=n):
# Include the sign of the "0th-order" term
sgnList = ([-1,1][isT],) + sgnList
# Calculate the diff to determine the integrals,
# adjusting the last sign accordingly
sgnDiff = diff(sgnList)
sgnDiff[-1] = int(sgnList[-2] == -1)
# Where the signs are the same, we get \(a\)
# Where they are different, we get \(\frac{e^{2ika}-1}{2ik}\)
# Finally, reduce multiplies all the terms together
integrandTerms = reduce(
lambda x, y: x * y,
where(
sgnDiff == 0,
a[i],
(exp(2.j*k[i]*a[i]) - 1)/(2.j*k[i])
)
)
# Additional factor if last two signs are negative
if (sgnList[-2] == sgnList[-1] == -1):
integrandTerms *= exp(-2.j*k[i]*a[i])
#
# Calculate the matrix \(\prod_{i=0}^{n-1} G_0(0_{\sgn{(x_i)}}, 0)\)
#
integrandMatrices = reduce(
lambda x, y: x @ y,
[G0(sgn*inf, 0., E[i]) for sgn in sgnList[:-1]]
)
calcedIntegrand[keyIntegrand] += V[i]**n * integrandTerms \
* integrandMatrices @ psi_i(0., E[i])
calcedIntegral += calcedIntegrand[keyIntegrand]
RT[i] = dot(integratedTerms, integratedTerms.conj()).real
return RT/E/2.
The below examples uses RT_int2
, but this can be simply swapped out with RT_int
. However, the orders should probably be reduced greatly as RT_int
is comically slower.
matplotlib
Setupimport matplotlib.pyplot as plt
# As we're intending to plot three potentials on one graph
# and have the nth-order of each potential share the same colour
colours = ["#509abe", "#ea7643", "#c21236"]
plt.rcParams["mathtext.fontset"] = "dejavuserif"
# ordinal indicator for labelling the order
def th(x):
return "th" if x != int(x) or x < 0 or x%10 > 3 else ["st", "nd", "rd"][int(x%10-1)]
# Three groups of lines according to their potential
Vs = [.1, .4, 1.75]
# And two sets of \(a\) and \(\{E\}\)
# \(E=1\) causes a divide-by-zero situation,
# so we begin very slightly away from it
As = [.05, .5]
Eses = [ [1. + 1E-10, 1.1], [1. + 1E-10, 5] ]
# We plot order = {1, 3, 5}
orders = range(1, 6, 2)
# Produce a graph each for transmittance, reflectance,
# for each set of values of \(a\).
for isT in [False, True]:
for j in range(2):
a = As[j]
Es = Eses[j]
ylims = array([inf, -inf])
for i in range(len(Vs)):
V = Vs[i]
c = colours[i]
E = linspace(Es[0], Es[1], 500)
# Plot the analytical value, using it
# to demarcate the limits of the figure
RT = RT_theory(E, V, a, isT=isT)
ylims = array([
min(ylims[0], min(RT)),
max(ylims[1], max(RT))
])
plt.plot(
E,
RT,
label=f"\(V_0 = \){V}",
c = c
)
# Plot each order
for order in orders:
plt.plot(
E,
RT_int2(E, V, a, isT=isT, order=order),
label = (f"{order}{th(order)} order"),
c = c,
# If it is the highest order, we add
# markers to highlight its values
marker = "x" if order == max(orders) else "",
markevery = 50,
markeredgewidth = 1.5,
# Each order made to have \(n\) dots,
# and higher orer lines made to be thicker
linestyle = (0, (5, 1, *((1,1)*order))),
linewidth = (.5 + order/max(orders))/1.15
)
# Plot the limits with a bit of breather space
plt.ylim(ylims + array([-1., 1.]) * diff(ylims)/10.)
plt.title(f"\(a=\){a}")
plt.xlabel("\(E\)")
plt.ylabel(["\(R\)", "\(T\)"][isT])
# Since the linestyles are consistent among every potential,
# remove all the other orders from the legend apart from
# those belonging to the last potential to reduce clutter
handles, labels = plt.gca().get_legend_handles_labels()
handles = handles[0::len(orders)+1] + handles[-len(orders):]
labels = labels[0::len(orders)+1] + labels[-len(orders):]
legends = plt.legend(
handles,
labels,
fontsize = "small",
ncol = 1,
loc = ["upper right", "lower right"][isT],
bbox_to_anchor = [(0.975, 0.975), (0.975, 0.025)][isT],
frameon = False
).get_texts()
for legend in legends[0:len(Vs)]:
legend.set_fontproperties(legend.get_fontproperties())
legend.set_size("large")
plt.show()
In this approach, we calculate
Effectively, splitting it in such a manner means that
Leaving
Succinctly, we find:
We take care to consider the edge case:
This is summarised by,