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::Track Class Referenceabstract

Abstract base class for track generation. More...

#include <Track.hh>

+ Inheritance diagram for Garfield::Track:

Public Member Functions

 Track ()=delete
 Default constructor.
 
 Track (const std::string &name)
 Constructor.
 
virtual ~Track ()
 Destructor.
 
virtual void SetParticle (const std::string &part)
 
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.
 
virtual bool NewTrack (const double x0, const double y0, const double z0, const double t0, const double dx0, const double dy0, const double dz0)=0
 
virtual bool GetCluster (double &xc, double &yc, double &zc, double &tc, int &nc, double &ec, double &extra)=0
 
virtual double GetClusterDensity ()
 
virtual double GetStoppingPower ()
 Get the stopping power (mean energy loss [eV] per cm).
 
void EnablePlotting (ViewDrift *viewer)
 Switch on plotting.
 
void DisablePlotting ()
 Switch off plotting.
 
void EnableDebugging ()
 Switch on debugging messages.
 
void DisableDebugging ()
 Switch off debugging messages.
 

Protected Member Functions

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

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

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

Abstract base class for track generation.

Definition at line 14 of file Track.hh.

Constructor & Destructor Documentation

◆ Track() [1/2]

◆ Track() [2/2]

Garfield::Track::Track ( const std::string & name)

Constructor.

Definition at line 13 of file Track.cc.

13 : m_mass(MuonMass) {
14 m_className = "Track" + name;
15 SetBetaGamma(3.);
16}
void SetBetaGamma(const double bg)
Set the relative momentum of the particle.
Definition Track.cc:106
std::string m_className
Definition Track.hh:104
double m_mass
Definition Track.hh:108

◆ ~Track()

virtual Garfield::Track::~Track ( )
inlinevirtual

Destructor.

Definition at line 21 of file Track.hh.

21{}

Member Function Documentation

◆ DisableDebugging()

void Garfield::Track::DisableDebugging ( )
inline

Switch off debugging messages.

Definition at line 101 of file Track.hh.

101{ m_debug = false; }

◆ DisablePlotting()

void Garfield::Track::DisablePlotting ( )

Switch off plotting.

Definition at line 186 of file Track.cc.

186 {
187 m_viewer = nullptr;
188}
ViewDrift * m_viewer
Definition Track.hh:118

◆ EnableDebugging()

void Garfield::Track::EnableDebugging ( )
inline

Switch on debugging messages.

Definition at line 99 of file Track.hh.

99{ m_debug = true; }

◆ EnablePlotting()

void Garfield::Track::EnablePlotting ( ViewDrift * viewer)

Switch on plotting.

Definition at line 178 of file Track.cc.

178 {
179 if (!view) {
180 std::cerr << m_className << "::EnablePlotting: Null pointer.\n";
181 return;
182 }
183 m_viewer = view;
184}

Referenced by main().

◆ GetBeta()

double Garfield::Track::GetBeta ( ) const
inline

Return the speed ( $\beta = v/c$) of the projectile.

Definition at line 56 of file Track.hh.

56{ return sqrt(m_beta2); }
double m_beta2
Definition Track.hh:110
DoubleAc sqrt(const DoubleAc &f)
Definition DoubleAc.cpp:314

Referenced by Garfield::TrackDegrade::NewTrack(), and Garfield::TrackHeed::NewTrack().

◆ GetBetaGamma()

double Garfield::Track::GetBetaGamma ( ) const
inline

Return the $\beta\gamma$ of the projectile.

Definition at line 54 of file Track.hh.

54{ return sqrt(m_beta2 / (1. - m_beta2)); }

Referenced by Garfield::TrackBichsel::ComputeCrossSection().

◆ GetCharge()

double Garfield::Track::GetCharge ( ) const
inline

Get the charge of the projectile.

Definition at line 65 of file Track.hh.

65{ return m_q; }

◆ GetCluster()

virtual bool Garfield::Track::GetCluster ( double & xc,
double & yc,
double & zc,
double & tc,
int & nc,
double & ec,
double & extra )
pure virtual

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)

Implemented in Garfield::TrackBichsel, Garfield::TrackDegrade, Garfield::TrackElectron, Garfield::TrackHeed, Garfield::TrackPAI, Garfield::TrackSimple, Garfield::TrackSrim, and Garfield::TrackTrim.

◆ GetClusterDensity()

virtual double Garfield::Track::GetClusterDensity ( )
inlinevirtual

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

Reimplemented in Garfield::TrackBichsel, Garfield::TrackDegrade, Garfield::TrackElectron, Garfield::TrackHeed, Garfield::TrackPAI, and Garfield::TrackSimple.

Definition at line 89 of file Track.hh.

89{ return 0.; }

◆ GetEnergy()

double Garfield::Track::GetEnergy ( ) const
inline

Return the particle energy.

Definition at line 52 of file Track.hh.

52{ return m_energy; }
double m_energy
Definition Track.hh:109

◆ GetGamma()

double Garfield::Track::GetGamma ( ) const
inline

Return the Lorentz factor of the projectile.

Definition at line 58 of file Track.hh.

58{ return sqrt(1. / (1. - m_beta2)); }

Referenced by Garfield::TrackHeed::Initialise(), and Garfield::TrackDegrade::NewTrack().

◆ GetKineticEnergy()

double Garfield::Track::GetKineticEnergy ( ) const
inline

◆ GetMass()

double Garfield::Track::GetMass ( ) const
inline

Get the mass [eV / c2] of the projectile.

Definition at line 67 of file Track.hh.

67{ return m_mass; }

◆ GetMomentum()

double Garfield::Track::GetMomentum ( ) const
inline

Return the particle momentum.

Definition at line 60 of file Track.hh.

60{ return m_mass * sqrt(m_beta2 / (1. - m_beta2)); }

◆ GetStoppingPower()

virtual double Garfield::Track::GetStoppingPower ( )
inlinevirtual

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

Reimplemented in Garfield::TrackBichsel, Garfield::TrackDegrade, Garfield::TrackElectron, Garfield::TrackHeed, Garfield::TrackPAI, and Garfield::TrackSimple.

Definition at line 91 of file Track.hh.

91{ return 0.; }

◆ NewTrack()

virtual bool Garfield::Track::NewTrack ( const double x0,
const double y0,
const double z0,
const double t0,
const double dx0,
const double dy0,
const double dz0 )
pure virtual

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

Implemented in Garfield::TrackBichsel, Garfield::TrackDegrade, Garfield::TrackElectron, Garfield::TrackHeed, Garfield::TrackPAI, Garfield::TrackSimple, Garfield::TrackSrim, and Garfield::TrackTrim.

◆ PlotCluster()

void Garfield::Track::PlotCluster ( const double x0,
const double y0,
const double z0 )
protected

Definition at line 195 of file Track.cc.

195 {
196 if (m_viewer) m_viewer->AddTrackPoint(m_plotId, x0, y0, z0);
197}
size_t m_plotId
Definition Track.hh:122

Referenced by Garfield::TrackHeed::NewTrack(), Garfield::TrackSrim::NewTrack(), and Garfield::TrackTrim::NewTrack().

◆ PlotNewTrack()

void Garfield::Track::PlotNewTrack ( const double x0,
const double y0,
const double z0 )
protected

Definition at line 190 of file Track.cc.

190 {
191 if (!m_viewer) return;
192 m_viewer->NewChargedParticleTrack(1, m_plotId, x0, y0, z0);
193}

Referenced by Garfield::TrackHeed::NewTrack(), Garfield::TrackSrim::NewTrack(), and Garfield::TrackTrim::NewTrack().

◆ SetBeta()

void Garfield::Track::SetBeta ( const double beta)

Set the speed ( $\beta = v/c$) of the particle.

Definition at line 119 of file Track.cc.

119 {
120 if (beta <= 0. || beta >= 1.) {
121 std::cerr << m_className << "::SetBeta:\n"
122 << " Beta must be between zero and one.\n";
123 return;
124 }
125
126 m_beta2 = beta * beta;
127 m_energy = m_mass * sqrt(1. / (1. - m_beta2));
128 m_isChanged = true;
129}
bool m_isChanged
Definition Track.hh:116

◆ SetBetaGamma()

void Garfield::Track::SetBetaGamma ( const double bg)

Set the relative momentum of the particle.

Definition at line 106 of file Track.cc.

106 {
107 if (bg <= 0.) {
108 std::cerr << m_className << "::SetBetaGamma:\n"
109 << " Particle speed must be greater than zero.\n";
110 return;
111 }
112
113 const double bg2 = bg * bg;
114 m_energy = m_mass * sqrt(1. + bg2);
115 m_beta2 = bg2 / (1. + bg2);
116 m_isChanged = true;
117}

Referenced by Track(), Garfield::TrackDegrade::TrackDegrade(), and Garfield::TrackElectron::TrackElectron().

◆ SetEnergy()

void Garfield::Track::SetEnergy ( const double e)

Set the particle energy.

Definition at line 93 of file Track.cc.

93 {
94 if (e <= m_mass) {
95 std::cerr << m_className << "::SetEnergy:\n"
96 << " Particle energy must be greater than the mass.\n";
97 return;
98 }
99
100 m_energy = e;
101 const double gamma = m_energy / m_mass;
102 m_beta2 = 1. - 1. / (gamma * gamma);
103 m_isChanged = true;
104}

◆ SetGamma()

void Garfield::Track::SetGamma ( const double gamma)

Set the Lorentz factor of the particle.

Definition at line 131 of file Track.cc.

131 {
132 if (gamma <= 1.) {
133 std::cerr << m_className << "::SetGamma:\n"
134 << " Gamma must be greater than one.\n";
135 return;
136 }
137
138 m_energy = m_mass * gamma;
139 m_beta2 = 1. - 1. / (gamma * gamma);
140 m_isChanged = true;
141}

◆ SetKineticEnergy()

void Garfield::Track::SetKineticEnergy ( const double ekin)

Set the kinetic energy of the particle.

Definition at line 156 of file Track.cc.

156 {
157 if (ekin <= 0.) {
158 std::cerr << m_className << "::SetKineticEnergy:\n"
159 << " Kinetic energy must be greater than zero.\n";
160 return;
161 }
162
163 m_energy = m_mass + ekin;
164 const double gamma = 1. + ekin / m_mass;
165 m_beta2 = 1. - 1. / (gamma * gamma);
166 m_isChanged = true;
167}

Referenced by Garfield::TrackTrim::ReadFile().

◆ SetMomentum()

void Garfield::Track::SetMomentum ( const double p)

Set the particle momentum.

Definition at line 143 of file Track.cc.

143 {
144 if (p <= 0.) {
145 std::cerr << m_className << "::SetMomentum:\n"
146 << " Particle momentum must be greater than zero.\n";
147 return;
148 }
149
150 m_energy = sqrt(m_mass * m_mass + p * p);
151 const double bg = p / m_mass;
152 m_beta2 = bg * bg / (1. + bg * bg);
153 m_isChanged = true;
154}

Referenced by main().

◆ SetParticle()

void Garfield::Track::SetParticle ( const std::string & part)
virtual

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 in Garfield::TrackDegrade, Garfield::TrackElectron, and Garfield::TrackTrim.

Definition at line 18 of file Track.cc.

18 {
19 std::string id = part;
20 std::transform(id.begin(), id.end(), id.begin(),
21 [](unsigned char c) -> unsigned char {
22 return std::toupper(c);
23 });
24 m_isElectron = false;
25 if (id == "ELECTRON" || id == "E-") {
26 m_q = -1;
27 m_mass = ElectronMass;
28 m_spin = 1;
29 m_isElectron = true;
30 m_particleName = "e-";
31 } else if (id == "POSITRON" || id == "E+") {
32 m_q = 1;
33 m_mass = ElectronMass;
34 m_spin = 1;
35 m_particleName = "e+";
36 } else if (id == "MUON" || id == "MU" || id == "MU-") {
37 m_q = -1;
38 m_mass = MuonMass;
39 m_spin = 1;
40 m_particleName = "mu-";
41 } else if (id == "MU+") {
42 m_q = 1;
43 m_mass = MuonMass;
44 m_spin = 1;
45 m_particleName = "mu+";
46 } else if (id == "PION" || id == "PI" || id == "PI-") {
47 m_q = -1;
48 m_mass = 139.57018e6;
49 m_spin = 0;
50 m_particleName = "pi-";
51 } else if (id == "PI+") {
52 m_q = 1;
53 m_mass = 139.57018e6;
54 m_spin = 0;
55 m_particleName = "pi+";
56 } else if (id == "KAON" || id == "K" || id == "K-") {
57 m_q = -1;
58 m_mass = 493.677e6;
59 m_spin = 0;
60 m_particleName = "K-";
61 } else if (id == "K+") {
62 m_q = 1;
63 m_mass = 493.677e6;
64 m_spin = 0;
65 m_particleName = "K+";
66 } else if (id == "PROTON" || id == "P") {
67 m_q = 1;
68 m_mass = ProtonMass;
69 m_spin = 1;
70 m_particleName = "p";
71 } else if (id == "ANTI-PROTON" || id == "ANTIPROTON" ||
72 id == "P-BAR" || id == "PBAR") {
73 m_q = -1;
74 m_mass = ProtonMass;
75 m_spin = 1;
76 m_particleName = "pbar";
77 } else if (id == "DEUTERON" || id == "D") {
78 m_q = 1;
79 m_mass = 1875.612793e6;
80 m_spin = 2;
81 m_particleName = "d";
82 } else if (id == "ALPHA") {
83 m_q = 2;
84 m_mass = 3.727379240e9;
85 m_spin = 0;
86 m_particleName = "alpha";
87 } else {
88 std::cerr << m_className << "::SetParticle:\n"
89 << " Particle " << part << " is not defined.\n";
90 }
91}
bool m_isElectron
Definition Track.hh:111
std::string m_particleName
Definition Track.hh:112

Referenced by main().

◆ SetSensor()

void Garfield::Track::SetSensor ( Sensor * s)

Set the sensor through which to transport the particle.

Definition at line 169 of file Track.cc.

169 {
170 if (!s) {
171 std::cerr << m_className << "::SetSensor: Null pointer.\n";
172 return;
173 }
174
175 m_sensor = s;
176}
Sensor * m_sensor
Definition Track.hh:114

Referenced by main().

◆ StepBfield()

std::array< double, 3 > Garfield::Track::StepBfield ( const double dt,
const double qoverm,
const double vmag,
double bx,
double by,
double bz,
std::array< double, 3 > & dir )
staticprotected

Definition at line 199 of file Track.cc.

201 {
202
203 double bmag = sqrt(bx * bx + by * by + bz * bz);
204 if (bmag < Garfield::Small) {
205 const double step = vmag * dt;
206 return {step * dir[0], step * dir[1], step * dir[2]};
207 }
208 std::array<std::array<double, 3>, 3> rot = {{{1, 0, 0}, {0, 1, 0}, {0, 0, 1}}};
209
210 bx /= bmag;
211 by /= bmag;
212 bz /= bmag;
213 const double bt = by * by + bz * bz;
214 if (bt > Garfield::Small) {
215 const double btInv = 1. / bt;
216 rot[0][0] = bx;
217 rot[0][1] = by;
218 rot[0][2] = bz;
219 rot[1][0] = -by;
220 rot[2][0] = -bz;
221 rot[1][1] = (bx * by * by + bz * bz) * btInv;
222 rot[2][2] = (bx * bz * bz + by * by) * btInv;
223 rot[1][2] = rot[2][1] = (bx - 1.) * by * bz * btInv;
224 } else if (bx < 0.) {
225 // B field is anti-parallel to x.
226 rot[0][0] = -1.;
227 rot[1][1] = -1.;
228 }
229 bmag *= Garfield::Tesla2Internal;
230 const double omega = qoverm * Garfield::OmegaCyclotronOverB * bmag *
231 Garfield::ElectronMass;
232 const double cphi = cos(omega * dt);
233 const double sphi = sin(omega * dt);
234
235 // Rotate the initial direction vector to the local frame.
236 std::array<double, 3> v0;
237 v0[0] = rot[0][0] * dir[0] + rot[0][1] * dir[1] + rot[0][2] * dir[2];
238 v0[1] = rot[1][0] * dir[0] + rot[1][1] * dir[1] + rot[1][2] * dir[2];
239 v0[2] = rot[2][0] * dir[0] + rot[2][1] * dir[1] + rot[2][2] * dir[2];
240
241 // Calculate the new direction in the local frame.
242 std::array<double, 3> v1;
243 v1[0] = v0[0];
244 v1[1] = v0[1] * cphi + v0[2] * sphi;
245 v1[2] = v0[2] * cphi - v0[1] * sphi;
246
247 // Rotate the direction vector back to the global frame.
248 dir[0] = rot[0][0] * v1[0] + rot[1][0] * v1[1] + rot[2][0] * v1[2];
249 dir[1] = rot[0][1] * v1[0] + rot[1][1] * v1[1] + rot[2][1] * v1[2];
250 dir[2] = rot[0][2] * v1[0] + rot[1][2] * v1[1] + rot[2][2] * v1[2];
251
252 // Calculate the new position in the local frame...
253 const double rho = vmag / omega;
254 const double u = vmag * v0[0] * dt;
255 const double v = rho * (v0[1] * sphi + v0[2] * (1. - cphi));
256 const double w = rho * (v0[2] * sphi - v0[1] * (1. - cphi));
257 // .... and in the global frame.
258 std::array<double, 3> pos;
259 pos[0] = rot[0][0] * u + rot[1][0] * v + rot[2][0] * w;
260 pos[1] = rot[0][1] * u + rot[1][1] * v + rot[2][1] * w;
261 pos[2] = rot[0][2] * u + rot[1][2] * v + rot[2][2] * w;
262 return pos;
263}
DoubleAc cos(const DoubleAc &f)
Definition DoubleAc.cpp:432
DoubleAc sin(const DoubleAc &f)
Definition DoubleAc.cpp:384

Referenced by Garfield::TrackSrim::NewTrack(), Garfield::TrackTrim::NewTrack(), and Garfield::TrackSrim::TerminateBfield().

Member Data Documentation

◆ m_beta2

double Garfield::Track::m_beta2 = 1.
protected

◆ m_className

std::string Garfield::Track::m_className = "Track"
protected

Definition at line 104 of file Track.hh.

Referenced by Garfield::TrackBichsel::ComputeCrossSection(), EnablePlotting(), Garfield::TrackSrim::EstimateRange(), Garfield::TrackSrim::GetCluster(), Garfield::TrackTrim::GetCluster(), Garfield::TrackHeed::GetClusterDensity(), Garfield::TrackPAI::GetClusterDensity(), Garfield::TrackHeed::GetElectron(), Garfield::TrackHeed::GetIon(), Garfield::TrackHeed::GetPhoton(), Garfield::TrackHeed::GetStoppingPower(), Garfield::TrackPAI::GetStoppingPower(), Garfield::TrackBichsel::Initialise(), Garfield::TrackDegrade::Initialise(), Garfield::TrackHeed::Initialise(), Garfield::TrackBichsel::NewTrack(), Garfield::TrackDegrade::NewTrack(), Garfield::TrackElectron::NewTrack(), Garfield::TrackHeed::NewTrack(), Garfield::TrackPAI::NewTrack(), Garfield::TrackSimple::NewTrack(), Garfield::TrackSrim::NewTrack(), Garfield::TrackTrim::NewTrack(), Garfield::TrackSrim::PreciseLoss(), Garfield::TrackTrim::Print(), Garfield::TrackSrim::ReadFile(), Garfield::TrackTrim::ReadFile(), SetBeta(), SetBetaGamma(), Garfield::TrackSimple::SetClusterDensity(), SetEnergy(), Garfield::TrackHeed::SetEnergyMesh(), SetGamma(), SetKineticEnergy(), SetMomentum(), SetParticle(), Garfield::TrackDegrade::SetParticle(), Garfield::TrackElectron::SetParticle(), Garfield::TrackTrim::SetParticle(), Garfield::TrackHeed::SetParticleUser(), SetSensor(), Garfield::TrackSimple::SetStoppingPower(), Garfield::TrackDegrade::SetThresholdEnergy(), Garfield::TrackDegrade::SetupPenning(), Garfield::TrackSrim::SmallestStep(), Track(), Garfield::TrackDegrade::TransportDeltaElectron(), Garfield::TrackHeed::TransportDeltaElectron(), and Garfield::TrackHeed::TransportPhoton().

◆ m_debug

◆ m_energy

double Garfield::Track::m_energy = 0.
protected

◆ m_isChanged

◆ m_isElectron

◆ m_mass

◆ m_particleName

◆ m_plotId

size_t Garfield::Track::m_plotId = 0
protected

Definition at line 122 of file Track.hh.

Referenced by PlotCluster(), and PlotNewTrack().

◆ m_q

◆ m_sensor

◆ m_spin

int Garfield::Track::m_spin = 1
protected

◆ m_viewer


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