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::TrackTrim Class Reference

#include <TrackTrim.hh>

+ Inheritance diagram for Garfield::TrackTrim:

Classes

struct  Cluster
 

Public Member Functions

 TrackTrim ()
 Default constructor.
 
 TrackTrim (Sensor *sensor)
 Constructor.
 
virtual ~TrackTrim ()
 Destructor.
 
bool ReadFile (const std::string &file, const unsigned int nIons=0, const unsigned int nSkip=0)
 Load data from an EXYZ.txt file.
 
void Print ()
 Print a summary of the available TRIM data.
 
void SetCharge (const double q)
 Set the projectile charge [-].
 
void SetWorkFunction (const double w)
 Set the W value [eV].
 
double GetWorkFunction () const
 Get the W value [eV].
 
void SetFanoFactor (const double f)
 Set the Fano factor.
 
void UnsetFanoFactor ()
 Use the default Fano factor.
 
double GetFanoFactor () const
 Get the Fano factor.
 
void EnableStepSizeLimit (const double dmax)
 Set a max. distance between subsequent steps.
 
void DisableStepSizeLimit ()
 Do not reduce the steps with respect to the TRIM input file (default).
 
void EnableEnergyLossLimit (const double emax)
 Set a max. energy loss per cluster.
 
void DisableEnergyLossLimit ()
 
void SetParticle (const std::string &part) 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
 
- 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.
 
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 AddIon (const std::vector< float > &x, const std::vector< float > &y, const std::vector< float > &z, const std::vector< float > &dedx, const std::vector< float > &ekin)
 
- 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)
 

Protected Attributes

double m_work = -1.
 Work function [eV] of the target.
 
bool m_fset = false
 Has the Fano factor been set?
 
double m_fano = -1.
 Fano factor [-] of the target.
 
double m_ekin = 0.
 Projectile energy [eV].
 
std::vector< std::vector< std::array< float, 6 > > > m_ions
 List of tracks.
 
size_t m_ion = 0
 Index of the current track.
 
std::vector< Clusterm_clusters
 Clusters on the current track.
 
size_t m_cluster = 0
 Index of the next cluster to be returned.
 
double m_maxStepSize = -1.
 Step size limit.
 
double m_maxLossPerStep = -1.
 Energy loss limit per step.
 
- 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
 

Additional Inherited Members

- 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)
 

Detailed Description

Generate tracks based on TRIM output files.

Definition at line 14 of file TrackTrim.hh.

Constructor & Destructor Documentation

◆ TrackTrim() [1/2]

Garfield::TrackTrim::TrackTrim ( )
inline

Default constructor.

Definition at line 17 of file TrackTrim.hh.

17: TrackTrim(nullptr) {}
TrackTrim()
Default constructor.
Definition TrackTrim.hh:17

Referenced by TrackTrim().

◆ TrackTrim() [2/2]

Garfield::TrackTrim::TrackTrim ( Sensor * sensor)

Constructor.

Definition at line 90 of file TrackTrim.cc.

90 : Track("Trim") {
91 m_sensor = sensor;
92 m_q = 1.;
93}
Sensor * m_sensor
Definition Track.hh:114
Track()=delete
Default constructor.

◆ ~TrackTrim()

virtual Garfield::TrackTrim::~TrackTrim ( )
inlinevirtual

Destructor.

Definition at line 21 of file TrackTrim.hh.

21{}

Member Function Documentation

◆ AddIon()

void Garfield::TrackTrim::AddIon ( const std::vector< float > & x,
const std::vector< float > & y,
const std::vector< float > & z,
const std::vector< float > & dedx,
const std::vector< float > & ekin )
protected

Definition at line 194 of file TrackTrim.cc.

198 {
199
200 const size_t nPoints = x.size();
201 if (nPoints < 2) return;
202 std::vector<std::array<float, 6> > path;
203 for (size_t i = 0; i < nPoints - 1; ++i) {
204 const float dx = x[i + 1] - x[i];
205 const float dy = y[i + 1] - y[i];
206 const float dz = z[i + 1] - z[i];
207 const float dmag = sqrt(dx * dx + dy * dy + dz * dz);
208 const float scale = dmag > 0. ? 1. / dmag : 1.;
209 float eloss = 0.;
210 if (i == 0 && dedx[i] > 10. * dedx[i + 1]) {
211 eloss = dmag * dedx[i + 1];
212 } else {
213 eloss = dmag * dedx[i];
214 }
215 const float dekin = ekin[i] - ekin[i + 1];
216 if (dekin > 0.) eloss = std::min(eloss, dekin);
217 path.push_back({dx * scale, dy * scale, dz * scale, dmag, eloss, ekin[i]});
218 }
219 m_ions.push_back(std::move(path));
220}
std::vector< std::vector< std::array< float, 6 > > > m_ions
List of tracks.
Definition TrackTrim.hh:85
DoubleAc sqrt(const DoubleAc &f)
Definition DoubleAc.cpp:314

Referenced by ReadFile().

◆ DisableEnergyLossLimit()

void Garfield::TrackTrim::DisableEnergyLossLimit ( )
inline

Do not limit the energy loss per cluster (default). Each segment in the TRIM input file corresponds to one cluster.

Definition at line 53 of file TrackTrim.hh.

53{ m_maxLossPerStep = -1.; }
double m_maxLossPerStep
Energy loss limit per step.
Definition TrackTrim.hh:97

◆ DisableStepSizeLimit()

void Garfield::TrackTrim::DisableStepSizeLimit ( )
inline

Do not reduce the steps with respect to the TRIM input file (default).

Definition at line 48 of file TrackTrim.hh.

48{ m_maxStepSize = -1.; }
double m_maxStepSize
Step size limit.
Definition TrackTrim.hh:95

◆ EnableEnergyLossLimit()

void Garfield::TrackTrim::EnableEnergyLossLimit ( const double emax)
inline

Set a max. energy loss per cluster.

Definition at line 50 of file TrackTrim.hh.

50{ m_maxLossPerStep = emax; }

◆ EnableStepSizeLimit()

void Garfield::TrackTrim::EnableStepSizeLimit ( const double dmax)
inline

Set a max. distance between subsequent steps.

Definition at line 46 of file TrackTrim.hh.

46{ m_maxStepSize = dmax; }

◆ GetCluster()

bool Garfield::TrackTrim::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 393 of file TrackTrim.cc.

394 {
395 if (m_debug) {
396 std::cout << m_className << "::GetCluster: Cluster " << m_cluster
397 << " of " << m_clusters.size() << "\n";
398 }
399 // Stop if we have exhausted the list of clusters.
400 if (m_cluster >= m_clusters.size()) return false;
401
402 const auto& cluster = m_clusters[m_cluster];
403 xcls = cluster.x;
404 ycls = cluster.y;
405 zcls = cluster.z;
406 tcls = cluster.t;
407
408 n = cluster.n;
409 e = cluster.energy;
410 extra = cluster.ekin;
411 // Move to the next cluster.
412 ++m_cluster;
413 return true;
414}
size_t m_cluster
Index of the next cluster to be returned.
Definition TrackTrim.hh:92
std::vector< Cluster > m_clusters
Clusters on the current track.
Definition TrackTrim.hh:90
std::string m_className
Definition Track.hh:104

◆ GetClusters()

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

Definition at line 70 of file TrackTrim.hh.

70 {
71 return m_clusters;
72 }

◆ GetFanoFactor()

double Garfield::TrackTrim::GetFanoFactor ( ) const
inline

Get the Fano factor.

Definition at line 43 of file TrackTrim.hh.

43{ return m_fano; }
double m_fano
Fano factor [-] of the target.
Definition TrackTrim.hh:80

◆ GetWorkFunction()

double Garfield::TrackTrim::GetWorkFunction ( ) const
inline

Get the W value [eV].

Definition at line 34 of file TrackTrim.hh.

34{ return m_work; }
double m_work
Work function [eV] of the target.
Definition TrackTrim.hh:76

◆ NewTrack()

bool Garfield::TrackTrim::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 243 of file TrackTrim.cc.

244 {
245
246 // TRMGEN - Generates TRIM clusters
247
248 if (m_ions.empty()) {
249 std::cerr << m_className << "::NewTrack: No TRIM data present.\n";
250 return false;
251 }
252
253 if (m_ion >= m_ions.size()) {
254 // Rewind.
255 std::cout << m_className << "::NewTrack: Rewinding.\n";
256 m_ion = 0;
257 }
258
259 // Verify that a sensor has been set.
260 if (!m_sensor) {
261 std::cerr << m_className << "::NewTrack: Sensor is not defined.\n";
262 return false;
263 }
264
265 // Set the initial direction.
266 std::array<double, 3> v = {dx0, dy0, dz0};
267 const double d0 = sqrt(dx0 * dx0 + dy0 * dy0 + dz0 * dz0);
268 if (d0 < Small) {
269 if (m_debug) {
270 std::cout << m_className << "::NewTrack: Sampling initial direction.\n";
271 }
272 // Null vector. Sample the direction isotropically.
273 RndmDirection(v[0], v[1], v[2]);
274 } else {
275 const double scale = 1. / d0;
276 for (size_t i = 0; i < 3; ++i) v[i] *= scale;
277 }
278
279 Medium* medium = m_sensor->GetMedium(x0, y0, z0);
280 if (!medium) {
281 std::cerr << m_className << "::NewTrack: No medium at initial point.\n";
282 return false;
283 }
284 double w = m_work > 0. ? m_work : medium->GetW();
285 // Warn if the W value is not defined.
286 if (w < Small) {
287 std::cerr << m_className << "::NewTrack: "
288 << "Work function at initial point is not defined.\n";
289 }
290 double fano = m_fset ? m_fano : medium->GetFanoFactor();
291 fano = std::max(fano, 0.);
292
293 // Charge-over-mass ratio.
294 const double qoverm = m_mass > 0. ? m_q / m_mass : 0.;
295
296 // Plot.
297 if (m_viewer) PlotNewTrack(x0, y0, z0);
298
299 // Reset the cluster count.
300 m_cluster = 0;
301 m_clusters.clear();
302
303 // Pool of unused energy
304 double epool = 0.0;
305
306 const double ekin0 = GetKineticEnergy();
307
308 const auto& path = m_ions[m_ion];
309 const size_t nPoints = path.size();
310 std::array<double, 3> x = {x0, y0, z0};
311 double t = t0;
312 for (size_t i = 0; i < nPoints; ++i) {
313 // Skip points with kinetic energy below the initial one set by the user.
314 double ekin = path[i][5];
315 if (ekin > ekin0) continue;
316 // Rotate the direction vector.
317 if (i == 0) {
318 Rotate({1, 0, 0}, {path[i][0], path[i][1], path[i][2]}, v);
319 } else {
320 Rotate({path[i - 1][0], path[i - 1][1], path[i - 1][2]},
321 {path[i][0], path[i][1], path[i][2]}, v);
322 }
323 // Get the step length and energy loss.
324 double dmag = path[i][3];
325 double eloss = path[i][4];
326 std::array<double, 3> d = {dmag * v[0], dmag * v[1], dmag * v[2]};
327 // Subdivide the step if necessary.
328 unsigned int nSteps = 1;
329 if (m_maxStepSize > 0. && dmag > m_maxStepSize) {
330 nSteps = std::ceil(dmag / m_maxStepSize);
331 }
332 if (m_maxLossPerStep > 0. && eloss > nSteps * m_maxLossPerStep) {
333 nSteps = std::ceil(eloss / m_maxLossPerStep);
334 }
335 if (nSteps > 1) {
336 const double scale = 1. / nSteps;
337 for (size_t j = 0; j < 3; ++j) d[j] *= scale;
338 dmag *= scale;
339 eloss *= scale;
340 }
341 // Compute the particle velocity.
342 const double vmag = Speed(ekin, m_mass);
343 // Compute the timestep.
344 const double dt = vmag > 0. ? dmag / vmag : 0.;
345 for (unsigned int j = 0; j < nSteps; ++j) {
346 Cluster cluster;
347 if (m_sensor->HasMagneticField()) {
348 double bx = 0., by = 0., bz = 0.;
349 int status = 0;
350 m_sensor->MagneticField(x[0], x[1], x[2], bx, by, bz, status);
351 d = StepBfield(dt, qoverm, vmag, bx, by, bz, v);
352 }
353 cluster.x = x[0] + d[0];
354 cluster.y = x[1] + d[1];
355 cluster.z = x[2] + d[2];
356 cluster.t = t + dt;
357 x = {cluster.x, cluster.y, cluster.z};
358 t = cluster.t;
359 // Is this point inside an ionisable medium?
360 medium = m_sensor->GetMedium(cluster.x, cluster.y, cluster.z);
361 if (!medium || !medium->IsIonisable()) continue;
362 if (m_work < Small) w = medium->GetW();
363 if (w < Small) continue;
364 if (fano < Small) {
365 // No fluctuations.
366 cluster.n = int((eloss + epool) / w);
367 cluster.energy = w * cluster.n;
368 } else {
369 double ec = eloss + epool;
370 cluster.n = 0;
371 cluster.energy = 0.0;
372 while (true) {
373 const double er = RndmHeedWF(w, fano);
374 if (er > ec) break;
375 cluster.n++;
376 cluster.energy += er;
377 ec -= er;
378 }
379 }
380 // TODO
381 cluster.ekin = i < nPoints - 1 ? path[i + 1][5] : ekin;
382 epool += eloss - cluster.energy;
383 if (cluster.n == 0) continue;
384 m_clusters.push_back(std::move(cluster));
385 if (m_viewer) PlotCluster(cluster.x, cluster.y, cluster.z);
386 }
387 }
388 // Move to the next ion in the list.
389 ++m_ion;
390 return true;
391}
bool m_fset
Has the Fano factor been set?
Definition TrackTrim.hh:78
size_t m_ion
Index of the current track.
Definition TrackTrim.hh:87
double GetKineticEnergy() const
Return the kinetic energy of the projectile.
Definition Track.hh:62
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)
Definition Track.cc:199
ViewDrift * m_viewer
Definition Track.hh:118
void PlotCluster(const double x0, const double y0, const double z0)
Definition Track.cc:195
double m_mass
Definition Track.hh:108
void PlotNewTrack(const double x0, const double y0, const double z0)
Definition Track.cc:190
double RndmHeedWF(const double w, const double f)
Definition Random.cc:699
void RndmDirection(double &dx, double &dy, double &dz, const double length=1.)
Draw a random (isotropic) direction vector.
Definition Random.hh:128

◆ Print()

void Garfield::TrackTrim::Print ( )

Print a summary of the available TRIM data.

Definition at line 222 of file TrackTrim.cc.

222 {
223 std::cout << m_className << "::Print:\n";
224 if (m_ions.empty()) {
225 std::cerr << " No TRIM data present.\n";
226 return;
227 }
228 std::cout << " Projectile: " << m_particleName << ", "
229 << m_ekin * 1.e-3 << " keV\n"
230 << " Number of tracks: " << m_ions.size() << "\n";
231 if (m_work > 0.) {
232 std::cout << " Work function: " << m_work << " eV\n";
233 } else {
234 std::cout << " Work function: Automatic\n";
235 }
236 if (m_fset) {
237 std::cout << " Fano factor: " << m_fano << "\n";
238 } else {
239 std::cout << " Fano factor: Automatic\n";
240 }
241}
double m_ekin
Projectile energy [eV].
Definition TrackTrim.hh:83
std::string m_particleName
Definition Track.hh:112

◆ ReadFile()

bool Garfield::TrackTrim::ReadFile ( const std::string & file,
const unsigned int nIons = 0,
const unsigned int nSkip = 0 )

Load data from an EXYZ.txt file.

Definition at line 99 of file TrackTrim.cc.

100 {
101
102 // TRMREE - Reads the TRIM EXYZ file.
103
104 // Reset.
105 m_ekin = 0.;
106 m_ions.clear();
107 m_ion = 0;
108 m_clusters.clear();
109 m_cluster = 0;
110
111 std::ifstream infile(filename);
112 if (!infile) {
113 std::cerr << m_className << "::ReadFile:\n"
114 << " Unable to open the EXYZ file (" << filename << ").\n";
115 return false;
116 }
117
118 constexpr double Angstrom = 1.e-8;
119 unsigned int nRead = 0;
120 unsigned int ionNumber = 0;
121 bool header = true;
122 double mass = 0.;
123 std::vector<float> x;
124 std::vector<float> y;
125 std::vector<float> z;
126 std::vector<float> dedx;
127 std::vector<float> ekin;
128 for (std::string line; std::getline(infile, line);) {
129 if (line.find("------- ") != std::string::npos) {
130 // Reached the end of the header.
131 header = false;
132 continue;
133 } else if (header) {
134 if (line.find("Ion Data: ") != std::string::npos) {
135 // Read the next line.
136 std::getline(infile, line);
137 auto words = tokenize(line);
138 if (words.size() >= 3) {
139 m_particleName = words[0];
140 mass = std::stod(words[1]);
141 auto pos = words[2].find("keV");
142 if (pos != std::string::npos) {
143 m_ekin = 1.e3 * std::stod(words[2].substr(0, pos));
144 }
145 }
146 }
147 // Otherwise, skip the header.
148 continue;
149 }
150 auto words = tokenize(line);
151 if (words.size() < 6) {
152 std::cerr << m_className << "::ReadFile: Unexpected line:\n"
153 << line << "\n";
154 continue;
155 }
156 if (ionNumber != std::stoul(words[0])) {
157 // New ion.
158 if (ionNumber > 0) {
159 if (nRead >= nSkip) AddIon(x, y, z, dedx, ekin);
160 x.clear();
161 y.clear();
162 z.clear();
163 dedx.clear();
164 ekin.clear();
165 ++nRead;
166 // Stop if we are done reading the requested number of ions.
167 if (nIons > 0 && m_ions.size() >= nIons) break;
168 }
169 ionNumber = std::stoi(words[0]);
170 }
171 if (nRead < nSkip) continue;
172 // Convert coordinates to cm.
173 x.push_back(std::stof(words[2]) * Angstrom);
174 y.push_back(std::stof(words[3]) * Angstrom);
175 z.push_back(std::stof(words[4]) * Angstrom);
176 // Convert stopping power from eV/A to eV/cm.
177 dedx.push_back(std::stof(words[5]) / Angstrom);
178 // Convert ion energy from keV to eV.
179 ekin.push_back(std::stof(words[1]) * 1.e3);
180 }
181 infile.close();
182 AddIon(x, y, z, dedx, ekin);
183 std::cout << m_className << "::ReadFile: Read energy vs position for "
184 << m_ions.size() << " ions.\n";
185 if (m_ekin > 0. && mass > 0.) {
186 std::cout << " Initial kinetic energy set to "
187 << m_ekin * 1.e-3 << " keV. Mass number: " << mass << ".\n";
188 m_mass = AtomicMassUnitElectronVolt * mass;
190 }
191 return true;
192}
void AddIon(const std::vector< float > &x, const std::vector< float > &y, const std::vector< float > &z, const std::vector< float > &dedx, const std::vector< float > &ekin)
Definition TrackTrim.cc:194
void SetKineticEnergy(const double ekin)
Set the kinetic energy of the particle.
Definition Track.cc:156
std::vector< std::string > tokenize(const std::string &line)
Definition Utilities.hh:25

◆ SetCharge()

void Garfield::TrackTrim::SetCharge ( const double q)
inline

Set the projectile charge [-].

Definition at line 30 of file TrackTrim.hh.

30{ if (fabs(q) > 0.) m_q = q; }
DoubleAc fabs(const DoubleAc &f)
Definition DoubleAc.h:615

◆ SetFanoFactor()

void Garfield::TrackTrim::SetFanoFactor ( const double f)
inline

Set the Fano factor.

Definition at line 36 of file TrackTrim.hh.

36 {
37 m_fano = f;
38 m_fset = true;
39 }

◆ SetParticle()

void Garfield::TrackTrim::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 95 of file TrackTrim.cc.

95 {
96 std::cerr << m_className << "::SetParticle: Not applicable.\n";
97}

◆ SetWorkFunction()

void Garfield::TrackTrim::SetWorkFunction ( const double w)
inline

Set the W value [eV].

Definition at line 32 of file TrackTrim.hh.

32{ m_work = w; }

◆ UnsetFanoFactor()

void Garfield::TrackTrim::UnsetFanoFactor ( )
inline

Use the default Fano factor.

Definition at line 41 of file TrackTrim.hh.

41{ m_fset = false; }

Member Data Documentation

◆ m_cluster

size_t Garfield::TrackTrim::m_cluster = 0
protected

Index of the next cluster to be returned.

Definition at line 92 of file TrackTrim.hh.

Referenced by GetCluster(), NewTrack(), and ReadFile().

◆ m_clusters

std::vector<Cluster> Garfield::TrackTrim::m_clusters
protected

Clusters on the current track.

Definition at line 90 of file TrackTrim.hh.

Referenced by GetCluster(), GetClusters(), NewTrack(), and ReadFile().

◆ m_ekin

double Garfield::TrackTrim::m_ekin = 0.
protected

Projectile energy [eV].

Definition at line 83 of file TrackTrim.hh.

Referenced by Print(), and ReadFile().

◆ m_fano

double Garfield::TrackTrim::m_fano = -1.
protected

Fano factor [-] of the target.

Definition at line 80 of file TrackTrim.hh.

Referenced by GetFanoFactor(), NewTrack(), Print(), and SetFanoFactor().

◆ m_fset

bool Garfield::TrackTrim::m_fset = false
protected

Has the Fano factor been set?

Definition at line 78 of file TrackTrim.hh.

Referenced by NewTrack(), Print(), SetFanoFactor(), and UnsetFanoFactor().

◆ m_ion

size_t Garfield::TrackTrim::m_ion = 0
protected

Index of the current track.

Definition at line 87 of file TrackTrim.hh.

Referenced by NewTrack(), and ReadFile().

◆ m_ions

std::vector<std::vector<std::array<float, 6> > > Garfield::TrackTrim::m_ions
protected

List of tracks.

Definition at line 85 of file TrackTrim.hh.

Referenced by AddIon(), NewTrack(), Print(), and ReadFile().

◆ m_maxLossPerStep

double Garfield::TrackTrim::m_maxLossPerStep = -1.
protected

Energy loss limit per step.

Definition at line 97 of file TrackTrim.hh.

Referenced by DisableEnergyLossLimit(), EnableEnergyLossLimit(), and NewTrack().

◆ m_maxStepSize

double Garfield::TrackTrim::m_maxStepSize = -1.
protected

Step size limit.

Definition at line 95 of file TrackTrim.hh.

Referenced by DisableStepSizeLimit(), EnableStepSizeLimit(), and NewTrack().

◆ m_work

double Garfield::TrackTrim::m_work = -1.
protected

Work function [eV] of the target.

Definition at line 76 of file TrackTrim.hh.

Referenced by GetWorkFunction(), NewTrack(), Print(), and SetWorkFunction().


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