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

#include <HeedMatterDef.h>

Public Member Functions

 HeedMatterDef ()=default
 Default constructor.
 
 HeedMatterDef (EnergyMesh *fenergy_mesh, MatterDef *amatter, const std::vector< AtomPhotoAbsCS * > &faapacs, double fW=0.0, double fF=standard_factor_Fano)
 
 HeedMatterDef (EnergyMesh *fenergy_mesh, GasDef *agas, std::vector< MolecPhotoAbsCS > &fampacs, double fW=0.0, double fF=standard_factor_Fano)
 
void replace_epsi12 (const std::string &file_name)
 
void print (std::ostream &file, int l) const
 
HeedMatterDefcopy () const
 

Public Attributes

MatterDefmatter = nullptr
 
std::vector< const AtomPhotoAbsCS * > apacs
 
double eldens_cm_3 = 0.
 Electron density cm**-3.
 
double eldens = 0.
 Electron density MeV**3.
 
double xeldens = 0.
 Long. electron density MeV**2/cm (for x=1 cm).
 
double wpla = 0.
 Squared plasma energy;.
 
double radiation_length = 0.
 Radiation Length.
 
double Rutherford_const = 0.
 Const for Rutherford cross section (1/cm3).
 
double W = 0.
 Mean work per pair production, MeV.
 
double F = 0.
 Fano factor.
 
EnergyMeshenergy_mesh = nullptr
 
std::vector< double > ACS
 Photoabsorption cross section per one atom(Mb).
 
std::vector< double > ICS
 
std::vector< double > epsip
 Some plasma dielectric constant (not used, but just initialized for print)
 
std::vector< double > epsi1
 Real part of dielectric constant (e_1 - 1).
 
std::vector< double > epsi2
 Imaginary part of dielectric constant.
 
double min_ioniz_pot = 0.
 

Static Public Attributes

static constexpr int s_use_mixture_thresholds = 0
 

Detailed Description

Definition of matter parameters necessary for HEED. This is photoabsorption cross section, dielectric constant and other parameters related to these. All the parameters depending on energy are kept in arrays associated with specific energy mesh, which should be defined.

The principle is ordinary: definition of just a class. To the contrary with wcpplib/matter, there is no any global "database" and no formal ban to duplicate these definitions (although there would not be sense in duplication).

Definition at line 26 of file HeedMatterDef.h.

Constructor & Destructor Documentation

◆ HeedMatterDef() [1/3]

Heed::HeedMatterDef::HeedMatterDef ( )
default

Default constructor.

Referenced by copy().

◆ HeedMatterDef() [2/3]

Heed::HeedMatterDef::HeedMatterDef ( EnergyMesh * fenergy_mesh,
MatterDef * amatter,
const std::vector< AtomPhotoAbsCS * > & faapacs,
double fW = 0.0,
double fF = standard_factor_Fano )

Constructor. If fW == 0.0, the program takes mean W from molecules for gas or from atoms for matters. If fF is input as 0.0, it is assigned to be mean for gas. For matters this is the terminating error.

Definition at line 19 of file HeedMatterDef.cpp.

22 : matter(amatter), W(fW), F(fF), energy_mesh(fenergy_mesh) {
23 mfunname("HeedMatterDef::HeedMatterDef(...)");
24 check_econd11(matter, == nullptr, mcerr);
25 check_econd11(matter->qatom(), <= 0, mcerr);
26 const long q = matter->qatom();
27 apacs.resize(q, nullptr);
28 for (long n = 0; n < q; ++n) {
29 apacs[n] = faapacs[n];
30 check_econd12(matter->atom(n)->Z(), !=, apacs[n]->get_Z(), mcerr);
31 }
32 check_econd11(F, == 0.0, mcerr);
33 if (W == 0.0) {
34#ifdef CALC_W_USING_CHARGES
35 double mean_I = 0.0;
36 double d = 0.0;
37 for (long n = 0; n < q; ++n) {
38 const double w = matter->weight_quan(n) * apacs[n]->get_Z();
39 mean_I += w * apacs[n]->get_I_min();
40 d += w;
41 }
42 W = coef_I_to_W * mean_I / d;
43#else
44 double mean_I = 0.0;
45 for (long n = 0; n < q; ++n) {
46 mean_I += matter->weight_quan(n) * apacs[n]->get_I_min();
47 }
48 W = coef_I_to_W * mean_I;
49#endif
50 }
51 initialize();
52}
#define check_econd11(a, signb, stream)
#define check_econd12(a, sign, b, stream)
#define mfunname(string)
double W
Mean work per pair production, MeV.
std::vector< const AtomPhotoAbsCS * > apacs
double F
Fano factor.
EnergyMesh * energy_mesh
constexpr double coef_I_to_W
Definition PhotoAbsCS.h:585
#define mcerr
Definition prstream.h:128

◆ HeedMatterDef() [3/3]

Heed::HeedMatterDef::HeedMatterDef ( EnergyMesh * fenergy_mesh,
GasDef * agas,
std::vector< MolecPhotoAbsCS > & fampacs,
double fW = 0.0,
double fF = standard_factor_Fano )

Definition at line 54 of file HeedMatterDef.cpp.

57 : matter(agas), W(fW), F(fF), energy_mesh(fenergy_mesh) {
58 mfunname("HeedMatterDef::HeedMatterDef(...)");
59 check_econd11(agas, == nullptr, mcerr);
60 check_econd11(agas->qmolec(), <= 0, mcerr);
61 const long qat = agas->qatom();
62 apacs.resize(qat, nullptr);
63 const long qmol = agas->qmolec();
64 long nat = 0;
65 for (long nmol = 0; nmol < qmol; ++nmol) {
66 check_econd12(agas->molec(nmol)->tqatom(), !=, fampacs[nmol].get_qatom(),
67 mcerr);
68 // number of different atoms in molecule
69 const long qa = agas->molec(nmol)->qatom();
70 for (long na = 0; na < qa; ++na) {
71 apacs[nat] = fampacs[nmol].get_atom(na);
72 check_econd12(apacs[nat]->get_Z(), !=, agas->molec(nmol)->atom(na)->Z(),
73 mcerr);
74 nat++;
75 }
76 }
77 if (F == 0.0) {
78#ifdef CALC_W_USING_CHARGES
79 double u = 0.0;
80 double d = 0.0;
81 for (long n = 0; n < qmol; ++n) {
82 const double w = agas->weight_quan_molec(n) * fampacs[n].get_total_Z();
83 u += w * fampacs[n].get_F();
84 d += w;
85 }
86 F = u / d;
87#else
88 for (long n = 0; n < qmol; ++n) {
89 F += agas->weight_quan_molec(n) * fampacs[n].get_F();
90 }
91#endif
92 }
93
94 if (W == 0.0) {
95#ifdef CALC_W_USING_CHARGES
96 double u = 0.0;
97 double d = 0.0;
98 for (long n = 0; n < qmol; ++n) {
99 const double w = agas->weight_quan_molec(n) * fampacs[n].get_total_Z();
100 u += w * fampacs[n].get_W();
101 d += w;
102 }
103 W = u / d;
104#else
105 for (long n = 0; n < qmol; ++n) {
106 W += agas->weight_quan_molec(n) * fampacs[n].get_W();
107 }
108#endif
109 }
110 initialize();
111}

Member Function Documentation

◆ copy()

HeedMatterDef * Heed::HeedMatterDef::copy ( ) const
inline

Definition at line 79 of file HeedMatterDef.h.

79{ return new HeedMatterDef(*this); }
HeedMatterDef()=default
Default constructor.

◆ print()

void Heed::HeedMatterDef::print ( std::ostream & file,
int l ) const

Definition at line 277 of file HeedMatterDef.cpp.

277 {
278 if (l <= 0) return;
279 Ifile << "HeedMatterDef:\n";
280 indn.n += 2;
281 matter->print(file, 1);
282 if (l >= 2) {
283 long q = matter->qatom();
284 Ifile << "Printing " << q << " photoabsorption cross sections:\n";
285 indn.n += 2;
286 for (long n = 0; n < q; ++n) {
287 apacs[n]->print(file, l - 1);
288 }
289 indn.n -= 2;
290 }
291 Iprintan(file, eldens_cm_3, "1/cm^3");
292 Iprintan(file, eldens, "MeV^3");
293 Iprintan(file, xeldens, "MeV^2/cm");
294 Iprintn(file, wpla);
296 Iprintan(file, Rutherford_const, "1/cm^3");
297 Iprintn(file, W);
298 Iprintn(file, F);
299 Iprintn(file, min_ioniz_pot);
300 Iprintn(file, energy_mesh->get_q());
301 if (l >= 2) {
302 long qe = energy_mesh->get_q();
303 long ne;
304 indn.n += 2;
305 Ifile << " ne energy ACS(Mb) ICS(Mb) ACS(1/MeV^2) "
306 "ICS(1/MeV^2) epsip epsi1 epsi2 "
307 "(1+epsi1)^2+epsi2^2\n";
308 for (ne = 0; ne < qe; ne++) {
309 Ifile << std::setw(3) << ne << ' ' << std::setw(12)
310 << energy_mesh->get_e(ne) << ' ' << std::setw(12) << ACS[ne] << ' '
311 << std::setw(12) << ICS[ne] << ' ' << std::setw(12)
312 << ACS[ne] * C1_MEV2_MBN << ' ' << std::setw(12)
313 << ICS[ne] * C1_MEV2_MBN << ' ' << std::setw(12) << epsip[ne] << ' '
314 << std::setw(12) << epsi1[ne] << ' ' << std::setw(12) << epsi2[ne]
315 << ' ' << std::setw(12)
316 << pow((1 + epsi1[ne]), 2) + pow(epsi2[ne], 2) << " \n";
317 }
318 indn.n -= 2;
319 }
320 indn.n -= 2;
321}
double eldens
Electron density MeV**3.
double wpla
Squared plasma energy;.
double xeldens
Long. electron density MeV**2/cm (for x=1 cm).
double eldens_cm_3
Electron density cm**-3.
std::vector< double > ACS
Photoabsorption cross section per one atom(Mb).
std::vector< double > epsip
Some plasma dielectric constant (not used, but just initialized for print)
std::vector< double > epsi1
Real part of dielectric constant (e_1 - 1).
double Rutherford_const
Const for Rutherford cross section (1/cm3).
std::vector< double > ICS
std::vector< double > epsi2
Imaginary part of dielectric constant.
double radiation_length
Radiation Length.
DoubleAc pow(const DoubleAc &f, double p)
Definition DoubleAc.cpp:337
constexpr double C1_MEV2_MBN
indentation indn
Definition prstream.cpp:15
#define Iprintan(file, name, addition)
Definition prstream.h:211
#define Ifile
Definition prstream.h:195
#define Iprintn(file, name)
Definition prstream.h:204

◆ replace_epsi12()

void Heed::HeedMatterDef::replace_epsi12 ( const std::string & file_name)

Definition at line 234 of file HeedMatterDef.cpp.

234 {
235 mfunnamep("void HeedMatterDef::replace_epsi12(const std::string& file_name)");
236
237 std::ifstream file(file_name.c_str());
238 if (!file) {
239 funnw.ehdr(mcerr);
240 mcerr << "cannot open file " << file_name << std::endl;
241 spexit(mcerr);
242 } else {
243 mcout << "file " << file_name << " is opened" << std::endl;
244 }
245 long qe = 0; // number of points in input mesh
246 file >> qe;
247 check_econd11(qe, <= 2, mcerr);
248
249 std::vector<double> ener(qe);
250 std::vector<double> eps1(qe);
251 std::vector<double> eps2(qe);
252
253 for (long ne = 0; ne < qe; ++ne) {
254 file >> ener[ne] >> eps1[ne] >> eps2[ne];
255 check_econd11(eps2[ne], < 0.0, mcerr);
256 if (ne > 0) {
257 check_econd12(ener[ne], <, ener[ne - 1], mcerr);
258 }
259 }
260
261 PointCoorMesh<double, std::vector<double> > pcmd(qe, &(ener));
262 double emin = ener[0] - 0.5 * (ener[1] - ener[0]);
263 double emax = ener[qe - 1] + 0.5 * (ener[qe - 1] - ener[qe - 2]);
264
265 qe = energy_mesh->get_q();
267 PointCoorMesh<double, std::vector<double> > >;
268 for (long ne = 0; ne < qe; ++ne) {
269 double ec = energy_mesh->get_ec(ne);
270 // pcmd: dimension q; eps1, eps2: dimension q - 1.
271 epsi1[ne] = interpolate(pcmd, eps1, ec, 0, 1, emin, 1, emax);
272 epsi2[ne] = interpolate(pcmd, eps2, ec, 1, 1, emin, 1, emax);
273 // Iprint3n(mcout, ec, epsi1[ne], epsi2[ne]);
274 }
275}
#define mfunnamep(string)
#define spexit(stream)
T t_value_straight_point_ar(const M &mesh, const D &y, T x, int s_ban_neg, int s_extrap_left, T left_bond, int s_extrap_right, T right_bond)
Definition tline.h:1590
#define mcout
Definition prstream.h:126

Member Data Documentation

◆ ACS

std::vector<double> Heed::HeedMatterDef::ACS

Photoabsorption cross section per one atom(Mb).

Definition at line 43 of file HeedMatterDef.h.

Referenced by print().

◆ apacs

◆ eldens

double Heed::HeedMatterDef::eldens = 0.

Electron density MeV**3.

Definition at line 32 of file HeedMatterDef.h.

Referenced by print().

◆ eldens_cm_3

double Heed::HeedMatterDef::eldens_cm_3 = 0.

Electron density cm**-3.

Definition at line 31 of file HeedMatterDef.h.

Referenced by print().

◆ energy_mesh

EnergyMesh* Heed::HeedMatterDef::energy_mesh = nullptr

◆ epsi1

std::vector<double> Heed::HeedMatterDef::epsi1

Real part of dielectric constant (e_1 - 1).

Definition at line 50 of file HeedMatterDef.h.

Referenced by print(), and replace_epsi12().

◆ epsi2

std::vector<double> Heed::HeedMatterDef::epsi2

Imaginary part of dielectric constant.

Definition at line 52 of file HeedMatterDef.h.

Referenced by print(), and replace_epsi12().

◆ epsip

std::vector<double> Heed::HeedMatterDef::epsip

Some plasma dielectric constant (not used, but just initialized for print)

Definition at line 48 of file HeedMatterDef.h.

Referenced by print().

◆ F

double Heed::HeedMatterDef::F = 0.

Fano factor.

Definition at line 38 of file HeedMatterDef.h.

Referenced by HeedMatterDef(), HeedMatterDef(), and print().

◆ ICS

std::vector<double> Heed::HeedMatterDef::ICS

Photoionization cross section per one atom(Mb).

Definition at line 44 of file HeedMatterDef.h.

Referenced by print().

◆ matter

◆ min_ioniz_pot

double Heed::HeedMatterDef::min_ioniz_pot = 0.

Minimum ionization potential. It is used only for switching off the Cherenkov radiation below it.

Definition at line 55 of file HeedMatterDef.h.

Referenced by print().

◆ radiation_length

double Heed::HeedMatterDef::radiation_length = 0.

Radiation Length.

Definition at line 35 of file HeedMatterDef.h.

Referenced by Heed::HeedParticle::physics(), and print().

◆ Rutherford_const

double Heed::HeedMatterDef::Rutherford_const = 0.

Const for Rutherford cross section (1/cm3).

Definition at line 36 of file HeedMatterDef.h.

Referenced by print().

◆ s_use_mixture_thresholds

int Heed::HeedMatterDef::s_use_mixture_thresholds = 0
staticconstexpr

Flag affecting mixtures of atoms with different ionization potentials. If 1, all energy transfers what is absorbed even with the energy less than the potential of ionization of single atom, but more than the minimal potential of ionization of the mixture, should ionize. This is emulation of Jesse effect in extreme case. It is likely not realistic. So the recommended value is 0.

Definition at line 87 of file HeedMatterDef.h.

◆ W

double Heed::HeedMatterDef::W = 0.

Mean work per pair production, MeV.

Definition at line 37 of file HeedMatterDef.h.

Referenced by HeedMatterDef(), HeedMatterDef(), and print().

◆ wpla

double Heed::HeedMatterDef::wpla = 0.

Squared plasma energy;.

Definition at line 34 of file HeedMatterDef.h.

Referenced by print().

◆ xeldens

double Heed::HeedMatterDef::xeldens = 0.

Long. electron density MeV**2/cm (for x=1 cm).

Definition at line 33 of file HeedMatterDef.h.

Referenced by print().


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