Skip to content

Commit 78ef147

Browse files
author
Uwe Hernandez Acosta
committed
add implementation of the cross section interface
1 parent a28b96f commit 78ef147

File tree

6 files changed

+329
-4
lines changed

6 files changed

+329
-4
lines changed

src/QEDprocesses.jl

+31-1
Original file line numberDiff line numberDiff line change
@@ -1,5 +1,14 @@
11
module QEDprocesses
22

3+
# constants
4+
export
5+
ALPHA,
6+
ALPHA_SQUARE,
7+
ELEMENTARY_CHARGE,
8+
ELEMENTARY_CHARGE_SQUARE,
9+
ELECTRONMASS,
10+
ONE_OVER_FOURPI
11+
312
# Abstract model interface
413
export AbstractModelDefinition, fundamental_interaction_type
514

@@ -28,16 +37,37 @@ export AbstractCoordinateSystem, SphericalCoordinateSystem
2837
export AbstractFrameOfReference, CenterOfMomentumFrame, ElectronRestFrame
2938
export AbstractPhasespaceDefinition, PhasespaceDefinition
3039

40+
# specific compute models
41+
export PerturbativeQED
42+
43+
# specific scattering processes
44+
export Compton, omega_prime
45+
46+
3147
using DocStringExtensions
48+
using StaticArrays
3249
using QEDbase
3350

34-
include("utils.jl")
51+
###
52+
# Generic implementations
53+
###
54+
55+
include("constants.jl")
3556
include("phase_spaces.jl")
3657
include("interfaces/model_interface.jl")
3758
include("interfaces/process_interface.jl")
3859
include("interfaces/setup_interface.jl")
60+
61+
include("models/models.jl")
62+
3963
include("momentum_generation.jl")
4064
include("propagators.jl")
4165
include("probabilities.jl")
4266
include("cross_sections.jl")
67+
68+
include("processes/one_photon_compton/one_photon_compton.jl")
69+
70+
include("utils.jl")
71+
72+
include("patch_QEDbase.jl")
4373
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,14 @@
1+
#################
2+
# The one-photon Compton process
3+
#
4+
# This file contains the implementation of the abstract process setup for
5+
# Compton
6+
##################
7+
8+
export Compton
9+
export omega_prime
10+
11+
12+
include("process.jl")
13+
include("perturbative/kinematics.jl")
14+
include("perturbative/cross_section.jl")
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,178 @@
1+
#####
2+
# Perturbative one-photon Compton scattering
3+
# Implementation of the cross section interface
4+
#####
5+
6+
function _incident_flux(
7+
proc::Compton, model::PerturbativeQED, in_ps::AbstractVector{T}
8+
) where {T<:QEDbase.AbstractFourMomentum}
9+
return prod(in_ps)
10+
end
11+
12+
function _matrix_element(
13+
proc::Compton,
14+
model::PerturbativeQED,
15+
in_ps::AbstractVector{T},
16+
out_ps::AbstractVector{T},
17+
) where {T<:QEDbase.AbstractFourMomentum}
18+
return _pert_compton_matrix_element(proc, in_ps, out_ps)
19+
end
20+
21+
"""
22+
23+
!!! note "Convention"
24+
25+
We average over the initial spins and pols, and sum over final.
26+
"""
27+
function _averaging_norm(proc::Compton)
28+
normalizations = number_of_spin_pol.(_in_spin_and_pol(proc))
29+
return inv(prod(normalizations))
30+
end
31+
32+
function _all_onshell(
33+
proc::Compton, in_ps::AbstractVector{T}, out_ps::AbstractVector{T}
34+
) where {T<:QEDbase.AbstractFourMomentum}
35+
sq_in_moms = getMass2.(in_ps)
36+
sq_out_moms = getMass2.(out_ps)
37+
sq_in_masses = mass.(incoming_particles(proc)) .^ 2
38+
sq_out_masses = mass.(outgoing_particles(proc)) .^ 2
39+
return isapprox(sq_in_moms, SVector(sq_in_masses)) &&
40+
isapprox(sq_out_moms, SVector(sq_out_masses))
41+
end
42+
43+
function _is_in_phasespace(
44+
proc::Compton,
45+
model::PerturbativeQED,
46+
in_ps_def::AbstractPhasespaceDefinition,
47+
in_ps::AbstractVector{T},
48+
out_ps_def::AbstractPhasespaceDefinition,
49+
out_ps::AbstractVector{T},
50+
) where {T<:QEDbase.AbstractFourMomentum}
51+
return (!isapprox(sum(in_ps), sum(out_ps))) ? false : _all_onshell(proc, in_ps, out_ps)
52+
end
53+
54+
@inline function _phase_space_factor(
55+
proc::Compton,
56+
model::PerturbativeQED,
57+
in_ps_def::AbstractPhasespaceDefinition,
58+
in_ps::AbstractVector{T},
59+
out_ps_def::AbstractPhasespaceDefinition,
60+
out_ps::AbstractVector{T},
61+
) where {T<:QEDbase.AbstractFourMomentum}
62+
return _pert_compton_ps_fac(in_ps_def, in_ps[2], out_ps_def, out_ps[2])
63+
end
64+
65+
#######
66+
# Matrix elements
67+
#######
68+
69+
@inline function _pert_compton_matrix_element(
70+
proc::Compton, in_ps::AbstractVector{T}, out_ps::AbstractVector{T}
71+
) where {T<:QEDbase.AbstractFourMomentum}
72+
in_electron_mom = in_ps[1]
73+
in_photon_mom = in_ps[2]
74+
out_electron_mom = out_ps[1]
75+
out_photon_mom = out_ps[2]
76+
77+
in_electron_state = base_state(Electron(), Incoming(), in_electron_mom, proc.in_spin)
78+
in_photon_state = base_state(Photon(), Incoming(), in_photon_mom, proc.in_pol)
79+
80+
out_electron_state = base_state(Electron(), Outgoing(), out_electron_mom, proc.out_spin)
81+
82+
out_photon_state = base_state(Photon(), Outgoing(), out_photon_mom, proc.out_pol)
83+
return _pert_compton_matrix_element(
84+
in_electron_mom,
85+
in_electron_state,
86+
in_photon_mom,
87+
in_photon_state,
88+
out_electron_mom,
89+
out_electron_state,
90+
out_photon_mom,
91+
out_photon_state,
92+
)
93+
end
94+
95+
function _pert_compton_matrix_element(
96+
in_electron_mom::T,
97+
in_electron_state,
98+
in_photon_mom::T,
99+
in_photon_state,
100+
out_electron_mom::T,
101+
out_electron_state,
102+
out_photon_mom::T,
103+
out_photon_state,
104+
) where {T<:QEDbase.AbstractFourMomentum}
105+
base_states_comb = Iterators.product(
106+
QEDbase._as_svec(in_electron_state),
107+
QEDbase._as_svec(in_photon_state),
108+
QEDbase._as_svec(out_electron_state),
109+
QEDbase._as_svec(out_photon_state),
110+
)
111+
112+
matrix_elements = Vector{ComplexF64}()
113+
sizehint!(matrix_elements, length(base_states_comb))
114+
for (in_el, in_ph, out_el, out_ph) in base_states_comb
115+
push!(
116+
matrix_elements,
117+
_pert_compton_matrix_element_single(
118+
in_electron_mom,
119+
in_el,
120+
in_photon_mom,
121+
in_ph,
122+
out_electron_mom,
123+
out_el,
124+
out_photon_mom,
125+
out_ph,
126+
),
127+
)
128+
end
129+
130+
return matrix_elements
131+
end
132+
133+
function _pert_compton_matrix_element_single(
134+
in_electron_mom::T,
135+
in_electron_state::BiSpinor,
136+
in_photon_mom::T,
137+
in_photon_state::SLorentzVector,
138+
out_electron_mom::T,
139+
out_electron_state::AdjointBiSpinor,
140+
out_photon_mom::T,
141+
out_photon_state::SLorentzVector,
142+
) where {T<:QEDbase.AbstractFourMomentum}
143+
in_ph_slashed = slashed(in_photon_state)
144+
out_ph_slashed = slashed(out_photon_state)
145+
146+
prop1 = _fermion_propagator(in_photon_mom + in_electron_mom, mass(Electron()))
147+
prop2 = _fermion_propagator(in_electron_mom - out_photon_mom, mass(Electron()))
148+
149+
# TODO: fermion propagator is not yet in QEDbase
150+
diagram_1 =
151+
out_electron_state *
152+
(out_ph_slashed * (prop1 * (in_ph_slashed * in_electron_state)))
153+
diagram_2 =
154+
out_electron_state *
155+
(in_ph_slashed * (prop2 * (out_ph_slashed * in_electron_state)))
156+
157+
result = diagram_1 + diagram_2
158+
159+
# TODO: find (preferably unitful) global provider for physical constants
160+
# elementary charge
161+
return ELEMENTARY_CHARGE_SQUARE * result
162+
end
163+
164+
#######
165+
# Phase space factors
166+
#######
167+
168+
function _pert_compton_ps_fac(
169+
in_ps_def::PhasespaceDefinition{inCS,ElectronRestFrame},
170+
in_photon_mom,
171+
out_ps_def::PhasespaceDefinition{SphericalCoordinateSystem},
172+
out_photon_mom,
173+
) where {inCS}
174+
# TODO
175+
omega = getE(in_photon_mom)
176+
omega_prime = getE(out_photon_mom)
177+
return omega_prime^2 / (16 * pi^2 * omega * mass(Electron()))
178+
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,44 @@
1+
omega_prime(::PerturbativeQED, om, cth; mass=1.0) = _pert_omega_prime(om, cth; mass=mass)
2+
3+
@inline function _pert_omega_prime(omega, cth; mass=1.0)
4+
return omega / (1 + omega / mass * (1 - cth))
5+
end
6+
7+
function generate_momenta(
8+
proc::Compton,
9+
model::PerturbativeQED,
10+
in_ps_def::PhasespaceDefinition{SphericalCoordinateSystem,ElectronRestFrame},
11+
in_ps::AbstractVector{T},
12+
out_ps_def::PhasespaceDefinition{SphericalCoordinateSystem,ElectronRestFrame},
13+
out_ps::AbstractVector{T},
14+
) where {T<:Real}
15+
return _generate_momenta(proc, model, in_ps_def, in_ps, out_ps_def, out_ps)
16+
end
17+
18+
function _generate_momenta(
19+
proc::Compton,
20+
model::PerturbativeQED,
21+
in_ps_def::PhasespaceDefinition{SphericalCoordinateSystem,ElectronRestFrame},
22+
in_ps::AbstractVector{T},
23+
out_ps_def::PhasespaceDefinition{SphericalCoordinateSystem,ElectronRestFrame},
24+
out_ps::AbstractVector{T},
25+
) where {T<:Real}
26+
omega = in_ps[1]
27+
cth = out_ps[1]
28+
phi = out_ps[2]
29+
P, K, Pp, Kp = _generate_momenta_elab_sph(omega, cth, phi) # TODO: do this coord and frame dependent
30+
in_moms = SVector(P, K)
31+
out_moms = SVector(Pp, Kp)
32+
return in_moms, out_moms
33+
end
34+
35+
function _generate_momenta_elab_sph(om, cth, phi, m=1.0)
36+
P = SFourMomentum(m, zero(m), zero(m), zero(m))
37+
K = SFourMomentum(om, zero(om), zero(om), om)
38+
omp = _pert_omega_prime(om, cth)
39+
sth = sqrt(1 - cth^2)
40+
sphi, cphi = sincos(phi)
41+
Kp = SFourMomentum(omp, omp * sth * cphi, omp * sth * sphi, omp * cth)
42+
Pp = P + K - Kp
43+
return P, K, Pp, Kp
44+
end
Original file line numberDiff line numberDiff line change
@@ -0,0 +1,61 @@
1+
"""
2+
3+
Compton(
4+
in_spin [= AllSpin()]
5+
in_pol [= AllPol()]
6+
out_spin [= AllSpin()]
7+
out_pol [= AllPol()]
8+
)
9+
10+
"""
11+
struct Compton{InElectronSpin,InPhotonPol,OutElectronSpin,OutPhotonPol} <:
12+
AbstractProcessDefinition where {
13+
InElectronSpin<:AbstractSpin,
14+
InPhotonPol<:AbstractPolarization,
15+
OutElectronSpin<:AbstractSpin,
16+
OutPhotonPol<:AbstractPolarization,
17+
}
18+
in_spin::InElectronSpin
19+
in_pol::InPhotonPol
20+
21+
out_spin::OutElectronSpin
22+
out_pol::OutPhotonPol
23+
end
24+
25+
function Compton()
26+
return Compton(AllSpin(), AllPol(), AllSpin(), AllPol())
27+
end
28+
29+
Compton(in_pol::AbstractPolarization) = Compton(AllSpin(), in_pol, AllSpin(), AllPol())
30+
function Compton(in_pol::AbstractPolarization, out_pol::AbstractPolarization)
31+
return Compton(AllSpin(), in_pol, AllSpin(), out_pol)
32+
end
33+
34+
_polarizations(proc::Compton) = (proc.in_pol, proc.out_pol)
35+
_spins(proc::Compton) = (proc.in_spin, proc.out_spin)
36+
_in_spin_and_pol(proc::Compton) = (proc.in_spin, proc.in_pol)
37+
_out_spin_and_pol(proc::Compton) = (proc.out_spin, proc.out_pol)
38+
39+
function QEDprocesses.incoming_particles(::Compton)
40+
return (Electron(), Photon())
41+
end
42+
43+
function QEDprocesses.outgoing_particles(::Compton)
44+
return (Electron(), Photon())
45+
end
46+
47+
function _spin_or_pol(process::Compton, ::Electron, ::Incoming)
48+
return process.in_spin
49+
end
50+
51+
function _spin_or_pol(process::Compton, ::Electron, ::Outgoing)
52+
return process.out_spin
53+
end
54+
55+
function _spin_or_pol(process::Compton, ::Photon, ::Incoming)
56+
return process.in_pol
57+
end
58+
59+
function _spin_or_pol(process::Compton, ::Photon, ::Outgoing)
60+
return process.out_pol
61+
end

src/propagators.jl

+1-3
Original file line numberDiff line numberDiff line change
@@ -7,9 +7,7 @@
77

88
"""
99
10-
```julia
11-
propagator(particle::AbstractParticleType, mom::QEDbase.AbstractFourMomentum, [mass::Real])
12-
```
10+
propagator(particle::AbstractParticleType, mom::QEDbase.AbstractFourMomentum, [mass::Real])
1311
1412
Return the propagator of a particle for a given four-momentum. If `mass` is passed, the respective propagator for massive particles is used, if not, it is assumed the particle passed in is massless.
1513

0 commit comments

Comments
 (0)