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

Base class for gas media. More...

#include <MediumGas.hh>

+ Inheritance diagram for Garfield::MediumGas:

Classes

struct  ExcLevel
 
struct  IonLevel
 

Public Member Functions

 MediumGas ()
 Constructor.
 
virtual ~MediumGas ()
 Destructor.
 
bool SetComposition (const std::string &gas1, const double f1=1., const std::string &gas2="", const double f2=0., const std::string &gas3="", const double f3=0., const std::string &gas4="", const double f4=0., const std::string &gas5="", const double f5=0., const std::string &gas6="", const double f6=0.)
 Set the gas mixture.
 
void GetComposition (std::string &gas1, double &f1, std::string &gas2, double &f2, std::string &gas3, double &f3, std::string &gas4, double &f4, std::string &gas5, double &f5, std::string &gas6, double &f6) const
 Retrieve the gas mixture.
 
bool LoadGasFile (const std::string &filename, const bool quiet=false)
 Read table of gas properties (transport parameters) from file.
 
bool WriteGasFile (const std::string &filename)
 Save the present table of gas properties (transport parameters) to a file.
 
bool MergeGasFile (const std::string &filename, const bool replaceOld)
 Read table of gas properties from and merge with the existing dataset.
 
virtual bool EnablePenningTransfer ()
 
virtual bool EnablePenningTransfer (const double r, const double lambda)
 
virtual bool EnablePenningTransfer (const double r, const double lambda, std::string gasname)
 
virtual void DisablePenningTransfer ()
 Switch the simulation of Penning transfers off globally.
 
virtual bool DisablePenningTransfer (std::string gasname)
 Switch the simulation of Penning transfers off for a given component.
 
bool GetPenningTransfer (const std::string &gasname, double &r, double &lambda)
 
virtual void PrintGas ()
 Print information about the present gas mixture and available data.
 
bool LoadIonMobility (const std::string &filename, const bool quiet=false)
 Read a table of (positive) ion mobilities vs. electric field from file.
 
bool LoadNegativeIonMobility (const std::string &filename, const bool quiet=false)
 Read a table of negative ion mobilities vs. electric field from file.
 
bool AdjustTownsendCoefficient ()
 
size_t GetNumberOfIonisationLevels () const
 Return the number of ionisation levels in the table.
 
size_t GetNumberOfExcitationLevels () const
 Return the number of excitation levels in the table.
 
void GetIonisationLevel (const size_t level, std::string &label, double &energy) const
 Return the identifier and threshold of an ionisation level.
 
void GetExcitationLevel (const size_t level, std::string &label, double &energy) const
 Return the identifier and energy of an excitation level.
 
bool GetElectronIonisationRate (const size_t level, const size_t ie, const size_t ib, const size_t ia, double &f) const
 Get an entry in the table of ionisation rates.
 
bool GetElectronExcitationRate (const size_t level, const size_t ie, const size_t ib, const size_t ia, double &f) const
 Get an entry in the table of excitation rates.
 
bool IsGas () const override
 Is this medium a gas?
 
void GetComponent (const unsigned int i, std::string &label, double &f) override
 Get the name and fraction of a given component.
 
void SetAtomicNumber (const double z) override
 Set the effective atomic number.
 
double GetAtomicNumber () const override
 Get the effective atomic number.
 
void SetAtomicWeight (const double a) override
 Set the effective atomic weight.
 
double GetAtomicWeight () const override
 Get the effective atomic weight.
 
void SetNumberDensity (const double n) override
 Set the number density [cm-3].
 
double GetNumberDensity () const override
 Get the number density [cm-3].
 
void SetMassDensity (const double rho) override
 Set the mass density [g/cm3].
 
double GetMassDensity () const override
 Get the mass density [g/cm3].
 
void ResetTables () override
 Reset all tables of transport parameters.
 
void SetExtrapolationMethodExcitationRates (const std::string &low, const std::string &high)
 
void SetExtrapolationMethodIonisationRates (const std::string &low, const std::string &high)
 
void SetInterpolationMethodExcitationRates (const unsigned int intrp)
 
void SetInterpolationMethodIonisationRates (const unsigned int intrp)
 
double ScaleElectricField (const double e) const override
 
double UnScaleElectricField (const double e) const override
 
double ScaleDiffusion (const double d) const override
 
double ScaleDiffusionTensor (const double d) const override
 
double ScaleTownsend (const double alpha) const override
 
double ScaleAttachment (const double eta) const override
 
double ScaleLorentzAngle (const double lor) const override
 
bool GetPhotoAbsorptionCrossSection (const double e, double &sigma, const unsigned int i) override
 
- Public Member Functions inherited from Garfield::Medium
 Medium ()
 Constructor.
 
virtual ~Medium ()
 Destructor.
 
int GetId () const
 Return the id number of the class instance.
 
const std::string & GetName () const
 Get the medium name/identifier.
 
virtual bool IsSemiconductor () const
 Is this medium a semiconductor?
 
virtual bool IsConductor () const
 Is this medium a conductor?
 
void SetTemperature (const double t)
 Set the temperature [K].
 
double GetTemperature () const
 Get the temperature [K].
 
void SetPressure (const double p)
 
double GetPressure () const
 
void SetDielectricConstant (const double eps)
 Set the relative static dielectric constant.
 
double GetDielectricConstant () const
 Get the relative static dielectric constant.
 
unsigned int GetNumberOfComponents () const
 Get number of components of the medium.
 
virtual void EnableDrift (const bool on=true)
 Switch electron/ion/hole transport on/off.
 
virtual void EnablePrimaryIonisation (const bool on=true)
 Make the medium ionisable or non-ionisable.
 
bool IsDriftable () const
 Is charge carrier transport enabled in this medium?
 
bool IsMicroscopic () const
 Does the medium have electron scattering rates?
 
bool IsIonisable () const
 Is charge deposition by charged particles/photon enabled in this medium?
 
void SetW (const double w)
 Set the W value (average energy to produce an electron/ion or e/h pair).
 
double GetW () const
 Get the W value.
 
void SetFanoFactor (const double f)
 Set the Fano factor.
 
double GetFanoFactor () const
 Get the Fano factor.
 
void PlotVelocity (const std::string &carriers, TPad *pad)
 Plot the drift velocity as function of the electric field.
 
void PlotDiffusion (const std::string &carriers, TPad *pad)
 Plot the diffusion coefficients as function of the electric field.
 
void PlotTownsend (const std::string &carriers, TPad *pad)
 Plot the Townsend coefficient(s) as function of the electric field.
 
void PlotAttachment (const std::string &carriers, TPad *pad)
 Plot the attachment coefficient(s) as function of the electric field.
 
void PlotAlphaEta (const std::string &carriers, TPad *pad)
 Plot Townsend and attachment coefficients.
 
virtual bool ElectronVelocity (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &vx, double &vy, double &vz)
 Drift velocity [cm / ns].
 
virtual bool ElectronDiffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &dl, double &dt)
 Longitudinal and transverse diffusion coefficients [cm1/2].
 
virtual bool ElectronDiffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double cov[3][3])
 
virtual bool ElectronTownsend (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &alpha)
 Ionisation coefficient [cm-1].
 
virtual bool ElectronAttachment (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &eta)
 Attachment coefficient [cm-1].
 
virtual bool ElectronLorentzAngle (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &lor)
 Lorentz angle.
 
virtual double ElectronMobility ()
 Low-field mobility [cm2 V-1 ns-1].
 
virtual double GetElectronEnergy (const double px, const double py, const double pz, double &vx, double &vy, double &vz, const int band=0)
 Dispersion relation (energy vs. wave vector)
 
virtual void GetElectronMomentum (const double e, double &px, double &py, double &pz, int &band)
 
virtual double GetElectronNullCollisionRate (const int band=0)
 Null-collision rate [ns-1].
 
virtual double GetElectronCollisionRate (const double e, const int band=0)
 Collision rate [ns-1] for given electron energy.
 
virtual bool ElectronCollision (const double e, int &type, int &level, double &e1, double &dx, double &dy, double &dz, std::vector< std::pair< Particle, double > > &secondaries, int &ndxc, int &band)
 Sample the collision type. Update energy and direction vector.
 
virtual unsigned int GetNumberOfDeexcitationProducts () const
 
virtual bool GetDeexcitationProduct (const unsigned int i, double &t, double &s, int &type, double &energy) const
 
virtual bool HoleVelocity (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &vx, double &vy, double &vz)
 Drift velocity [cm / ns].
 
virtual bool HoleDiffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &dl, double &dt)
 Longitudinal and transverse diffusion coefficients [cm1/2].
 
virtual bool HoleDiffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double cov[3][3])
 Diffusion tensor.
 
virtual bool HoleTownsend (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &alpha)
 Ionisation coefficient [cm-1].
 
virtual bool HoleAttachment (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &eta)
 Attachment coefficient [cm-1].
 
virtual double HoleMobility ()
 Low-field mobility [cm2 V-1 ns-1].
 
virtual bool IonVelocity (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &vx, double &vy, double &vz)
 Ion drift velocity [cm / ns].
 
virtual bool IonDiffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &dl, double &dt)
 Longitudinal and transverse diffusion coefficients [cm1/2].
 
virtual bool IonDissociation (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &diss)
 Dissociation coefficient.
 
virtual double IonMobility ()
 Low-field ion mobility [cm2 V-1 ns-1].
 
virtual bool NegativeIonVelocity (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, double &vx, double &vy, double &vz)
 Negative ion drift velocity [cm / ns].
 
virtual double NegativeIonMobility ()
 Low-field negative ion mobility [cm2 V-1 ns-1].
 
void SetFieldGrid (double emin, double emax, const size_t ne, bool logE, double bmin=0., double bmax=0., const size_t nb=1, double amin=HalfPi, double amax=HalfPi, const size_t na=1)
 Set the range of fields to be covered by the transport tables.
 
void SetFieldGrid (const std::vector< double > &efields, const std::vector< double > &bfields, const std::vector< double > &angles)
 Set the fields and E-B angles to be used in the transport tables.
 
void GetFieldGrid (std::vector< double > &efields, std::vector< double > &bfields, std::vector< double > &angles)
 Get the fields and E-B angles used in the transport tables.
 
bool SetElectronVelocityE (const size_t ie, const size_t ib, const size_t ia, const double v)
 Set an entry in the table of drift speeds along E.
 
bool GetElectronVelocityE (const size_t ie, const size_t ib, const size_t ia, double &v)
 Get an entry in the table of drift speeds along E.
 
bool SetElectronVelocityExB (const size_t ie, const size_t ib, const size_t ia, const double v)
 Set an entry in the table of drift speeds along ExB.
 
bool GetElectronVelocityExB (const size_t ie, const size_t ib, const size_t ia, double &v)
 Get an entry in the table of drift speeds along ExB.
 
bool SetElectronVelocityB (const size_t ie, const size_t ib, const size_t ia, const double v)
 Set an entry in the table of drift speeds along Btrans.
 
bool GetElectronVelocityB (const size_t ie, const size_t ib, const size_t ia, double &v)
 Get an entry in the table of drift speeds along Btrans.
 
bool SetElectronLongitudinalDiffusion (const size_t ie, const size_t ib, const size_t ia, const double dl)
 Set an entry in the table of longitudinal diffusion coefficients.
 
bool GetElectronLongitudinalDiffusion (const size_t ie, const size_t ib, const size_t ia, double &dl)
 Get an entry in the table of longitudinal diffusion coefficients.
 
bool SetElectronTransverseDiffusion (const size_t ie, const size_t ib, const size_t ia, const double dt)
 Set an entry in the table of transverse diffusion coefficients.
 
bool GetElectronTransverseDiffusion (const size_t ie, const size_t ib, const size_t ia, double &dt)
 Get an entry in the table of transverse diffusion coefficients.
 
bool SetElectronTownsend (const size_t ie, const size_t ib, const size_t ia, const double alpha)
 Set an entry in the table of Townsend coefficients.
 
bool GetElectronTownsend (const size_t ie, const size_t ib, const size_t ia, double &alpha)
 Get an entry in the table of Townsend coefficients.
 
bool SetElectronAttachment (const size_t ie, const size_t ib, const size_t ia, const double eta)
 Set an entry in the table of attachment coefficients.
 
bool GetElectronAttachment (const size_t ie, const size_t ib, const size_t ia, double &eta)
 Get an entry in the table of attachment coefficients.
 
bool SetElectronLorentzAngle (const size_t ie, const size_t ib, const size_t ia, const double lor)
 Set an entry in the table of Lorentz angles.
 
bool GetElectronLorentzAngle (const size_t ie, const size_t ib, const size_t ia, double &lor)
 Get an entry in the table of Lorentz angles.
 
bool SetHoleVelocityE (const size_t ie, const size_t ib, const size_t ia, const double v)
 Set an entry in the table of drift speeds along E.
 
bool GetHoleVelocityE (const size_t ie, const size_t ib, const size_t ia, double &v)
 Get an entry in the table of drift speeds along E.
 
bool SetHoleVelocityExB (const size_t ie, const size_t ib, const size_t ia, const double v)
 Set an entry in the table of drift speeds along ExB.
 
bool GetHoleVelocityExB (const size_t ie, const size_t ib, const size_t ia, double &v)
 Get an entry in the table of drift speeds along ExB.
 
bool SetHoleVelocityB (const size_t ie, const size_t ib, const size_t ia, const double v)
 Set an entry in the table of drift speeds along Btrans.
 
bool GetHoleVelocityB (const size_t ie, const size_t ib, const size_t ia, double &v)
 Get an entry in the table of drift speeds along Btrans.
 
bool SetHoleLongitudinalDiffusion (const size_t ie, const size_t ib, const size_t ia, const double dl)
 Set an entry in the table of longitudinal diffusion coefficients.
 
bool GetHoleLongitudinalDiffusion (const size_t ie, const size_t ib, const size_t ia, double &dl)
 Get an entry in the table of longitudinal diffusion coefficients.
 
bool SetHoleTransverseDiffusion (const size_t ie, const size_t ib, const size_t ia, const double dt)
 Set an entry in the table of transverse diffusion coefficients.
 
bool GetHoleTransverseDiffusion (const size_t ie, const size_t ib, const size_t ia, double &dt)
 Get an entry in the table of transverse diffusion coefficients.
 
bool SetHoleTownsend (const size_t ie, const size_t ib, const size_t ia, const double alpha)
 Set an entry in the table of Townsend coefficients.
 
bool GetHoleTownsend (const size_t ie, const size_t ib, const size_t ia, double &alpha)
 Get an entry in the table of Townsend coefficients.
 
bool SetHoleAttachment (const size_t ie, const size_t ib, const size_t ia, const double eta)
 Set an entry in the table of attachment coefficients.
 
bool GetHoleAttachment (const size_t ie, const size_t ib, const size_t ia, double &eta)
 Get an entry in the table of attachment coefficients.
 
bool SetIonMobility (const std::vector< double > &fields, const std::vector< double > &mobilities, const bool negativeIons=false)
 
bool SetIonMobility (const size_t ie, const size_t ib, const size_t ia, const double mu)
 Set an entry in the table of ion mobilities.
 
bool GetIonMobility (const size_t ie, const size_t ib, const size_t ia, double &mu)
 Get an entry in the table of ion mobilities.
 
bool SetIonLongitudinalDiffusion (const size_t ie, const size_t ib, const size_t ia, const double dl)
 Set an entry in the table of longitudinal diffusion coefficients.
 
bool GetIonLongitudinalDiffusion (const size_t ie, const size_t ib, const size_t ia, double &dl)
 Get an entry in the table of longitudinal diffusion coefficients.
 
bool SetIonTransverseDiffusion (const size_t ie, const size_t ib, const size_t ia, const double dt)
 Set an entry in the table of transverse diffusion coefficients.
 
bool GetIonTransverseDiffusion (const size_t ie, const size_t ib, const size_t ia, double &dt)
 Get an entry in the table of transverse diffusion coefficients.
 
bool SetIonDissociation (const size_t ie, const size_t ib, const size_t ia, const double diss)
 Set an entry in the table of dissociation coefficients.
 
bool GetIonDissociation (const size_t ie, const size_t ib, const size_t ia, double &diss)
 Get an entry in the table of dissociation coefficients.
 
bool SetNegativeIonMobility (const size_t ie, const size_t ib, const size_t ia, const double mu)
 Set an entry in the table of negative ion mobilities.
 
bool GetNegativeIonMobility (const size_t ie, const size_t ib, const size_t ia, double &mu)
 Get an entry in the table of negative ion mobilities.
 
void ResetElectronVelocity ()
 
void ResetElectronDiffusion ()
 
void ResetElectronTownsend ()
 
void ResetElectronAttachment ()
 
void ResetElectronLorentzAngle ()
 
void ResetHoleVelocity ()
 
void ResetHoleDiffusion ()
 
void ResetHoleTownsend ()
 
void ResetHoleAttachment ()
 
void ResetIonMobility ()
 
void ResetIonDiffusion ()
 
void ResetIonDissociation ()
 
void ResetNegativeIonMobility ()
 
void SetExtrapolationMethodVelocity (const std::string &extrLow, const std::string &extrHigh)
 
void SetExtrapolationMethodDiffusion (const std::string &extrLow, const std::string &extrHigh)
 
void SetExtrapolationMethodTownsend (const std::string &extrLow, const std::string &extrHigh)
 
void SetExtrapolationMethodAttachment (const std::string &extrLow, const std::string &extrHigh)
 
void SetExtrapolationMethodIonMobility (const std::string &extrLow, const std::string &extrHigh)
 
void SetExtrapolationMethodIonDissociation (const std::string &extrLow, const std::string &extrHigh)
 
void SetInterpolationMethodVelocity (const unsigned int intrp)
 Set the degree of polynomial interpolation (usually 2).
 
void SetInterpolationMethodDiffusion (const unsigned int intrp)
 
void SetInterpolationMethodTownsend (const unsigned int intrp)
 
void SetInterpolationMethodAttachment (const unsigned int intrp)
 
void SetInterpolationMethodIonMobility (const unsigned int intrp)
 
void SetInterpolationMethodIonDissociation (const unsigned int intrp)
 
virtual double ScaleVelocity (const double v) const
 
virtual double ScaleDissociation (const double diss) const
 
virtual bool GetOpticalDataRange (double &emin, double &emax, const unsigned int i=0)
 Get the energy range [eV] of the available optical data.
 
virtual bool GetDielectricFunction (const double e, double &eps1, double &eps2, const unsigned int i=0)
 Get the complex dielectric function at a given energy.
 
virtual double GetPhotonCollisionRate (const double e)
 
virtual bool GetPhotonCollision (const double e, int &type, int &level, double &e1, double &ctheta, int &nsec, double &esec)
 
void EnableDebugging ()
 Switch on/off debugging messages.
 
void DisableDebugging ()
 

Static Public Member Functions

static void PrintGases ()
 Print a list of all available gases.
 

Protected Member Functions

bool LoadMobility (const std::string &filename, const bool quiet, const bool negative)
 
bool ReadHeader (std::ifstream &gasfile, int &version, std::bitset< 20 > &gasok, bool &is3d, std::vector< double > &mixture, std::vector< double > &efields, std::vector< double > &bfields, std::vector< double > &angles, std::vector< ExcLevel > &excLevels, std::vector< IonLevel > &ionLevels)
 
void ReadFooter (std::ifstream &gasfile, std::array< unsigned int, 13 > &extrapH, std::array< unsigned int, 13 > &extrapL, std::array< unsigned int, 13 > &interp, unsigned int &thrAlp, unsigned int &thrAtt, unsigned int &thrDis, double &ionDiffL, double &ionDiffT, double &pgas, double &tgas)
 
void ReadRecord3D (std::ifstream &gasfile, double &ve, double &vb, double &vx, double &dl, double &dt, double &alpha, double &alpha0, double &eta, double &mu, double &lor, double &dis, std::array< double, 6 > &dif, std::vector< double > &rexc, std::vector< double > &rion)
 
void ReadRecord1D (std::ifstream &gasfile, double &ve, double &vb, double &vx, double &dl, double &dt, double &alpha, double &alpha0, double &eta, double &mu, double &lor, double &dis, std::array< double, 6 > &dif, std::vector< double > &rexc, std::vector< double > &rion)
 
void InsertE (const int ie, const int ne, const int nb, const int na)
 
void InsertB (const int ib, const int ne, const int nb, const int na)
 
void InsertA (const int ia, const int ne, const int nb, const int na)
 
void ZeroRowE (const int ie, const int nb, const int na)
 
void ZeroRowB (const int ib, const int ne, const int na)
 
void ZeroRowA (const int ia, const int ne, const int nb)
 
bool GetMixture (const std::vector< double > &mixture, const int version, std::vector< std::string > &gasnames, std::vector< double > &percentages) const
 
void GetGasBits (std::bitset< 20 > &gasok) const
 
- Protected Member Functions inherited from Garfield::Medium
bool Velocity (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, const std::vector< std::vector< std::vector< double > > > &velE, const std::vector< std::vector< std::vector< double > > > &velB, const std::vector< std::vector< std::vector< double > > > &velX, const double q, double &vx, double &vy, double &vz) const
 
bool Diffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, const std::vector< std::vector< std::vector< double > > > &difL, const std::vector< std::vector< std::vector< double > > > &difT, double &dl, double &dt) const
 
bool Diffusion (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, const std::vector< std::vector< std::vector< std::vector< double > > > > &diff, double cov[3][3]) const
 
bool Alpha (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, const std::vector< std::vector< std::vector< double > > > &tab, unsigned int intp, const unsigned int thr, const std::pair< unsigned int, unsigned int > &extr, double &alpha) const
 
double GetAngle (const double ex, const double ey, const double ez, const double bx, const double by, const double bz, const double e, const double b) const
 
bool Interpolate (const double e, const double b, const double a, const std::vector< std::vector< std::vector< double > > > &table, double &y, const unsigned int intp, const std::pair< unsigned int, unsigned int > &extr) const
 
double Interpolate1D (const double e, const std::vector< double > &table, const std::vector< double > &fields, const unsigned int intpMeth, const std::pair< unsigned int, unsigned int > &extr) const
 
bool SetEntry (const size_t i, const size_t j, const size_t k, const std::string &fcn, std::vector< std::vector< std::vector< double > > > &tab, const double val)
 
bool GetEntry (const size_t i, const size_t j, const size_t k, const std::string &fcn, const std::vector< std::vector< std::vector< double > > > &tab, double &val) const
 
void SetExtrapolationMethod (const std::string &low, const std::string &high, std::pair< unsigned int, unsigned int > &extr, const std::string &fcn)
 
bool GetExtrapolationIndex (std::string str, unsigned int &nb) const
 
size_t SetThreshold (const std::vector< std::vector< std::vector< double > > > &tab) const
 
void Clone (std::vector< std::vector< std::vector< double > > > &tab, const std::vector< double > &efields, const std::vector< double > &bfields, const std::vector< double > &angles, const unsigned int intp, const std::pair< unsigned int, unsigned int > &extr, const double init, const std::string &label)
 
void Clone (std::vector< std::vector< std::vector< std::vector< double > > > > &tab, const size_t n, const std::vector< double > &efields, const std::vector< double > &bfields, const std::vector< double > &angles, const unsigned int intp, const std::pair< unsigned int, unsigned int > &extr, const double init, const std::string &label)
 
void Init (const size_t nE, const size_t nB, const size_t nA, std::vector< std::vector< std::vector< double > > > &tab, const double val)
 
void Init (const size_t nE, const size_t nB, const size_t nA, const size_t nT, std::vector< std::vector< std::vector< std::vector< double > > > > &tab, const double val)
 

Static Protected Member Functions

static bool GetGasInfo (const std::string &gasname, double &a, double &z, double &w, double &f)
 
static std::string GetGasName (const int gasnumber, const int version)
 
static std::string GetGasName (std::string input)
 
static int GetGasNumberGasFile (const std::string &input)
 
static const std::vector< std::string > GetAliases (const std::string &gas)
 
- Static Protected Member Functions inherited from Garfield::Medium
static void Langevin (const double ex, const double ey, const double ez, double bx, double by, double bz, const double mu, double &vx, double &vy, double &vz)
 
static void Langevin (const double ex, const double ey, const double ez, double bx, double by, double bz, const double mu, const double muH, double &vx, double &vy, double &vz)
 

Protected Attributes

std::array< std::string, m_nMaxGasesm_gas
 
std::array< double, m_nMaxGasesm_fraction
 
std::array< double, m_nMaxGasesm_atWeight
 
std::array< double, m_nMaxGasesm_atNum
 
bool m_usePenning = false
 
double m_rPenningGlobal = 0.
 
double m_lambdaPenningGlobal = 0.
 
std::array< double, m_nMaxGasesm_rPenningGas
 
std::array< double, m_nMaxGasesm_lambdaPenningGas
 
double m_pressureTable
 
double m_temperatureTable
 
std::vector< std::vector< std::vector< double > > > m_eAlp0
 
std::vector< std::vector< std::vector< std::vector< double > > > > m_excRates
 
std::vector< std::vector< std::vector< std::vector< double > > > > m_ionRates
 
std::vector< ExcLevelm_excLevels
 
std::vector< IonLevelm_ionLevels
 
std::pair< unsigned int, unsigned int > m_extrExc = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrIon = {0, 1}
 
unsigned int m_intpExc = 2
 
unsigned int m_intpIon = 2
 
- Protected Attributes inherited from Garfield::Medium
std::string m_className = "Medium"
 
int m_id
 
unsigned int m_nComponents = 1
 
std::string m_name = ""
 
double m_temperature = 293.15
 
double m_pressure = 760.
 
double m_epsilon = 1.
 
double m_z = 1.
 
double m_a = 0.
 
double m_density = 0.
 
double m_w = 0.
 
double m_fano = 0.
 
bool m_driftable = false
 
bool m_microscopic = false
 
bool m_ionisable = false
 
bool m_isChanged = true
 
bool m_debug = false
 
bool m_tab2d = false
 
std::vector< double > m_eFields
 
std::vector< double > m_bFields
 
std::vector< double > m_bAngles
 
std::vector< std::vector< std::vector< double > > > m_eVelE
 
std::vector< std::vector< std::vector< double > > > m_eVelX
 
std::vector< std::vector< std::vector< double > > > m_eVelB
 
std::vector< std::vector< std::vector< double > > > m_eDifL
 
std::vector< std::vector< std::vector< double > > > m_eDifT
 
std::vector< std::vector< std::vector< double > > > m_eAlp
 
std::vector< std::vector< std::vector< double > > > m_eAtt
 
std::vector< std::vector< std::vector< double > > > m_eLor
 
std::vector< std::vector< std::vector< std::vector< double > > > > m_eDifM
 
std::vector< std::vector< std::vector< double > > > m_hVelE
 
std::vector< std::vector< std::vector< double > > > m_hVelX
 
std::vector< std::vector< std::vector< double > > > m_hVelB
 
std::vector< std::vector< std::vector< double > > > m_hDifL
 
std::vector< std::vector< std::vector< double > > > m_hDifT
 
std::vector< std::vector< std::vector< double > > > m_hAlp
 
std::vector< std::vector< std::vector< double > > > m_hAtt
 
std::vector< std::vector< std::vector< std::vector< double > > > > m_hDifM
 
std::vector< std::vector< std::vector< double > > > m_iMob
 
std::vector< std::vector< std::vector< double > > > m_iDifL
 
std::vector< std::vector< std::vector< double > > > m_iDifT
 
std::vector< std::vector< std::vector< double > > > m_iDis
 
std::vector< std::vector< std::vector< double > > > m_nMob
 
unsigned int m_eThrAlp = 0
 
unsigned int m_eThrAtt = 0
 
unsigned int m_hThrAlp = 0
 
unsigned int m_hThrAtt = 0
 
unsigned int m_iThrDis = 0
 
std::pair< unsigned int, unsigned int > m_extrVel = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrDif = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrAlp = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrAtt = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrLor = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrMob = {0, 1}
 
std::pair< unsigned int, unsigned int > m_extrDis = {0, 1}
 
unsigned int m_intpVel = 2
 
unsigned int m_intpDif = 2
 
unsigned int m_intpAlp = 2
 
unsigned int m_intpAtt = 2
 
unsigned int m_intpLor = 2
 
unsigned int m_intpMob = 2
 
unsigned int m_intpDis = 2
 

Static Protected Attributes

static constexpr unsigned int m_nMaxGases = 6
 
- Static Protected Attributes inherited from Garfield::Medium
static int m_idCounter = -1
 

Detailed Description

Base class for gas media.

Definition at line 15 of file MediumGas.hh.

Constructor & Destructor Documentation

◆ MediumGas()

Garfield::MediumGas::MediumGas ( )

Constructor.

Definition at line 115 of file MediumGas.cc.

117 m_className = "MediumGas";
118
119 m_gas.fill("");
120 m_fraction.fill(0.);
121 m_atWeight.fill(0.);
122 m_atNum.fill(0.);
123 // Default gas mixture: pure argon
124 m_gas[0] = "Ar";
125 m_fraction[0] = 1.;
126 m_name = m_gas[0];
128
129 m_rPenningGas.fill(0.);
130 m_lambdaPenningGas.fill(0.);
131
132 m_isChanged = true;
133
134 m_driftable = true;
135 m_ionisable = true;
136}
std::array< double, m_nMaxGases > m_rPenningGas
Definition MediumGas.hh:177
std::array< double, m_nMaxGases > m_atNum
Definition MediumGas.hh:167
static bool GetGasInfo(const std::string &gasname, double &a, double &z, double &w, double &f)
std::array< double, m_nMaxGases > m_atWeight
Definition MediumGas.hh:166
std::array< double, m_nMaxGases > m_lambdaPenningGas
Definition MediumGas.hh:179
std::array< std::string, m_nMaxGases > m_gas
Definition MediumGas.hh:164
std::array< double, m_nMaxGases > m_fraction
Definition MediumGas.hh:165
double m_pressure
Definition Medium.hh:542
std::string m_name
Definition Medium.hh:538
Medium()
Constructor.
Definition Medium.cc:61
std::string m_className
Definition Medium.hh:529
double m_temperature
Definition Medium.hh:540

Referenced by Garfield::MediumMagboltz::MediumMagboltz().

◆ ~MediumGas()

virtual Garfield::MediumGas::~MediumGas ( )
inlinevirtual

Destructor.

Definition at line 20 of file MediumGas.hh.

20{}

Member Function Documentation

◆ AdjustTownsendCoefficient()

bool Garfield::MediumGas::AdjustTownsendCoefficient ( )

Adjust the Townsend coefficient using the excitation and ionisation rates stored in the gas table and the Penning transfer probabilities.

Definition at line 2762 of file MediumGas.cc.

2762 {
2763
2764 // -----------------------------------------------------------------------
2765 // GASSPT
2766 // -----------------------------------------------------------------------
2767
2768 // Make sure there are Townsend coefficients.
2769 if (m_eAlp.empty() || m_eAlp0.empty()) {
2770 std::cerr << m_className << "::AdjustTownsendCoefficient:\n "
2771 << "Present gas table does not include Townsend coefficients.\n";
2772 return false;
2773 }
2774 // Make sure there are excitation and ionisation rates.
2775 if (m_excLevels.empty() || m_excRates.empty()) {
2776 std::cerr << m_className << "::AdjustTownsendCoefficient:\n "
2777 << "Present gas table does not include excitation rates.\n";
2778 return false;
2779 }
2780 if (m_ionLevels.empty() || m_ionRates.empty()) {
2781 std::cerr << m_className << "::AdjustTownsendCoefficient:\n "
2782 << "Present gas table does not include ionisation rates.\n";
2783 return false;
2784 }
2785 const unsigned int nE = m_eFields.size();
2786 const unsigned int nB = m_bFields.size();
2787 const unsigned int nA = m_bAngles.size();
2788 if (m_debug) {
2789 std::cout << m_className << "::AdjustTownsendCoefficient:\n"
2790 << " Entry Exc. Ion.\n";
2791 }
2792 for (unsigned int i = 0; i < nE; ++i) {
2793 for (unsigned int j = 0; j < nA; ++j) {
2794 for (unsigned int k = 0; k < nB; ++k) {
2795 // Compute total ionisation rate.
2796 double rion = 0.;
2797 for (const auto& ion : m_ionRates) {
2798 rion += ion[j][k][i];
2799 }
2800 // Compute rate of Penning ionisations.
2801 double rexc = 0.;
2802 const unsigned int nexc = m_excLevels.size();
2803 for (unsigned int ie = 0; ie < nexc; ++ie) {
2804 rexc += m_excLevels[ie].prob * m_excRates[ie][j][k][i];
2805 }
2806 if (m_debug) {
2807 std::cout << FmtInt(i, 4) << FmtInt(j, 4) << FmtInt(k, 4)
2808 << FmtFloat(rexc, 12, 5) << FmtFloat(rion, 12, 5) << "\n";
2809 }
2810 // Adjust the Townsend coefficient.
2811 double alpha0 = m_eAlp0[j][k][i];
2812 if (alpha0 < -20.) {
2813 alpha0 = 0.;
2814 } else {
2815 alpha0 = m_pressure * exp(alpha0);
2816 }
2817 double alpha1 = alpha0;
2818 if (rion > 0.) alpha1 *= (rexc + rion) / rion;
2819 m_eAlp[j][k][i] = alpha1 > 0. ? log(alpha1 / m_pressure) : -30.;
2820 }
2821 }
2822 }
2823 // Update the threshold index.
2825 return true;
2826}
std::vector< std::vector< std::vector< std::vector< double > > > > m_excRates
Definition MediumGas.hh:190
std::vector< IonLevel > m_ionLevels
Definition MediumGas.hh:207
std::vector< std::vector< std::vector< std::vector< double > > > > m_ionRates
Definition MediumGas.hh:191
std::vector< ExcLevel > m_excLevels
Definition MediumGas.hh:201
std::vector< std::vector< std::vector< double > > > m_eAlp0
Definition MediumGas.hh:187
std::vector< double > m_bFields
Definition Medium.hh:573
std::vector< std::vector< std::vector< double > > > m_eAlp
Definition Medium.hh:582
size_t SetThreshold(const std::vector< std::vector< std::vector< double > > > &tab) const
Definition Medium.cc:1252
std::vector< double > m_eFields
Definition Medium.hh:572
std::vector< double > m_bAngles
Definition Medium.hh:574
DoubleAc exp(const DoubleAc &f)
Definition DoubleAc.cpp:377

Referenced by DisablePenningTransfer(), DisablePenningTransfer(), EnablePenningTransfer(), and EnablePenningTransfer().

◆ DisablePenningTransfer() [1/2]

void Garfield::MediumGas::DisablePenningTransfer ( )
virtual

Switch the simulation of Penning transfers off globally.

Reimplemented in Garfield::MediumMagboltz.

Definition at line 2642 of file MediumGas.cc.

2642 {
2643
2644 m_rPenningGlobal = 0.;
2646
2647 m_rPenningGas.fill(0.);
2648 m_lambdaPenningGas.fill(0.);
2649
2650 if (m_excLevels.empty()) return;
2651 for (auto& exc : m_excLevels) {
2652 exc.prob = 0.;
2653 }
2655}
bool AdjustTownsendCoefficient()
double m_lambdaPenningGlobal
Definition MediumGas.hh:175

Referenced by Garfield::MediumMagboltz::DisablePenningTransfer(), Garfield::MediumMagboltz::DisablePenningTransfer(), and EnablePenningTransfer().

◆ DisablePenningTransfer() [2/2]

bool Garfield::MediumGas::DisablePenningTransfer ( std::string gasname)
virtual

Switch the simulation of Penning transfers off for a given component.

Reimplemented in Garfield::MediumMagboltz.

Definition at line 2722 of file MediumGas.cc.

2722 {
2723
2724 // Get the "standard" name of this gas.
2725 gasname = GetGasName(gasname);
2726 if (gasname.empty()) {
2727 std::cerr << m_className << "::DisablePenningTransfer: Unknown gas name.\n";
2728 return false;
2729 }
2730
2731 // Look for this gas in the present gas mixture.
2732 int iGas = -1;
2733 for (unsigned int i = 0; i < m_nComponents; ++i) {
2734 if (m_gas[i] == gasname) {
2735 m_rPenningGas[i] = 0.;
2736 m_lambdaPenningGas[i] = 0.;
2737 iGas = i;
2738 break;
2739 }
2740 }
2741
2742 if (iGas < 0) {
2743 std::cerr << m_className << "::DisablePenningTransfer:\n"
2744 << " Requested gas (" << gasname
2745 << ") is not part of the present gas mixture.\n";
2746 return false;
2747 }
2748
2749 if (m_excLevels.empty()) return true;
2750 for (auto& exc : m_excLevels) {
2751 // Try to extract the gas name from the label.
2752 const auto pos = exc.label.find('-');
2753 if (pos == std::string::npos) continue;
2754 if (GetGasName(exc.label.substr(0, pos)) != gasname) continue;
2755 exc.prob = 0.;
2756 }
2758 return true;
2759}
static std::string GetGasName(const int gasnumber, const int version)
unsigned int m_nComponents
Definition Medium.hh:536

◆ EnablePenningTransfer() [1/3]

bool Garfield::MediumGas::EnablePenningTransfer ( )
virtual

Switch on simulation of Penning transfers, using pre-implemented parameterisations of the transfer probability (if available).

Reimplemented in Garfield::MediumMagboltz.

Definition at line 2328 of file MediumGas.cc.

2328 {
2330
2331 if (m_nComponents != 2) {
2332 std::cerr << m_className << "::EnablePenningTransfer:\n"
2333 << " Penning transfer probability for " << m_name
2334 << " is not implemented.\n";
2335 return false;
2336 }
2337
2338 const double p = m_pressure / AtmosphericPressure;
2339
2340 auto itNe = std::find(m_gas.cbegin(), m_gas.cend(), "Ne");
2341 auto itAr = std::find(m_gas.cbegin(), m_gas.cend(), "Ar");
2342 auto itXe = std::find(m_gas.cbegin(), m_gas.cend(), "Xe");
2343
2344 auto itN2 = std::find(m_gas.cbegin(), m_gas.cend(), "N2");
2345 auto itCO2 = std::find(m_gas.cbegin(), m_gas.cend(), "CO2");
2346
2347 auto itCH4 = std::find(m_gas.cbegin(), m_gas.cend(), "CH4");
2348 auto itC2H2 = std::find(m_gas.cbegin(), m_gas.cend(), "C2H2");
2349 auto itC2H6 = std::find(m_gas.cbegin(), m_gas.cend(), "C2H6");
2350 auto itC3H8 = std::find(m_gas.cbegin(), m_gas.cend(), "C3H8");
2351 auto itC4H10 = std::find(m_gas.cbegin(), m_gas.cend(), "iC4H10");
2352
2353 auto itTMA = std::find(m_gas.cbegin(), m_gas.cend(), "TMA");
2354
2355 double rP = 0.;
2356 std::string gas = "";
2357 if (itAr != m_gas.cend() && itCO2 != m_gas.cend()) {
2358 gas = "Ar";
2359 const int iCO2 = std::distance(m_gas.cbegin(), itCO2);
2360 const double cCO2 = m_fraction[iCO2];
2361 if (fabs(p - 1.) < 1.e-3) {
2362 // 2014 paper with p = 1 atm
2363 // http://dx.doi.org/10.1016/j.nima.2014.09.061
2364 constexpr double a1 = 0.6643;
2365 constexpr double a2 = 0.0518;
2366 constexpr double a3 = 0.0028;
2367 rP = (a1 * cCO2 + a3) / (cCO2 + a2);
2368 } else {
2369 // http://dx.doi.org/10.1088/1748-0221/12/01/C01035
2370 constexpr double a1 = 0.627898;
2371 constexpr double a2 = 0.041394;
2372 constexpr double a3 = 0.004716;
2373 constexpr double a4 = 0.001562;
2374 constexpr double a5 = 0.002422;
2375 constexpr double a6 = 0.027115;
2376 const double pcCO2 = p * cCO2;
2377 const double pcAr = p * (1. - cCO2);
2378 rP = (a5 * pcAr * pcAr + a1 * pcCO2 + a4 * cCO2 + a3) /
2379 (a6 * pcAr * pcAr + pcCO2 + a2);
2380 }
2381 } else if (itAr != m_gas.cend() && itCH4 != m_gas.cend()) {
2382 // http://dx.doi.org/10.1088/1748-0221/5/05/P05002
2383 constexpr double b1 = 0.1956;
2384 constexpr double b2 = 16.38;
2385 constexpr double b3 = 22.12;
2386 constexpr double b4 = 3.842;
2387 constexpr double b5 = 2.992;
2388 constexpr double b6 = b4;
2389 const int iCH4 = std::distance(m_gas.cbegin(), itCH4);
2390 const double cCH4 = m_fraction[iCH4];
2391 const double pcAr = p * (1. - cCH4);
2392 rP = (b4 * p * cCH4 + b1 * pcAr + b2 * cCH4 + b5) /
2393 (b6 * p * cCH4 + pcAr + b3);
2394 gas = "Ar";
2395 } else if (itAr != m_gas.cend() && itC2H6 != m_gas.cend()) {
2396 // http://dx.doi.org/10.1088/1748-0221/5/05/P05002
2397 // There is only one value for this mixture: c = 0.1, p = 1 atm.
2398 rP = 0.31;
2399 const int iC2H6 = std::distance(m_gas.cbegin(), itC2H6);
2400 const double c = m_fraction[iC2H6];
2401 if (fabs(c - 0.1) > 0.01 || fabs(p - 1.) > 1.e-3) {
2402 std::cout << m_className << "::EnablePenningTransfer:\n"
2403 << " Using transfer probability";
2404 if (fabs(c - 0.1) > 0.01) std::cout << " for 10% C2H6";
2405 if (fabs(p - 1.) > 1.e-3) std::cout << " at atmospheric pressure";
2406 std::cout << ".\n";
2407 }
2408 gas = "Ar";
2409 } else if (itAr != m_gas.cend() && itC3H8 != m_gas.cend()) {
2410 constexpr double a1 = 0.4536;
2411 constexpr double a2 = 0.0035;
2412 const int iC3H8 = std::distance(m_gas.cbegin(), itC3H8);
2413 const double cC3H8 = m_fraction[iC3H8];
2414 rP = (a1 * cC3H8) / (cC3H8 + a2);
2415 if (fabs(p - 1.) > 1.e-3) {
2416 std::cout << m_className << "::EnablePenningTransfer:\n"
2417 << " Using transfer probability at atmospheric pressure.\n";
2418 }
2419 gas = "Ar";
2420 } else if (itAr != m_gas.cend() && itC4H10 != m_gas.cend()) {
2421 // http://dx.doi.org/10.1088/1748-0221/5/05/P05002
2422 // There is only one value for this mixture: c = 0.1, p = 1 atm.
2423 rP = 0.40;
2424 const int iC4H10 = std::distance(m_gas.cbegin(), itC4H10);
2425 const double c = m_fraction[iC4H10];
2426 if (fabs(c - 0.1) > 0.01 || fabs(p - 1.) > 1.e-3) {
2427 std::cout << m_className << "::EnablePenningTransfer:\n"
2428 << " Using transfer probability";
2429 if (fabs(c - 0.1) > 0.01) std::cout << " for 10% iC4H10";
2430 if (fabs(p - 1.) > 1.e-3) std::cout << " at atmospheric pressure";
2431 std::cout << ".\n";
2432 }
2433 gas = "Ar";
2434 } else if (itAr != m_gas.cend() && itC2H2 != m_gas.cend()) {
2435 // http://dx.doi.org/10.1088/1748-0221/5/05/P05002
2436 // For this mixture r_p is constant but it has different values for
2437 // cylindrical and parallel plate chambers.
2438 // I have used the case of cylindrical chamber here.
2439 rP = 0.72;
2440 if (fabs(p - 1.) > 1.e-3) {
2441 std::cout << m_className << "::EnablePenningTransfer:\n"
2442 << " Using transfer probability at atmospheric pressure.\n";
2443 }
2444 gas = "Ar";
2445 } else if (itAr != m_gas.cend() && itXe != m_gas.cend()) {
2446 // http://dx.doi.org/10.1088/1748-0221/5/05/P05002
2447 constexpr double a1 = 1.248;
2448 constexpr double a2 = 0.039;
2449 constexpr double a3 = 0.008;
2450 constexpr double a4 = 0;
2451 const int iXe = std::distance(m_gas.cbegin(), itXe);
2452 const double cXe = m_fraction[iXe];
2453 const double cAr = 1. - cXe;
2454 rP = (a1 * cXe + a3) / (a4 * cAr * cAr + cXe + a2);
2455 if (fabs(p - 1.) > 1.e-3) {
2456 std::cout << m_className << "::EnablePenningTransfer:\n"
2457 << " Using transfer probability at atmospheric pressure.\n";
2458 }
2459 gas = "Ar";
2460 } else if (itNe != m_gas.cend() && itCO2 != m_gas.cend()) {
2461 // https://doi.org/10.1088/1748-0221/16/03/P03026
2462 constexpr double a1 = 0.71104;
2463 constexpr double a2 = 0.06323;
2464 constexpr double a3 = 0.03085;
2465 constexpr double a4 = 4.20089;
2466 constexpr double a5 = 0.07831;
2467 constexpr double a6 = 0.13235;
2468 constexpr double a7 = 1.47470;
2469 const int iCO2 = std::distance(m_gas.cbegin(), itCO2);
2470 const double cCO2 = m_fraction[iCO2];
2471 const double pcCO2 = p * cCO2;
2472 const double pcNe = p * (1.- cCO2);
2473 rP = (a5 * pcNe * pcNe + a7 * cCO2 * cCO2 + a1 * pcCO2 + a3) /
2474 (a6 * pcNe * pcNe + a4 * cCO2 * cCO2 + pcCO2 + a2);
2475 gas = "Ne";
2476 } else if (itNe != m_gas.cend() && itN2 != m_gas.cend()) {
2477 // https://doi.org/10.1088/1748-0221/16/03/P03026
2478 constexpr double a1 = 0.55802;
2479 constexpr double a2 = 0.00514;
2480 constexpr double a3 = 0.00206;
2481 constexpr double a4 = 0.55385;
2482 constexpr double a5 = 0.01153;
2483 constexpr double a6 = 0.02073;
2484 constexpr double a7 = 0.01;
2485 const int iN2 = std::distance(m_gas.cbegin(), itN2);
2486 const double cN2 = m_fraction[iN2];
2487 const double pcNe = p * (1. - cN2);
2488 rP = (a5 * pcNe * pcNe + a7 * cN2 * cN2 + a1 * p * cN2 + a3) /
2489 (a6 * pcNe * pcNe + a4 * cN2 * cN2 + p * cN2 + a2);
2490 gas = "Ne";
2491 } else if (itXe != m_gas.cend() && itTMA != m_gas.cend()) {
2492 // https://doi.org/10.1088/1748-0221/13/10/P10032
2493 constexpr double a1 = 0.2472;
2494 constexpr double a2 = 0.2372;
2495 constexpr double a3 = 0.0414;
2496 // This mixture's r_P is not a function of the fraction of TMA,
2497 // only the pressure.
2498 rP = (a1 * p + a3) / (p + a2);
2499 const int iTMA = std::distance(m_gas.cbegin(), itTMA);
2500 const double cTMA = m_fraction[iTMA];
2501 if (fabs(cTMA - 0.05) > 0.002) {
2502 std::cout << m_className << "::EnablePenningTransfer:\n"
2503 << " Using transfer probability for 5% TMA.\n";
2504 }
2505 gas = "Xe";
2506 } else {
2507 std::cerr << m_className << "::EnablePenningTransfer:\n"
2508 << " Penning transfer probability for " << m_name
2509 << " is not implemented.\n";
2510 return false;
2511 }
2512 rP = std::max(rP, 0.);
2513 return EnablePenningTransfer(rP, 0., gas);
2514}
virtual bool EnablePenningTransfer()
virtual void DisablePenningTransfer()
Switch the simulation of Penning transfers off globally.
DoubleAc fabs(const DoubleAc &f)
Definition DoubleAc.h:615

Referenced by EnablePenningTransfer(), Garfield::MediumMagboltz::EnablePenningTransfer(), Garfield::MediumMagboltz::EnablePenningTransfer(), and Garfield::MediumMagboltz::EnablePenningTransfer().

◆ EnablePenningTransfer() [2/3]

bool Garfield::MediumGas::EnablePenningTransfer ( const double r,
const double lambda )
virtual

Switch on simulation of Penning transfers by means of transfer probabilities, for all excitation levels in the mixture.

Parameters
rtransfer probability [0, 1]
lambdaparameter for sampling the distance of the Penning electron with respect to the excitation.

Reimplemented in Garfield::MediumMagboltz.

Definition at line 2516 of file MediumGas.cc.

2517 {
2518
2519 if (r < 0. ) {
2520 std::cerr << m_className << "::EnablePenningTransfer:\n"
2521 << " Transfer probability must be >= 0.\n";
2522 return false;
2523 }
2524
2525 m_rPenningGlobal = r;
2526 m_lambdaPenningGlobal = lambda > Small ? lambda : 0.;
2527
2528 std::cout << m_className << "::EnablePenningTransfer:\n"
2529 << " Global Penning transfer parameters set to:\n"
2530 << " r = " << m_rPenningGlobal << "\n"
2531 << " lambda = " << m_lambdaPenningGlobal << " cm\n";
2532
2533 // Find the min. ionisation energy.
2534 if (m_ionLevels.empty()) {
2535 std::cerr << m_className << "::EnablePenningTransfer:\n Warning: present"
2536 << " gas table has no ionisation rates.\n Ignore this message "
2537 << "if you are using microscopic tracking only.\n";
2538 return true;
2539 }
2540 double minIonPot = -1.;
2541 for (const auto& ion : m_ionLevels) {
2542 if (minIonPot < 0.) {
2543 minIonPot = ion.energy;
2544 } else {
2545 minIonPot = std::min(minIonPot, ion.energy);
2546 }
2547 }
2548
2549 // Update the transfer probabilities of the excitation levels in the table.
2550 unsigned int nLevelsFound = 0;
2551 for (auto& exc : m_excLevels) {
2552 if (exc.energy < minIonPot) continue;
2553 exc.prob = m_rPenningGlobal;
2554 exc.rms = m_lambdaPenningGlobal;
2555 ++nLevelsFound;
2556 }
2557 if (nLevelsFound > 0) {
2558 std::cout << m_className << "::EnablePenningTransfer:\n"
2559 << " Updated transfer probabilities for " << nLevelsFound
2560 << " excitation rates.\n";
2562 } else {
2563 std::cerr << m_className << "::EnablePenningTransfer:\n Warning: present"
2564 << " gas table has no eligible excitation rates.\n Ignore this"
2565 << " message if you are using microscopic tracking only.\n";
2566 }
2567 return true;
2568}

◆ EnablePenningTransfer() [3/3]

bool Garfield::MediumGas::EnablePenningTransfer ( const double r,
const double lambda,
std::string gasname )
virtual

Switch on simulation of Penning transfers by means of transfer probabilities, for all excitations of a given component.

Reimplemented in Garfield::MediumMagboltz.

Definition at line 2570 of file MediumGas.cc.

2571 {
2572
2573 if (r < 0.) {
2574 std::cerr << m_className << "::EnablePenningTransfer:\n"
2575 << " Transfer probability must be >= 0.\n";
2576 return false;
2577 }
2578
2579 // Get the "standard" name of this gas.
2580 gasname = GetGasName(gasname);
2581 if (gasname.empty()) {
2582 std::cerr << m_className << "::EnablePenningTransfer: Unknown gas name.\n";
2583 return false;
2584 }
2585
2586 // Look for this gas in the present gas mixture.
2587 int iGas = -1;
2588 for (unsigned int i = 0; i < m_nComponents; ++i) {
2589 if (m_gas[i] == gasname) {
2590 m_rPenningGas[i] = r;
2591 m_lambdaPenningGas[i] = lambda > Small ? lambda : 0.;
2592 iGas = i;
2593 break;
2594 }
2595 }
2596
2597 if (iGas < 0) {
2598 std::cerr << m_className << "::EnablePenningTransfer:\n"
2599 << " Requested gas (" << gasname
2600 << ") is not part of the present gas mixture.\n";
2601 return false;
2602 }
2603
2604 // Find the min. ionisation energy.
2605 if (m_ionLevels.empty()) {
2606 std::cerr << m_className << "::EnablePenningTransfer:\n Warning: present"
2607 << " gas table has no ionisation rates.\n Ignore this message"
2608 << " if you are using microscopic tracking only.\n";
2609 return true;
2610 }
2611 double minIonPot = -1.;
2612 for (const auto& ion : m_ionLevels) {
2613 if (minIonPot < 0.) {
2614 minIonPot = ion.energy;
2615 } else {
2616 minIonPot = std::min(minIonPot, ion.energy);
2617 }
2618 }
2619 // Update the transfer probabilities of the excitation levels in the table.
2620 unsigned int nLevelsFound = 0;
2621 for (auto& exc : m_excLevels) {
2622 if (exc.energy < minIonPot) continue;
2623 // Skip excitation levels of other components in the mixture.
2624 if (exc.label.find(gasname) != 0) continue;
2625 exc.prob = r;
2626 exc.rms = lambda;
2627 ++nLevelsFound;
2628 }
2629 if (nLevelsFound > 0) {
2630 std::cout << m_className << "::EnablePenningTransfer:\n"
2631 << " Updated transfer probabilities for " << nLevelsFound
2632 << " " << gasname << " excitation rates.\n";
2634 } else {
2635 std::cerr << m_className << "::EnablePenningTransfer:\n Warning: present"
2636 << " gas table has no eligible excitation rates.\n Ignore this"
2637 << " message if you are using microscopic tracking only.\n";
2638 }
2639 return true;
2640}

◆ GetAliases()

const std::vector< std::string > Garfield::MediumGas::GetAliases ( const std::string & gas)
staticprotected

Definition at line 3248 of file MediumGas.cc.

3248 {
3249
3250 if (gas == "CF4") {
3251 return {"tetrafluoromethane", "Freon", "Freon-14"};
3252 } else if (gas == "Ar") {
3253 return {"argon"};
3254 } else if (gas == "He") {
3255 return {"helium", "He-4", "He 4", "He4", "4-He", "4 He", "4He",
3256 "helium-4", "helium 4", "helium4"};
3257 } else if (gas == "He-3") {
3258 return {"He3", "He 3", "3-He", "3 He", "3He",
3259 "helium-3", "helium 3", "helium3"};
3260 } else if (gas == "Ne") {
3261 return {"neon"};
3262 } else if (gas == "Kr") {
3263 return {"krypton"};
3264 } else if (gas == "Xe") {
3265 return {"xenon"};
3266 } else if (gas == "CH4") {
3267 return {"methane"};
3268 } else if (gas == "C2H6") {
3269 return {"ethane"};
3270 } else if (gas == "C3H8") {
3271 return {"propane"};
3272 } else if (gas == "iC4H10") {
3273 return {"isobutane", "iso-C4H10", "isoC4H10", "C4H10"};
3274 } else if (gas == "CO2") {
3275 return {"carbon-dioxide", "carbon dioxide", "carbondioxide"};
3276 } else if (gas == "neoC5H12") {
3277 return {"neopentane", "neo-pentane", "neo-C5H12", "C5H12",
3278 "dimethylpropane", "tetramethylmethane"};
3279 } else if (gas == "H2O") {
3280 return {"water", "water-vapour", "water vapour"};
3281 } else if (gas == "O2") {
3282 return {"oxygen"};
3283 } else if (gas == "N2") {
3284 return {"nitrogen"};
3285 } else if (gas == "NO") {
3286 return {"nitric-oxide", "nitric oxide",
3287 "nitrogen-monoxide", "nitrogen monoxide"};
3288 } else if (gas == "N2O") {
3289 return {"nitrous-oxide", "nitrous oxide", "laughing-gas", "laughing gas",
3290 "dinitrogen-monoxide", "dinitrogen monoxide",
3291 "dinitrogen-oxide", "dinitrogen oxide"};
3292 } else if (gas == "C2H4") {
3293 return {"ethene", "ethylene"};
3294 } else if (gas == "C2H2") {
3295 return {"acetyl", "acetylene", "ethyne"};
3296 } else if (gas == "H2") {
3297 return {"hydrogen"};
3298 } else if (gas == "paraH2") {
3299 return {"para H2", "para-H2", "para hydrogen",
3300 "para-hydrogen", "parahydrogen"};
3301 } else if (gas == "D2") {
3302 return {"deuterium"};
3303 } else if (gas == "orthoD2") {
3304 return {"ortho D2", "ortho-D2", "ortho deuterium",
3305 "ortho-deuterium", "orthodeuterium"};
3306 } else if (gas == "CO") {
3307 return {"carbon-monoxide", "carbon monoxide"};
3308 } else if (gas == "Methylal") {
3309 return {"methylal-hot", "DMM", "dimethoxymethane", "Formal", "C3H8O2"};
3310 } else if (gas == "DME") {
3311 return {"dimethyl-ether", "dimethylether", "dimethyl ether",
3312 "methyl-ether", "methylether", "methyl ether",
3313 "wood-ether", "woodether", "wood ether",
3314 "dimethyl oxide", "dimethyl-oxide", "Demeon",
3315 "methoxymethane", "C4H10O2"};
3316 } else if (gas == "Reid-Step") {
3317 return {};
3318 } else if (gas == "Maxwell-Model") {
3319 return {};
3320 } else if (gas == "Reid-Ramp") {
3321 return {};
3322 } else if (gas == "C2F6") {
3323 return {"Freon-116", "Zyron-116", "Zyron-116-N5", "hexafluoroethane"};
3324 } else if (gas == "SF6") {
3325 return {"sulphur-hexafluoride", "sulfur-hexafluoride",
3326 "sulphur hexafluoride", "sulfur hexafluoride"};
3327 } else if (gas == "NH3") {
3328 return {"ammonia", "azane", "R-717", "R717"};
3329 } else if (gas == "C3H6") {
3330 return {"propene", "propylene"};
3331 } else if (gas == "cC3H6") {
3332 return {"c-propane", "cyclo-propane", "cyclo propane", "cyclopropane",
3333 "c-C3H6", "cyclo-C3H6"};
3334 } else if (gas == "CH3OH") {
3335 return {"methanol", "methyl-alcohol", "methyl alcohol", "wood alcohol",
3336 "wood-alcohol"};
3337 } else if (gas == "C2H5OH") {
3338 return {"ethanol", "ethyl-alcohol", "ethyl alcohol", "grain alcohol",
3339 "grain-alcohol"};
3340 } else if (gas == "C3H7OH") {
3341 return {"propanol", "2-propanol", "isopropyl", "iso-propanol",
3342 "isopropanol", "isopropyl alcohol", "isopropyl-alcohol"};
3343 } else if (gas == "nC3H7OH") {
3344 return {"npropanol", "n-propanol", "1-propanol", "propyl alcohol",
3345 "propyl-alcohol", "n-propyl alcohol", "nC3H7OH", "n-C3H7OH"};
3346 } else if (gas == "Cs") {
3347 return {"cesium", "caesium"};
3348 } else if (gas == "F2") {
3349 return {"fluor", "fluorine"};
3350 } else if (gas == "CS2") {
3351 return {"carbon-disulphide", "carbon-disulfide",
3352 "carbon disulphide", "carbon disulfide"};
3353 } else if (gas == "COS") {
3354 return {"carbonyl-sulphide", "carbonyl-sulfide", "carbonyl sulfide"};
3355 } else if (gas == "CD4") {
3356 return {"deut-methane", "deuterium-methane", "deuterated-methane",
3357 "deuterated methane", "deuterium methane"};
3358 } else if (gas == "BF3") {
3359 return {"boron-trifluoride", "boron trifluoride"};
3360 } else if (gas == "C2H2F4") {
3361 return {"C2HF5", "C2F5H", "C2F4H2", "Freon 134", "Freon 134A",
3362 "Freon-134", "Freon-134-A", "R-134a", "R134a",
3363 "Freon 125", "Freon-125", "Zyron 125", "Zyron-125",
3364 "tetrafluoroethane", "pentafluoroethane", "norflurane"};
3365 } else if (gas == "TMA") {
3366 return {"trimethylamine", "N(CH3)3", "N-(CH3)3"};
3367 } else if (gas == "CHF3") {
3368 return {"Freon-23", "trifluoromethane", "Fluoroform"};
3369 } else if (gas == "CF3Br") {
3370 return {"CBrF3", "trifluorobromomethane", "bromotrifluoromethane",
3371 "Halon-1301", "Halon 1301", "Freon-13B1", "Freon 13BI"};
3372 } else if (gas == "C3F8") {
3373 return {"octafluoropropane", "R218", "R-218", "Freon 218", "Freon-218",
3374 "perfluoropropane", "RC 218", "PFC 218",
3375 "RC-218", "PFC-218", "Flutec PP30", "Genetron 218"};
3376 } else if (gas == "O3") {
3377 return {"ozone"};
3378 } else if (gas == "Hg") {
3379 return {"mercury", "Hg2"};
3380 } else if (gas == "H2S") {
3381 return {"hydrogen sulphide", "hydrogen-sulphide",
3382 "hydrogen sulfide", "hydrogen-sulfide",
3383 "sewer gas", "sewer-gas", "hepatic acid", "hepatic-acid",
3384 "sulfur hydride", "sulfur-hydride",
3385 "dihydrogen monosulfide", "dihydrogen-monosulfide",
3386 "dihydrogen monosulphide", "dihydrogen-monosulphide",
3387 "sulphur hydride", "sulphur-hydride", "stink damp", "stink-damp",
3388 "sulfurated hydrogen", "sulfurated-hydrogen"};
3389 } else if (gas == "nC4H10") {
3390 return {"n-butane", "n-C4H10", "nbutane"};
3391 } else if (gas == "nC5H12") {
3392 return {"n-pentane", "n-C5H12", "npentane"};
3393 } else if (gas == "N2 (Phelps)") {
3394 return {"nitrogen-Phelps", "nitrogen Phelps", "N2-Phelps", "N2 Phelps"};
3395 } else if (gas == "GeH4") {
3396 return {"germane", "germanium-hydride", "germanium hydride",
3397 "germanium tetrahydride", "germanium-tetrahydride",
3398 "germanomethane", "monogermane"};
3399 } else if (gas == "SiH4") {
3400 return {"silane", "silicon-hydride", "silicon hydride",
3401 "silicon-tetrahydride", "silicane", "monosilane"};
3402 } else if (gas == "CCl4") {
3403 return {"carbon tetrachloride", "carbon-tetrachloride",
3404 "Benziform", "tetrachloromethane", "carbon tet",
3405 "Halon 104", "Halon-104", "Freon 10", "Freon-10"};
3406 }
3407 return {};
3408}

Referenced by GetGasName(), and PrintGases().

◆ GetAtomicNumber()

double Garfield::MediumGas::GetAtomicNumber ( ) const
overridevirtual

Get the effective atomic number.

Reimplemented from Garfield::Medium.

Definition at line 314 of file MediumGas.cc.

314 {
315 // Effective Z, weighted by the fractions of the components.
316 double z = 0.;
317 for (unsigned int i = 0; i < m_nComponents; ++i) {
318 z += m_atNum[i] * m_fraction[i];
319 }
320 return z;
321}

◆ GetAtomicWeight()

double Garfield::MediumGas::GetAtomicWeight ( ) const
overridevirtual

Get the effective atomic weight.

Reimplemented from Garfield::Medium.

Definition at line 295 of file MediumGas.cc.

295 {
296 // Effective A, weighted by the fractions of the components.
297 double a = 0.;
298 for (unsigned int i = 0; i < m_nComponents; ++i) {
299 a += m_atWeight[i] * m_fraction[i];
300 }
301 return a;
302}

Referenced by GetMassDensity().

◆ GetComponent()

void Garfield::MediumGas::GetComponent ( const unsigned int i,
std::string & label,
double & f )
overridevirtual

Get the name and fraction of a given component.

Reimplemented from Garfield::Medium.

Definition at line 258 of file MediumGas.cc.

259 {
260 if (i >= m_nComponents) {
261 std::cerr << m_className << "::GetComponent: Index out of range.\n";
262 label = "";
263 f = 0.;
264 return;
265 }
266
267 label = m_gas[i];
268 f = m_fraction[i];
269}

◆ GetComposition()

void Garfield::MediumGas::GetComposition ( std::string & gas1,
double & f1,
std::string & gas2,
double & f2,
std::string & gas3,
double & f3,
std::string & gas4,
double & f4,
std::string & gas5,
double & f5,
std::string & gas6,
double & f6 ) const

Retrieve the gas mixture.

Definition at line 240 of file MediumGas.cc.

243 {
244 gas1 = m_gas[0];
245 gas2 = m_gas[1];
246 gas3 = m_gas[2];
247 gas4 = m_gas[3];
248 gas5 = m_gas[4];
249 gas6 = m_gas[5];
250 f1 = m_fraction[0];
251 f2 = m_fraction[1];
252 f3 = m_fraction[2];
253 f4 = m_fraction[3];
254 f5 = m_fraction[4];
255 f6 = m_fraction[5];
256}

◆ GetElectronExcitationRate()

bool Garfield::MediumGas::GetElectronExcitationRate ( const size_t level,
const size_t ie,
const size_t ib,
const size_t ia,
double & f ) const

Get an entry in the table of excitation rates.

Definition at line 2711 of file MediumGas.cc.

2713 {
2714 if (level >= m_excLevels.size()) {
2715 std::cerr << m_className << "::GetElectronExcitationRate:\n"
2716 << " Level index out of range.\n";
2717 return false;
2718 }
2719 return GetEntry(ie, ib, ia, "ElectronExcitationRate", m_excRates[level], f);
2720}
bool GetEntry(const size_t i, const size_t j, const size_t k, const std::string &fcn, const std::vector< std::vector< std::vector< double > > > &tab, double &val) const
Definition Medium.cc:982

◆ GetElectronIonisationRate()

bool Garfield::MediumGas::GetElectronIonisationRate ( const size_t level,
const size_t ie,
const size_t ib,
const size_t ia,
double & f ) const

Get an entry in the table of ionisation rates.

Definition at line 2700 of file MediumGas.cc.

2702 {
2703 if (level >= m_ionLevels.size()) {
2704 std::cerr << m_className << "::GetElectronIonisationRate:\n"
2705 << " Level index out of range.\n";
2706 return false;
2707 }
2708 return GetEntry(ie, ib, ia, "ElectronIonisationRate", m_ionRates[level], f);
2709}

◆ GetExcitationLevel()

void Garfield::MediumGas::GetExcitationLevel ( const size_t level,
std::string & label,
double & energy ) const

Return the identifier and energy of an excitation level.

Definition at line 2690 of file MediumGas.cc.

2691 {
2692 if (level >= m_excLevels.size()) {
2693 std::cerr << m_className << "::GetExcitationLevel: Index out of range.\n";
2694 return;
2695 }
2696 label = m_excLevels[level].label;
2697 energy = m_excLevels[level].energy;
2698}

◆ GetGasBits()

void Garfield::MediumGas::GetGasBits ( std::bitset< 20 > & gasok) const
protected

Definition at line 2071 of file MediumGas.cc.

2071 {
2072
2073 gasok.reset();
2074 if (!m_eVelE.empty()) gasok.set(0);
2075 if (!m_iMob.empty()) gasok.set(1);
2076 if (!m_eDifL.empty()) gasok.set(2);
2077 if (!m_eAlp.empty()) gasok.set(3);
2078 // Cluster size distribution; skipped
2079 if (!m_eAtt.empty()) gasok.set(5);
2080 if (!m_eLor.empty()) gasok.set(6);
2081 if (!m_eDifT.empty()) gasok.set(7);
2082 if (!m_eVelB.empty()) gasok.set(8);
2083 if (!m_eVelX.empty()) gasok.set(9);
2084 if (!m_eDifM.empty()) gasok.set(10);
2085 if (!m_iDis.empty()) gasok.set(11);
2086 // SRIM, HEED; skipped
2087 if (!m_excRates.empty()) gasok.set(14);
2088 if (!m_ionRates.empty()) gasok.set(15);
2089}
std::vector< std::vector< std::vector< double > > > m_eVelE
Definition Medium.hh:577
std::vector< std::vector< std::vector< double > > > m_eVelX
Definition Medium.hh:578
std::vector< std::vector< std::vector< double > > > m_eDifL
Definition Medium.hh:580
std::vector< std::vector< std::vector< double > > > m_eAtt
Definition Medium.hh:583
std::vector< std::vector< std::vector< double > > > m_eLor
Definition Medium.hh:584
std::vector< std::vector< std::vector< double > > > m_eDifT
Definition Medium.hh:581
std::vector< std::vector< std::vector< double > > > m_eVelB
Definition Medium.hh:579
std::vector< std::vector< std::vector< std::vector< double > > > > m_eDifM
Definition Medium.hh:586
std::vector< std::vector< std::vector< double > > > m_iMob
Definition Medium.hh:600
std::vector< std::vector< std::vector< double > > > m_iDis
Definition Medium.hh:603

Referenced by MergeGasFile(), and WriteGasFile().

◆ GetGasInfo()

bool Garfield::MediumGas::GetGasInfo ( const std::string & gasname,
double & a,
double & z,
double & w,
double & f )
staticprotected

Definition at line 2828 of file MediumGas.cc.

2829 {
2830 // Unless indicated otherwise, the W values are taken from
2831 // ICRU report 31 (Table 5-IX), and the Fano factors are taken
2832 // from IAEA TECDOC 799.
2833 // For gases for which no experimental data on the Fano factor
2834 // are available, the Fano factor is calculated using the
2835 // Krajcar-Bronic relation, F = 0.188 * W / I - 0.15
2836 if (gasname == "CF4") {
2837 a = 12.0107 + 4 * 18.9984032;
2838 z = 6 + 4 * 9;
2839 w = 34.3; // DOI: 10.1063/1.337792
2840 f = 0.26; // Krajcar-Bronic relation
2841 return true;
2842 } else if (gasname == "Ar") {
2843 a = 39.948;
2844 z = 18;
2845 w = 26.4;
2846 f = 0.17;
2847 } else if (gasname == "He") {
2848 a = 4.002602;
2849 z = 2;
2850 w = 41.3;
2851 f = 0.17;
2852 } else if (gasname == "He-3") {
2853 a = 3.01602931914;
2854 z = 2;
2855 w = 41.3;
2856 f = 0.17;
2857 } else if (gasname == "Ne") {
2858 a = 20.1797;
2859 z = 10;
2860 w = 35.4;
2861 f = 0.17;
2862 } else if (gasname == "Kr") {
2863 a = 37.798;
2864 z = 36;
2865 w = 24.4;
2866 f = 0.17;
2867 } else if (gasname == "Xe") {
2868 a = 131.293;
2869 z = 54;
2870 w = 22.1;
2871 f = 0.17;
2872 } else if (gasname == "CH4") {
2873 a = 12.0107 + 4 * 1.00794;
2874 z = 6 + 4;
2875 w = 27.3;
2876 f = 0.26;
2877 } else if (gasname == "C2H6") {
2878 a = 2 * 12.0107 + 6 * 1.00794;
2879 z = 2 * 6 + 6;
2880 w = 25.0;
2881 f = 0.28; // DOI 10.1088/0022-3700/20/17/025
2882 } else if (gasname == "C3H8") {
2883 a = 3 * 12.0107 + 8 * 1.00794;
2884 z = 3 * 6 + 8;
2885 w = 24.0;
2886 f = 0.25;
2887 } else if (gasname == "iC4H10") {
2888 a = 4 * 12.0107 + 10 * 1.00794;
2889 z = 4 * 6 + 10;
2890 w = 23.4;
2891 f = 0.26; // DOI 10.1088/0022-3700/20/17/025
2892 } else if (gasname == "CO2") {
2893 a = 12.0107 + 2 * 15.9994;
2894 z = 6 + 2 * 8;
2895 w = 33.0;
2896 f = 0.32;
2897 } else if (gasname == "neoC5H12") {
2898 a = 5 * 12.0107 + 12 * 1.00794;
2899 z = 5 * 6 + 12;
2900 w = 23.2;
2901 f = 0.27; // DOI 10.1088/0022-3700/20/17/025
2902 } else if (gasname == "H2O") {
2903 a = 2 * 1.00794 + 15.9994;
2904 z = 2 + 8;
2905 w = 29.6;
2906 f = 0.25;
2907 } else if (gasname == "O2") {
2908 a = 2 * 15.9994;
2909 z = 2 * 8;
2910 w = 30.8;
2911 f = 0.37;
2912 } else if (gasname == "N2") {
2913 a = 2 * 14.0067;
2914 z = 2 * 7;
2915 w = 34.8;
2916 f = 0.28;
2917 } else if (gasname == "NO") {
2918 a = 14.0067 + 15.9994;
2919 z = 7 + 8;
2920 w = 28.9; // ICRU 31, Table 5-V
2921 f = 0.44; // Krajcar-Bronic relation
2922 } else if (gasname == "N2O") {
2923 a = 2 * 14.0067 + 15.9994;
2924 z = 2 * 7 + 8;
2925 w = 32.6;
2926 f = 0.33; // Krajcar-Bronic relation
2927 } else if (gasname == "C2H4") {
2928 a = 2 * 12.0107 + 4 * 1.00794;
2929 z = 2 * 6 + 4;
2930 w = 25.8;
2931 f = 0.31; // DOI 10.1088/0022-3700/20/17/025
2932 } else if (gasname == "C2H2") {
2933 a = 2 * 12.0107 + 2 * 1.00794;
2934 z = 2 * 6 + 2;
2935 w = 25.8;
2936 f = 0.27;
2937 } else if (gasname == "H2" || gasname == "paraH2") {
2938 a = 2 * 1.00794;
2939 z = 2;
2940 w = 36.5;
2941 f = 0.34;
2942 } else if (gasname == "D2" || gasname == "orthoD2") {
2943 a = 2 * 2.01410177785;
2944 z = 2;
2945 w = 36.5;
2946 f = 0.34;
2947 } else if (gasname == "CO") {
2948 a = 12.0107 + 15.9994;
2949 z = 6 + 8;
2950 w = 34.5; // ICRU 31, Table 5-V
2951 f = 0.31; // Krajcar-Bronic relation
2952 } else if (gasname == "Methylal") {
2953 a = 3 * 12.0107 + 8 * 1.00794 + 2 * 15.9994;
2954 z = 3 * 6 + 8 + 2 * 8;
2955 w = 20.0; // rough estimate (twice the ionisation potential)
2956 f = 0.23; // Krajcar-Bronic relation
2957 } else if (gasname == "DME") {
2958 a = 4 * 12.0107 + 10 * 1.00794 + 2 * 15.9994;
2959 z = 4 * 6 + 10 + 2 * 8;
2960 // DOI 10.1063/1.365787
2961 w = 27.7;
2962 f = 0.285;
2963 } else if (gasname == "Reid-Step" || gasname == "Maxwell-Model" ||
2964 gasname == "Reid-Ramp") {
2965 a = 1.;
2966 z = 1.;
2967 w = 30.;
2968 f = 0.2;
2969 } else if (gasname == "C2F6") {
2970 a = 2 * 12.0107 + 6 * 18.9984032;
2971 z = 2 * 6 + 6 * 9;
2972 w = 34.5; // DOI: 10.1063/1.337792
2973 f = 0.30; // Krajcar-Bronic relation
2974 } else if (gasname == "SF6") {
2975 a = 32.065 + 6 * 18.9984032;
2976 z = 16 + 6 * 9;
2977 w = 35.8; // ICRU 31, Table 5-V
2978 f = 0.28; // Krajcar-Bronic relation
2979 } else if (gasname == "NH3") {
2980 a = 14.0067 + 3 * 1.00794;
2981 z = 7 + 3;
2982 w = 26.6;
2983 f = 0.34; // Krajcar-Bronic relation
2984 } else if (gasname == "C3H6") {
2985 a = 3 * 12.0107 + 6 * 1.00794;
2986 z = 3 * 6 + 6;
2987 w = 27.1; // ICRU 31, Table 5-V
2988 f = 0.37; // Krajcar-Bronic relation
2989 } else if (gasname == "cC3H6") {
2990 a = 3 * 12.0107 + 6 * 1.00794;
2991 z = 3 * 6 + 6;
2992 w = 25.9; // ICRU 31, Table 5-V
2993 f = 0.34; // Krajcar-Bronic relation
2994 } else if (gasname == "CH3OH") {
2995 a = 12.0107 + 4 * 1.00794 + 15.9994;
2996 z = 6 + 4 + 8;
2997 w = 24.7;
2998 f = 0.37; // DOI 10.1088/0022-3700/20/17/025
2999 } else if (gasname == "C2H5OH") {
3000 a = 2 * 12.0107 + 6 * 1.00794 + 15.9994;
3001 z = 2 * 6 + 6 + 8;
3002 w = 24.8;
3003 f = 0.37; // DOI 10.1088/0022-3700/20/17/025
3004 } else if (gasname == "C3H7OH" || gasname == "nC3H7OH") {
3005 a = 3 * 12.0107 + 8 * 1.00794 + 15.9994;
3006 z = 3 * 6 + 8 * 8;
3007 w = 21.; // Magboltz
3008 f = 0.37; // same value as for methanol and ethanol
3009 } else if (gasname == "Cs") {
3010 a = 132.9054519;
3011 z = 55;
3012 w = 16.; // Dugan and Sovie (1964)
3013 f = 0.6; // Krajcar-Bronic relation. Seems high.
3014 } else if (gasname == "F2") {
3015 a = 2 * 18.9984032;
3016 z = 2 * 9;
3017 // Magboltz
3018 w = 30.2;
3019 f = 0.21;
3020 } else if (gasname == "CS2") {
3021 a = 12.0107 + 2 * 32.065;
3022 z = 6 + 2 * 16;
3023 w = 26.0; // Myers
3024 f = 0.34; // Krajcar-Bronic relation
3025 } else if (gasname == "COS") {
3026 a = 12.0107 + 15.9994 + 32.065;
3027 z = 6 + 8 + 16;
3028 // Magboltz
3029 w = 23.7;
3030 f = 0.25;
3031 } else if (gasname == "CD4") {
3032 a = 12.0107 + 4 * 2.01410177785;
3033 z = 6 + 4;
3034 w = 27.3;
3035 f = 0.26;
3036 } else if (gasname == "BF3") {
3037 a = 10.811 + 3 * 18.9984032;
3038 z = 5 + 3 * 9;
3039 w = 35.7; // ICRU 31, Table 5-V
3040 f = 0.28; // Krajcar-Bronic relation
3041 } else if (gasname == "C2H2F4") {
3042 a = 2 * 12.0107 + 2 * 1.00794 + 4 * 18.9984032;
3043 z = 2 * 6 + 2 + 4 * 9;
3044 // Magboltz
3045 w = 30.7;
3046 f = 0.25;
3047 } else if (gasname == "CHF3") {
3048 a = 12.0107 + 1.00794 + 3 * 18.9984032;
3049 z = 6 + 1 + 3 * 9;
3050 // Magboltz
3051 w = 26.6;
3052 f = 0.21;
3053 } else if (gasname == "CF3Br") {
3054 a = 12.0107 + 3 * 18.9984032 + 79.904;
3055 z = 6 + 3 * 9 + 35;
3056 // Magboltz
3057 w = 22.4;
3058 f = 0.22;
3059 } else if (gasname == "C3F8") {
3060 a = 3 * 12.0107 + 8 * 18.9984032;
3061 z = 3 * 6 + 8 * 9;
3062 w = 34.4; // DOI: 10.1063/1.337792
3063 f = 0.33; // Krajcar-Bronic relation
3064 } else if (gasname == "O3") {
3065 a = 3 * 15.9994;
3066 z = 3 * 8;
3067 // Magboltz
3068 w = 30.7;
3069 f = 0.3;
3070 } else if (gasname == "Hg") {
3071 a = 2 * 200.59;
3072 z = 80;
3073 w = 23.6;
3074 f = 0.28; // Krajcar-Bronic relation
3075 } else if (gasname == "H2S") {
3076 a = 2 * 1.00794 + 32.065;
3077 z = 2 + 16;
3078 w = 23.3; // ICRU 31, Table 5-V
3079 f = 0.27; // Krajcar-Bronic relation
3080 } else if (gasname == "nC4H10") {
3081 a = 4 * 12.0107 + 10 * 1.00794;
3082 z = 4 * 6 + 10;
3083 w = 23.4;
3084 f = 0.26; // DOI 10.1088/0022-3700/20/17/025
3085 } else if (gasname == "nC5H12") {
3086 a = 5 * 12.0107 + 12 * 1.00794;
3087 z = 5 * 6 + 12;
3088 w = 23.2;
3089 f = 0.27; // DOI 10.1088/0022-3700/20/17/025
3090 } else if (gasname == "GeH4") {
3091 a = 72.64 + 4 * 1.00794;
3092 z = 32 + 4;
3093 // Magboltz
3094 w = 25.9;
3095 f = 0.28;
3096 } else if (gasname == "SiH4") {
3097 a = 28.0855 + 4 * 1.00794;
3098 z = 14 + 4;
3099 // Magboltz
3100 w = 27.5;
3101 f = 0.30;
3102 } else if (gasname == "CCl4") {
3103 a = 12.0107 + 4 * 35.45;
3104 z = 6 + 4 * 17;
3105 w = 25.8; // ICRU 31, Table 5-V
3106 f = 0.21; // Krajcar-Bronic relation
3107 } else {
3108 a = 0.;
3109 z = 0.;
3110 w = 0.;
3111 f = 0.;
3112 return false;
3113 }
3114 return true;
3115}

Referenced by LoadGasFile(), MediumGas(), and SetComposition().

◆ GetGasName() [1/2]

std::string Garfield::MediumGas::GetGasName ( const int gasnumber,
const int version )
staticprotected

Definition at line 3117 of file MediumGas.cc.

3117 {
3118
3119 switch (gasnumber) {
3120 case 1:
3121 return "CF4";
3122 case 2:
3123 return "Ar";
3124 case 3:
3125 return "He";
3126 case 4:
3127 return "He-3";
3128 case 5:
3129 return "Ne";
3130 case 6:
3131 return "Kr";
3132 case 7:
3133 return "Xe";
3134 case 8:
3135 return "CH4";
3136 case 9:
3137 return "C2H6";
3138 case 10:
3139 return "C3H8";
3140 case 11:
3141 return "iC4H10";
3142 case 12:
3143 return "CO2";
3144 case 13:
3145 return "neoC5H12";
3146 case 14:
3147 return "H2O";
3148 case 15:
3149 return "O2";
3150 case 16:
3151 return "N2";
3152 case 17:
3153 return "NO";
3154 case 18:
3155 return "N2O";
3156 case 19:
3157 return "C2H4";
3158 case 20:
3159 return "C2H2";
3160 case 21:
3161 return "H2";
3162 case 22:
3163 return "D2";
3164 case 23:
3165 return "CO";
3166 case 24:
3167 return "Methylal";
3168 case 25:
3169 return "DME";
3170 case 26:
3171 return "Reid-Step";
3172 case 27:
3173 return "Maxwell-Model";
3174 case 28:
3175 return "Reid-Ramp";
3176 case 29:
3177 return "C2F6";
3178 case 30:
3179 return "SF6";
3180 case 31:
3181 return "NH3";
3182 case 32:
3183 return "C3H6";
3184 case 33:
3185 return "cC3H6";
3186 case 34:
3187 return "CH3OH";
3188 case 35:
3189 return "C2H5OH";
3190 case 36:
3191 return "C3H7OH";
3192 case 37:
3193 return "Cs";
3194 case 38:
3195 return "F2";
3196 case 39:
3197 return "CS2";
3198 case 40:
3199 return "COS";
3200 case 41:
3201 return "CD4";
3202 case 42:
3203 return "BF3";
3204 case 43:
3205 return "C2H2F4";
3206 case 44:
3207 return version <= 11 ? "He-3" : "TMA";
3208 case 45:
3209 return version <= 11 ? "He" : "paraH2";
3210 case 46:
3211 return version <= 11 ? "Ne" : "nC3H7OH";
3212 case 47:
3213 return "Ar";
3214 case 48:
3215 return version <= 11 ? "Kr" : "orthoD2";
3216 case 49:
3217 return "Xe";
3218 case 50:
3219 return "CHF3";
3220 case 51:
3221 return "CF3Br";
3222 case 52:
3223 return "C3F8";
3224 case 53:
3225 return "O3";
3226 case 54:
3227 return "Hg";
3228 case 55:
3229 return "H2S";
3230 case 56:
3231 return "nC4H10";
3232 case 57:
3233 return "nC5H12";
3234 case 58:
3235 return "N2";
3236 case 59:
3237 return "GeH4";
3238 case 60:
3239 return "SiH4";
3240 case 61:
3241 return "CCl4";
3242 default:
3243 break;
3244 }
3245 return "";
3246}

Referenced by DisablePenningTransfer(), Garfield::MediumMagboltz::DisablePenningTransfer(), EnablePenningTransfer(), Garfield::MediumMagboltz::EnablePenningTransfer(), GetGasName(), GetMixture(), GetPenningTransfer(), PrintGases(), SetComposition(), and Garfield::MediumMagboltz::SetExcitationScaling().

◆ GetGasName() [2/2]

std::string Garfield::MediumGas::GetGasName ( std::string input)
staticprotected

Definition at line 3439 of file MediumGas.cc.

3439 {
3440 // Convert to upper-case.
3441 std::transform(input.begin(), input.end(), input.begin(), toupper);
3442 if (input.empty()) return "";
3443
3444 // Loop over the available gases.
3445 for (int i = 1; i <= 61; ++i) {
3446 const std::string gas = i == 58 ? "N2 (Phelps)" : GetGasName(i, 12);
3447 if (gas.empty()) continue;
3448
3449 std::string tmp = gas;
3450 std::transform(tmp.begin(), tmp.end(), tmp.begin(), toupper);
3451 if (tmp == input) return gas;
3452 const auto aliases = GetAliases(gas);
3453 for (const auto& alias : aliases) {
3454 tmp = alias;
3455 std::transform(tmp.begin(), tmp.end(), tmp.begin(), toupper);
3456 if (tmp == input) return gas;
3457 }
3458 }
3459 return "";
3460}
static const std::vector< std::string > GetAliases(const std::string &gas)

◆ GetGasNumberGasFile()

int Garfield::MediumGas::GetGasNumberGasFile ( const std::string & input)
staticprotected

Definition at line 3462 of file MediumGas.cc.

3462 {
3463
3464 if (input.empty()) return 0;
3465
3466 if (input == "CF4") {
3467 return 1;
3468 } else if (input == "Ar") {
3469 return 2;
3470 } else if (input == "He" || input == "He-4") {
3471 return 3;
3472 } else if (input == "He-3") {
3473 return 4;
3474 } else if (input == "Ne") {
3475 return 5;
3476 } else if (input == "Kr") {
3477 return 6;
3478 } else if (input == "Xe") {
3479 return 7;
3480 } else if (input == "CH4") {
3481 // Methane
3482 return 8;
3483 } else if (input == "C2H6") {
3484 // Ethane
3485 return 9;
3486 } else if (input == "C3H8") {
3487 // Propane
3488 return 10;
3489 } else if (input == "iC4H10") {
3490 // Isobutane
3491 return 11;
3492 } else if (input == "CO2") {
3493 return 12;
3494 } else if (input == "neoC5H12") {
3495 // Neopentane
3496 return 13;
3497 } else if (input == "H2O") {
3498 return 14;
3499 } else if (input == "O2") {
3500 return 15;
3501 } else if (input == "N2") {
3502 return 16;
3503 } else if (input == "NO") {
3504 // Nitric oxide
3505 return 17;
3506 } else if (input == "N2O") {
3507 // Nitrous oxide
3508 return 18;
3509 } else if (input == "C2H4") {
3510 // Ethene
3511 return 19;
3512 } else if (input == "C2H2") {
3513 // Acetylene
3514 return 20;
3515 } else if (input == "H2") {
3516 return 21;
3517 } else if (input == "D2") {
3518 // Deuterium
3519 return 22;
3520 } else if (input == "CO") {
3521 return 23;
3522 } else if (input == "Methylal") {
3523 // Methylal (dimethoxymethane, CH3-O-CH2-O-CH3, "hot" version)
3524 return 24;
3525 } else if (input == "DME") {
3526 return 25;
3527 } else if (input == "Reid-Step") {
3528 return 26;
3529 } else if (input == "Maxwell-Model") {
3530 return 27;
3531 } else if (input == "Reid-Ramp") {
3532 return 28;
3533 } else if (input == "C2F6") {
3534 return 29;
3535 } else if (input == "SF6") {
3536 return 30;
3537 } else if (input == "NH3") {
3538 return 31;
3539 } else if (input == "C3H6") {
3540 // Propene
3541 return 32;
3542 } else if (input == "cC3H6") {
3543 // Cyclopropane
3544 return 33;
3545 } else if (input == "CH3OH") {
3546 // Methanol
3547 return 34;
3548 } else if (input == "C2H5OH") {
3549 // Ethanol
3550 return 35;
3551 } else if (input == "C3H7OH") {
3552 // Propanol
3553 return 36;
3554 } else if (input == "Cs") {
3555 return 37;
3556 } else if (input == "F2") {
3557 // Fluorine
3558 return 38;
3559 } else if (input == "CS2") {
3560 return 39;
3561 } else if (input == "COS") {
3562 return 40;
3563 } else if (input == "CD4") {
3564 // Deuterated methane
3565 return 41;
3566 } else if (input == "BF3") {
3567 return 42;
3568 } else if (input == "C2HF5" || input == "C2H2F4") {
3569 return 43;
3570 } else if (input == "TMA") {
3571 return 44;
3572 } else if (input == "paraH2") {
3573 return 45;
3574 } else if (input == "nC3H7OH") {
3575 return 46;
3576 } else if (input == "orthoD2") {
3577 return 48;
3578 } else if (input == "CHF3") {
3579 return 50;
3580 } else if (input == "CF3Br") {
3581 return 51;
3582 } else if (input == "C3F8") {
3583 return 52;
3584 } else if (input == "O3") {
3585 // Ozone
3586 return 53;
3587 } else if (input == "Hg") {
3588 return 54;
3589 } else if (input == "H2S") {
3590 return 55;
3591 } else if (input == "nC4H10") {
3592 // n-butane
3593 return 56;
3594 } else if (input == "nC5H12") {
3595 // n-pentane
3596 return 57;
3597 } else if (input == "N2 (Phelps)") {
3598 return 58;
3599 } else if (input == "GeH4") {
3600 // Germane
3601 return 59;
3602 } else if (input == "SiH4") {
3603 // Silane
3604 return 60;
3605 } else if (input == "CCl4") {
3606 return 61;
3607 }
3608 return 0;
3609}

Referenced by WriteGasFile().

◆ GetIonisationLevel()

void Garfield::MediumGas::GetIonisationLevel ( const size_t level,
std::string & label,
double & energy ) const

Return the identifier and threshold of an ionisation level.

Definition at line 2680 of file MediumGas.cc.

2681 {
2682 if (level >= m_ionLevels.size()) {
2683 std::cerr << m_className << "::GetIonisationLevel: Index out of range.\n";
2684 return;
2685 }
2686 label = m_ionLevels[level].label;
2687 energy = m_ionLevels[level].energy;
2688}

◆ GetMassDensity()

double Garfield::MediumGas::GetMassDensity ( ) const
overridevirtual

Get the mass density [g/cm3].

Reimplemented from Garfield::Medium.

Definition at line 310 of file MediumGas.cc.

310 {
311 return GetNumberDensity() * GetAtomicWeight() * AtomicMassUnit;
312}
double GetNumberDensity() const override
Get the number density [cm-3].
Definition MediumGas.cc:304
double GetAtomicWeight() const override
Get the effective atomic weight.
Definition MediumGas.cc:295

◆ GetMixture()

bool Garfield::MediumGas::GetMixture ( const std::vector< double > & mixture,
const int version,
std::vector< std::string > & gasnames,
std::vector< double > & percentages ) const
protected

Definition at line 918 of file MediumGas.cc.

920 {
921
922 gasnames.clear();
923 percentages.clear();
924 const unsigned int nMagboltzGases = mixture.size();
925 for (unsigned int i = 0; i < nMagboltzGases; ++i) {
926 if (mixture[i] < Small) continue;
927 const std::string gasname = GetGasName(i + 1, version);
928 if (gasname.empty()) {
929 std::cerr << m_className << "::GetMixture:\n"
930 << " Unknown gas (gas number " << i + 1 << ").\n";
931 return false;
932 }
933 gasnames.push_back(gasname);
934 percentages.push_back(mixture[i]);
935 }
936 if (gasnames.size() > m_nMaxGases) {
937 std::cerr << m_className << "::GetMixture:\n"
938 << " Gas mixture has " << gasnames.size() << " components.\n"
939 << " Number of gases is limited to " << m_nMaxGases << ".\n";
940 return false;
941 } else if (gasnames.empty()) {
942 std::cerr << m_className << "::GetMixture:\n"
943 << " Gas mixture is not defined (zero components).\n";
944 return false;
945 }
946 double sum = std::accumulate(percentages.begin(), percentages.end(), 0.);
947 if (sum != 100.) {
948 std::cout << m_className << "::GetMixture:\n"
949 << " Renormalizing the percentages.\n";
950 for (auto& percentage : percentages) percentage *= 100. / sum;
951 }
952 return true;
953}
static constexpr unsigned int m_nMaxGases
Definition MediumGas.hh:161

Referenced by LoadGasFile(), and MergeGasFile().

◆ GetNumberDensity()

double Garfield::MediumGas::GetNumberDensity ( ) const
overridevirtual

Get the number density [cm-3].

Reimplemented from Garfield::Medium.

Definition at line 304 of file MediumGas.cc.

304 {
305 // Ideal gas law.
306 return LoschmidtNumber * (m_pressure / AtmosphericPressure) *
307 (ZeroCelsius / m_temperature);
308}

Referenced by GetMassDensity(), and Garfield::MediumMagboltz::PlotElectronCrossSections().

◆ GetNumberOfExcitationLevels()

size_t Garfield::MediumGas::GetNumberOfExcitationLevels ( ) const
inline

Return the number of excitation levels in the table.

Definition at line 86 of file MediumGas.hh.

86{ return m_excLevels.size(); }

◆ GetNumberOfIonisationLevels()

size_t Garfield::MediumGas::GetNumberOfIonisationLevels ( ) const
inline

Return the number of ionisation levels in the table.

Definition at line 84 of file MediumGas.hh.

84{ return m_ionLevels.size(); }

◆ GetPenningTransfer()

bool Garfield::MediumGas::GetPenningTransfer ( const std::string & gasname,
double & r,
double & lambda )

Retrieve the Penning transfer probability and distance for a specific component.

Definition at line 2657 of file MediumGas.cc.

2658 {
2659
2660 r = 0.;
2661 lambda = 0.;
2662 // Get the "standard" name of this gas.
2663 const std::string gas = GetGasName(gasname);
2664 if (gas.empty()) {
2665 std::cerr << m_className << "::GetPenningTransfer: Unknown gas name.\n";
2666 return false;
2667 }
2668 for (unsigned int i = 0; i < m_nComponents; ++i) {
2669 if (m_gas[i] == gas) {
2670 r = m_rPenningGas[i];
2671 lambda = m_lambdaPenningGas[i];
2672 return true;
2673 }
2674 }
2675 std::cerr << m_className << "::GetPenningTransfer: " << gasname
2676 << " is not part of the mixture.\n";
2677 return false;
2678}

◆ GetPhotoAbsorptionCrossSection()

bool Garfield::MediumGas::GetPhotoAbsorptionCrossSection ( const double e,
double & sigma,
const unsigned int i )
overridevirtual

Reimplemented from Garfield::Medium.

Definition at line 3611 of file MediumGas.cc.

3612 {
3613 if (i >= m_nMaxGases) {
3614 std::cerr << m_className
3615 << "::GetPhotoAbsorptionCrossSection: Index out of range.\n";
3616 return false;
3617 }
3618
3619 if (!OpticalData::IsAvailable(m_gas[i])) return false;
3620 double eta = 0.;
3621 return OpticalData::PhotoabsorptionCrossSection(m_gas[i], e, sigma, eta);
3622}
static bool IsAvailable(const std::string &material)
Check whether optical data have been implemented for a given gas.
static bool PhotoabsorptionCrossSection(const std::string &material, const double energy, double &cs, double &eta)
Photo-absorption cross-section and ionisation yield at a given energy.

◆ InsertA()

void Garfield::MediumGas::InsertA ( const int ia,
const int ne,
const int nb,
const int na )
protected

Definition at line 1715 of file MediumGas.cc.

1716 {
1717 ResizeA(m_eVelE, ne, nb, na + 1);
1718 ResizeA(m_eVelB, ne, nb, na + 1);
1719 ResizeA(m_eVelX, ne, nb, na + 1);
1720 ResizeA(m_eDifL, ne, nb, na + 1);
1721 ResizeA(m_eDifT, ne, nb, na + 1);
1722 ResizeA(m_eAlp, ne, nb, na + 1);
1723 ResizeA(m_eAlp0, ne, nb, na + 1);
1724 ResizeA(m_eAtt, ne, nb, na + 1);
1725 ResizeA(m_eLor, ne, nb, na + 1);
1726 ResizeA(m_iMob, ne, nb, na + 1);
1727 ResizeA(m_iDis, ne, nb, na + 1);
1728 ResizeA(m_iDifL, ne, nb, na + 1);
1729 ResizeA(m_iDifT, ne, nb, na + 1);
1730 for (auto& dif : m_eDifM) ResizeA(dif, ne, nb, na + 1);
1731 for (auto& exc : m_excRates) ResizeA(exc, ne, nb, na + 1);
1732 for (auto& ion : m_ionRates) ResizeA(ion, ne, nb, na + 1);
1733 for (int j = 0; j < nb; ++j) {
1734 for (int i = 0; i < ne; ++i) {
1735 for (int k = na; k > ia; k--) {
1736 if (!m_eVelE.empty()) m_eVelE[k][j][i] = m_eVelE[k - 1][j][i];
1737 if (!m_eVelB.empty()) m_eVelB[k][j][i] = m_eVelB[k - 1][j][i];
1738 if (!m_eVelX.empty()) m_eVelX[k][j][i] = m_eVelX[k - 1][j][i];
1739 if (!m_eDifL.empty()) m_eDifL[k][j][i] = m_eDifL[k - 1][j][i];
1740 if (!m_eDifT.empty()) m_eDifT[k][j][i] = m_eDifT[k - 1][j][i];
1741 if (!m_eAlp.empty()) m_eAlp[k][j][i] = m_eAlp[k - 1][j][i];
1742 if (!m_eAlp0.empty()) m_eAlp0[k][j][i] = m_eAlp0[k - 1][j][i];
1743 if (!m_eAtt.empty()) m_eAtt[k][j][i] = m_eAtt[k - 1][j][i];
1744 if (!m_eLor.empty()) m_eLor[k][j][i] = m_eLor[k - 1][j][i];
1745 if (!m_iMob.empty()) m_iMob[k][j][i] = m_iMob[k - 1][j][i];
1746 if (!m_iDis.empty()) m_iDis[k][j][i] = m_iDis[k - 1][j][i];
1747 if (!m_iDifL.empty()) m_iDifL[k][j][i] = m_iDifL[k - 1][j][i];
1748 if (!m_iDifT.empty()) m_iDifT[k][j][i] = m_iDifT[k - 1][j][i];
1749 for (auto& dif : m_eDifM) dif[k][j][i] = dif[k - 1][j][i];
1750 for (auto& exc : m_excRates) exc[k][j][i] = exc[k - 1][j][i];
1751 for (auto& ion : m_ionRates) ion[k][j][i] = ion[k - 1][j][i];
1752 }
1753 }
1754 }
1755}
std::vector< std::vector< std::vector< double > > > m_iDifT
Definition Medium.hh:602
std::vector< std::vector< std::vector< double > > > m_iDifL
Definition Medium.hh:601

Referenced by MergeGasFile().

◆ InsertB()

void Garfield::MediumGas::InsertB ( const int ib,
const int ne,
const int nb,
const int na )
protected

Definition at line 1667 of file MediumGas.cc.

1668 {
1669 for (int k = 0; k < na; ++k) {
1670 if (!m_eVelE.empty()) m_eVelE[k].resize(nb + 1, std::vector<double>(ne, 0.));
1671 if (!m_eVelB.empty()) m_eVelB[k].resize(nb + 1, std::vector<double>(ne, 0.));
1672 if (!m_eVelX.empty()) m_eVelX[k].resize(nb + 1, std::vector<double>(ne, 0.));
1673 if (!m_eDifL.empty()) m_eDifL[k].resize(nb + 1, std::vector<double>(ne, 0.));
1674 if (!m_eDifT.empty()) m_eDifT[k].resize(nb + 1, std::vector<double>(ne, 0.));
1675 if (!m_eAlp.empty()) m_eAlp[k].resize(nb + 1, std::vector<double>(ne, 0.));
1676 if (!m_eAlp0.empty()) m_eAlp0[k].resize(nb + 1, std::vector<double>(ne, 0.));
1677 if (!m_eAtt.empty()) m_eAtt[k].resize(nb + 1, std::vector<double>(ne, 0.));
1678 if (!m_eLor.empty()) m_eLor[k].resize(nb + 1, std::vector<double>(ne, 0.));
1679 if (!m_iMob.empty()) m_iMob[k].resize(nb + 1, std::vector<double>(ne, 0.));
1680 if (!m_iDis.empty()) m_iDis[k].resize(nb + 1, std::vector<double>(ne, 0.));
1681 if (!m_iDifL.empty()) m_iDifL[k].resize(nb + 1, std::vector<double>(ne, 0.));
1682 if (!m_iDifT.empty()) m_iDifT[k].resize(nb + 1, std::vector<double>(ne, 0.));
1683 for (auto& dif : m_eDifM) {
1684 dif[k].resize(nb + 1, std::vector<double>(ne, 0.));
1685 }
1686 for (auto& exc : m_excRates) {
1687 exc[k].resize(nb + 1, std::vector<double>(ne, 0.));
1688 }
1689 for (auto& ion : m_ionRates) {
1690 ion[k].resize(nb + 1, std::vector<double>(ne, 0.));
1691 }
1692 for (int i = 0; i < ne; ++i) {
1693 for (int j = nb; j > ib; j--) {
1694 if (!m_eVelE.empty()) m_eVelE[k][j][i] = m_eVelE[k][j - 1][i];
1695 if (!m_eVelB.empty()) m_eVelB[k][j][i] = m_eVelB[k][j - 1][i];
1696 if (!m_eVelX.empty()) m_eVelX[k][j][i] = m_eVelX[k][j - 1][i];
1697 if (!m_eDifL.empty()) m_eDifL[k][j][i] = m_eDifL[k][j - 1][i];
1698 if (!m_eDifT.empty()) m_eDifT[k][j][i] = m_eDifT[k][j - 1][i];
1699 if (!m_eAlp.empty()) m_eAlp[k][j][i] = m_eAlp[k][j - 1][i];
1700 if (!m_eAlp0.empty()) m_eAlp0[k][j][i] = m_eAlp0[k][j - 1][i];
1701 if (!m_eAtt.empty()) m_eAtt[k][j][i] = m_eAtt[k][j - 1][i];
1702 if (!m_eLor.empty()) m_eLor[k][j][i] = m_eLor[k][j - 1][i];
1703 if (!m_iMob.empty()) m_iMob[k][j][i] = m_iMob[k][j - 1][i];
1704 if (!m_iDis.empty()) m_iDis[k][j][i] = m_iDis[k][j - 1][i];
1705 if (!m_iDifL.empty()) m_iDifL[k][j][i] = m_iDifL[k][j - 1][i];
1706 if (!m_iDifT.empty()) m_iDifT[k][j][i] = m_iDifT[k][j - 1][i];
1707 for (auto& dif : m_eDifM) dif[k][j][i] = dif[k][j - 1][i];
1708 for (auto& exc : m_excRates) exc[k][j][i] = exc[k][j - 1][i];
1709 for (auto& ion : m_ionRates) ion[k][j][i] = ion[k][j - 1][i];
1710 }
1711 }
1712 }
1713}

Referenced by MergeGasFile().

◆ InsertE()

void Garfield::MediumGas::InsertE ( const int ie,
const int ne,
const int nb,
const int na )
protected

Definition at line 1625 of file MediumGas.cc.

1626 {
1627 for (int k = 0; k < na; ++k) {
1628 for (int j = 0; j < nb; ++j) {
1629 if (!m_eVelE.empty()) m_eVelE[k][j].resize(ne + 1, 0.);
1630 if (!m_eVelB.empty()) m_eVelB[k][j].resize(ne + 1, 0.);
1631 if (!m_eVelX.empty()) m_eVelX[k][j].resize(ne + 1, 0.);
1632 if (!m_eDifL.empty()) m_eDifL[k][j].resize(ne + 1, 0.);
1633 if (!m_eDifT.empty()) m_eDifT[k][j].resize(ne + 1, 0.);
1634 if (!m_eAlp.empty()) m_eAlp[k][j].resize(ne + 1, 0.);
1635 if (!m_eAlp0.empty()) m_eAlp0[k][j].resize(ne + 1, 0.);
1636 if (!m_eAtt.empty()) m_eAtt[k][j].resize(ne + 1, 0.);
1637 if (!m_eLor.empty()) m_eLor[k][j].resize(ne + 1, 0.);
1638 if (!m_iMob.empty()) m_iMob[k][j].resize(ne + 1, 0.);
1639 if (!m_iDis.empty()) m_iDis[k][j].resize(ne + 1, 0.);
1640 if (!m_iDifL.empty()) m_iDifL[k][j].resize(ne + 1, 0.);
1641 if (!m_iDifT.empty()) m_iDifT[k][j].resize(ne + 1, 0.);
1642 for (auto& dif : m_eDifM) dif[k][j].resize(ne + 1, 0.);
1643 for (auto& exc : m_excRates) exc[k][j].resize(ne + 1, 0.);
1644 for (auto& ion : m_ionRates) ion[k][j].resize(ne + 1, 0.);
1645 for (int i = ne; i > ie; --i) {
1646 if (!m_eVelE.empty()) m_eVelE[k][j][i] = m_eVelE[k][j][i - 1];
1647 if (!m_eVelB.empty()) m_eVelB[k][j][i] = m_eVelB[k][j][i - 1];
1648 if (!m_eVelX.empty()) m_eVelX[k][j][i] = m_eVelX[k][j][i - 1];
1649 if (!m_eDifL.empty()) m_eDifL[k][j][i] = m_eDifL[k][j][i - 1];
1650 if (!m_eDifT.empty()) m_eDifT[k][j][i] = m_eDifT[k][j][i - 1];
1651 if (!m_eAlp.empty()) m_eAlp[k][j][i] = m_eAlp[k][j][i - 1];
1652 if (!m_eAlp0.empty()) m_eAlp0[k][j][i] = m_eAlp0[k][j][i - 1];
1653 if (!m_eAtt.empty()) m_eAtt[k][j][i] = m_eAtt[k][j][i - 1];
1654 if (!m_eLor.empty()) m_eLor[k][j][i] = m_eLor[k][j][i - 1];
1655 if (!m_iMob.empty()) m_iMob[k][j][i] = m_iMob[k][j][i - 1];
1656 if (!m_iDis.empty()) m_iDis[k][j][i] = m_iDis[k][j][i - 1];
1657 if (!m_iDifL.empty()) m_iDifL[k][j][i] = m_iDifL[k][j][i - 1];
1658 if (!m_iDifT.empty()) m_iDifT[k][j][i] = m_iDifT[k][j][i - 1];
1659 for (auto& dif : m_eDifM) dif[k][j][i] = dif[k][j][i - 1];
1660 for (auto& exc : m_excRates) exc[k][j][i] = exc[k][j][i - 1];
1661 for (auto& ion : m_ionRates) ion[k][j][i] = ion[k][j][i - 1];
1662 }
1663 }
1664 }
1665}

Referenced by MergeGasFile().

◆ IsGas()

bool Garfield::MediumGas::IsGas ( ) const
inlineoverridevirtual

Is this medium a gas?

Reimplemented from Garfield::Medium.

Definition at line 102 of file MediumGas.hh.

102{ return true; }

◆ LoadGasFile()

bool Garfield::MediumGas::LoadGasFile ( const std::string & filename,
const bool quiet = false )

Read table of gas properties (transport parameters) from file.

Definition at line 323 of file MediumGas.cc.

324 {
325
326 // -----------------------------------------------------------------------
327 // GASGET
328 // -----------------------------------------------------------------------
329 // Open the file.
330 std::ifstream gasfile(filename);
331 // Make sure the file could be opened.
332 if (!gasfile) {
333 std::cerr << m_className << "::LoadGasFile:\n"
334 << " Cannot open file " << filename << ".\n";
335 return false;
336 }
337 if (!quiet || m_debug) {
338 std::cout << m_className << "::LoadGasFile:\n"
339 << " Reading file " << filename << ".\n";
340 }
341
342 ResetTables();
343
344 // Start reading the data.
345 if (m_debug) std::cout << " Reading header.\n";
346 int version = 12;
347 // GASOK bits
348 std::bitset<20> gasok;
349 // Gas composition
350 constexpr int nMagboltzGases = 60;
351 std::vector<double> mixture(nMagboltzGases, 0.);
352 if (!ReadHeader(gasfile, version, gasok, m_tab2d, mixture,
354 gasfile.close();
355 return false;
356 }
357 if (!quiet) std::cout << " Version " << version << ".\n";
358
359 // Check the gas mixture.
360 std::vector<std::string> gasnames;
361 std::vector<double> percentages;
362 if (!GetMixture(mixture, version, gasnames, percentages)) {
363 std::cerr << m_className << "::LoadGasFile:\n "
364 << "Cannot determine the gas composition.\n";
365 gasfile.close();
366 return false;
367 }
368
369 m_name = "";
370 m_nComponents = gasnames.size();
371 m_w = 0.;
372 m_fano = 0.;
373 for (unsigned int i = 0; i < m_nComponents; ++i) {
374 if (i > 0) m_name += "/";
375 m_name += gasnames[i];
376 m_gas[i] = gasnames[i];
377 m_fraction[i] = percentages[i] / 100.;
378 double w = 0., f = 0.;
379 GetGasInfo(m_gas[i], m_atWeight[i], m_atNum[i], w, f);
380 m_w += w * m_fraction[i];
381 m_fano += f * m_fraction[i];
382 }
383 if (!quiet) {
384 std::cout << " Gas composition set to " << m_name;
385 if (m_nComponents > 1) {
386 std::cout << " (" << m_fraction[0] * 100;
387 for (unsigned int i = 1; i < m_nComponents; ++i) {
388 std::cout << "/" << m_fraction[i] * 100;
389 }
390 std::cout << ")";
391 }
392 std::cout << ".\n";
393 }
394
395 const int nE = m_eFields.size();
396 const int nB = m_bFields.size();
397 const int nA = m_bAngles.size();
398 if (m_debug) {
399 std::cout << " " << nE << " electric field(s), " << nB
400 << " magnetic field(s), " << nA << " angle(s).\n";
401 }
402
403 // Decode the GASOK bits.
404 // GASOK(I) : .TRUE. if present
405 // (1) electron drift velocity || E
406 // (2) ion mobility,
407 // (3) longitudinal diffusion || E
408 // (4) Townsend coefficient,
409 // (5) cluster size distribution.
410 // (6) attachment coefficient,
411 // (7) Lorentz angle,
412 // (8) transverse diffusion || ExB and Bt
413 // (9) electron drift velocity || Bt
414 // (10) electron drift velocity || ExB
415 // (11) diffusion tensor
416 // (12) ion dissociation
417 // (13) allocated for SRIM data (not used)
418 // (14) allocated for HEED data (not used)
419 // (15) excitation rates
420 // (16) ionisation rates
421
422 if (gasok[0]) Init(nE, nB, nA, m_eVelE, 0.);
423 if (gasok[1]) Init(nE, nB, nA, m_iMob, 0.);
424 if (gasok[2]) Init(nE, nB, nA, m_eDifL, 0.);
425 if (gasok[3]) {
426 Init(nE, nB, nA, m_eAlp, -30.);
427 Init(nE, nB, nA, m_eAlp0, -30.);
428 }
429 if (gasok[5]) Init(nE, nB, nA, m_eAtt, -30.);
430 if (gasok[6]) Init(nE, nB, nA, m_eLor, -30.);
431 if (gasok[7]) Init(nE, nB, nA, m_eDifT, 0.);
432 if (gasok[8]) Init(nE, nB, nA, m_eVelB, 0.);
433 if (gasok[9]) Init(nE, nB, nA, m_eVelX, 0.);
434 if (gasok[10]) Init(nE, nB, nA, 6, m_eDifM, 0.);
435 if (gasok[11]) Init(nE, nB, nA, m_iDis, -30.);
436 if (gasok[14]) Init(nE, nB, nA, m_excLevels.size(), m_excRates, 0.);
437 if (gasok[15]) Init(nE, nB, nA, m_ionLevels.size(), m_ionRates, 0.);
438
439 // Force re-initialisation of collision rates etc.
440 m_isChanged = true;
441
442 if (m_debug) {
443 const std::string fmt = m_tab2d ? "3D" : "1D";
444 std::cout << " Reading " << fmt << " table.\n";
445 }
446
447 // Drift velocity along E, Bt and ExB
448 double ve = 0., vb = 0., vx = 0.;
449 // Lorentz angle
450 double lor = 0.;
451 // Longitudinal and transverse diffusion coefficients
452 double dl = 0., dt = 0.;
453 // Townsend and attachment coefficients
454 double alpha = 0., alpha0 = 0., eta = 0.;
455 // Ion mobility and dissociation coefficient
456 double mu = 0., dis = 0.;
457 // Diffusion tensor.
458 std::array<double, 6> diff;
459 // Excitation and ionization rates.
460 const unsigned int nexc = m_excLevels.size();
461 std::vector<double> rexc(nexc, 0.);
462 const unsigned int nion = m_ionLevels.size();
463 std::vector<double> rion(nion, 0.);
464 for (int i = 0; i < nE; i++) {
465 for (int j = 0; j < nA; j++) {
466 for (int k = 0; k < nB; k++) {
467 if (m_tab2d) {
468 ReadRecord3D(gasfile, ve, vb, vx, dl, dt, alpha, alpha0, eta, mu,
469 lor, dis, diff, rexc, rion);
470 } else {
471 ReadRecord1D(gasfile, ve, vb, vx, dl, dt, alpha, alpha0, eta, mu,
472 lor, dis, diff, rexc, rion);
473 }
474 if (!m_eVelE.empty()) m_eVelE[j][k][i] = ve;
475 if (!m_eVelB.empty()) m_eVelB[j][k][i] = vb;
476 if (!m_eVelX.empty()) m_eVelX[j][k][i] = vx;
477 if (!m_eDifL.empty()) m_eDifL[j][k][i] = dl;
478 if (!m_eDifT.empty()) m_eDifT[j][k][i] = dt;
479 if (!m_eAlp.empty()) {
480 m_eAlp[j][k][i] = alpha;
481 m_eAlp0[j][k][i] = alpha0;
482 }
483 if (!m_eAtt.empty()) m_eAtt[j][k][i] = eta;
484 if (!m_iMob.empty()) m_iMob[j][k][i] = mu;
485 if (!m_eLor.empty()) m_eLor[j][k][i] = lor;
486 if (!m_iDis.empty()) m_iDis[j][k][i] = dis;
487 if (!m_eDifM.empty()) {
488 for (int l = 0; l < 6; l++) {
489 m_eDifM[l][j][k][i] = diff[l];
490 }
491 }
492 if (!m_excRates.empty()) {
493 for (unsigned int l = 0; l < nexc; ++l) {
494 m_excRates[l][j][k][i] = rexc[l];
495 }
496 }
497 if (!m_ionRates.empty()) {
498 for (unsigned int l = 0; l < nion; ++l) {
499 m_ionRates[l][j][k][i] = rion[l];
500 }
501 }
502 }
503 }
504 }
505
506 // Extrapolation methods
507 std::array<unsigned int, 13> extrapH = {{0}};
508 std::array<unsigned int, 13> extrapL = {{1}};
509 // Interpolation methods
510 std::array<unsigned int, 13> interp = {{2}};
511 // Ion diffusion coefficients.
512 double ionDiffL = 0.;
513 double ionDiffT = 0.;
514 // Gas pressure [Torr] and temperature [K].
515 double pgas = 0.;
516 double tgas = 0.;
517 // Moving on to the file footer
518 gasfile.ignore(std::numeric_limits<std::streamsize>::max(), '\n');
519 if (m_debug) std::cout << " Reading footer.\n";
520 ReadFooter(gasfile, extrapH, extrapL, interp,
521 m_eThrAlp, m_eThrAtt, m_iThrDis, ionDiffL, ionDiffT, pgas, tgas);
522 gasfile.close();
523
524 // Decrement the threshold indices (compatibility with Fortran).
525 if (m_eThrAlp > 0) --m_eThrAlp;
526 if (m_eThrAtt > 0) --m_eThrAtt;
527 if (m_iThrDis > 0) --m_iThrDis;
528
529 // Set the reference pressure and temperature.
530 if (pgas > 0.) m_pressure = m_pressureTable = pgas;
531 if (tgas > 0.) m_temperature = m_temperatureTable = tgas;
532
533 // Multiply the E/p values by the pressure.
534 for (auto& field : m_eFields) field *= m_pressureTable;
535
536 // Scale the parameters.
537 const double sqrp = sqrt(m_pressureTable);
538 const double logp = log(m_pressureTable);
539 for (int i = nE; i--;) {
540 for (int j = nA; j--;) {
541 for (int k = nB; k--;) {
542 if (!m_eDifL.empty()) m_eDifL[j][k][i] /= sqrp;
543 if (!m_eDifT.empty()) m_eDifT[j][k][i] /= sqrp;
544 if (!m_eDifM.empty()) {
545 for (int l = 6; l--;) m_eDifM[l][j][k][i] /= m_pressureTable;
546 }
547 if (!m_eAlp.empty()) {
548 m_eAlp[j][k][i] += logp;
549 m_eAlp0[j][k][i] += logp;
550 }
551 if (!m_eAtt.empty()) m_eAtt[j][k][i] += logp;
552 if (!m_iDis.empty()) m_iDis[j][k][i] += logp;
553 /*
554 for (auto& exc : m_excRates) {
555 exc[j][k][i] /= m_pressureTable;
556 }
557 for (auto& ion : m_ionRates) {
558 ion[j][k][i] /= m_pressureTable;
559 }
560 */
561 }
562 }
563 }
564
565 // Decode the extrapolation and interpolation tables.
566 m_extrVel = {extrapL[0], extrapH[0]};
567 // Indices 1 and 2 correspond to velocities along Bt and ExB.
568 m_extrDif = {extrapL[3], extrapH[3]};
569 m_extrAlp = {extrapL[4], extrapH[4]};
570 m_extrAtt = {extrapL[5], extrapH[5]};
571 m_extrMob = {extrapL[6], extrapH[6]};
572 m_extrLor = {extrapL[7], extrapH[7]};
573 // Index 8: transverse diffusion.
574 m_extrDis = {extrapL[9], extrapH[9]};
575 // Index 10: diff. tensor
576 m_extrExc = {extrapL[11], extrapH[11]};
577 m_extrIon = {extrapL[12], extrapH[12]};
578 m_intpVel = interp[0];
579 m_intpDif = interp[3];
580 m_intpAlp = interp[4];
581 m_intpAtt = interp[5];
582 m_intpMob = interp[6];
583 m_intpLor = interp[7];
584 m_intpDis = interp[9];
585 m_intpExc = interp[11];
586 m_intpIon = interp[12];
587
588 // Ion diffusion
589 if (ionDiffL > 0.) Init(nE, nB, nA, m_iDifL, ionDiffL);
590 if (ionDiffT > 0.) Init(nE, nB, nA, m_iDifT, ionDiffT);
591
592 if (m_debug) std::cout << " Done.\n";
593
594 return true;
595}
void ReadRecord3D(std::ifstream &gasfile, double &ve, double &vb, double &vx, double &dl, double &dt, double &alpha, double &alpha0, double &eta, double &mu, double &lor, double &dis, std::array< double, 6 > &dif, std::vector< double > &rexc, std::vector< double > &rion)
Definition MediumGas.cc:778
std::pair< unsigned int, unsigned int > m_extrIon
Definition MediumGas.hh:211
unsigned int m_intpIon
Definition MediumGas.hh:213
void ResetTables() override
Reset all tables of transport parameters.
void ReadFooter(std::ifstream &gasfile, std::array< unsigned int, 13 > &extrapH, std::array< unsigned int, 13 > &extrapL, std::array< unsigned int, 13 > &interp, unsigned int &thrAlp, unsigned int &thrAtt, unsigned int &thrDis, double &ionDiffL, double &ionDiffT, double &pgas, double &tgas)
Definition MediumGas.cc:836
void ReadRecord1D(std::ifstream &gasfile, double &ve, double &vb, double &vx, double &dl, double &dt, double &alpha, double &alpha0, double &eta, double &mu, double &lor, double &dis, std::array< double, 6 > &dif, std::vector< double > &rexc, std::vector< double > &rion)
Definition MediumGas.cc:812
bool GetMixture(const std::vector< double > &mixture, const int version, std::vector< std::string > &gasnames, std::vector< double > &percentages) const
Definition MediumGas.cc:918
std::pair< unsigned int, unsigned int > m_extrExc
Definition MediumGas.hh:210
bool ReadHeader(std::ifstream &gasfile, int &version, std::bitset< 20 > &gasok, bool &is3d, std::vector< double > &mixture, std::vector< double > &efields, std::vector< double > &bfields, std::vector< double > &angles, std::vector< ExcLevel > &excLevels, std::vector< IonLevel > &ionLevels)
Definition MediumGas.cc:597
unsigned int m_intpExc
Definition MediumGas.hh:212
unsigned int m_intpMob
Definition Medium.hh:629
unsigned int m_intpDis
Definition Medium.hh:630
unsigned int m_intpDif
Definition Medium.hh:625
std::pair< unsigned int, unsigned int > m_extrAtt
Definition Medium.hh:618
std::pair< unsigned int, unsigned int > m_extrVel
Definition Medium.hh:615
void Init(const size_t nE, const size_t nB, const size_t nA, std::vector< std::vector< std::vector< double > > > &tab, const double val)
Definition Medium.cc:1408
unsigned int m_intpVel
Definition Medium.hh:624
unsigned int m_intpAtt
Definition Medium.hh:627
std::pair< unsigned int, unsigned int > m_extrDis
Definition Medium.hh:621
std::pair< unsigned int, unsigned int > m_extrAlp
Definition Medium.hh:617
unsigned int m_eThrAtt
Definition Medium.hh:609
std::pair< unsigned int, unsigned int > m_extrLor
Definition Medium.hh:619
unsigned int m_intpLor
Definition Medium.hh:628
std::pair< unsigned int, unsigned int > m_extrDif
Definition Medium.hh:616
unsigned int m_iThrDis
Definition Medium.hh:612
std::pair< unsigned int, unsigned int > m_extrMob
Definition Medium.hh:620
unsigned int m_eThrAlp
Definition Medium.hh:608
unsigned int m_intpAlp
Definition Medium.hh:626
DoubleAc sqrt(const DoubleAc &f)
Definition DoubleAc.cpp:314

◆ LoadIonMobility()

bool Garfield::MediumGas::LoadIonMobility ( const std::string & filename,
const bool quiet = false )

Read a table of (positive) ion mobilities vs. electric field from file.

Definition at line 2234 of file MediumGas.cc.

2235 {
2236 return LoadMobility(filename, quiet, false);
2237}
bool LoadMobility(const std::string &filename, const bool quiet, const bool negative)

◆ LoadMobility()

bool Garfield::MediumGas::LoadMobility ( const std::string & filename,
const bool quiet,
const bool negative )
protected

Definition at line 2244 of file MediumGas.cc.

2245 {
2246 // Open the file.
2247 std::ifstream infile(filename);
2248 // Make sure the file could actually be opened.
2249 if (!infile) {
2250 std::cerr << m_className << "::LoadMobility:\n"
2251 << " Cannot open file " << filename << ".\n";
2252 return false;
2253 } else if (m_debug) {
2254 std::cout << m_className << "::LoadMobility: Opened " << filename
2255 << " for reading.\n";
2256 }
2257
2258 std::vector<std::pair<double, double> > data;
2259 // Read the file line by line.
2260 int i = 0;
2261 for (std::string line; std::getline(infile, line);) {
2262 ++i;
2263 if (line.empty()) continue;
2264 // Skip comments.
2265 if (startsWith(line, "//") || startsWith(line, "#")) continue;
2266 auto words = tokenize(line);
2267 if (words.size() < 2) {
2268 std::cout << m_className << "::LoadMobility: Skipping line "
2269 << i << ".\n";
2270 continue;
2271 }
2272 const double field = std::stod(words[0]);
2273 const double mu = std::stod(words[1]);
2274 if (m_debug) {
2275 std::cout << " E/N = " << field << " Td: mu = " << mu << " cm2/(Vs)\n";
2276 }
2277 // Make sure the values make sense.
2278 // Negative field values are not allowed.
2279 if (field < 0.) {
2280 std::cerr << m_className << "::LoadMobility:\n"
2281 << " Negative electric field (line " << i << ").\n";
2282 return false;
2283 }
2284 // Add the values to the list.
2285 data.push_back(std::make_pair(field, mu));
2286 }
2287 infile.close();
2288
2289 if (data.empty()) {
2290 std::cerr << m_className << "::LoadMobility: No valid data found.\n";
2291 return false;
2292 }
2293 // Sort by electric field.
2294 std::sort(data.begin(), data.end());
2295
2296 const double pr = m_pressureTable / AtmosphericPressure;
2297 const double tr = m_temperatureTable / ZeroCelsius;
2298 // The E/N values in the file are supposed to be in Td (10^-17 V cm2).
2299 const double scaleField = 1.e-17 * LoschmidtNumber * pr / tr;
2300 // The reduced mobilities in the file are supposed to be in cm2/(V s).
2301 const double scaleMobility = 1.e-9 * tr / pr;
2302
2303 const size_t ne = data.size();
2304 std::vector<double> efields(ne, 0.);
2305 std::vector<double> mobilities(ne, 0.);
2306 for (size_t j = 0; j < ne; ++j) {
2307 // Scale the fields and mobilities.
2308 efields[j] = data[j].first * scaleField;
2309 mobilities[j] = data[j].second * scaleMobility;
2310 }
2311 if (!quiet) {
2312 std::cout << m_className << "::LoadMobility:\n"
2313 << " Read " << ne << " values from file " << filename << "\n";
2314 }
2315 return SetIonMobility(efields, mobilities, negative);
2316}
bool SetIonMobility(const std::vector< double > &fields, const std::vector< double > &mobilities, const bool negativeIons=false)
Definition Medium.cc:1139
std::vector< std::string > tokenize(const std::string &line)
Definition Utilities.hh:25
bool startsWith(const std::string &line, const std::string &s)
Definition Utilities.hh:34

Referenced by LoadIonMobility(), and LoadNegativeIonMobility().

◆ LoadNegativeIonMobility()

bool Garfield::MediumGas::LoadNegativeIonMobility ( const std::string & filename,
const bool quiet = false )

Read a table of negative ion mobilities vs. electric field from file.

Definition at line 2239 of file MediumGas.cc.

2240 {
2241 return LoadMobility(filename, quiet, true);
2242}

◆ MergeGasFile()

bool Garfield::MediumGas::MergeGasFile ( const std::string & filename,
const bool replaceOld )

Read table of gas properties from and merge with the existing dataset.

Definition at line 955 of file MediumGas.cc.

956 {
957
958 // -----------------------------------------------------------------------
959 // GASMRG - Merges gas data from a file with existing gas tables.
960 // (Last changed on 16/ 2/11.)
961 // -----------------------------------------------------------------------
962
963 constexpr double eps = 1.e-3;
964 // Open the file.
965 std::ifstream gasfile(filename);
966 // Make sure the file could be opened.
967 if (!gasfile) {
968 std::cerr << m_className << "::MergeGasFile:\n"
969 << " Cannot open file " << filename << ".\n";
970 return false;
971 }
972
973 int version = 12;
974 std::bitset<20> gasok;
975 bool new3d = false;
976 constexpr int nMagboltzGases = 60;
977 std::vector<double> mixture(nMagboltzGases, 0.);
978 std::vector<double> efields;
979 std::vector<double> bfields;
980 std::vector<double> angles;
981 std::vector<ExcLevel> excLevels;
982 std::vector<IonLevel> ionLevels;
983 if (!ReadHeader(gasfile, version, gasok, new3d, mixture, efields, bfields,
984 angles, excLevels, ionLevels)) {
985 std::cerr << m_className << "::MergeGasFile: Error reading header.\n";
986 gasfile.close();
987 return false;
988 }
989 // Check the version.
990 if (version != 12) {
991 std::cout << m_className << "::MergeGasFile:\n "
992 << "This dataset cannot be read because of a change in format.\n";
993 gasfile.close();
994 return false;
995 }
996
997 // Check the gas composition.
998 std::vector<std::string> gasnames;
999 std::vector<double> percentages;
1000 if (!GetMixture(mixture, version, gasnames, percentages)) {
1001 std::cerr << m_className << "::MergeGasFile:\n "
1002 << "Cannot determine the gas composition.\n";
1003 gasfile.close();
1004 return false;
1005 }
1006 if (m_nComponents != gasnames.size()) {
1007 std::cerr << m_className << "::MergeGasFile:\n "
1008 << "Composition of the dataset differs from the present one.\n";
1009 gasfile.close();
1010 return false;
1011 }
1012
1013 for (unsigned int i = 0; i < m_nComponents; ++i) {
1014 const auto it = std::find(gasnames.begin(), gasnames.end(), m_gas[i]);
1015 if (it == gasnames.end()) {
1016 std::cerr << m_className << "::MergeGasFile:\n "
1017 << "Composition of the dataset differs from the present one.\n";
1018 gasfile.close();
1019 return false;
1020 }
1021 const double f2 = m_fraction[i];
1022 const double f1 = 0.01 * percentages[it - gasnames.begin()];
1023 if (fabs(f1 - f2) > 1.e-6 * (1. + fabs(f1) + fabs(f2))) {
1024 std::cerr << m_className << "::MergeGasFile:\n "
1025 << "Percentages of " << m_gas[i] << " differ.\n";
1026 gasfile.close();
1027 return false;
1028 }
1029 }
1030
1031 // Check that the excitations and ionisations match.
1032 const unsigned int nexc = excLevels.size();
1033 const unsigned int nion = ionLevels.size();
1034 bool excMatch = (m_excLevels.size() == nexc);
1035 if (excMatch) {
1036 for (unsigned int i = 0; i < nexc; ++i) {
1037 if (m_excLevels[i].label == excLevels[i].label) continue;
1038 excMatch = false;
1039 break;
1040 }
1041 }
1042 bool ionMatch = (m_ionLevels.size() == nion);
1043 if (ionMatch) {
1044 for (unsigned int i = 0; i < nion; ++i) {
1045 if (m_ionLevels[i].label == ionLevels[i].label) continue;
1046 ionMatch = false;
1047 break;
1048 }
1049 }
1050
1051 // Drift velocity along E, Bt and ExB
1052 double ve = 0., vb = 0., vx = 0.;
1053 // Lorentz angle
1054 double lor = 0.;
1055 // Longitudinal and transverse diffusion coefficients
1056 double dl = 0., dt = 0.;
1057 // Townsend and attachment coefficients
1058 double alpha = 0., alpha0 = 0., eta = 0.;
1059 // Ion mobility and dissociation coefficient
1060 double mu = 0., dis = 0.;
1061 // Diffusion tensor.
1062 std::array<double, 6> diff;
1063 // Excitation and ionization rates.
1064 std::vector<double> rexc(nexc, 0.);
1065 std::vector<double> rion(nion, 0.);
1066 // Loop through the gas tables to fast-forward to the footer.
1067 const unsigned int nNewE = efields.size();
1068 const unsigned int nNewB = bfields.size();
1069 const unsigned int nNewA = angles.size();
1070 for (unsigned int i = 0; i < nNewE; i++) {
1071 for (unsigned int j = 0; j < nNewA; j++) {
1072 for (unsigned int k = 0; k < nNewB; k++) {
1073 if (new3d) {
1074 ReadRecord3D(gasfile, ve, vb, vx, dl, dt, alpha, alpha0, eta, mu,
1075 lor, dis, diff, rexc, rion);
1076 } else {
1077 ReadRecord1D(gasfile, ve, vb, vx, dl, dt, alpha, alpha0, eta, mu,
1078 lor, dis, diff, rexc, rion);
1079 }
1080 }
1081 }
1082 }
1083
1084 // Extrapolation methods
1085 std::array<unsigned int, 13> extrapH = {{0}};
1086 std::array<unsigned int, 13> extrapL = {{1}};
1087 // Interpolation methods
1088 std::array<unsigned int, 13> interp = {{2}};
1089 // Thresholds.
1090 unsigned int thrAlp = 0, thrAtt = 0, thrDis = 0;
1091 // Ion diffusion coefficients.
1092 double ionDiffL = 0., ionDiffT = 0.;
1093 // Gas pressure [Torr] and temperature [K].
1094 double pgas = 0., tgas = 0.;
1095 // Read the footer.
1096 gasfile.ignore(std::numeric_limits<std::streamsize>::max(), '\n');
1097 ReadFooter(gasfile, extrapH, extrapL, interp, thrAlp, thrAtt, thrDis,
1098 ionDiffL, ionDiffT, pgas, tgas);
1099
1100 // Check the pressure and temperature.
1101 if (!Similar(pgas, m_pressureTable, eps)) {
1102 std::cerr << m_className << "::MergeGasFile:\n "
1103 << "The gas pressure of the dataset to be read differs\n "
1104 << "from the current reference pressure; stop.\n";
1105 gasfile.close();
1106 return false;
1107 }
1108 if (!Similar(tgas, m_temperatureTable, eps)) {
1109 std::cerr << m_className << "::MergeGasFile:\n "
1110 << "The gas temperature of the dataset to be read differs\n "
1111 << "from the current reference temperature; stop.\n";
1112 gasfile.close();
1113 return false;
1114 }
1115
1116 // Go back to the start and re-read the header to get to the gas tables.
1117 gasfile.clear();
1118 gasfile.seekg(0);
1119 if (!ReadHeader(gasfile, version, gasok, new3d, mixture, efields, bfields,
1120 angles, excLevels, ionLevels)) {
1121 std::cerr << m_className << "::MergeGasFile: Error re-reading header.\n";
1122 gasfile.close();
1123 return false;
1124 }
1125
1126 // Multiply the E/p values by the pressure.
1127 for (auto& field : efields) field *= pgas;
1128
1129 if (m_debug) {
1130 std::cout << m_className << "::MergeGasFile:\n "
1131 << "Dataset to be merged has the following dimensions:\n "
1132 << "3D = " << new3d << " nE = " << nNewE << ", nB = " << nNewB
1133 << ", nA = " << nNewA << ", nExc = "
1134 << excLevels.size() << ", nIon = " << ionLevels.size() << "\n";
1135 }
1136
1137 unsigned int nE = m_eFields.size();
1138 unsigned int nB = m_bFields.size();
1139 unsigned int nA = m_bAngles.size();
1140 // Determine which mode we have to use for the E field.
1141 const int iemode = Equal(efields, m_eFields, eps);
1142 // Determine which mode we have to use for the angles.
1143 const int iamode = Equal(angles, m_bAngles, eps);
1144 // Determine which mode we have to use for the B field.
1145 const int ibmode = Equal(bfields, m_bFields, eps);
1146 if (m_debug) {
1147 std::cout << m_className << "::MergeGasFile:\n";
1148 if (iemode == 0) std::cout << " The E vectors differ.\n";
1149 else std::cout << " The E vectors are identical.\n";
1150 if (iamode == 0) std::cout << " The angle vectors differ.\n";
1151 else std::cout << " The angle vectors are identical.\n";
1152 if (ibmode == 0) std::cout << " The B vectors differ.\n";
1153 else std::cout << " The B vectors are identical.\n";
1154 }
1155 // Ensure there is a common mode.
1156 if (iemode + iamode + ibmode < 2) {
1157 std::cerr << m_className << "::MergeGasFile:\n Existing data and data "
1158 << "in the file don't have two common axes; not merged.\n";
1159 gasfile.close();
1160 return false;
1161 }
1162 // Decide whether we have to produce a 3D table or a 1D table.
1163 const bool old3d = m_tab2d;
1164 if ((new3d || ibmode * iamode == 0) && !m_tab2d) {
1165 if (m_debug) std::cout << " Expanding existing table to 3D mode.\n";
1166 m_tab2d = true;
1167 }
1168
1169 // Determine which data are currently present.
1170 std::bitset<20> existing;
1171 GetGasBits(existing);
1172 // If the grids don't match, warn for data being lost in the merge.
1173 if (iemode * ibmode * iamode == 0) {
1174 // Check for data currently present which are absent in the new data.
1175 if (existing[0] && !gasok[0]) {
1176 existing.reset(0);
1177 m_eVelE.clear();
1178 PrintAbsentInNew("drift velocity");
1179 }
1180 if (existing[1] && !gasok[1]) {
1181 existing.reset(1);
1182 m_iMob.clear();
1183 PrintAbsentInNew("ion mobility");
1184 }
1185 if (existing[2] && !gasok[2]) {
1186 existing.reset(2);
1187 m_eDifL.clear();
1188 PrintAbsentInNew("longitudinal diffusion");
1189 }
1190 if (existing[3] && !gasok[3]) {
1191 existing.reset(3);
1192 m_eAlp.clear();
1193 PrintAbsentInNew("Townsend coefficient");
1194 }
1195 if (existing[5] && !gasok[5]) {
1196 existing.reset(5);
1197 m_eAtt.clear();
1198 PrintAbsentInNew("attachment coefficient");
1199 }
1200 if (existing[6] && !gasok[6]) {
1201 existing.reset(6);
1202 m_eLor.clear();
1203 PrintAbsentInNew("Lorentz angle");
1204 }
1205 if (existing[7] && !gasok[7]) {
1206 existing.reset(7);
1207 m_eDifT.clear();
1208 PrintAbsentInNew("transverse diffusion");
1209 }
1210 if (existing[8] && !gasok[8]) {
1211 existing.reset(8);
1212 m_eVelB.clear();
1213 PrintAbsentInNew("velocity along Bt");
1214 }
1215 if (existing[9] && !gasok[9]) {
1216 existing.reset(9);
1217 m_eVelX.clear();
1218 PrintAbsentInNew("velocity along ExB");
1219 }
1220 if (existing[10] && !gasok[10]) {
1221 existing.reset(10);
1222 m_eDifM.clear();
1223 PrintAbsentInNew("diffusion tensor");
1224 }
1225 if (existing[11] && !gasok[11]) {
1226 existing.reset(11);
1227 m_iDis.clear();
1228 PrintAbsentInNew("ion dissociation data");
1229 }
1230 if (existing[14] && !gasok[14]) {
1231 existing.reset(14);
1232 m_excLevels.clear();
1233 m_excRates.clear();
1234 PrintAbsentInNew("excitation data");
1235 }
1236 if (existing[15] && !gasok[15]) {
1237 existing.reset(15);
1238 m_ionLevels.clear();
1239 m_ionRates.clear();
1240 PrintAbsentInNew("ionisation data");
1241 }
1242 // And for data present in the file but not currently present.
1243 if (!existing[0] && gasok[0]) {
1244 gasok.reset(0);
1245 PrintAbsentInExisting("drift velocity");
1246 }
1247 if (!existing[1] && gasok[1]) {
1248 gasok.reset(1);
1249 PrintAbsentInExisting("ion mobility");
1250 }
1251 if (!existing[2] && gasok[2]) {
1252 gasok.reset(2);
1253 PrintAbsentInExisting("longitudinal diffusion");
1254 }
1255 if (!existing[3] && gasok[3]) {
1256 gasok.reset(3);
1257 PrintAbsentInExisting("Townsend coefficient");
1258 }
1259 if (!existing[5] && gasok[5]) {
1260 gasok.reset(5);
1261 PrintAbsentInExisting("attachment coefficient");
1262 }
1263 if (!existing[6] && gasok[6]) {
1264 if (old3d) {
1265 gasok.reset(6);
1266 PrintAbsentInExisting("Lorentz angle");
1267 } else {
1268 // Existing dataset is for B = 0 (no Lorentz angle).
1269 Init(nE, nB, nA, m_eLor, -30.);
1270 existing.set(6);
1271 }
1272 }
1273 if (!existing[7] && gasok[7]) {
1274 gasok.reset(7);
1275 PrintAbsentInExisting("transverse diffusion");
1276 }
1277 if (!existing[8] && gasok[8]) {
1278 if (old3d) {
1279 gasok.reset(8);
1280 PrintAbsentInExisting("velocity along Bt");
1281 } else {
1282 // Existing dataset is for B = 0 (no velocity component || Bt).
1283 Init(nE, nB, nA, m_eVelB, 0.);
1284 existing.set(8);
1285 }
1286 }
1287 if (!existing[9] && gasok[9]) {
1288 if (old3d) {
1289 gasok.reset(9);
1290 PrintAbsentInExisting("velocity along ExB");
1291 } else {
1292 // Existing dataset is for B = 0 (no velocity component || ExB).
1293 Init(nE, nB, nA, m_eVelX, 0.);
1294 existing.set(9);
1295 }
1296 }
1297 if (!existing[10] && gasok[10]) {
1298 gasok.reset(10);
1299 PrintAbsentInExisting("diffusion tensor");
1300 }
1301 if (!existing[11] && gasok[11]) {
1302 gasok.reset(11);
1303 PrintAbsentInExisting("ion dissociation data");
1304 }
1305 if (!existing[14] && gasok[14]) {
1306 gasok.reset(14);
1307 PrintAbsentInExisting("excitation data");
1308 }
1309 if (!existing[15] && gasok[15]) {
1310 gasok.reset(15);
1311 PrintAbsentInExisting("ionisation data");
1312 }
1313 if (existing[14] && gasok[14] && !excMatch) {
1314 std::cerr << " Excitation levels of the two datasets don't match.\n"
1315 << " Deleting excitation data.\n";
1316 m_excLevels.clear();
1317 m_excRates.clear();
1318 existing.reset(14);
1319 gasok.reset(14);
1320 }
1321 if (existing[15] && gasok[15] && !ionMatch) {
1322 std::cerr << " Ionisation levels of the two datasets don't match.\n"
1323 << " Deleting ionisation data.\n";
1324 m_ionLevels.clear();
1325 m_ionRates.clear();
1326 existing.reset(15);
1327 gasok.reset(15);
1328 }
1329 } else {
1330 // If the grids are identical, initialise the tables that are only present
1331 // in the new dataset but not in existing one.
1332 if (gasok[0] && !existing[0]) Init(nE, nB, nA, m_eVelE, 0.);
1333 if (gasok[1] && !existing[1]) Init(nE, nB, nA, m_iMob, 0.);
1334 if (gasok[2] && !existing[2]) Init(nE, nB, nA, m_eDifL, 0.);
1335 if (gasok[3] && !existing[3]) {
1336 Init(nE, nB, nA, m_eAlp, -30.);
1337 Init(nE, nB, nA, m_eAlp0, -30.);
1338 }
1339 if (gasok[5] && !existing[5]) Init(nE, nB, nA, m_eAtt, -30.);
1340 if (gasok[6] && !existing[6]) Init(nE, nB, nA, m_eLor, -30.);
1341 if (gasok[7] && !existing[7]) Init(nE, nB, nA, m_eDifT, 0.);
1342 if (gasok[8] && !existing[8]) Init(nE, nB, nA, m_eVelB, 0.);
1343 if (gasok[9] && !existing[9]) Init(nE, nB, nA, m_eVelX, 0.);
1344 if (gasok[10] && !existing[10]) Init(nE, nB, nA, 6, m_eDifM, 0.);
1345 if (gasok[11] && !existing[11]) Init(nE, nB, nA, m_iDis, -30.);
1346 if (gasok[14] && (!existing[14] || replaceOld)) {
1347 Init(nE, nB, nA, nexc, m_excRates, 0.);
1348 }
1349 if (gasok[15] && (!existing[15] || replaceOld)) {
1350 Init(nE, nB, nA, nion, m_ionRates, 0.);
1351 }
1352 }
1353
1354 // Initialise the "new" flags.
1355 std::vector<bool> newE(nE, false);
1356 std::vector<bool> newA(nA, false);
1357 std::vector<bool> newB(nB, false);
1358 // Extend the existing tables.
1359 std::cout << m_className << "::MergeGasFile: Extending the tables.\n";
1360 // Insert room in the tables for new columns in E.
1361 if (iemode == 0) {
1362 // Loop over the new values.
1363 for (const auto efield : efields) {
1364 // Loop over the old values.
1365 bool found = false;
1366 for (unsigned int j = 0; j < nE; ++j) {
1367 // If it overlaps with existing E, either keep old or new data.
1368 if (Similar(efield, m_eFields[j], eps)) {
1369 if (replaceOld) {
1370 std::cout << " Replacing existing data for E = "
1371 << m_eFields[j] << " V/cm by data from file.\n";
1372 m_eFields[j] = efield;
1373 newE[j] = true;
1374 ZeroRowE(j, nB, nA);
1375 } else {
1376 std::cout << " Keeping existing data for E = " << m_eFields[j]
1377 << " V/cm, not using data from the file.\n";
1378 }
1379 found = true;
1380 break;
1381 } else if (efield < m_eFields[j]) {
1382 // Otherwise shift all data at higher E values.
1383 if (m_debug) {
1384 std::cout << " Inserting E = " << efield
1385 << " V/cm at slot " << j << ".\n";
1386 }
1387 InsertE(j, nE, nB, nA);
1388 m_eFields.insert(m_eFields.begin() + j, efield);
1389 newE.insert(newE.begin() + j, true);
1390 ZeroRowE(j, nB, nA);
1391 ++nE;
1392 found = true;
1393 break;
1394 }
1395 }
1396 if (found) continue;
1397 // If there is no higher E, then add the line at the end.
1398 if (m_debug) {
1399 std::cout << " Adding E = " << efield << " V/cm at the end.\n";
1400 }
1401 InsertE(nE, nE, nB, nA);
1402 m_eFields.push_back(efield);
1403 newE.push_back(true);
1404 ZeroRowE(nE, nB, nA);
1405 ++nE;
1406 }
1407 }
1408 // Insert room in the tables for new columns in B.
1409 if (ibmode == 0) {
1410 // Loop over the new values.
1411 for (const auto bfield : bfields) {
1412 // Loop over the old values.
1413 bool found = false;
1414 for (unsigned int j = 0; j < nB; ++j) {
1415 // If it overlaps with existing B, either keep old or new data.
1416 if (Similar(bfield, m_bFields[j], eps)) {
1417 if (replaceOld) {
1418 std::cout << " Replacing old data for B = " << m_bFields[j]
1419 << " T by data from file.\n";
1420 m_bFields[j] = bfield;
1421 newB[j] = true;
1422 ZeroRowB(j, nE, nA);
1423 } else {
1424 std::cout << " Keeping old data for B = " << m_bFields[j]
1425 << " T, not using data from file.\n";
1426 }
1427 found = true;
1428 break;
1429 } else if (bfield < m_bFields[j]) {
1430 // Otherwise shift all data at higher B values.
1431 if (m_debug) {
1432 std::cout << " Inserting B = " << bfield << " T at slot "
1433 << j << ".\n";
1434 }
1435 InsertB(j, nE, nB, nA);
1436 m_bFields.insert(m_bFields.begin() + j, bfield);
1437 newB.insert(newB.begin() + j, true);
1438 ZeroRowB(j, nE, nA);
1439 ++nB;
1440 found = true;
1441 break;
1442 }
1443 }
1444 if (found) continue;
1445 // If there is no higher B, then add the line at the end.
1446 if (m_debug) {
1447 std::cout << " Adding B = " << bfield << " T at the end.\n";
1448 }
1449 InsertB(nB, nE, nB, nA);
1450 m_bFields.push_back(bfield);
1451 newB.push_back(true);
1452 ZeroRowB(nB, nE, nA);
1453 ++nB;
1454 }
1455 }
1456 // Insert room in the tables for new columns in angle.
1457 if (iamode == 0) {
1458 // Loop over the new values.
1459 for (const auto angle : angles) {
1460 // Loop over the old values.
1461 bool found = false;
1462 for (unsigned int j = 0; j < nA; ++j) {
1463 // If it overlaps with an existing angle, either keep old or new data.
1464 if (Similar(angle, m_bAngles[j], eps)) {
1465 if (replaceOld) {
1466 std::cout << " Replacing old data for angle(E,B) = "
1467 << m_bAngles[j] * RadToDegree
1468 << " degrees by data from the file.\n";
1469 m_bAngles[j] = angle;
1470 newA[j] = true;
1471 ZeroRowA(j, nE, nB);
1472 } else {
1473 std::cout << " Keeping old data for angle(E,B) = "
1474 << m_bAngles[j] * RadToDegree
1475 << " degrees, not using data from file.\n";
1476 }
1477 found = true;
1478 break;
1479 } else if (angle < m_bAngles[j]) {
1480 // Otherwise shift all data at higher angles.
1481 if (m_debug) {
1482 std::cout << " Inserting angle = " << angle * RadToDegree
1483 << " degrees at slot " << j << ".\n";
1484 }
1485 InsertA(j, nE, nB, nA);
1486 m_bAngles.insert(m_bAngles.begin() + j, angle);
1487 newA.insert(newA.begin() + j, true);
1488 ZeroRowA(j, nE, nB);
1489 ++nA;
1490 found = true;
1491 break;
1492 }
1493 }
1494 if (found) continue;
1495 // If there is no higher angle, then add the line at the end.
1496 if (m_debug) {
1497 std::cout << " Adding angle = " << angle * RadToDegree
1498 << " degrees at the end.\n";
1499 }
1500 InsertA(nA, nE, nB, nA);
1501 m_bAngles.push_back(angle);
1502 newA.push_back(true);
1503 ZeroRowA(nA, nE, nB);
1504 ++nA;
1505 }
1506 }
1507
1508 const double sqrp = sqrt(pgas);
1509 const double logp = log(pgas);
1510
1511 // Read the gas table.
1512 for (const auto efield : efields) {
1513 // Locate the index at which these values are to be stored.
1514 const int inde = FindIndex(efield, m_eFields, eps);
1515 for (const auto angle : angles) {
1516 const int inda = FindIndex(angle, m_bAngles, eps);
1517 for (const auto bfield : bfields) {
1518 // Read the record.
1519 if (new3d) {
1520 ReadRecord3D(gasfile, ve, vb, vx, dl, dt, alpha, alpha0, eta, mu,
1521 lor, dis, diff, rexc, rion);
1522 } else {
1523 ReadRecord1D(gasfile, ve, vb, vx, dl, dt, alpha, alpha0, eta, mu,
1524 lor, dis, diff, rexc, rion);
1525 }
1526 const int indb = FindIndex(bfield, m_bFields, eps);
1527 if (inde < 0 || inda < 0 || indb < 0) {
1528 std::cerr << m_className << "::MergeGasFile:\n Unable to locate"
1529 << " the (E,angle,B) insertion point; no gas data read.\n";
1530 std::cout << "BFIELD = " << bfield << ", IB = " << indb << "\n";
1531 ResetTables();
1532 gasfile.close();
1533 return false;
1534 }
1535 const bool update = newE[inde] || newA[inda] || newB[indb] || replaceOld;
1536 // Store the data.
1537 if (gasok[0] && (update || !existing[0])) {
1538 m_eVelE[inda][indb][inde] = ve;
1539 }
1540 if (gasok[1] && (update || !existing[1])) {
1541 m_iMob[inda][indb][inde] = mu;
1542 }
1543 if (gasok[2] && (update || !existing[2])) {
1544 m_eDifL[inda][indb][inde] = dl / sqrp;
1545 }
1546 if (gasok[3] && (update || !existing[3])) {
1547 m_eAlp[inda][indb][inde] = alpha + logp;
1548 m_eAlp0[inda][indb][inde] = alpha0 + logp;
1549 }
1550 if (gasok[5] && (update || !existing[5])) {
1551 m_eAtt[inda][indb][inde] = eta + logp;
1552 }
1553 if (gasok[6] && (update || !existing[6])) {
1554 m_eLor[inda][indb][inde] = lor;
1555 }
1556 if (gasok[7] && (update || !existing[7])) {
1557 m_eDifT[inda][indb][inde] = dt / sqrp;
1558 }
1559 if (gasok[8] && (update || !existing[8])) {
1560 m_eVelB[inda][indb][inde] = vb;
1561 }
1562 if (gasok[9] && (update || !existing[9])) {
1563 m_eVelX[inda][indb][inde] = vx;
1564 }
1565 if (gasok[10] && (update || !existing[10])) {
1566 for (unsigned int l = 0; l < 6; ++l) {
1567 m_eDifM[l][inda][indb][inde] = diff[l] / pgas;
1568 }
1569 }
1570 if (gasok[11] && (update || !existing[11])) {
1571 m_iDis[inda][indb][inde] = dis + logp;
1572 }
1573 if (gasok[14] && (update || !existing[14])) {
1574 for (unsigned int l = 0; l < nexc; ++l) {
1575 m_excRates[l][inda][indb][inde] = rexc[l];
1576 }
1577 }
1578 if (gasok[15] && (update || !existing[15])) {
1579 for (unsigned int l = 0; l < nion; ++l) {
1580 m_ionRates[l][inda][indb][inde] = rion[l];
1581 }
1582 }
1583 }
1584 }
1585 }
1586 // if (iemode + iamode + ibmode == 3) { ... }
1587 if (replaceOld) {
1588 if (m_debug) {
1589 std::cout << m_className << "::MergeGasFile: "
1590 << "Replacing extrapolation and interpolation data.\n";
1591 }
1592 if (gasok[0]) m_extrVel = {extrapL[0], extrapH[0]};
1593 if (gasok[1]) m_extrMob = {extrapL[6], extrapH[6]};
1594 if (gasok[2]) m_extrDif = {extrapL[3], extrapH[3]};
1595 if (gasok[3]) m_extrAlp = {extrapL[4], extrapH[4]};
1596 if (gasok[5]) m_extrAtt = {extrapL[5], extrapH[5]};
1597 if (gasok[6]) m_extrLor = {extrapL[7], extrapH[7]};
1598 if (gasok[11]) m_extrDis = {extrapL[9], extrapH[9]};
1599 if (gasok[14]) m_extrExc = {extrapL[11], extrapH[11]};
1600 if (gasok[15]) m_extrIon = {extrapL[12], extrapH[12]};
1601
1602 if (gasok[0]) m_intpVel = interp[0];
1603 if (gasok[1]) m_intpMob = interp[6];
1604 if (gasok[2]) m_intpDif = interp[3];
1605 if (gasok[3]) m_intpAlp = interp[4];
1606 if (gasok[5]) m_intpAtt = interp[5];
1607 if (gasok[6]) m_intpLor = interp[7];
1608 if (gasok[11]) m_intpDis = interp[9];
1609 if (gasok[14]) m_intpExc = interp[11];
1610 if (gasok[15]) m_intpIon = interp[12];
1611
1612 // Ion diffusion.
1613 if (m_debug && (ionDiffL > 0. || ionDiffT > 0.)) {
1614 std::cout << m_className << "::MergeGasFile: Replacing ion diffusion.\n";
1615 }
1616 if (ionDiffL > 0.) Init(nE, nB, nA, m_iDifL, ionDiffL);
1617 if (ionDiffT > 0.) Init(nE, nB, nA, m_iDifT, ionDiffT);
1618 }
1619 // Update the Townsend and attachment threshold indices.
1622 return true;
1623}
void InsertB(const int ib, const int ne, const int nb, const int na)
void GetGasBits(std::bitset< 20 > &gasok) const
void ZeroRowA(const int ia, const int ne, const int nb)
void ZeroRowB(const int ib, const int ne, const int na)
void ZeroRowE(const int ie, const int nb, const int na)
void InsertA(const int ia, const int ne, const int nb, const int na)
void InsertE(const int ie, const int ne, const int nb, const int na)

◆ PrintGas()

void Garfield::MediumGas::PrintGas ( )
virtual

Print information about the present gas mixture and available data.

Reimplemented in Garfield::MediumMagboltz.

Definition at line 2091 of file MediumGas.cc.

2091 {
2092 // Print a summary.
2093 std::cout << m_className << "::PrintGas:\n"
2094 << " Gas composition: " << m_name;
2095 if (m_nComponents > 1) {
2096 std::cout << " (" << m_fraction[0] * 100;
2097 for (unsigned int i = 1; i < m_nComponents; ++i) {
2098 std::cout << "/" << m_fraction[i] * 100;
2099 }
2100 std::cout << ")";
2101 }
2102 std::cout << "\n";
2103 std::cout << " Pressure: " << m_pressure << " Torr\n"
2104 << " Temperature: " << m_temperature << " K\n"
2105 << " Gas file:\n"
2106 << " Pressure: " << m_pressureTable << " Torr\n"
2107 << " Temperature: " << m_temperatureTable << " K\n";
2108 if (m_eFields.size() > 1) {
2109 std::cout << " Electric field range: " << m_eFields[0] << " - "
2110 << m_eFields.back() << " V/cm in " << m_eFields.size() - 1
2111 << " steps.\n";
2112 } else if (m_eFields.size() == 1) {
2113 std::cout << " Electric field: " << m_eFields[0] << " V/cm\n";
2114 } else {
2115 std::cout << " Electric field range: not set\n";
2116 }
2117 if (m_bFields.size() > 1) {
2118 std::cout << " Magnetic field range: " << m_bFields[0] << " - "
2119 << m_bFields.back() << " T in " << m_bFields.size() - 1
2120 << " steps.\n";
2121 } else if (m_bFields.size() == 1) {
2122 std::cout << " Magnetic field: " << m_bFields[0] << " T\n";
2123 } else {
2124 std::cout << " Magnetic field range: not set\n";
2125 }
2126 if (m_bAngles.size() > 1) {
2127 std::cout << " Angular range: " << m_bAngles[0] << " - "
2128 << m_bAngles.back() << " rad in " << m_bAngles.size() - 1
2129 << " steps.\n";
2130 } else if (m_bAngles.size() == 1) {
2131 std::cout << " Angle between E and B: " << m_bAngles[0] << " rad\n";
2132 } else {
2133 std::cout << " Angular range: not set\n";
2134 }
2135
2136 std::cout << " Available electron transport data:\n";
2137 if (!m_eVelE.empty()) {
2138 std::cout << " Velocity along E\n";
2139 }
2140 if (!m_eVelB.empty()) {
2141 std::cout << " Velocity along Bt\n";
2142 }
2143 if (!m_eVelX.empty()) {
2144 std::cout << " Velocity along ExB\n";
2145 }
2146 if (!(m_eVelE.empty() && m_eVelB.empty() &&
2147 m_eVelX.empty())) {
2148 PrintExtrapolation(m_extrVel);
2149 std::cout << " Interpolation order: " << m_intpVel << "\n";
2150 }
2151 if (!m_eDifL.empty()) {
2152 std::cout << " Longitudinal diffusion coefficient\n";
2153 }
2154 if (!m_eDifT.empty()) {
2155 std::cout << " Transverse diffusion coefficient\n";
2156 }
2157 if (!m_eDifM.empty()) {
2158 std::cout << " Diffusion tensor\n";
2159 }
2160 if (!m_eDifL.empty() || !m_eDifT.empty() || !m_eDifM.empty()) {
2161 PrintExtrapolation(m_extrDif);
2162 std::cout << " Interpolation order: " << m_intpDif << "\n";
2163 }
2164 if (!m_eAlp.empty()) {
2165 std::cout << " Townsend coefficient\n";
2166 PrintExtrapolation(m_extrAlp);
2167 std::cout << " Interpolation order: " << m_intpAlp << "\n";
2168 }
2169 if (!m_eAtt.empty()) {
2170 std::cout << " Attachment coefficient\n";
2171 PrintExtrapolation(m_extrAtt);
2172 std::cout << " Interpolation order: " << m_intpAtt << "\n";
2173 }
2174 if (!m_eLor.empty()) {
2175 std::cout << " Lorentz Angle\n";
2176 PrintExtrapolation(m_extrLor);
2177 std::cout << " Interpolation order: " << m_intpLor << "\n";
2178 }
2179 if (!m_excRates.empty()) {
2180 std::cout << " Excitation rates\n";
2181 for (const auto& exc : m_excLevels) {
2182 std::cout << " " << exc.label << "\n";
2183 std::cout << " Energy = " << exc.energy << " eV";
2184 if (exc.prob > 0.) {
2185 std::cout << ", Penning transfer probability = " << exc.prob;
2186 }
2187 std::cout << "\n";
2188 }
2189 PrintExtrapolation(m_extrExc);
2190 std::cout << " Interpolation order: " << m_intpExc << "\n";
2191 }
2192 if (!m_ionRates.empty()) {
2193 std::cout << " Ionisation rates\n";
2194 for (const auto& ion : m_ionLevels) {
2195 std::cout << " " << ion.label << "\n";
2196 std::cout << " Threshold = " << ion.energy << " eV\n";
2197 }
2198 PrintExtrapolation(m_extrIon);
2199 std::cout << " Interpolation order: " << m_intpIon << "\n";
2200 }
2201 if (m_eVelE.empty() && m_eVelB.empty() && m_eVelX.empty() &&
2202 m_eDifL.empty() && m_eDifT.empty() && m_eDifM.empty() &&
2203 m_eAlp.empty() && m_eAtt.empty() && m_excRates.empty() &&
2204 m_ionRates.empty() && m_eLor.empty()) {
2205 std::cout << " none\n";
2206 }
2207
2208 std::cout << " Available ion transport data:\n";
2209 if (!m_iMob.empty()) {
2210 std::cout << " Mobility\n";
2211 PrintExtrapolation(m_extrMob);
2212 std::cout << " Interpolation order: " << m_intpMob << "\n";
2213 }
2214 if (!m_iDifL.empty()) {
2215 std::cout << " Longitudinal diffusion coefficient\n";
2216 }
2217 if (!m_iDifT.empty()) {
2218 std::cout << " Transverse diffusion coefficient\n";
2219 }
2220 if (!m_iDifL.empty() || !m_iDifT.empty()) {
2221 PrintExtrapolation(m_extrDif);
2222 std::cout << " Interpolation order: " << m_intpDif << "\n";
2223 }
2224 if (!m_iDis.empty()) {
2225 std::cout << " Dissociation coefficient\n";
2226 PrintExtrapolation(m_extrDis);
2227 std::cout << " Interpolation order: " << m_intpDis << "\n";
2228 }
2229 if (m_iMob.empty() && m_iDifL.empty() && m_iDifT.empty() && m_iDis.empty()) {
2230 std::cout << " none\n";
2231 }
2232}

Referenced by Garfield::MediumMagboltz::PrintGas().

◆ PrintGases()

void Garfield::MediumGas::PrintGases ( )
static

Print a list of all available gases.

Definition at line 3410 of file MediumGas.cc.

3410 {
3411
3412 constexpr int version = 12;
3413 std::cout << "MediumGas::PrintGases:\n"
3414 << "Gas Aliases\n" << std::string(80, '-') << "\n";
3415 for (int i = 1; i <= 61; ++i) {
3416 if (i == 47) continue;
3417 const std::string gas = i == 58 ? "N2 (Phelps)" : GetGasName(i, version);
3418 if (gas.empty()) continue;
3419 std::cout << std::setw(15) << std::left << gas;
3420 const auto aliases = GetAliases(gas);
3421 size_t count = 0;
3422 for (auto it = aliases.cbegin(); it != aliases.cend(); ++it) {
3423 const auto alias = (*it);
3424 if (count + alias.size() > 63) {
3425 std::cout << "\n" << std::string(15, ' ');
3426 count = 0;
3427 }
3428 std::cout << alias;
3429 count += alias.size();
3430 if (std::next(it) != aliases.cend()) {
3431 std::cout << ", ";
3432 count += 2;
3433 }
3434 }
3435 std::cout << "\n";
3436 }
3437}

◆ ReadFooter()

void Garfield::MediumGas::ReadFooter ( std::ifstream & gasfile,
std::array< unsigned int, 13 > & extrapH,
std::array< unsigned int, 13 > & extrapL,
std::array< unsigned int, 13 > & interp,
unsigned int & thrAlp,
unsigned int & thrAtt,
unsigned int & thrDis,
double & ionDiffL,
double & ionDiffT,
double & pgas,
double & tgas )
protected

Definition at line 836 of file MediumGas.cc.

842 {
843
844 bool done = false;
845 while (!done) {
846 char line[256];
847 gasfile.getline(line, 256);
848 char* token = strtok(line, " :,%=\t");
849 while (token) {
850 if (strcmp(token, "H") == 0) {
851 token = strtok(NULL, " :,%=\t");
852 for (int i = 0; i < 13; i++) {
853 token = strtok(NULL, " :,%=\t");
854 if (token != NULL) extrapH[i] = atoi(token);
855 }
856 } else if (strcmp(token, "L") == 0) {
857 token = strtok(NULL, " :,%=\t");
858 for (int i = 0; i < 13; i++) {
859 token = strtok(NULL, " :,%=\t");
860 if (token != NULL) extrapL[i] = atoi(token);
861 }
862 } else if (strcmp(token, "Thresholds") == 0) {
863 token = strtok(NULL, " :,%=\t");
864 if (token != NULL) thrAlp = atoi(token);
865 token = strtok(NULL, " :,%=\t");
866 if (token != NULL) thrAtt = atoi(token);
867 token = strtok(NULL, " :,%=\t");
868 if (token != NULL) thrDis = atoi(token);
869 } else if (strcmp(token, "Interp") == 0) {
870 for (int i = 0; i < 13; i++) {
871 token = strtok(NULL, " :,%=\t");
872 if (token != NULL) interp[i] = atoi(token);
873 }
874 } else if (strcmp(token, "A") == 0) {
875 // Parameter for energy loss distribution, not used in Garfield++.
876 token = strtok(NULL, " :,%=\t");
877 } else if (strcmp(token, "Z") == 0) {
878 // Parameter for energy loss distribution, not used in Garfield++.
879 token = strtok(NULL, " :,%=\t");
880 } else if (strcmp(token, "EMPROB") == 0) {
881 // Parameter for energy loss distribution, not used in Garfield++.
882 token = strtok(NULL, " :,%=\t");
883 } else if (strcmp(token, "EPAIR") == 0) {
884 // Parameter for energy loss distribution, not used in Garfield++.
885 token = strtok(NULL, " :,%=\t");
886 } else if (strcmp(token, "Ion") == 0) {
887 // Ion diffusion coefficients
888 token = strtok(NULL, " :,%=\t");
889 token = strtok(NULL, " :,%=\t");
890 if (token != NULL) ionDiffL = atof(token);
891 token = strtok(NULL, " :,%=\t");
892 if (token != NULL) ionDiffT = atof(token);
893 } else if (strcmp(token, "CMEAN") == 0) {
894 // Clusters per cm, not used in Garfield..
895 token = strtok(NULL, " :,%=\t");
896 } else if (strcmp(token, "RHO") == 0) {
897 // Parameter for energy loss distribution, not used in Garfield++.
898 token = strtok(NULL, " :,%=\t");
899 } else if (strcmp(token, "PGAS") == 0) {
900 // Pressure [Torr]
901 token = strtok(NULL, " :,%=\t");
902 if (token != NULL) pgas = atof(token);
903 } else if (strcmp(token, "TGAS") == 0) {
904 // Temperature [K]
905 token = strtok(NULL, " :,%=\t");
906 if (token != NULL) tgas = atof(token);
907 done = true;
908 break;
909 } else {
910 done = true;
911 break;
912 }
913 token = strtok(NULL, " :,%=\t");
914 }
915 }
916}

Referenced by LoadGasFile(), and MergeGasFile().

◆ ReadHeader()

bool Garfield::MediumGas::ReadHeader ( std::ifstream & gasfile,
int & version,
std::bitset< 20 > & gasok,
bool & is3d,
std::vector< double > & mixture,
std::vector< double > & efields,
std::vector< double > & bfields,
std::vector< double > & angles,
std::vector< ExcLevel > & excLevels,
std::vector< IonLevel > & ionLevels )
protected

Definition at line 597 of file MediumGas.cc.

601 {
602
603 gasok.reset();
604 bool done = false;
605 char line[256];
606 while (gasfile.getline(line, 256)) {
607 const bool quotes = (strstr(line, "\"") != NULL);
608 if (strncmp(line, " The gas tables follow:", 8) == 0 ||
609 strncmp(line, "The gas tables follow:", 7) == 0) {
610 done = true;
611 break;
612 }
613 char* token = strtok(line, " :,%");
614 while (token) {
615 if (strcmp(token, "Version") == 0) {
616 token = strtok(NULL, " :,%");
617 if (!token) {
618 std::cerr << m_className << "::ReadHeader:\n"
619 << " Cannot read version number.\n";
620 return false;
621 }
622 version = atoi(token);
623 // Check the version number.
624 if (version != 10 && version != 11 && version != 12) {
625 std::cerr << m_className << "::ReadHeader:\n"
626 << " The file has version number " << version << ".\n"
627 << " Files written in this format cannot be read.\n";
628 return false;
629 }
630 } else if (strcmp(token, "GASOK") == 0) {
631 // Get the GASOK bits indicating if a parameter
632 // is present in the table (T) or not (F).
633 token = strtok(NULL, " :,%\t");
634 token = strtok(NULL, " :,%\t");
635 std::string okstr(token);
636 if (m_debug) std::cout << " GASOK bits: " << okstr << "\n";
637 if (okstr.size() < 20) {
638 std::cerr << m_className << "::ReadHeader:\n"
639 << " Unexpected size of GASOK string ("
640 << okstr.size() << ").\n";
641 return false;
642 }
643 for (unsigned int i = 0; i < 20; ++i) {
644 if (okstr[i] == 'T') gasok.set(i);
645 }
646 } else if (strcmp(token, "Identifier") == 0) {
647 // Get the identification string.
648 std::string identifier = "";
649 token = strtok(NULL, "\n");
650 if (token != NULL) identifier += token;
651 if (m_debug) std::cout << " Identifier: " << identifier << "\n";
652 } else if (strcmp(token, "Dimension") == 0) {
653 token = strtok(NULL, " :,%\t");
654 if (strcmp(token, "F") == 0) {
655 is3d = false;
656 } else {
657 is3d = true;
658 }
659 token = strtok(NULL, " :,%\t");
660 const int nE = atoi(token);
661 // Check the number of E points.
662 if (nE <= 0) {
663 std::cerr << m_className << "::ReadHeader:\n"
664 << " Number of E fields out of range.\n";
665 return false;
666 }
667 token = strtok(NULL, " :,%\t");
668 const int nA = atoi(token);
669 // Check the number of angles.
670 if (is3d && nA <= 0) {
671 std::cerr << m_className << "::ReadHeader:\n"
672 << " Number of E-B angles out of range.\n";
673 return false;
674 }
675 token = strtok(NULL, " :,%\t");
676 const int nB = atoi(token);
677 // Check the number of B points.
678 if (is3d && nB <= 0) {
679 std::cerr << m_className << "::ReadHeader:\n"
680 << " Number of B fields out of range.\n";
681 return false;
682 }
683 efields.resize(nE);
684 angles.resize(nA);
685 bfields.resize(nB);
686 // Fill in the excitation/ionisation structs
687 // Excitation
688 token = strtok(NULL, " :,%\t");
689 const int nexc = atoi(token);
690 // Ionization
691 token = strtok(NULL, " :,%\t");
692 const int nion = atoi(token);
693 if (m_debug) {
694 std::cout << " " << nexc << " excitations, " << nion
695 << " ionisations.\n";
696 }
697 } else if (strcmp(token, "E") == 0) {
698 token = strtok(NULL, " :,%");
699 if (strncmp(token, "fields", 6) == 0) {
700 const int nE = efields.size();
701 for (int i = 0; i < nE; ++i) gasfile >> efields[i];
702 }
703 } else if (strcmp(token, "E-B") == 0) {
704 token = strtok(NULL, " :,%");
705 if (strncmp(token, "angles", 6) == 0) {
706 const int nA = angles.size();
707 for (int i = 0; i < nA; ++i) gasfile >> angles[i];
708 }
709 } else if (strcmp(token, "B") == 0) {
710 token = strtok(NULL, " :,%");
711 if (strncmp(token, "fields", 6) == 0) {
712 double bstore = 0.;
713 const int nB = bfields.size();
714 for (int i = 0; i < nB; i++) {
715 gasfile >> bstore;
716 bfields[i] = bstore / 100.;
717 }
718 }
719 } else if (strcmp(token, "Mixture") == 0) {
720 const unsigned int nMagboltzGases = mixture.size();
721 for (unsigned int i = 0; i < nMagboltzGases; ++i) {
722 gasfile >> mixture[i];
723 }
724 } else if (strcmp(token, "Excitation") == 0) {
725 // Skip number.
726 token = strtok(NULL, " :,%");
727 ExcLevel exc;
728 // Get label.
729 if (quotes) {
730 token = strtok(NULL, "\"");
731 token = strtok(NULL, "\"");
732 } else {
733 token = strtok(NULL, " :,%");
734 }
735 exc.label = token;
736 // Get energy.
737 token = strtok(NULL, " :,%");
738 exc.energy = atof(token);
739 // Get Penning probability.
740 token = strtok(NULL, " :,%");
741 exc.prob = atof(token);
742 exc.rms = 0.;
743 exc.dt = 0.;
744 if (version >= 11) {
745 // Get Penning rms distance.
746 token = strtok(NULL, " :,%");
747 if (token) {
748 exc.rms = atof(token);
749 // Get decay time.
750 token = strtok(NULL, " :,%");
751 if (token) exc.dt = atof(token);
752 }
753 }
754 excLevels.push_back(std::move(exc));
755 } else if (strcmp(token, "Ionisation") == 0) {
756 // Skip number.
757 token = strtok(NULL, " :,%");
758 // Get label.
759 IonLevel ion;
760 if (quotes) {
761 token = strtok(NULL, "\"");
762 token = strtok(NULL, "\"");
763 } else {
764 token = strtok(NULL, " :,%");
765 }
766 ion.label += token;
767 // Get energy.
768 token = strtok(NULL, " :,%");
769 ion.energy = atof(token);
770 ionLevels.push_back(std::move(ion));
771 }
772 token = strtok(NULL, " :,%");
773 }
774 }
775 return done;
776}

Referenced by LoadGasFile(), and MergeGasFile().

◆ ReadRecord1D()

void Garfield::MediumGas::ReadRecord1D ( std::ifstream & gasfile,
double & ve,
double & vb,
double & vx,
double & dl,
double & dt,
double & alpha,
double & alpha0,
double & eta,
double & mu,
double & lor,
double & dis,
std::array< double, 6 > & dif,
std::vector< double > & rexc,
std::vector< double > & rion )
protected

Definition at line 812 of file MediumGas.cc.

816 {
817
818 double waste = 0.;
819 gasfile >> ve >> waste >> vb >> waste >> vx >> waste;
820 ve *= 1.e-3;
821 vb *= 1.e-3;
822 vx *= 1.e-3;
823 gasfile >> dl >> waste >> dt >> waste;
824 gasfile >> alpha >> waste >> alpha0 >> eta >> waste;
825 gasfile >> mu >> waste;
826 mu *= 1.e-3;
827 gasfile >> lor >> waste;
828 gasfile >> dis >> waste;
829 for (int j = 0; j < 6; j++) gasfile >> dif[j] >> waste;
830 const unsigned int nexc = rexc.size();
831 for (unsigned int j = 0; j < nexc; ++j) gasfile >> rexc[j] >> waste;
832 const unsigned int nion = rion.size();
833 for (unsigned int j = 0; j < nion; ++j) gasfile >> rion[j] >> waste;
834}

Referenced by LoadGasFile(), and MergeGasFile().

◆ ReadRecord3D()

void Garfield::MediumGas::ReadRecord3D ( std::ifstream & gasfile,
double & ve,
double & vb,
double & vx,
double & dl,
double & dt,
double & alpha,
double & alpha0,
double & eta,
double & mu,
double & lor,
double & dis,
std::array< double, 6 > & dif,
std::vector< double > & rexc,
std::vector< double > & rion )
protected

Definition at line 778 of file MediumGas.cc.

782 {
783
784 // Drift velocity along E, Bt and ExB
785 gasfile >> ve >> vb >> vx;
786 // Convert from cm / us to cm / ns.
787 ve *= 1.e-3;
788 vb *= 1.e-3;
789 vx *= 1.e-3;
790 // Longitudinal and transverse diffusion coefficients
791 gasfile >> dl >> dt;
792 // Townsend and attachment coefficients
793 gasfile >> alpha >> alpha0 >> eta;
794 // Ion mobility
795 gasfile >> mu;
796 // Convert from cm2 / (V us) to cm2 / (V ns)
797 mu *= 1.e-3;
798 // Lorentz angle
799 gasfile >> lor;
800 // Ion dissociation
801 gasfile >> dis;
802 // Diffusion tensor
803 for (int l = 0; l < 6; l++) gasfile >> dif[l];
804 // Excitation rates
805 const unsigned int nexc = rexc.size();
806 for (unsigned int l = 0; l < nexc; ++l) gasfile >> rexc[l];
807 // Ionization rates
808 const unsigned int nion = rion.size();
809 for (unsigned int l = 0; l < nion; ++l) gasfile >> rion[l];
810}

Referenced by LoadGasFile(), and MergeGasFile().

◆ ResetTables()

void Garfield::MediumGas::ResetTables ( )
overridevirtual

Reset all tables of transport parameters.

Reimplemented from Garfield::Medium.

Definition at line 2318 of file MediumGas.cc.

2318 {
2319
2321 m_eAlp0.clear();
2322 m_excLevels.clear();
2323 m_ionLevels.clear();
2324 m_excRates.clear();
2325 m_ionRates.clear();
2326}
virtual void ResetTables()
Reset all tables of transport parameters.
Definition Medium.cc:999

Referenced by LoadGasFile(), MergeGasFile(), and SetComposition().

◆ ScaleAttachment()

double Garfield::MediumGas::ScaleAttachment ( const double eta) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 150 of file MediumGas.hh.

150 {
151 return eta * m_pressure / m_pressureTable;
152 }

◆ ScaleDiffusion()

double Garfield::MediumGas::ScaleDiffusion ( const double d) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 141 of file MediumGas.hh.

141 {
142 return d * sqrt(m_pressureTable / m_pressure);
143 }

◆ ScaleDiffusionTensor()

double Garfield::MediumGas::ScaleDiffusionTensor ( const double d) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 144 of file MediumGas.hh.

144 {
145 return d * m_pressureTable / m_pressure;
146 }

◆ ScaleElectricField()

double Garfield::MediumGas::ScaleElectricField ( const double e) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 135 of file MediumGas.hh.

135 {
136 return e * m_pressureTable / m_pressure;
137 }

◆ ScaleLorentzAngle()

double Garfield::MediumGas::ScaleLorentzAngle ( const double lor) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 153 of file MediumGas.hh.

153 {
154 return lor * m_pressure / m_pressureTable;
155 }

◆ ScaleTownsend()

double Garfield::MediumGas::ScaleTownsend ( const double alpha) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 147 of file MediumGas.hh.

147 {
149 }

◆ SetAtomicNumber()

void Garfield::MediumGas::SetAtomicNumber ( const double z)
overridevirtual

Set the effective atomic number.

Reimplemented from Garfield::Medium.

Definition at line 271 of file MediumGas.cc.

271 {
272 std::cerr << m_className << "::SetAtomicNumber:\n"
273 << " Effective Z cannot be changed directly.\n"
274 << " Use SetComposition to define the gas mixture.\n";
275}

◆ SetAtomicWeight()

void Garfield::MediumGas::SetAtomicWeight ( const double a)
overridevirtual

Set the effective atomic weight.

Reimplemented from Garfield::Medium.

Definition at line 277 of file MediumGas.cc.

277 {
278 std::cerr << m_className << "::SetAtomicWeight:\n"
279 << " Effective A cannot be changed directly.\n"
280 << " Use SetComposition to define the gas mixture.\n";
281}

◆ SetComposition()

bool Garfield::MediumGas::SetComposition ( const std::string & gas1,
const double f1 = 1.,
const std::string & gas2 = "",
const double f2 = 0.,
const std::string & gas3 = "",
const double f3 = 0.,
const std::string & gas4 = "",
const double f4 = 0.,
const std::string & gas5 = "",
const double f5 = 0.,
const std::string & gas6 = "",
const double f6 = 0. )

Set the gas mixture.

Definition at line 138 of file MediumGas.cc.

143 {
144 std::array<std::string, 6> gases = {gas1, gas2, gas3, gas4, gas5, gas6};
145 std::array<double, 6> fractions = {f1, f2, f3, f4, f5, f6};
146
147 // Make a backup copy of the gas composition.
148 const std::array<std::string, m_nMaxGases> gasOld = m_gas;
149 const unsigned int nComponentsOld = m_nComponents;
150
151 // Reset all transport parameters.
152 ResetTables();
153 // Force a recalculation of the collision rates.
154 m_isChanged = true;
155
156 m_nComponents = 0;
157 m_gas.fill("");
158 m_fraction.fill(0.);
159 m_atWeight.fill(0.);
160 m_atNum.fill(0.);
161 for (unsigned int i = 0; i < 6; ++i) {
162 if (fractions[i] < Small) continue;
163 // Find the gas name corresponding to the input string.
164 const std::string gasname = GetGasName(gases[i]);
165 if (!gasname.empty()) {
166 m_gas[m_nComponents] = gasname;
167 m_fraction[m_nComponents] = fractions[i];
169 } else {
170 std::cerr << m_className << "::SetComposition:\n"
171 << " Unknown identifier '" << gases[i] << "'.\n";
172 }
173 }
174
175 // Check if at least one valid ingredient was specified.
176 if (m_nComponents == 0) {
177 std::cerr << m_className << "::SetComposition:\n"
178 << " Error setting the composition. No valid components.\n";
179 return false;
180 }
181
182 // Establish the name.
183 m_name = "";
184 double sum = 0.;
185 for (unsigned int i = 0; i < m_nComponents; ++i) {
186 if (i > 0) m_name += "/";
187 m_name += m_gas[i];
188 sum += m_fraction[i];
189 }
190 // Normalise the fractions to unity.
191 for (unsigned int i = 0; i < m_nComponents; ++i) {
192 m_fraction[i] /= sum;
193 }
194
195 // Set the W value, Fano factor, and the atomic weight and number.
196 m_w = 0.;
197 m_fano = 0.;
198 for (unsigned int i = 0; i < m_nComponents; ++i) {
199 double w = 0., f = 0.;
200 GetGasInfo(m_gas[i], m_atWeight[i], m_atNum[i], w, f);
201 m_w += w * m_fraction[i];
202 m_fano += f * m_fraction[i];
203 }
204
205 // Print the composition.
206 std::cout << m_className << "::SetComposition: " << m_name;
207 if (m_nComponents > 1) {
208 std::cout << " (" << m_fraction[0] * 100;
209 for (unsigned int i = 1; i < m_nComponents; ++i) {
210 std::cout << "/" << m_fraction[i] * 100;
211 }
212 std::cout << ")";
213 }
214 std::cout << "\n";
215
216
217 // Copy the previous Penning transfer parameters.
218 std::array<double, m_nMaxGases> rPenningGasOld;
219 std::array<double, m_nMaxGases> lambdaPenningGasOld;
220 rPenningGasOld.fill(0.);
221 lambdaPenningGasOld.fill(0.);
222 rPenningGasOld.swap(m_rPenningGas);
223 lambdaPenningGasOld.swap(m_lambdaPenningGas);
224 for (unsigned int i = 0; i < m_nComponents; ++i) {
225 for (unsigned int j = 0; j < nComponentsOld; ++j) {
226 if (m_gas[i] != gasOld[j]) continue;
227 if (rPenningGasOld[j] < Small) continue;
228 m_rPenningGas[i] = rPenningGasOld[j];
229 m_lambdaPenningGas[i] = lambdaPenningGasOld[i];
230 std::cout << m_className << "::SetComposition:\n"
231 << " Using Penning transfer parameters for " << m_gas[i]
232 << " from previous mixture.\n"
233 << " r = " << m_rPenningGas[i] << "\n"
234 << " lambda = " << m_lambdaPenningGas[i] << " cm\n";
235 }
236 }
237 return true;
238}

Referenced by Garfield::MediumMagboltz::MediumMagboltz().

◆ SetExtrapolationMethodExcitationRates()

void Garfield::MediumGas::SetExtrapolationMethodExcitationRates ( const std::string & low,
const std::string & high )
inline

Definition at line 118 of file MediumGas.hh.

119 {
120 SetExtrapolationMethod(low, high, m_extrExc, "ExcitationRates");
121 }
void SetExtrapolationMethod(const std::string &low, const std::string &high, std::pair< unsigned int, unsigned int > &extr, const std::string &fcn)
Definition Medium.cc:1215

◆ SetExtrapolationMethodIonisationRates()

void Garfield::MediumGas::SetExtrapolationMethodIonisationRates ( const std::string & low,
const std::string & high )
inline

Definition at line 122 of file MediumGas.hh.

123 {
124 SetExtrapolationMethod(low, high, m_extrIon, "IonisationRates");
125 }

◆ SetInterpolationMethodExcitationRates()

void Garfield::MediumGas::SetInterpolationMethodExcitationRates ( const unsigned int intrp)
inline

Definition at line 126 of file MediumGas.hh.

126 {
127 if (intrp > 0) m_intpExc = intrp;
128 }

◆ SetInterpolationMethodIonisationRates()

void Garfield::MediumGas::SetInterpolationMethodIonisationRates ( const unsigned int intrp)
inline

Definition at line 129 of file MediumGas.hh.

129 {
130 if (intrp > 0) m_intpIon = intrp;
131 }

◆ SetMassDensity()

void Garfield::MediumGas::SetMassDensity ( const double rho)
overridevirtual

Set the mass density [g/cm3].

Reimplemented from Garfield::Medium.

Definition at line 289 of file MediumGas.cc.

289 {
290 std::cerr << m_className << "::SetMassDensity:\n"
291 << " Density cannot be changed directly.\n"
292 << " Use SetTemperature, SetPressure and SetComposition.\n";
293}

◆ SetNumberDensity()

void Garfield::MediumGas::SetNumberDensity ( const double n)
overridevirtual

Set the number density [cm-3].

Reimplemented from Garfield::Medium.

Definition at line 283 of file MediumGas.cc.

283 {
284 std::cerr << m_className << "::SetNumberDensity:\n"
285 << " Density cannot be changed directly.\n"
286 << " Use SetTemperature and SetPressure.\n";
287}

◆ UnScaleElectricField()

double Garfield::MediumGas::UnScaleElectricField ( const double e) const
inlineoverridevirtual

Reimplemented from Garfield::Medium.

Definition at line 138 of file MediumGas.hh.

138 {
139 return e * m_pressure / m_pressureTable;
140 }

◆ WriteGasFile()

bool Garfield::MediumGas::WriteGasFile ( const std::string & filename)

Save the present table of gas properties (transport parameters) to a file.

Definition at line 1781 of file MediumGas.cc.

1781 {
1782
1783 // -----------------------------------------------------------------------
1784 // GASWRT
1785 // -----------------------------------------------------------------------
1786
1787 // Set the gas mixture.
1788 constexpr int nMagboltzGases = 60;
1789 std::vector<double> mixture(nMagboltzGases, 0.);
1790 for (unsigned int i = 0; i < m_nComponents; ++i) {
1791 const int ng = GetGasNumberGasFile(m_gas[i]);
1792 if (ng <= 0) {
1793 std::cerr << m_className << "::WriteGasFile:\n"
1794 << " Error retrieving gas number for " << m_gas[i] << ".\n";
1795 continue;
1796 }
1797 mixture[ng - 1] = m_fraction[i] * 100.;
1798 }
1799
1800 if (m_debug) {
1801 std::cout << m_className << "::WriteGasFile:\n"
1802 << " Writing gas tables to file " << filename << "\n";
1803 }
1804
1805 std::ofstream outfile(filename, std::ios::out);
1806 if (!outfile) {
1807 std::cerr << m_className << "::WriteGasFile:\n"
1808 << " Cannot open file " << filename << ".\n";
1809 outfile.close();
1810 return false;
1811 }
1812
1813 // Assemble the GASOK bits.
1814 std::bitset<20> gasok;
1815 GetGasBits(gasok);
1816 std::string okstr(20, 'F');
1817 for (unsigned int i = 0; i < 20; ++i) {
1818 if (gasok[i]) okstr[i] = 'T';
1819 }
1820 if (m_debug) std::cout << " GASOK bits: " << okstr << "\n";
1821 // Get the current time.
1822 time_t rawtime = time(0);
1823 tm timeinfo = *localtime(&rawtime);
1824 char datebuf[80] = {0};
1825 char timebuf[80] = {0};
1826 // Format date and time.
1827 strftime(datebuf, sizeof(datebuf) - 1, "%d/%m/%y", &timeinfo);
1828 strftime(timebuf, sizeof(timebuf) - 1, "%H.%M.%S", &timeinfo);
1829 // Set the member name.
1830 std::string member = "< none >";
1831 // Write the header.
1832 outfile << "*----.----1----.----2----.----3----.----4----.----"
1833 << "5----.----6----.----7----.----8----.----9----.---"
1834 << "10----.---11----.---12----.---13--\n";
1835 outfile << "% Created " << datebuf << " at " << timebuf << " ";
1836 outfile << member << " GAS ";
1837 // Add remark.
1838 std::string buffer;
1839 outfile << "\"none" << std::string(25, ' ') << "\"\n";
1840 const int version = 12;
1841 outfile << " Version : " << version << "\n";
1842 outfile << " GASOK bits: " << okstr << "\n";
1843 std::stringstream ids("");
1844 for (unsigned int i = 0; i < m_nComponents; ++i) {
1845 ids << m_gas[i] << " " << 100. * m_fraction[i] << "%, ";
1846 }
1847 ids << "T=" << m_temperatureTable << " K, "
1848 << "p=" << m_pressureTable / AtmosphericPressure << " atm";
1849 outfile << " Identifier: " << std::setw(80) << std::left << ids.str() << "\n";
1850 outfile << " Clusters : " << std::string(80, ' ') << "\n";
1851 outfile << " Dimension : ";
1852 if (m_tab2d) {
1853 outfile << "T ";
1854 } else {
1855 outfile << "F ";
1856 }
1857
1858 const unsigned int nE = m_eFields.size();
1859 const unsigned int nB = m_bFields.size();
1860 const unsigned int nA = m_bAngles.size();
1861 if (m_debug) {
1862 std::cout << m_className << "::WriteGasFile:\n "
1863 << "Dataset has the following dimensions:\n "
1864 << "3D = " << m_tab2d << " nE = " << nE << ", nB = " << nB
1865 << ", nA = " << nA << ", nExc = "
1866 << m_excLevels.size() << ", nIon = " << m_ionLevels.size() << "\n";
1867 }
1868 outfile << FmtInt(nE, 9) << " " << FmtInt(nA, 9) << " "
1869 << FmtInt(nB, 9) << " " << FmtInt(m_excLevels.size(), 9) << " "
1870 << FmtInt(m_ionLevels.size(), 9) << "\n";
1871 // Store reduced electric fields (E/p).
1872 outfile << " E fields \n";
1873 std::vector<double> efields = m_eFields;
1874 for (auto& field : efields) field /= m_pressureTable;
1875 int cnt = 0;
1876 // List 5 values, then new line.
1877 PrintArray(efields, outfile, cnt, 5);
1878 if (nE % 5 != 0) outfile << "\n";
1879 // Store angles.
1880 outfile << " E-B angles \n";
1881 cnt = 0;
1882 PrintArray(m_bAngles, outfile, cnt, 5);
1883 if (nA % 5 != 0) outfile << "\n";
1884 // Store B fields (convert to hGauss).
1885 outfile << " B fields \n";
1886 std::vector<double> bfields = m_bFields;
1887 for (auto& field : bfields) field *= 100.;
1888 cnt = 0;
1889 PrintArray(bfields, outfile, cnt, 5);
1890 if (nB % 5 != 0) outfile << "\n";
1891
1892 // Store the gas composition.
1893 outfile << " Mixture: \n";
1894 cnt = 0;
1895 PrintArray(mixture, outfile, cnt, 5);
1896 if (nMagboltzGases % 5 != 0) outfile << "\n";
1897
1898 cnt = 0;
1899 for (const auto& exc : m_excLevels) {
1900 ++cnt;
1901 outfile << " Excitation " << FmtInt(cnt, 5) << ": " << std::setw(45);
1902 // If the label contains white space, enclose it in quotes.
1903 if (exc.label.find(" ") != std::string::npos) {
1904 outfile << "\"" + exc.label + "\"";
1905 } else {
1906 outfile << exc.label;
1907 }
1908 outfile << " " << FmtFloat(exc.energy) << FmtFloat(exc.prob)
1909 << FmtFloat(exc.rms) << FmtFloat(exc.dt) << "\n";
1910 }
1911 cnt = 0;
1912 for (const auto& ion : m_ionLevels) {
1913 ++cnt;
1914 outfile << " Ionisation " << FmtInt(cnt, 5) << ": " << std::setw(45);
1915 // If the label contains white space, enclose it in quotes.
1916 if (ion.label.find(" ") != std::string::npos) {
1917 outfile << "\"" + ion.label << "\"";
1918 } else {
1919 outfile << ion.label;
1920 }
1921 outfile << " " << FmtFloat(ion.energy) << "\n";
1922 }
1923
1924 const double sqrp = sqrt(m_pressureTable);
1925 const double logp = log(m_pressureTable);
1926 outfile << " The gas tables follow:\n";
1927 cnt = 0;
1928 for (unsigned int i = 0; i < nE; ++i) {
1929 for (unsigned int j = 0; j < nA; ++j) {
1930 for (unsigned int k = 0; k < nB; ++k) {
1931 // Get the velocities.
1932 double ve = m_eVelE.empty() ? 0. : m_eVelE[j][k][i];
1933 double vb = m_eVelB.empty() ? 0. : m_eVelB[j][k][i];
1934 double vx = m_eVelX.empty() ? 0. : m_eVelX[j][k][i];
1935 // Convert from cm / ns to cm / us.
1936 ve *= 1.e3;
1937 vb *= 1.e3;
1938 vx *= 1.e3;
1939 // Make a list of the values to be written, start with the velocities.
1940 std::vector<double> val;
1941 if (m_tab2d) {
1942 val = {ve, vb, vx};
1943 } else {
1944 // Add dummy spline values in case of a 1D table.
1945 val = {ve, 0., vb, 0., vx, 0.};
1946 }
1947 // Get the diffusion coefficients.
1948 double dl = m_eDifL.empty() ? 0. : m_eDifL[j][k][i] * sqrp;
1949 double dt = m_eDifT.empty() ? 0. : m_eDifT[j][k][i] * sqrp;
1950 // Get the Townsend and attachment coefficients.
1951 double alpha = m_eAlp.empty() ? -30. : m_eAlp[j][k][i] - logp;
1952 double alpha0 = m_eAlp0.empty() ? -30. : m_eAlp0[j][k][i] - logp;
1953 double eta = m_eAtt.empty() ? -30. : m_eAtt[j][k][i] - logp;
1954 // Add them to the list.
1955 if (m_tab2d) {
1956 val.insert(val.end(), {dl, dt, alpha, alpha0, eta});
1957 } else {
1958 val.insert(val.end(), {dl, 0., dt, 0., alpha, 0., alpha0, eta, 0.});
1959 }
1960 // Get the ion mobility and convert from cm2 / (V ns) to cm2 / (V us).
1961 double mu = m_iMob.empty() ? 0. : 1.e3 * m_iMob[j][k][i];
1962 // Get the Lorentz angle.
1963 double lor = m_eLor.empty() ? 0 : m_eLor[j][k][i];
1964 // Get the dissociation coefficient.
1965 double diss = m_iDis.empty() ? -30. : m_iDis[j][k][i] - logp;
1966 // Add them to the list.
1967 if (m_tab2d) {
1968 val.insert(val.end(), {mu, lor, diss});
1969 } else {
1970 val.insert(val.end(), {mu, 0., lor, 0., diss, 0.});
1971 }
1972 // Get the components of the diffusion tensor.
1973 for (int l = 0; l < 6; ++l) {
1974 if (!m_eDifM.empty()) {
1975 const double cov = m_eDifM[l][j][k][i] * m_pressureTable;
1976 val.push_back(cov);
1977 } else {
1978 val.push_back(0.);
1979 }
1980 if (!m_tab2d) val.push_back(0.);
1981 }
1982 // Get the excitation and ionisation rates.
1983 for (const auto& rexc : m_excRates) {
1984 if (rexc[j][k][i] > Small) {
1985 val.push_back(rexc[j][k][i]);
1986 } else {
1987 val.push_back(0.);
1988 }
1989 if (!m_tab2d) val.push_back(0.);
1990 }
1991 for (const auto& rion : m_ionRates) {
1992 if (rion[j][k][i] > Small) {
1993 val.push_back(rion[j][k][i]);
1994 } else {
1995 val.push_back(0.);
1996 }
1997 if (!m_tab2d) val.push_back(0.);
1998 }
1999 PrintArray(val, outfile, cnt, 8);
2000 }
2001 if (cnt % 8 != 0) outfile << "\n";
2002 cnt = 0;
2003 }
2004 }
2005
2006 if (!m_tab2d) {
2007 // Extrapolation methods
2008 int extrapH[13], extrapL[13];
2009 extrapL[0] = extrapL[1] = extrapL[2] = m_extrVel.first;
2010 extrapH[0] = extrapH[1] = extrapH[2] = m_extrVel.second;
2011 extrapL[3] = extrapL[8] = extrapL[10] = m_extrDif.first;
2012 extrapH[3] = extrapH[8] = extrapH[10] = m_extrDif.second;
2013 extrapL[4] = m_extrAlp.first;
2014 extrapH[4] = m_extrAlp.second;
2015 extrapL[5] = m_extrAtt.first;
2016 extrapH[5] = m_extrAtt.second;
2017 extrapL[6] = m_extrMob.first;
2018 extrapH[6] = m_extrMob.second;
2019 // Lorentz angle
2020 extrapL[7] = m_extrLor.first;
2021 extrapH[7] = m_extrLor.second;
2022 extrapL[9] = m_extrDis.first;
2023 extrapH[9] = m_extrDis.second;
2024 extrapL[11] = m_extrExc.first;
2025 extrapH[11] = m_extrExc.second;
2026 extrapL[12] = m_extrIon.first;
2027 extrapH[12] = m_extrIon.second;
2028 outfile << " H Extr: ";
2029 for (int i = 0; i < 13; i++) outfile << FmtInt(extrapH[i], 5);
2030 outfile << "\n";
2031 outfile << " L Extr: ";
2032 for (int i = 0; i < 13; i++) outfile << FmtInt(extrapL[i], 5);
2033 outfile << "\n";
2034 }
2035 // Increment the threshold indices for compatibility with Fortran.
2036 outfile << " Thresholds: " << FmtInt(m_eThrAlp + 1, 10)
2037 << FmtInt(m_eThrAtt + 1, 10) << FmtInt(m_iThrDis + 1, 10) << "\n";
2038 // Interpolation methods.
2039 int interp[13];
2040 interp[0] = interp[1] = interp[2] = m_intpVel;
2041 interp[3] = interp[8] = interp[10] = m_intpDif;
2042 interp[4] = m_intpAlp;
2043 interp[5] = m_intpAtt;
2044 interp[6] = m_intpMob;
2045 interp[7] = m_intpLor;
2046 interp[9] = m_intpDis;
2047 interp[11] = m_intpExc;
2048 interp[12] = m_intpIon;
2049 outfile << " Interp: ";
2050 for (int i = 0; i < 13; i++) outfile << FmtInt(interp[i], 5);
2051 outfile << "\n";
2052 outfile << " A =" << FmtFloat(0.) << ", Z =" << FmtFloat(0.) << ","
2053 << " EMPROB=" << FmtFloat(0.) << ", EPAIR =" << FmtFloat(0.) << "\n";
2054 const double dli = m_iDifL.empty() ? 0. : m_iDifL[0][0][0];
2055 const double dti = m_iDifT.empty() ? 0. : m_iDifT[0][0][0];
2056 outfile << " Ion diffusion: " << FmtFloat(dli) << FmtFloat(dti) << "\n";
2057 outfile << " CMEAN =" << FmtFloat(0.) << ", RHO =" << FmtFloat(0.) << ","
2058 << " PGAS =" << FmtFloat(m_pressureTable) << ","
2059 << " TGAS =" << FmtFloat(m_temperatureTable) << "\n";
2060 outfile << " CLSTYP : NOT SET \n"
2061 << " FCNCLS : " << std::string(80, ' ') << "\n"
2062 << " NCLS : " << FmtInt(0, 10) << "\n"
2063 << " Average : " << FmtFloat(0., 25, 18) << "\n"
2064 << " Heed initialisation done: F\n"
2065 << " SRIM initialisation done: F\n";
2066 outfile.close();
2067
2068 return true;
2069}
static int GetGasNumberGasFile(const std::string &input)

◆ ZeroRowA()

void Garfield::MediumGas::ZeroRowA ( const int ia,
const int ne,
const int nb )
protected

Definition at line 1773 of file MediumGas.cc.

1773 {
1774 for (int j = 0; j < nb; ++j) {
1775 for (int i = 0; i < ne; ++i) {
1776 if (!m_eVelE.empty()) m_eVelE[ia][j][i] = 0.;
1777 }
1778 }
1779}

Referenced by MergeGasFile().

◆ ZeroRowB()

void Garfield::MediumGas::ZeroRowB ( const int ib,
const int ne,
const int na )
protected

Definition at line 1765 of file MediumGas.cc.

1765 {
1766 for (int k = 0; k < na; ++k) {
1767 for (int i = 0; i < ne; ++i) {
1768 if (!m_eVelE.empty()) m_eVelE[k][ib][i] = 0.;
1769 }
1770 }
1771}

Referenced by MergeGasFile().

◆ ZeroRowE()

void Garfield::MediumGas::ZeroRowE ( const int ie,
const int nb,
const int na )
protected

Definition at line 1757 of file MediumGas.cc.

1757 {
1758 for (int k = 0; k < na; ++k) {
1759 for (int j = 0; j < nb; ++j) {
1760 if (!m_eVelE.empty()) m_eVelE[k][j][ie] = 0.;
1761 }
1762 }
1763}

Referenced by MergeGasFile().

Member Data Documentation

◆ m_atNum

std::array<double, m_nMaxGases> Garfield::MediumGas::m_atNum
protected

Definition at line 167 of file MediumGas.hh.

Referenced by GetAtomicNumber(), LoadGasFile(), MediumGas(), and SetComposition().

◆ m_atWeight

std::array<double, m_nMaxGases> Garfield::MediumGas::m_atWeight
protected

Definition at line 166 of file MediumGas.hh.

Referenced by GetAtomicWeight(), LoadGasFile(), MediumGas(), and SetComposition().

◆ m_eAlp0

std::vector<std::vector<std::vector<double> > > Garfield::MediumGas::m_eAlp0
protected

◆ m_excLevels

◆ m_excRates

std::vector<std::vector<std::vector<std::vector<double> > > > Garfield::MediumGas::m_excRates
protected

◆ m_extrExc

std::pair<unsigned int, unsigned int> Garfield::MediumGas::m_extrExc = {0, 1}
protected

Definition at line 210 of file MediumGas.hh.

210{0, 1};

Referenced by LoadGasFile(), MergeGasFile(), PrintGas(), SetExtrapolationMethodExcitationRates(), and WriteGasFile().

◆ m_extrIon

std::pair<unsigned int, unsigned int> Garfield::MediumGas::m_extrIon = {0, 1}
protected

Definition at line 211 of file MediumGas.hh.

211{0, 1};

Referenced by LoadGasFile(), MergeGasFile(), PrintGas(), SetExtrapolationMethodIonisationRates(), and WriteGasFile().

◆ m_fraction

◆ m_gas

◆ m_intpExc

unsigned int Garfield::MediumGas::m_intpExc = 2
protected

◆ m_intpIon

unsigned int Garfield::MediumGas::m_intpIon = 2
protected

◆ m_ionLevels

◆ m_ionRates

std::vector<std::vector<std::vector<std::vector<double> > > > Garfield::MediumGas::m_ionRates
protected

◆ m_lambdaPenningGas

std::array<double, m_nMaxGases> Garfield::MediumGas::m_lambdaPenningGas
protected

◆ m_lambdaPenningGlobal

double Garfield::MediumGas::m_lambdaPenningGlobal = 0.
protected

◆ m_nMaxGases

unsigned int Garfield::MediumGas::m_nMaxGases = 6
staticconstexprprotected

Definition at line 161 of file MediumGas.hh.

Referenced by GetMixture(), and GetPhotoAbsorptionCrossSection().

◆ m_pressureTable

◆ m_rPenningGas

std::array<double, m_nMaxGases> Garfield::MediumGas::m_rPenningGas
protected

◆ m_rPenningGlobal

double Garfield::MediumGas::m_rPenningGlobal = 0.
protected

◆ m_temperatureTable

double Garfield::MediumGas::m_temperatureTable
protected

◆ m_usePenning


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