Introduction

phasr is a python package able to calculate scattering phase shifts for arbitrary radial potentials and calculate (elastic) electron nucleus scattering cross sections based on it. In combination with a fitting routine it can be used to fit elastic electron nucleus scattering data to extract charge density parameterizations. It is also possible to increase the precision sufficiently to quantitatively resolve parity violating electron scattering.

Versions/Change-Log:

Version 0.4.0 : Add left-right asymmetry.
Version 0.3.2 : Extend docs.
Version 0.3.1 : Add access to reference parameterizations.
Version 0.3.0 : Add overlap integrals.
Version 0.2.2 : Fix some dependencies.
Version 0.2.1 : First PyPI Release.
Version 0.2.0 : Basic features implemented.
Version 0.1.4 : Build dirac_solvers module.
Version 0.1.3 : Build nuclei module.
Version 0.1.2 : Build skeleton.
Version 0.1.0 : First init. Empty.

About this Package

This package was developed with the goal of extracting charge density parameterizations based on (elastic) electron nucleus scattering cross section data while properly accounting for Coulomb corrections using the so called phase shift model. While this procedure is known since the 60s, the documentation and availability of programs used back then, are very limited and hardly accessible. Furthermore, for a majority of nuclei the extractions of model-independent parameterizations of their charge densities have not been updated since the 80s and do not provide any uncertainty estimates. Since these also applied to the nuclei we were interested in, we build such a framework in python, which calculates elastic electron nucleus scattering cross sections based on input charge densities using the phase shift model, from which this package evolved. With such a more modern implementation and programming language, the calculations can become faster, broader accessible, easier to understand and easier to incorporate into existing programs. The code leading up to this package has already been used successfully in the papers [Noël, Hoferichter - 2024] and [Heinz, Hoferichter, Miyagi, Noël, Schwenk - 2024] to calculate and extract charge distributions for nuclei of interest to \( \mu \to e \) conversion, a beyond the Standard Model process of interest in particle physics. The package has been benchmarked for nuclei reaching from ... to ... .

Dependencies

This program is built with python 3.

It requires the following packages to operate properly:
numpy
scipy
mpmath

Getting Started

Install the package

To install and use the program please follow the following steps for setup. We assume you already have a working python environment setup on your machine (othewise see REF).
The package is listed on PyPI, which is why it can be easily installed via:

 pip install phasr 
If you want the latest (development) version, you can clone it from the phasr GitHub repository .
Note that you need need to also install all the required packages as listed above .

Use the package

You can import the python package the same way as every other package, i.e.:

 import phasr as phr 
You can then use the contained methods in the standard way. For example
 nucleus_Al27 = phr.nucleus(name='Al27',Z=13,A=27,rc=5)
 mmu = phr.masses.mmu
 boundstates_Al27 = phr.boundstates(nucleus_Al27,kappa=-1,lepton_mass=mmu) 
 print('E_1s=',boundstates_Al27.energy_levels[0],'MeV') 
will give you the groundstate energy of a muonic atom for the nucleus parameterization, described used a uniform charge distribution of charge 13 and a radius of 5 fm. We will assume the import with the alias phr throughout this manual.

Basic Modules

The code is structured into two main modules. The nuclei module is home of the nucleus class and manages all the relevant properties of a nucleus/isotope that is considered and calculates other properties based on the information it has available (e.g. the electric field from the charge density). The dirac_solvers module is home of the boundstates and continuumstates classes and manages solving the Dirac equation for a given nucleus based on its nucleus potential and returns the desired consequential quantities like for example electron wave functions, phase shifts or the crosssection. In all applicational scenarios one will first construct a nucleus object, which is then be used to construct a boundstates or continuumstates object. For calculating elastic scattering crosssections we supply the function crosssection_lepton_nucleus_scattering, which can be used to directly calculate the crosssection using the energy, the angle and a nucleus object.

The nucleus class

To get a nucleus parameterization, use the nucleus class to construct a nucleus object. A nucleus object requires a few minimum parameters (e.g. a name, a charge \(Z\) and a nucleon number \(A\)) and and has a lot of optional parameters (e.g. some parameters for a specific parameterization). Based on the parameters supplied the class decides what kind of nucleus it is supposed to construct. You can check what parameterization was choosen based on the attribute nucleus_type

 phr.nucleus(name,Z,A,m=None,**args) 
General parameters are:
  • name (str): Label for the nucleus, part of the filename if things about this nucleus are saved, should be unique.
  • Z (int): Nuclear charge number / proton number of the considered nucleus, necessary for the normalization. Will raise a warning if not consistent with the normalization of a provided charge density in **args.
  • A (int): Atomic mass number / nucleon number of the considered nucleus, necessary for recoil, enables lookup of nucleon mass, spin, parity and isotope abundancy.
  • m (float,optional) mass of the nucleus, necessary for recoil, is looked up based on \(Z\), \(A\) if not supplied.
  • abundance (float,optional) natural abundance of the nucleus, stored for convencience, is looked up based on \(Z\), \(A\) if not supplied.
  • spin (float,optional) spin of the nucleus, restricts what multipoles can exist, is looked up based on \(Z\), \(A\) if not supplied.
  • parity (float,optional) parity of the nucleus, stored for convenience, is looked up based on \(Z\), \(A\) if not supplied.
  • k_barrett (float,optional) value of k used to calculate barrett moments.
  • alpha_barrett (float,optional) value of alpha used to calculate barrett moments.
Parameterization specific parameters are:
nucleus_type   Parameters / **args
'coulomb' None
'fourier-bessel' ai (1d-array): Array of parameters \(a_i\) in fm\(^{-3}\). \(N\) given by length of a.
R (float): Cutoff radius R in fm.
'oszillator-basis' Ci_dict (dict): dictionary of 1d-arrays \(C_i\), with multipole names as keys (see below).
'fermi' c (float): \(c\) parameter in fm for Fermi parameterization.
z (float): \(z\) parameter in fm for Fermi parameterization.
w (float,optional): \(w\) parameter for Fermi parameterization (default: w=0).
'gauss' b (float): \(b\) parameter in fm for Gauss parameterization.
'uniform' rc (float): \(r_c\) parameter in fm for Uniform parameterization.
'numerical' see below

The parameterizations are based on: \[ \rho_\text{FB}(r) = \begin{cases} \sum_{i=1}^N a_i ~ j_0(q_i r) & r \leq R \\ 0 & r > R \end{cases} \qquad q_i= \frac{i \pi}{R} \] \[ \rho_\text{Fermi}(r) = \rho_0 \frac{1+w \tfrac{r^2}{c^2}}{1 + e^{(r-c)/z}}\] \[ \rho_\text{Gauss}(r) = \frac{Z}{\pi^{3/2} b^3} e^{-(r/b)^2} \] \[ \rho_\text{Uni}(r) = \begin{cases} \frac{3 Z}{4 \pi r_c^3} & r \leq r_c \\ 0 & r > r_c \end{cases} \] \[ F_\text{Osz}(q) = e^{-u(q)/2} \sum_i C_i ~ u(q)^i; \qquad u(q)=\frac{q^2 b^2}{2} \] Apart from storing the input parameters a nucleus object can have the following attributes (if the prerequisites are met), that you might want to access
  • charge_density(r) (callable): charge density in fm\(^{-3}\) for r in fm
  • form_factor(q) (callable): normalized form factor (\(F_\text{ch}(0)=1\)) for q in MeV
  • electric_field(r) (callable): electric field in fm\(^{-2}\) for r in fm
  • electric_potential(r) (callable): electric potential in fm\(^{-1}\) for r in fm
  • proton_density(r) (callable): proton density in fm\(^{-3}\) for r in fm
  • neutron_density(r) (callable): neutron density in fm\(^{-3}\) for r in fm
  • weak_density(r) (callable): weak density in fm\(^{-3}\) for r in fm
  • charge_radius (float): charge radius in fm (also attribute charge_radius_sq in fm\(^2\) exists)
  • proton_radius (float): proton radius in fm (also attribute proton_radius_sq in fm\(^2\) exists)
  • neutron_radius (float): neutron radius in fm (also attribute neutron_radius_sq in fm\(^2\) exists)
  • weak_radius (float): weak radius in fm (also attribute weak_radius_sq in fm\(^2\) exists)
  • total_charge (float): total charge from the charge density. Generates warning if total_charge and Z differ significantly.
  • weak_charge (float): weak charge of the weak density
One can also supply general descriptions for charge_density, form_factor or the different multipoles. These get the label of nucleus_type 'numerical'. Here the other quantities can be calculated based on the given ones using numerical methods. Possible parameters are:
Parameters/**args
charge_density (callable,optional): Function describing the charge density (see below).
form_factor (callable,optional): Function describing the form factor (see below).
electric_field (callable,optional): Function describing the electric field (see below).
electric_potential (callable,optional): Function describing the electric potential (see below).
form_factor_dict (dict,optional): Dictionary containing form factor functions for specific multipoles (keys are 'F'+multipole , see below).
density_dict (dict,optional): Dictionary containing density functions for specific multipoles (keys are 'rho'+multipole , see below).
To adjust the way in which the numerical calculations are happening there are three parameters (unique to the nucleus_type 'numcerial') which can be set:
rrange (list,optional): Sets range parameters for the beginning of the integration and highenergy continuation (in fm, default: [0.,20.,0.02]).
qrange (list,optional): Sets range parameters for the beginning of the integration and highenergy continuation (in MeV, default: [0.,1000.,1.]).
renew (bool,optional): Says if numerical calculations should be done from scratch (aka renewed) or recovered from file if existent (default: False).
For the 'numerical' nuclei type, related quantities first need to be calculated numerically. Scalar quantities like the total charge or charge radius are calculated by default, but the construction of functions, requires the explicit call of one of the following attribute, due to their runtime. The resulting splines are saves and and can be recovered
  • fill_gasp() (callable): Runs a combination of the functions below to calculate everything it can calculate base on the supplied quantities.
  • set_electric_field_from_charge_density() (callable): Calculates the electric_field based of the charge_density. Splines and saves the result. Includes highenergy continuation.
  • set_electric_potential_from_electric_field() (callable): Calculates the electric_potential based of the electric_field. Splines and saves the result. Includes highenergy continuation.
  • set_form_factor_from_charge_density() (callable): Calculates the form_factor based of the charge_density. Splines and saves the result. Includes highenergy continuation.
  • set_charge_density_from_electric_field() (callable): Calculates the charge_density based of the electric_field. Splines and saves the result. Includes highenergy continuation.
  • set_electric_field_from_electric_potential() (callable): Calculates the electric_potential based of the electric_potential. Splines and saves the result. Includes highenergy continuation.
  • set_charge_density_from_form_factor() (callable): Calculates the charge_density based of the form_factor. Splines and saves the result. Includes highenergy continuation.
  • set_density_dict_from_form_factor_dict() (callable): Calculates the multipole densities based of the multipole form factors (structure functions).
  • set_form_factor_dict_from_density_dict() (callable): Calculates the multipole form factors (structure functions) based of the multipole densities.
The 'fermi' nucleus_type also has a few of these attributes as not all quantities can be written in a simple closed analytic form, for this parameterization.
If a form_factor_dict or density_dict is supplied the different multipoles also become attributes (as 'F'+multipole or 'rho'+multipole).
The multipoles follow the naming pattern of multipole = multipole_name + L + N, which gives for example : 'M0p', 'M0n', 'M2p', 'M2n', ... , 'Phipp0p', 'Phipp0n', ... , 'Delta1p', ... , 'Sigmap1n', ... , which should be the way in which the keys of the dictionaries are written (as 'F'+multipole or 'rho'+multipole). Existing multipoles are collected in the attribute multipoles.
Further attributes are Fch(q,L=0), Fw(q,L=0), Fmag(q,L=1), which make it possible to also access the form factors for higher \(L\) if the necessary multipoles were supplied.

The dirac_solvers module

The dirac_solvers module has two main duties, covered by two classes. The boundstates class calculates the boundstate solutions of a given nucleus by solving the Dirac equation in the presence of the nucleus potential, which includes finding the boundstate energy first. The continuumstates class calculates the continuumstate solution for a given energy of a given nucleus by solving the Dirac equation in the presence of the nucleus potential. Finally, there are some functions that make use of the boundstate and continuumstate solutions by calculating elastic electron nucleus scattering crosssections and overlap integrals for \(\mu \to e\) conversion.
The boundstate and continuumstate wavefunctions are both parameterized according to \[ \psi = \psi_\kappa^\mu(\vec{r})= \frac{1}{r} \Bigg(\begin{array}{c} g_\kappa(r) \phi_\kappa^\mu(\hat{r}) \\ i f_\kappa(r) \phi_{-\kappa}^\mu(\hat{r}) \end{array} \Bigg), \] separating off the angular degrees of freedom, which are the same for all radial symmetric potential. The \(\kappa\) label refers to the angular momentum quantum numbers and spin according to \[j = |\kappa| - \frac{1}{2}; \quad l = \begin{cases} \kappa, & \quad \kappa > 0 \\ - \kappa - 1 , & \quad \kappa < 0 \end{cases}\] The numerical calculations then provide descriptions for \(g_\kappa(r)\) and \(f_\kappa(r)\).

The boundstates class:
The boundstates class is used to calculate the boundstates for a given nucleus object, beginning from the ground state for the given partial wave. First the energy for the boundstate is found by iteratively scanning for flips in the asymptotic behaviour of the wave functions, which indicate a boundstate in between, until a set precision is reached. For this energy then the solution of the Dirac equation gives the dirac wavefunction for that state.

 phr.boundstates(nucleus,kappa,lepton_mass,**args) 
  • nucleus (nucleus object): Nucleus, whose electric potential is used for the calculation.
  • kappa (int): selects total spin and angular momentum quantum number.
  • lepton_mass (float): mass of the lepton bound to the nucleus in MeV. Common choices are electron mass phr.masses.me or muon mass phr.masses.mmu. needs to be non-zero.
  • bindingenergy_limit_lower (float,optional): lower limit for the binding energy to look for boundstates. If not provided uses the potential at zero as the lower bound.
  • bindingenergy_limit_upper (float,optional): upper limit for the binding energy to look for boundstates (default: 0).
  • **args (dict,optional): Additional keywords can be used to pass parameters to the underlying numerical routine (including parameters for scipy.integrate.solve_IVP). Default values are set by phr.default_boundstate_settings.
Apart from storing the input paramters the boundstates object has the following attributes, which you might want to access:
  • principal_quantum_numbers (list of int's): principal quantum numbers of the calculated boundstates.
  • energy_levels (list of floats): energy values of the calculated boundstates.
  • find_next_energy_level() (callable): called to find the next boundstate energy (for that /(\kappa/)). The groundstate energy is always calculated at initialisation.
  • solve_IVP_at_current_energy() (callable): called to calculate the boundstate wavefunctions at the current boundstate energy. The groundstate wavefunction is always calculated at initialisation.
  • find_next_solution(**args) (callable): same as calling find_next_energy_level and solve_IVP_at_current_energy consecutively. Can be passed **args to change the solver_setting.
  • wavefunction_g_<state>(r) (callable): returns the upper radial component of the wavefunction evaluated at r in fm for the state <state>. Exists only if find_next_solution() was called enough times. Example: Groundstate is wavefunction_g_1s12 (using \(\kappa=-1\))
  • wavefunction_f_<state>(r) (callable): returns the lower radial component of the wavefunction evaluated at r in fm for the state <state>. Exists only if find_next_solution() was called enough times. Example: Groundstate is wavefunction_f_1s12 (using \(\kappa=-1\))
The states are labeled according to principal quantum numbers, angular momentum quantum number and total spin following the scheme of atomic orbitals here writte according to <state>=1s12, 2s12, ..., 2p12, 2d12, ..., 2p32, 2d32, ... .

The continuumstate class:
 phr.continuumstates(nucleus,kappa,energy,lepton_mass=0,**args) 
  • nucleus (nucleus object): Nucleus, whose electric potential is used for the calculation.
  • kappa (int): selects total spin and angular momentum quantum number.
  • energy (float): energy of the (initial) lepton in MeV.
  • lepton_mass (float,optional): mass of the lepton bound to the nucleus in MeV (default: 0). Can be set to 0 if energy \(\gg\) lepton_mass, which gives significant runtime improvements.
  • **args (dict,optional): Additional keywords can be used to pass parameters to the underlying numerical routine (including parameters for scipy.integrate.solve_IVP). Default values are set by phr.default_continuumstate_settings.
Apart from storing the input paramters the continuumstates object has the following attributes, which you might want to access:
  • solve_IVP() (callable): called to calculate the continuumstate wavefunctions for the given energy. Needs to be called once explicitly, does not happen at initialisation.
  • wavefunction_g(r) (callable): returns the upper radial component of the wavefunction evaluated at r in fm for the given energy. exists only if solve_IVP() was called.
  • wavefunction_f(r) (callable): returns the upper radial component of the wavefunction evaluated at r in fm for the given energy. exists only if solve_IVP() was called.
  • extract_phase_shift() (callable): called to calculate the asymptotic phase shift for the given energy. Needs to be called once explicitly, does not happen at initialisation. Faster than calling solve_IVP().
  • phase_difference (float): difference between the phase shift of a Coulomb potential and the considered nucleus potential.
  • phase_shift (float): phase shift of the considered nucleus potential. Input for elastic scattering crosssection.
The crosssection_lepton_nucleus_scattering function:
Used to calculate the crosssection for elastic lepton nucleus scattering for specific intial lepton energys and scattering angles based on a given nucleus.
 phr.crosssection_lepton_nucleus_scattering(energy,theta,nucleus,lepton_mass=0,recoil=True,subtractions=3,**args) 
  • energy (float): energy of the (initial) lepton in MeV.
  • theta (float / 1d-array): elastic scattering angle in rad (\(\theta=0\) forward direction, \(\theta=2\pi\) backward direction).
  • nucleus (nucleus object): nucleus against which the lepton is scattered.
  • lepton_mass (float,optional): mass of the lepton bound to the nucleus in MeV (default: 0). Can be set to 0 if energy \(\gg\) lepton_mass, which gives significant runtime improvements. No convergent implementation for non-zero lepton_mass yet.
  • recoil (bool,optional): if recoil of the nucleus at leading (kinematic) order should be considered (default: True).
  • subtractions (int, optional): number of subtractions to make the partial wave sum convergent (default: 3). subtractions=0 will not converge. subtractions=3 seems to work most consistently.
  • **args (dict,optional): Additional keywords can be used to pass parameters to the underlying numerical routines. The time-optimal parameters for a given dataset can be accessed by calling optimise_crosssection_precision() (see below).

  • return: crosssection for elastic lepton nucleus scattering of the given nucleus at the given energy and angles in MeV\(^{-2}\)
Possible **args/ parameters for the underlying numerical routines are:
Parameters/**args
N_partial_waves (int,optional): angular momenutum of the partial wave at which the series is terminated. (default: 100)
phase_difference_limit (float,optional): limit at which (numerical) value for the phase_difference attribute of a continuumstates all following partial waves are considered indistinguishable to the coulomb solution. (default:0).
energy_norm (float,optional): scaling factor for the units while solving the inital value problem to increase speed (default: \( \hbar c\) fm\(^{-1}\))
method (str,optional): method keyword passed to scipy.integrate.solve_IVP (default: 'DOP853' / as set in default_continuumstate_settings)
atol (float,optional): atol keyword passed to scipy.integrate.solve_IVP (default: 1e-12 / as set in default_continuumstate_settings)
rtol (float,optional): rtol keyword passed to scipy.integrate.solve_IVP (default: 1e-9 / as set in default_continuumstate_settings)

If you want to call crosssection_lepton_nucleus_scattering many times for the same energies and angles theta for similar nuclei (for example for a fit), it makes sense to assess the necessary precision for the numerical calculation using optimise_crosssection_precision. This functions can run a few minutes as it is scanning a large **args / parameter space, but can afterwards improve the runtime significantly. Unfortunately the necessary precision is very dependent on how large the energy and angles are (larger energies and angles require significantly more precision and runtime), which is why this is the best solution for a reasonable runtime. Of course you can always also try to finetune the parameters yourself, but note that the convergence might break down, and that you should always check if the calculated crosssection is still reasonable.
 phr.optimise_crosssection_precision(energy,theta,nucleus,lepton_mass=0,recoil=True,subtractions=3,crosssection_precision=1e-3,jump_forward_dist=1) 
  • energy (float): energy of the (initial) lepton in MeV.
  • theta (float / 1d-array): elastic scattering angle in rad (\(\theta=0\) forward direction, \(\theta=2\pi\) backward direction).
  • nucleus (nucleus object): nucleus against which the lepton is scattered.
  • lepton_mass (float,optional): mass of the lepton bound to the nucleus in MeV (default: 0). Can be set to 0 if energy \(\gg\) lepton_mass, which gives significant runtime improvements. No convergent implementation for non-zero lepton_mass yet.

  • return: args with the quickest runtime for crosssection_lepton_nucleus_scattering which are still consistent with crosssection calculations with the maximum precision up to a relative precision of the value of crosssection_precision.

Common use cases

For common use cases we also refer to the Python notebook Example.pynb , which shows a selection of example usecases. It also repeats the examples shown here.

Calculate the scattering crosssection based on an analytic charge densitycharge distribution parametrisation

To calculate the scattering cross section base on a analytic charge distribution parametrisation, you first construct the nucleus object, which you then use to calculate the cross section. As an example, we use a Fourier Bessel parameterisation for \(^{48}\)Ti with \( R = 9.25\) fm and \[a_{1} = 0.03392 ~ \text{fm}^{-3}, ~ a_{2}=0.05913 ~ \text{fm}^{-3}, ~ a_{3}=0.01547 ~ \text{fm}^{-3}, ~ a_{4}=-0.02550 ~ \text{fm}^{-3}, \] \[a_{5}=-0.0152 ~ \text{fm}^{-3}, ~ a_{6}=0.0029 ~ \text{fm}^{-3}, ~ a_{7}=0.0037 ~ \text{fm}^{-3}, \] The nucleus is then constructed by

ai_48Ti=np.array([0.03392,0.05913,0.01547,-0.02550,-0.0152,0.0029,0.0037])
R_48Ti=9.25
nucleus_48Ti = phr.nucleus('48Ti_FB',Z=22,A=48,ai=ai_48Ti,R=R_48Ti)
We give it the name '48Ti_FB', which ideally should be unique for this parameterisation, such that temporary files can be uniquely assigned. If no temporary files are created or loaded during the calculation, the name should in principle not matter, but we advise the use of a unique name nevertheless, if alone for you personal bookkeeping.
We can now use this to calculate the crosssection. We consider an initial energy of 249.5 MeV and scattering angles between 30\(^{\circ}\) and 120\(^{\circ}\). The angles are defined such that 0\(^{\circ}\) refers to forward scattering and 180\(^{\circ}\) to backwards scattering. We use the package matplotlib to plot the resulting cross section.
import matplotlib.pyplot as plt
energy=249.5
theta=np.arange(30,120,1e-1)
plt.plot(theta,phr.crosssection_lepton_nucleus_scattering(energy,theta*pi/180,nucleus_48Ti),label=r'$E=249.5~$MeV')
plt.yscale('log')
plt.title(r"Cross section $^{48}$Ti")
plt.xlabel(r"$\theta$ in deg")
plt.ylabel(r"$\frac{\operatorname{d}\sigma}{\operatorname{d}\Omega}$ in MeV$^{-2}$")
plt.legend()
plt.xlim(30,120)
This results in the following graphic:

Which you can now for example compare to data. Depending on your maschine this calculation might take a few seconds, which might be problematic if one wants to iterate over this process many times for example in a fit. For this reason there is the option to optimise the precison of the numerical calculation for the specific nucleus, angle and energy range, to speed up the calculation. Under the assumption that the nucleus does not change to drastically during the fit these settings can then be used to increase the runtime significantly, as expensive cases like high energies or very small or very large angles are excluded. This assessment itself is however quite time intensive and may run several minutes, as it scans over a variety of different parameter combinations. We can run this funcions via
args=phr.optimise_crosssection_precision(energy,theta*pi/180,nucleus_48Ti,crosssection_precision=1e-2)
which in this case increases the runtime by roughtly a factor of 10x compared to maximal precision, by demanding consistency of at least relative \(10^{-2}\). Plotting now again (with the additional **args)
import matplotlib.pyplot as plt
energy=249.5
theta=np.arange(30,120,1e-1)
plt.plot(theta,phr.crosssection_lepton_nucleus_scattering(energy,theta*pi/180,nucleus_48Ti,**args),label=r'$E=249.5~$MeV')
plt.yscale('log')
plt.title(r"Cross section $^{48}$Ti")
plt.xlabel(r"$\theta$ in deg")
plt.ylabel(r"$\frac{\operatorname{d}\sigma}{\operatorname{d}\Omega}$ in MeV$^{-2}$")
plt.legend()
plt.xlim(30,120)

is significantly faster, but leads to an indistinguishable cross section for these energy and angle values (up to relative differences of \(10^{-2}\)).

Calculate the scattering crosssection based on a numerical charge density parametrisation

Calculating the scattering crosssection for a numerical charge density is for the most part identical to the analytical part. The only difference is that the nucleus object requires slighlty more preparation, as for example the nucleus potential needs to be calculated numerically. Let's construct the same nucleus as in the analytical case as a numerical nucleus. We do

ai_48Ti=np.array([0.03392,0.05913,0.01547,-0.02550,-0.0152,0.0029,0.0037])
R_48Ti=9.25
N_48Ti=len(ai_48Ti)
qi_48Ti = np.arange(1,N_48Ti+1)*np.pi/R_48Ti
def rho_48Ti(r): return phr.nuclei.parameterizations.fourier_bessel.charge_density_FB(r,ai_48Ti,R_48Ti,qi_48Ti)
nucleus_48Ti_num = phr.nucleus('48Ti_num',Z=22,A=48,charge_density=rho_48Ti)
which constructs the same charge density, but uses it as a generic (potentially numerical) input. This nucleus doe not have a nucleus potential yet. As this requires two numerical integrations. We can tell the nucleus to do these calculations either expliticitly. By doing
nucleus_48Ti_num.set_electric_field_from_charge_density()
nucleus_48Ti_num.set_electric_potential_from_electric_field()
or implicitly by calling
nucleus_48Ti_num.fill_gaps()
which will however calculate anything that is missing, in this case in particular also the form factor. In either way, if you used renew=False, which is the default, the results will be saved in a file and loaded if you call these functions again. After this you can calculate the crosssection as for the analytical case
energy=249.5
theta=np.arange(30,120,1e-1)
plt.plot(theta,phr.crosssection_lepton_nucleus_scattering(energy,theta*pi/180,nucleus_48Ti_num),label=r'$E=249.5~$MeV')
plt.yscale('log')
plt.title(r"Cross section $^{48}$Ti")
plt.xlabel(r"$\theta$ in deg")
plt.ylabel(r"$\frac{\operatorname{d}\sigma}{\operatorname{d}\Omega}$ in MeV$^{-2}$")
plt.legend()
plt.xlim(30,120)
plt.show()
which will again lead to the same figure shown above, but will probably have a bit longer runtime. In case you want to fit over numerical charge densities, you should set renew=True or iterate over the name of the nucleus such that the integrations for the electric field and electric potential are repeated with every change of the charge density. As this is necessary, we however strongly discourage this strategy, as the extra integrations will increase the runtimes to unfeasable numbers (also since the integrations are not optimised for this usecase). If you have a way of analytically calculating the nucleus potential from the charge density this should always be priotized. If the parameterization you want to use is not implemented you can always also pass the electric_potential directly to the nucleus.

Calculate the left-right asymmetry for parity violating electron scattering

TBD

More Info

The package is currently in an development stage, and partly incomplete. Use the package at your own risk and without any garanties.
This package was written by Frederic Noël. I would like to thank my collaborators and office mates for meaningfull inputs. This website was build based on a template from github user charlyllo.