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

#include <DriftLineRKF.hh>

Public Member Functions

 DriftLineRKF ()
 Default constructor.
 
 DriftLineRKF (Sensor *sensor)
 Constructor.
 
 ~DriftLineRKF ()
 Destructor.
 
void SetSensor (Sensor *s)
 Set the sensor.
 
void EnablePlotting (ViewDrift *view)
 Switch on drift line plotting.
 
void DisablePlotting ()
 Switch off drift line plotting.
 
void EnableSignalCalculation (const bool on=true)
 Switch calculation of induced currents on or off (default: enabled).
 
void SetSignalAveragingOrder (const unsigned int navg)
 
void UseWeightingPotential (const bool on=true)
 
void SetIntegrationAccuracy (const double eps)
 Set the accuracy of the Runge Kutta Fehlberg drift line integration.
 
void SetMaximumStepSize (const double ms)
 Set (explicitly) the maximum step size that is allowed.
 
void SetMaximumStepSize ()
 
void UnsetMaximumStepSize ()
 Do not apply an upper limit to the step size that is allowed.
 
void RejectKinks (const bool on=true)
 
void SetElectronSignalScalingFactor (const double scale)
 Set multiplication factor for the signal induced by electrons.
 
void SetHoleSignalScalingFactor (const double scale)
 Set multiplication factor for the signal induced by holes.
 
void SetIonSignalScalingFactor (const double scale)
 Set multiplication factor for the signal induced by ions.
 
void EnableAvalanche (const bool on=true)
 Enable/disable simulation electron multiplication (default: on).
 
void EnableIonTail (const bool on=true)
 Enable/disable simulation of the ion tail (default: off).
 
void EnableNegativeIonTail (const bool on=true)
 Enable/disable simulation of the negative ion tail (default: off).
 
void SetGainFluctuationsFixed (const double gain=-1.)
 Do not randomize the avalanche size.
 
void SetGainFluctuationsPolya (const double theta, const double mean=-1., const bool quiet=false)
 
void EnableTownsendMap (const bool on=true)
 Retrieve the Townsend coefficient from the component.
 
void EnableVelocityMap (const bool on=true)
 Retrieve the drift velocity from the component.
 
bool DriftElectron (const double x0, const double y0, const double z0, const double t0)
 Simulate the drift line of an electron with a given starting point.
 
bool DriftHole (const double x0, const double y0, const double z0, const double t0)
 Simulate the drift line of a hole with a given starting point.
 
bool DriftIon (const double x0, const double y0, const double z0, const double t0)
 Simulate the drift line of an ion with a given starting point.
 
bool DriftPositron (const double x0, const double y0, const double z0, const double t0)
 
bool DriftNegativeIon (const double x0, const double y0, const double z0, const double t0)
 
void PrintDriftLine () const
 Print the trajectory of the most recent drift line.
 
void GetEndPoint (double &x, double &y, double &z, double &t, int &st) const
 Get the end point and status flag of the most recent drift line.
 
size_t GetNumberOfDriftLinePoints () const
 Get the number of points of the most recent drift line.
 
void GetDriftLinePoint (const size_t i, double &x, double &y, double &z, double &t) const
 Get the coordinates and time of a point along the most recent drift line.
 
double GetArrivalTimeSpread (const double eps=1.e-4) const
 
double GetGain (const double eps=1.e-4) const
 Compute the multiplication factor for the current drift line.
 
double GetLoss (const double eps=1.e-4) const
 Compute the attachment loss factor for the current drift line.
 
double GetDriftTime () const
 Get the cumulative drift time.
 
double GetPathLength () const
 Get the cumulative path length.
 
void GetAvalancheSize (double &ne, double &ni) const
 
bool FieldLine (const double xi, const double yi, const double zi, std::vector< std::array< float, 3 > > &xl, const bool electron=true) const
 
void EnableDebugging (const bool on=true)
 Switch debugging messages on/off (default: off).
 

Detailed Description

Calculation of drift lines based on macroscopic transport coefficients using Runge-Kutta-Fehlberg integration.

Definition at line 18 of file DriftLineRKF.hh.

Constructor & Destructor Documentation

◆ DriftLineRKF() [1/2]

Garfield::DriftLineRKF::DriftLineRKF ( )
inline

Default constructor.

Definition at line 21 of file DriftLineRKF.hh.

21: DriftLineRKF(nullptr) {}
DriftLineRKF()
Default constructor.

Referenced by DriftLineRKF().

◆ DriftLineRKF() [2/2]

Garfield::DriftLineRKF::DriftLineRKF ( Sensor * sensor)

Constructor.

Definition at line 58 of file DriftLineRKF.cc.

58 : m_sensor(sensor) {
59 m_t.reserve(1000);
60 m_x.reserve(1000);
61}

◆ ~DriftLineRKF()

Garfield::DriftLineRKF::~DriftLineRKF ( )
inline

Destructor.

Definition at line 25 of file DriftLineRKF.hh.

25{}

Member Function Documentation

◆ DisablePlotting()

void Garfield::DriftLineRKF::DisablePlotting ( )

Switch off drift line plotting.

Definition at line 103 of file DriftLineRKF.cc.

103{ m_view = nullptr; }

◆ DriftElectron()

bool Garfield::DriftLineRKF::DriftElectron ( const double x0,
const double y0,
const double z0,
const double t0 )

Simulate the drift line of an electron with a given starting point.

Definition at line 143 of file DriftLineRKF.cc.

144 {
145 std::vector<std::array<double, 3> > x;
146 std::vector<double> t;
147 int status = 0;
148 const bool ok = DriftLine({x0, y0, z0}, t0, Particle::Electron,
149 t, x, status);
150 if (ok) {
151 const size_t nPoints = t.size();
152 std::vector<double> ne(nPoints, 1.);
153 std::vector<double> ni(nPoints, 0.);
154 std::vector<double> nn(nPoints, 0.);
155 double scale = 1.;
156 if (m_doAvalanche) Avalanche(Particle::Electron, x, ne, ni, nn, scale);
157 if (m_doSignal) {
158 ComputeSignal(Particle::Electron, scale * m_scaleE, t, x, ne);
159 }
160 if (m_doAvalanche) {
161 if (m_doIonTail) AddIonTail(t, x, ni, scale);
162 if (m_doNegativeIonTail) AddNegativeIonTail(t, x, nn, scale);
163 }
164 m_nE = scale * ne.back();
165 m_nI = scale * std::accumulate(ni.begin(), ni.end(), 0.);
166 } else {
167 m_nE = 0.;
168 m_nI = 0.;
169 }
170 std::swap(m_x, x);
171 std::swap(m_t, t);
172 m_particle = Particle::Electron;
173 m_status = status;
174 return ok;
175}

◆ DriftHole()

bool Garfield::DriftLineRKF::DriftHole ( const double x0,
const double y0,
const double z0,
const double t0 )

Simulate the drift line of a hole with a given starting point.

Definition at line 250 of file DriftLineRKF.cc.

251 {
252 std::vector<std::array<double, 3> > x;
253 std::vector<double> t;
254 int status = 0;
255 const bool ok = DriftLine({x0, y0, z0}, t0, Particle::Hole, t, x, status);
256 if (ok && m_doSignal) {
257 ComputeSignal(Particle::Hole, m_scaleH, t, x, {});
258 }
259 std::swap(m_x, x);
260 std::swap(m_t, t);
261 m_particle = Particle::Hole;
262 m_status = status;
263 return ok;
264}

◆ DriftIon()

bool Garfield::DriftLineRKF::DriftIon ( const double x0,
const double y0,
const double z0,
const double t0 )

Simulate the drift line of an ion with a given starting point.

Definition at line 266 of file DriftLineRKF.cc.

267 {
268 std::vector<std::array<double, 3> > x;
269 std::vector<double> t;
270 int status = 0;
271 const bool ok = DriftLine({x0, y0, z0}, t0, Particle::Ion, t, x, status);
272 if (ok && m_doSignal) {
273 ComputeSignal(Particle::Ion, m_scaleI, t, x, {});
274 }
275 std::swap(m_x, x);
276 std::swap(m_t, t);
277 m_particle = Particle::Ion;
278 m_status = status;
279 return ok;
280}

◆ DriftNegativeIon()

bool Garfield::DriftLineRKF::DriftNegativeIon ( const double x0,
const double y0,
const double z0,
const double t0 )

Simulate the drift line of an ion with a given starting point, assuming that it has negative charge.

Definition at line 282 of file DriftLineRKF.cc.

283 {
284 std::vector<std::array<double, 3> > x;
285 std::vector<double> t;
286 int status = 0;
287 const bool ok = DriftLine({x0, y0, z0}, t0, Particle::NegativeIon,
288 t, x, status);
289 if (ok && m_doSignal) {
290 ComputeSignal(Particle::NegativeIon, m_scaleI, t, x, {});
291 }
292 std::swap(m_x, x);
293 std::swap(m_t, t);
294 m_particle = Particle::NegativeIon;
295 m_status = status;
296 return ok;
297}

◆ DriftPositron()

bool Garfield::DriftLineRKF::DriftPositron ( const double x0,
const double y0,
const double z0,
const double t0 )

Simulate the drift line of an electron with a given starting point, assuming that it has positive charge.

Definition at line 233 of file DriftLineRKF.cc.

234 {
235 std::vector<std::array<double, 3> > x;
236 std::vector<double> t;
237 int status = 0;
238 const bool ok = DriftLine({x0, y0, z0}, t0, Particle::Positron,
239 t, x, status);
240 if (ok && m_doSignal) {
241 ComputeSignal(Particle::Positron, m_scaleE, t, x, {});
242 }
243 std::swap(m_x, x);
244 std::swap(m_t, t);
245 m_particle = Particle::Positron;
246 m_status = status;
247 return ok;
248}

◆ EnableAvalanche()

void Garfield::DriftLineRKF::EnableAvalanche ( const bool on = true)
inline

Enable/disable simulation electron multiplication (default: on).

Definition at line 69 of file DriftLineRKF.hh.

69{ m_doAvalanche = on; }

◆ EnableDebugging()

void Garfield::DriftLineRKF::EnableDebugging ( const bool on = true)
inline

Switch debugging messages on/off (default: off).

Definition at line 140 of file DriftLineRKF.hh.

140{ m_debug = on; }

◆ EnableIonTail()

void Garfield::DriftLineRKF::EnableIonTail ( const bool on = true)
inline

Enable/disable simulation of the ion tail (default: off).

Definition at line 71 of file DriftLineRKF.hh.

71{ m_doIonTail = on; }

◆ EnableNegativeIonTail()

void Garfield::DriftLineRKF::EnableNegativeIonTail ( const bool on = true)
inline

Enable/disable simulation of the negative ion tail (default: off).

Definition at line 73 of file DriftLineRKF.hh.

73{ m_doNegativeIonTail = on; }

◆ EnablePlotting()

void Garfield::DriftLineRKF::EnablePlotting ( ViewDrift * view)

Switch on drift line plotting.

Definition at line 95 of file DriftLineRKF.cc.

95 {
96 if (!view) {
97 std::cerr << m_className << "::EnablePlotting: Null pointer.\n";
98 return;
99 }
100 m_view = view;
101}

◆ EnableSignalCalculation()

void Garfield::DriftLineRKF::EnableSignalCalculation ( const bool on = true)
inline

Switch calculation of induced currents on or off (default: enabled).

Definition at line 36 of file DriftLineRKF.hh.

36{ m_doSignal = on; }

◆ EnableTownsendMap()

void Garfield::DriftLineRKF::EnableTownsendMap ( const bool on = true)
inline

Retrieve the Townsend coefficient from the component.

Definition at line 82 of file DriftLineRKF.hh.

82{ m_useTownsendMap = on; }

◆ EnableVelocityMap()

void Garfield::DriftLineRKF::EnableVelocityMap ( const bool on = true)
inline

Retrieve the drift velocity from the component.

Definition at line 84 of file DriftLineRKF.hh.

84{ m_useVelocityMap = on; }

◆ FieldLine()

bool Garfield::DriftLineRKF::FieldLine ( const double xi,
const double yi,
const double zi,
std::vector< std::array< float, 3 > > & xl,
const bool electron = true ) const

Compute an electric field line.

Parameters
xi,yi,zistarting point
xlpoints along the field line
electronflag to set the direction in which to follow the field

Definition at line 1506 of file DriftLineRKF.cc.

1508 {
1509
1510 xl.clear();
1511 // Is the sensor set?
1512 if (!m_sensor) {
1513 std::cerr << m_className << "::FieldLine: Sensor is not defined.\n";
1514 return false;
1515 }
1516
1517 // Get the sensor's bounding box.
1518 double xmin = 0., xmax = 0.;
1519 double ymin = 0., ymax = 0.;
1520 double zmin = 0., zmax = 0.;
1521 bool bbox = m_sensor->GetArea(xmin, ymin, zmin, xmax, ymax, zmax);
1522
1523 // Set the step size limit if requested.
1524 double maxStep = -1.;
1525 if (m_useStepSizeLimit) {
1526 if (m_maxStepSize > 0.) {
1527 maxStep = m_maxStepSize;
1528 } else {
1529 maxStep = 0.5 * m_sensor->StepSizeHint();
1530 }
1531 }
1532
1533 // Make sure the initial position is at a valid location.
1534 double ex = 0., ey = 0., ez = 0.;
1535 Medium* medium = nullptr;
1536 int stat = 0;
1537 m_sensor->ElectricField(xi, yi, zi, ex, ey, ez, medium, stat);
1538 if (!medium || stat != 0) {
1539 std::cerr << m_className << "::FieldLine: "
1540 << "No valid field at initial position.\n";
1541 return false;
1542 }
1543 Vec x0 = {xi, yi, zi};
1544 Vec f0 = {ex, ey, ez};
1545 if (electron) for (auto& f : f0) f *= -1;
1546
1547 // Set the numerical constants for the RKF integration.
1548 constexpr double c10 = 214. / 891.;
1549 constexpr double c11 = 1. / 33.;
1550 constexpr double c12 = 650. / 891.;
1551 constexpr double c20 = 533. / 2106.;
1552 constexpr double c22 = 800. / 1053.;
1553 constexpr double c23 = -1. / 78.;
1554
1555 constexpr double b10 = 1. / 4.;
1556 constexpr double b20 = -189. / 800.;
1557 constexpr double b21 = 729. / 800.;
1558 constexpr double b30 = 214. / 891.;
1559 constexpr double b31 = 1. / 33.;
1560 constexpr double b32 = 650. / 891.;
1561
1562 const double fmag0 = Mag(f0);
1563 if (fmag0 < Small) {
1564 std::cerr << m_className << "::FieldLine:\n"
1565 << " Zero field at initial position.\n";
1566 return false;
1567 }
1568
1569 // Initialise time step and previous time step.
1570 double h = m_accuracy / fmag0;
1571 double hprev = h;
1572 if (m_debug) {
1573 std::cout << m_className << "::FieldLine:\n"
1574 << " Initial step size: " << h << ".\n";
1575 }
1576 // Set the initial point.
1577 xl.push_back({float(x0[0]), float(x0[1]), float(x0[2])});
1578
1579 int initCycle = 3;
1580 bool ok = true;
1581 while (ok) {
1582 // Get the field at the first probe point.
1583 Vec x1 = x0;
1584 for (unsigned int i = 0; i < 3; ++i) {
1585 x1[i] += h * b10 * f0[i];
1586 }
1587 m_sensor->ElectricField(x1[0], x1[1], x1[2], ex, ey, ez, medium, stat);
1588 if (stat != 0) {
1589 if (m_debug) std::cout << " Point 1 outside.\n";
1590 Terminate(x0, x1, xl);
1591 return true;
1592 }
1593 Vec f1 = {ex, ey, ez};
1594 if (electron) for (auto& f : f1) f *= -1;
1595 // Get the field at the second probe point.
1596 Vec x2 = x0;
1597 for (unsigned int i = 0; i < 3; ++i) {
1598 x2[i] += h * (b20 * f0[i] + b21 * f1[i]);
1599 }
1600 m_sensor->ElectricField(x2[0], x2[1], x2[2], ex, ey, ez, medium, stat);
1601 if (stat != 0) {
1602 if (m_debug) std::cout << " Point 2 outside.\n";
1603 Terminate(x0, x2, xl);
1604 return true;
1605 }
1606 Vec f2 = {ex, ey, ez};
1607 if (electron) for (auto& f : f2) f *= -1;
1608 // Get the field at the third probe point.
1609 Vec x3 = x0;
1610 for (unsigned int i = 0; i < 3; ++i) {
1611 x3[i] += h * (b30 * f0[i] + b31 * f1[i] + b32 * f2[i]);
1612 }
1613 m_sensor->ElectricField(x3[0], x3[1], x3[2], ex, ey, ez, medium, stat);
1614 if (stat != 0) {
1615 if (m_debug) std::cout << " Point 3 outside.\n";
1616 Terminate(x0, x3, xl);
1617 return true;
1618 }
1619 Vec f3 = {ex, ey, ez};
1620 if (electron) for (auto& f : f3) f *= -1;
1621 // Check if we crossed a wire.
1622 double xw = 0., yw = 0., zw = 0., rw = 0.;
1623 if (m_sensor->CrossedWire(x0[0], x0[1], x0[2],
1624 x1[0], x1[1], x1[2], xw, yw, zw, false, rw) ||
1625 m_sensor->CrossedWire(x0[0], x0[1], x0[2],
1626 x2[0], x2[1], x2[2], xw, yw, zw, false, rw) ||
1627 m_sensor->CrossedWire(x0[0], x0[1], x0[2],
1628 x3[0], x3[1], x3[2], xw, yw, zw, false, rw)) {
1629 // TODO!
1630 xl.push_back({float(xw), float(yw), float(zw)});
1631 return true;
1632 // Drift to wire.
1633 if (h > Small) {
1634 h *= 0.5;
1635 continue;
1636 } else {
1637 std::cerr << m_className << "::FieldLine: Step size too small. Stop.\n";
1638 return false;
1639 }
1640 }
1641 // Calculate the correction terms.
1642 Vec phi1 = {0., 0., 0.};
1643 Vec phi2 = {0., 0., 0.};
1644 for (unsigned int i = 0; i < 3; ++i) {
1645 phi1[i] = c10 * f0[i] + c11 * f1[i] + c12 * f2[i];
1646 phi2[i] = c20 * f0[i] + c22 * f2[i] + c23 * f3[i];
1647 }
1648 // Check if the step length is valid.
1649 const double phi1mag = Mag(phi1);
1650 if (phi1mag < Small) {
1651 std::cerr << m_className << "::FieldLine: Step has zero length. Stop.\n";
1652 break;
1653 } else if (maxStep > 0. && h * phi1mag > maxStep) {
1654 if (m_debug) {
1655 std::cout << " Step is considered too long. H is reduced.\n";
1656 }
1657 h = 0.5 * maxStep / phi1mag;
1658 continue;
1659 } else if (bbox) {
1660 // Don't allow h to become too large.
1661 if (h * fabs(phi1[0]) > 0.1 * fabs(xmax - xmin) ||
1662 h * fabs(phi1[1]) > 0.1 * fabs(ymax - ymin)) {
1663 h *= 0.5;
1664 if (m_debug) {
1665 std::cout << " Step is considered too long. H is halved.\n";
1666 }
1667 continue;
1668 }
1669 }
1670 if (m_debug) std::cout << " Step size ok.\n";
1671 // Update the position.
1672 for (size_t i = 0; i < 3; ++i) x0[i] += h * phi1[i];
1673 // Check the new position.
1674 m_sensor->ElectricField(x0[0], x0[1], x0[2], ex, ey, ez, medium, stat);
1675 if (stat != 0) {
1676 // The new position is not inside a valid drift medium.
1677 // Terminate the drift line.
1678 if (m_debug) std::cout << " Point outside. Terminate.\n";
1679 std::array<double, 3> xp = {xl.back()[0], xl.back()[1], xl.back()[2]};
1680 Terminate(xp, x0, xl);
1681 return true;
1682 }
1683 // Add the new point to the drift line.
1684 xl.push_back({float(x0[0]), float(x0[1]), float(x0[2])});
1685 // Adjust the step size according to the accuracy of the two estimates.
1686 hprev = h;
1687 const double dphi = fabs(phi1[0] - phi2[0]) + fabs(phi1[1] - phi2[1]) +
1688 fabs(phi1[2] - phi2[2]);
1689 if (dphi > 0) {
1690 h = sqrt(h * m_accuracy / dphi);
1691 if (m_debug) std::cout << " Adapting H to " << h << ".\n";
1692 } else {
1693 h *= 2;
1694 if (m_debug) std::cout << " H increased by factor two.\n";
1695 }
1696 // Make sure that H is different from zero; this should always be ok.
1697 if (h < Small) {
1698 std::cerr << m_className << "::FieldLine: Step size is zero. Stop.\n";
1699 return false;
1700 }
1701 // Check the initial step size.
1702 if (initCycle > 0 && h < 0.2 * hprev) {
1703 if (m_debug) std::cout << " Reinitialise step size.\n";
1704 --initCycle;
1705 x0 = {xi, yi, zi};
1706 xl.clear();
1707 xl.push_back({float(xi), float(yi), float(zi)});
1708 continue;
1709 }
1710 initCycle = 0;
1711 // Don't allow H to grow too quickly
1712 if (h > 10 * hprev) {
1713 h = 10 * hprev;
1714 if (m_debug) {
1715 std::cout << " H restricted to 10 times the previous value.\n";
1716 }
1717 }
1718 // Stop in case H tends to become too small.
1719 if (h * (fabs(phi1[0]) + fabs(phi1[1]) + fabs(phi1[2])) < m_accuracy) {
1720 std::cerr << m_className << "::FieldLine: Step size has become smaller "
1721 << "than int. accuracy. Stop.\n";
1722 return false;
1723 }
1724 // Update the field.
1725 f0 = f3;
1726 }
1727 return true;
1728}
std::array< double, 3 > Vec
DoubleAc fabs(const DoubleAc &f)
Definition DoubleAc.h:615
DoubleAc sqrt(const DoubleAc &f)
Definition DoubleAc.cpp:314

Referenced by Garfield::ViewField::PlotFieldLines().

◆ GetArrivalTimeSpread()

double Garfield::DriftLineRKF::GetArrivalTimeSpread ( const double eps = 1.e-4) const

Compute the sigma of the arrival time distribution for the current drift line by integrating the longitudinal diffusion coefficient.

Definition at line 735 of file DriftLineRKF.cc.

735 {
736 return ComputeSigma(m_x, m_particle, eps);
737}

◆ GetAvalancheSize()

void Garfield::DriftLineRKF::GetAvalancheSize ( double & ne,
double & ni ) const
inline

Definition at line 128 of file DriftLineRKF.hh.

128{ ne = m_nE; ni = m_nI; }

◆ GetDriftLinePoint()

void Garfield::DriftLineRKF::GetDriftLinePoint ( const size_t i,
double & x,
double & y,
double & z,
double & t ) const

Get the coordinates and time of a point along the most recent drift line.

Definition at line 1287 of file DriftLineRKF.cc.

1288 {
1289 if (i >= m_x.size()) {
1290 std::cerr << m_className << "::GetDriftLinePoint: Index out of range.\n";
1291 return;
1292 }
1293
1294 const auto& p = m_x[i];
1295 x = p[0];
1296 y = p[1];
1297 z = p[2];
1298 t = m_t[i];
1299}

◆ GetDriftTime()

double Garfield::DriftLineRKF::GetDriftTime ( ) const
inline

Get the cumulative drift time.

Definition at line 122 of file DriftLineRKF.hh.

122 {
123 return m_t.empty() ? 0. : m_t.back() - m_t.front();
124 }

◆ GetEndPoint()

void Garfield::DriftLineRKF::GetEndPoint ( double & x,
double & y,
double & z,
double & t,
int & st ) const

Get the end point and status flag of the most recent drift line.

Definition at line 1272 of file DriftLineRKF.cc.

1273 {
1274 if (m_x.empty()) {
1275 x = y = z = t = 0.;
1276 stat = m_status;
1277 return;
1278 }
1279 const auto& p = m_x.back();
1280 x = p[0];
1281 y = p[1];
1282 z = p[2];
1283 t = m_t.back();
1284 stat = m_status;
1285}

◆ GetGain()

double Garfield::DriftLineRKF::GetGain ( const double eps = 1.e-4) const

Compute the multiplication factor for the current drift line.

Definition at line 777 of file DriftLineRKF.cc.

777 {
778 if (m_status == StatusCalculationAbandoned) return 1.;
779 return ComputeGain(m_x, m_particle, eps);
780}

◆ GetLoss()

double Garfield::DriftLineRKF::GetLoss ( const double eps = 1.e-4) const

Compute the attachment loss factor for the current drift line.

Definition at line 825 of file DriftLineRKF.cc.

825 {
826 if (m_status == StatusCalculationAbandoned) return 1.;
827 return ComputeLoss(m_x, m_particle, eps);
828}

◆ GetNumberOfDriftLinePoints()

size_t Garfield::DriftLineRKF::GetNumberOfDriftLinePoints ( ) const
inline

Get the number of points of the most recent drift line.

Definition at line 109 of file DriftLineRKF.hh.

109{ return m_x.size(); }

◆ GetPathLength()

double Garfield::DriftLineRKF::GetPathLength ( ) const

Get the cumulative path length.

Definition at line 871 of file DriftLineRKF.cc.

871 {
872
873 const size_t nPoints = m_x.size();
874 if (nPoints < 2) return 0.;
875 double path = 0.;
876 for (size_t i = 1; i < nPoints; ++i) {
877 path += Dist(m_x[i - 1], m_x[i]);
878 }
879 return path;
880}

◆ PrintDriftLine()

void Garfield::DriftLineRKF::PrintDriftLine ( ) const

Print the trajectory of the most recent drift line.

Definition at line 1241 of file DriftLineRKF.cc.

1241 {
1242
1243 std::cout << m_className << "::PrintDriftLine:\n";
1244 if (m_x.empty()) {
1245 std::cout << " No drift line present.\n";
1246 return;
1247 }
1248 if (m_particle == Particle::Electron) {
1249 std::cout << " Particle: electron\n";
1250 } else if (m_particle == Particle::Ion) {
1251 std::cout << " Particle: ion\n";
1252 } else if (m_particle == Particle::Hole) {
1253 std::cout << " Particle: hole\n";
1254 } else if (m_particle == Particle::Positron) {
1255 std::cout << " Particle: positive electron\n";
1256 } else if (m_particle == Particle::NegativeIon) {
1257 std::cout << " Particle: negative ion\n";
1258 } else {
1259 std::cout << " Particle: unknown\n";
1260 }
1261 std::cout << " Status: " << m_status << "\n"
1262 << " Step time [ns] "
1263 << "x [cm] y [cm] z [cm]\n";
1264 const unsigned int nPoints = m_x.size();
1265 for (unsigned int i = 0; i < nPoints; ++i) {
1266 std::printf("%6u %15.7f %15.7f %15.7f %15.7f\n",
1267 i, m_t[i], m_x[i][0], m_x[i][1], m_x[i][2]);
1268 }
1269
1270}

◆ RejectKinks()

void Garfield::DriftLineRKF::RejectKinks ( const bool on = true)
inline

Request (or not) the drift line calculation to be aborted if the drift line makes a bend sharper than 90 degrees.

Definition at line 59 of file DriftLineRKF.hh.

59{ m_rejectKinks = on; }

◆ SetElectronSignalScalingFactor()

void Garfield::DriftLineRKF::SetElectronSignalScalingFactor ( const double scale)
inline

Set multiplication factor for the signal induced by electrons.

Definition at line 62 of file DriftLineRKF.hh.

62{ m_scaleE = scale; }

◆ SetGainFluctuationsFixed()

void Garfield::DriftLineRKF::SetGainFluctuationsFixed ( const double gain = -1.)

Do not randomize the avalanche size.

Definition at line 105 of file DriftLineRKF.cc.

105 {
106
107 if (gain > 1.) {
108 std::cout << m_className << "::SetGainFluctuationsFixed: "
109 << "Avalanche size set to " << gain << ".\n";
110 } else {
111 std::cout << m_className << "::SetGainFluctuationsFixed:\n "
112 << "Avalanche size will be given by "
113 << "the integrated Townsend coefficient.\n";
114 }
115 m_gain = gain;
116 m_gainFluctuations = GainFluctuations::None;
117}

◆ SetGainFluctuationsPolya()

void Garfield::DriftLineRKF::SetGainFluctuationsPolya ( const double theta,
const double mean = -1.,
const bool quiet = false )

Sample the avalanche size from a Polya distribution with shape parameter theta.

Definition at line 119 of file DriftLineRKF.cc.

121 {
122
123 if (theta < 0.) {
124 std::cerr << m_className << "::SetGainFluctuationsPolya: "
125 << "Shape parameter must be >= 0.\n";
126 return;
127 }
128 if (!quiet) {
129 if (mean > 1.) {
130 std::cout << m_className << "::SetGainFluctuationsPolya: "
131 << "Mean avalanche size set to " << mean << ".\n";
132 } else {
133 std::cout << m_className << "::SetGainFluctuationsPolya:\n "
134 << "Mean avalanche size will be given by "
135 << "the integrated Townsend coefficient.\n";
136 }
137 }
138 m_gain = mean;
139 m_theta = theta;
140 m_gainFluctuations = GainFluctuations::Polya;
141}

◆ SetHoleSignalScalingFactor()

void Garfield::DriftLineRKF::SetHoleSignalScalingFactor ( const double scale)
inline

Set multiplication factor for the signal induced by holes.

Definition at line 64 of file DriftLineRKF.hh.

64{ m_scaleH = scale; }

◆ SetIntegrationAccuracy()

void Garfield::DriftLineRKF::SetIntegrationAccuracy ( const double eps)

Set the accuracy of the Runge Kutta Fehlberg drift line integration.

Definition at line 71 of file DriftLineRKF.cc.

71 {
72 if (eps > 0.) {
73 m_accuracy = eps;
74 } else {
75 std::cerr << m_className << "::SetIntegrationAccuracy:\n"
76 << " Accuracy must be greater than zero.\n";
77 }
78}

◆ SetIonSignalScalingFactor()

void Garfield::DriftLineRKF::SetIonSignalScalingFactor ( const double scale)
inline

Set multiplication factor for the signal induced by ions.

Definition at line 66 of file DriftLineRKF.hh.

66{ m_scaleI = scale; }

◆ SetMaximumStepSize() [1/2]

void Garfield::DriftLineRKF::SetMaximumStepSize ( )

Try to set an upper limit to the allowable step size based on the feature size of the sensor.

Definition at line 80 of file DriftLineRKF.cc.

80 {
81 m_maxStepSize = -1.;
82 m_useStepSizeLimit = true;
83}

◆ SetMaximumStepSize() [2/2]

void Garfield::DriftLineRKF::SetMaximumStepSize ( const double ms)

Set (explicitly) the maximum step size that is allowed.

Definition at line 85 of file DriftLineRKF.cc.

85 {
86 if (ms > 0.) {
87 m_maxStepSize = ms;
88 m_useStepSizeLimit = true;
89 } else {
90 std::cerr << m_className << "::SetMaximumStepSize:\n"
91 << " Step size must be greater than zero.\n";
92 }
93}

Referenced by Garfield::ViewField::PlotFieldLines().

◆ SetSensor()

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

Set the sensor.

Definition at line 63 of file DriftLineRKF.cc.

63 {
64 if (!s) {
65 std::cerr << m_className << "::SetSensor: Null pointer.\n";
66 return;
67 }
68 m_sensor = s;
69}

Referenced by Garfield::ViewField::PlotFieldLines().

◆ SetSignalAveragingOrder()

void Garfield::DriftLineRKF::SetSignalAveragingOrder ( const unsigned int navg)
inline

Set the number of points to be used when averaging the delayed signal vector over a time bin in the Sensor class. The averaging is done with a $2\times navg + 1$ point Newton-Raphson integration. Default: 2.

Definition at line 41 of file DriftLineRKF.hh.

41{ m_navg = navg; }

◆ UnsetMaximumStepSize()

void Garfield::DriftLineRKF::UnsetMaximumStepSize ( )
inline

Do not apply an upper limit to the step size that is allowed.

Definition at line 56 of file DriftLineRKF.hh.

56{ m_useStepSizeLimit = false; }

◆ UseWeightingPotential()

void Garfield::DriftLineRKF::UseWeightingPotential ( const bool on = true)
inline

Use the weighting potential (as opposed to the weighting field) for calculating the induced signal.

Definition at line 44 of file DriftLineRKF.hh.

44 {
45 m_useWeightingPotential = on;
46 }

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