Garfield++ 5.0
A toolkit for the detailed simulation of particle detectors based on ionisation measurement in gases and semiconductors
Loading...
Searching...
No Matches
Garfield::TrackElectron Class Reference

[WIP] Ionization calculation based on MIP program (S. Biagi). More...

#include <TrackElectron.hh>

+ Inheritance diagram for Garfield::TrackElectron:

Classes

struct  Cluster
 

Public Member Functions

 TrackElectron ()
 Constructor.
 
virtual ~TrackElectron ()
 Destructor.
 
void SetParticle (const std::string &particle) override
 
bool NewTrack (const double x0, const double y0, const double z0, const double t0, const double dx0, const double dy0, const double dz0) override
 
bool GetCluster (double &xc, double &yc, double &zc, double &tc, int &nc, double &ec, double &extra) override
 
const std::vector< Cluster > & GetClusters () const
 
double GetClusterDensity () override
 
double GetStoppingPower () override
 Get the stopping power (mean energy loss [eV] per cm).
 
- Public Member Functions inherited from Garfield::Track
 Track ()=delete
 Default constructor.
 
 Track (const std::string &name)
 Constructor.
 
virtual ~Track ()
 Destructor.
 
void SetEnergy (const double e)
 Set the particle energy.
 
void SetBetaGamma (const double bg)
 Set the relative momentum of the particle.
 
void SetBeta (const double beta)
 Set the speed ( $\beta = v/c$) of the particle.
 
void SetGamma (const double gamma)
 Set the Lorentz factor of the particle.
 
void SetMomentum (const double p)
 Set the particle momentum.
 
void SetKineticEnergy (const double ekin)
 Set the kinetic energy of the particle.
 
double GetEnergy () const
 Return the particle energy.
 
double GetBetaGamma () const
 Return the $\beta\gamma$ of the projectile.
 
double GetBeta () const
 Return the speed ( $\beta = v/c$) of the projectile.
 
double GetGamma () const
 Return the Lorentz factor of the projectile.
 
double GetMomentum () const
 Return the particle momentum.
 
double GetKineticEnergy () const
 Return the kinetic energy of the projectile.
 
double GetCharge () const
 Get the charge of the projectile.
 
double GetMass () const
 Get the mass [eV / c2] of the projectile.
 
void SetSensor (Sensor *s)
 Set the sensor through which to transport the particle.
 
void EnablePlotting (ViewDrift *viewer)
 Switch on plotting.
 
void DisablePlotting ()
 Switch off plotting.
 
void EnableDebugging ()
 Switch on debugging messages.
 
void DisableDebugging ()
 Switch off debugging messages.
 

Additional Inherited Members

- Protected Member Functions inherited from Garfield::Track
void PlotNewTrack (const double x0, const double y0, const double z0)
 
void PlotCluster (const double x0, const double y0, const double z0)
 
- Static Protected Member Functions inherited from Garfield::Track
static std::array< double, 3 > StepBfield (const double dt, const double qoverm, const double vmag, double bx, double by, double bz, std::array< double, 3 > &dir)
 
- Protected Attributes inherited from Garfield::Track
std::string m_className = "Track"
 
double m_q = -1.
 
int m_spin = 1
 
double m_mass
 
double m_energy = 0.
 
double m_beta2 = 1.
 
bool m_isElectron = false
 
std::string m_particleName = "mu-"
 
Sensorm_sensor = nullptr
 
bool m_isChanged = true
 
ViewDriftm_viewer = nullptr
 
bool m_debug = false
 
size_t m_plotId = 0
 

Detailed Description

[WIP] Ionization calculation based on MIP program (S. Biagi).

Definition at line 13 of file TrackElectron.hh.

Constructor & Destructor Documentation

◆ TrackElectron()

Garfield::TrackElectron::TrackElectron ( )

Constructor.

Definition at line 13 of file TrackElectron.cc.

13 : Track("Electron") {
14
15 // Setup the particle properties.
16 m_q = -1;
17 m_spin = 1;
18 m_mass = ElectronMass;
19 m_isElectron = true;
20 SetBetaGamma(3.);
21 m_particleName = "electron";
22}
void SetBetaGamma(const double bg)
Set the relative momentum of the particle.
Definition Track.cc:106
bool m_isElectron
Definition Track.hh:111
std::string m_particleName
Definition Track.hh:112
double m_mass
Definition Track.hh:108
Track()=delete
Default constructor.

◆ ~TrackElectron()

virtual Garfield::TrackElectron::~TrackElectron ( )
inlinevirtual

Destructor.

Definition at line 23 of file TrackElectron.hh.

23{}

Member Function Documentation

◆ GetCluster()

bool Garfield::TrackElectron::GetCluster ( double & xc,
double & yc,
double & zc,
double & tc,
int & nc,
double & ec,
double & extra )
overridevirtual

Get the next "cluster" (ionising collision of the charged particle).

Parameters
xc,yc,zccoordinates of the collision
tctime of the collision
ncnumber of electrons produced
ecdeposited energy
extraadditional information (not always implemented)

Implements Garfield::Track.

Definition at line 124 of file TrackElectron.cc.

125 {
126 xc = yc = zc = tc = ec = extra = 0.;
127 ne = 0;
128 if (m_clusters.empty()) return false;
129 // Increment the cluster index.
130 if (m_cluster < m_clusters.size()) {
131 ++m_cluster;
132 } else if (m_cluster > m_clusters.size()) {
133 m_cluster = 0;
134 }
135 if (m_cluster >= m_clusters.size()) return false;
136
137 xc = m_clusters[m_cluster].x;
138 yc = m_clusters[m_cluster].y;
139 zc = m_clusters[m_cluster].z;
140 tc = m_clusters[m_cluster].t;
141 ec = m_clusters[m_cluster].esec;
142 ne = 1;
143 return true;
144}

◆ GetClusterDensity()

double Garfield::TrackElectron::GetClusterDensity ( )
overridevirtual

Get the cluster density (number of ionizing collisions per cm or inverse mean free path for ionization).

Reimplemented from Garfield::Track.

Definition at line 146 of file TrackElectron.cc.

146 {
147 return m_mfp > 0. ? 1. / m_mfp : 0.;
148}

◆ GetClusters()

const std::vector< Cluster > & Garfield::TrackElectron::GetClusters ( ) const
inline

Definition at line 33 of file TrackElectron.hh.

33{ return m_clusters; }

◆ GetStoppingPower()

double Garfield::TrackElectron::GetStoppingPower ( )
overridevirtual

Get the stopping power (mean energy loss [eV] per cm).

Reimplemented from Garfield::Track.

Definition at line 150 of file TrackElectron.cc.

150 {
151 return m_dedx;
152}

◆ NewTrack()

bool Garfield::TrackElectron::NewTrack ( const double x0,
const double y0,
const double z0,
const double t0,
const double dx0,
const double dy0,
const double dz0 )
overridevirtual

Calculate a new track starting from (x0, y0, z0) at time t0 in direction (dx0, dy0, dz0).

Implements Garfield::Track.

Definition at line 30 of file TrackElectron.cc.

32 {
33 // Reset the list of clusters.
34 m_clusters.clear();
35 m_cluster = 0;
36 // Make sure the sensor has been set.
37 if (!m_sensor) {
38 std::cerr << m_className << "::NewTrack: Sensor is not defined.\n";
39 return false;
40 }
41
42 // Make sure the medium at this location is an ionisable gas.
43 Medium* medium = m_sensor->GetMedium(x0, y0, z0);
44 if (!medium || !medium->IsIonisable() || !medium->IsGas()) {
45 std::cerr << m_className << "::NewTrack:\n"
46 << " No ionisable gas medium at initial position.\n";
47 return false;
48 }
49 std::vector<Parameters> par;
50 std::vector<double> frac;
51 if (!Setup(medium, par, frac)) {
52 std::cerr << m_className << "::NewTrack:\n"
53 << " Properties of " << medium->GetName()
54 << " are not implemented.\n";
55 return false;
56 }
57
58 const std::string mediumName = medium->GetName();
59 const double density = medium->GetNumberDensity();
60
61 const size_t nComponents = frac.size();
62 std::vector<double> prob(nComponents, 0.);
63 double mfp = 0., dedx = 0.;
64 if (!Update(density, m_beta2, par, frac, prob, mfp, dedx)) {
65 std::cerr << m_className << "::NewTrack:\n"
66 << " Cross-sections could not be calculated.\n";
67 return false;
68 }
69 m_mfp = mfp;
70 m_dedx = dedx;
71
72 double x = x0;
73 double y = y0;
74 double z = z0;
75 double t = t0;
76 double dx = dx0;
77 double dy = dy0;
78 double dz = dz0;
79 const double d = sqrt(dx * dx + dy * dy + dz * dz);
80 if (d < Small) {
81 RndmDirection(dx, dy, dz);
82 } else {
83 // Normalize the direction vector.
84 const double scale = 1. / d;
85 dx *= scale;
86 dy *= scale;
87 dz *= scale;
88 }
89 const double dt = 1. / (sqrt(m_beta2) * SpeedOfLight);
90 double e0 = ElectronMass * (sqrt(1. / (1. - m_beta2)) - 1.);
91 while (e0 > 0.) {
92 // Draw a step length and propagate the electron.
93 const double step = -m_mfp * log(RndmUniformPos());
94 x += step * dx;
95 y += step * dy;
96 z += step * dz;
97 t += step * dt;
98
99 medium = m_sensor->GetMedium(x, y, z);
100 if (!medium || !medium->IsIonisable() ||
101 medium->GetName() != mediumName ||
102 medium->GetNumberDensity() != density) {
103 break;
104 }
105 Cluster cluster;
106 cluster.x = x;
107 cluster.y = y;
108 cluster.z = z;
109 cluster.t = t;
110 const double r = RndmUniform();
111 for (size_t i = 0; i < nComponents; ++i) {
112 if (r > prob[i]) continue;
113 // Sample secondary electron energy according to
114 // Opal-Beaty-Peterson splitting function.
115 cluster.esec = Esec(e0, par[i]);
116 m_clusters.push_back(std::move(cluster));
117 break;
118 }
119 }
120 m_cluster = m_clusters.size() + 2;
121 return true;
122}
Sensor * m_sensor
Definition Track.hh:114
double m_beta2
Definition Track.hh:110
std::string m_className
Definition Track.hh:104
double RndmUniform()
Draw a random number uniformly distributed in the range [0, 1).
Definition Random.hh:14
void RndmDirection(double &dx, double &dy, double &dz, const double length=1.)
Draw a random (isotropic) direction vector.
Definition Random.hh:128
double RndmUniformPos()
Draw a random number uniformly distributed in the range (0, 1).
Definition Random.hh:17
DoubleAc sqrt(const DoubleAc &f)
Definition DoubleAc.cpp:314

◆ SetParticle()

void Garfield::TrackElectron::SetParticle ( const std::string & part)
overridevirtual

Set the type of charged particle.

  • electron,e-
  • positron,e+
  • muon,mu-
  • mu+
  • pion,pi-
  • pi+
  • kaon,K-
  • K+
  • proton,p
  • anti-proton,p-bar
  • deuteron,d
  • alpha

Reimplemented from Garfield::Track.

Definition at line 24 of file TrackElectron.cc.

24 {
25 if (particle != "electron" && particle != "e" && particle != "e-") {
26 std::cerr << m_className << "::SetParticle: Only electrons are allowed.\n";
27 }
28}

The documentation for this class was generated from the following files: