Geant4  10.02.p03
G4GEMProbability Class Reference

#include <G4GEMProbability.hh>

Inherits G4VEmissionProbability.

Inherited by G4AlphaGEMProbability, G4B10GEMProbability, G4B11GEMProbability, G4B12GEMProbability, G4B13GEMProbability, G4B8GEMProbability, G4Be10GEMProbability, G4Be11GEMProbability, G4Be12GEMProbability, G4Be7GEMProbability, G4Be9GEMProbability, G4C10GEMProbability, G4C11GEMProbability, G4C12GEMProbability, G4C13GEMProbability, G4C14GEMProbability, G4C15GEMProbability, G4C16GEMProbability, G4DeuteronGEMProbability, G4F17GEMProbability, G4F18GEMProbability, G4F19GEMProbability, G4F20GEMProbability, G4F21GEMProbability, G4He3GEMProbability, G4He6GEMProbability, G4He8GEMProbability, G4Li6GEMProbability, G4Li7GEMProbability, G4Li8GEMProbability, G4Li9GEMProbability, G4Mg22GEMProbability, G4Mg23GEMProbability, G4Mg24GEMProbability, G4Mg25GEMProbability, G4Mg26GEMProbability, G4Mg27GEMProbability, G4Mg28GEMProbability, G4N12GEMProbability, G4N13GEMProbability, G4N14GEMProbability, G4N15GEMProbability, G4N16GEMProbability, G4N17GEMProbability, G4Na21GEMProbability, G4Na22GEMProbability, G4Na23GEMProbability, G4Na24GEMProbability, G4Na25GEMProbability, G4Ne18GEMProbability, G4Ne19GEMProbability, G4Ne20GEMProbability, G4Ne21GEMProbability, G4Ne22GEMProbability, G4Ne23GEMProbability, G4Ne24GEMProbability, G4NeutronGEMProbability, G4O14GEMProbability, G4O15GEMProbability, G4O16GEMProbability, G4O17GEMProbability, G4O18GEMProbability, G4O19GEMProbability, G4O20GEMProbability, G4ProtonGEMProbability, and G4TritonGEMProbability.

Collaboration diagram for G4GEMProbability:

Public Member Functions

 G4GEMProbability (G4int anA, G4int aZ, G4double aSpin)
 
virtual ~G4GEMProbability ()
 
G4double EmissionProbability (const G4Fragment &fragment, G4double anEnergy)
 
void Dump () const
 
G4int GetZ_asInt (void) const
 
G4int GetA_asInt (void) const
 
G4double GetZ (void) const
 
G4double GetA (void) const
 
G4double GetSpin (void) const
 
void SetCoulomBarrier (const G4VCoulombBarrier *aCoulombBarrierStrategy)
 
G4double GetCoulombBarrier (const G4Fragment &fragment) const
 
G4double CalcAlphaParam (const G4Fragment &) const
 
G4double CalcBetaParam (const G4Fragment &) const
 
- Public Member Functions inherited from G4VEmissionProbability
 G4VEmissionProbability ()
 
virtual ~G4VEmissionProbability ()
 
void SetOPTxs (G4int opt)
 
void UseSICB (G4bool use)
 

Protected Attributes

G4double fPlanck
 
std::vector< G4doubleExcitEnergies
 
std::vector< G4doubleExcitSpins
 
std::vector< G4doubleExcitLifetimes
 
- Protected Attributes inherited from G4VEmissionProbability
G4int OPTxs
 
G4bool useSICB
 
G4PowfG4pow
 
G4PairingCorrectionfPairCorr
 
G4EvaporationLevelDensityParametertheEvapLDPptr
 

Private Member Functions

G4double CalcProbability (const G4Fragment &fragment, G4double MaximalKineticEnergy, G4double V)
 
G4double CCoeficient (G4int) const
 
G4double I0 (G4double t)
 
G4double I1 (G4double t, G4double tx)
 
G4double I2 (G4double s0, G4double sx)
 
G4double I3 (G4double s0, G4double sx)
 
 G4GEMProbability ()
 
 G4GEMProbability (const G4GEMProbability &right)
 
const G4GEMProbabilityoperator= (const G4GEMProbability &right)
 
G4bool operator== (const G4GEMProbability &right) const
 
G4bool operator!= (const G4GEMProbability &right) const
 

Private Attributes

G4PowfG4pow
 
G4PairingCorrectionfPairCorr
 
G4VLevelDensityParametertheEvapLDPptr
 
G4int theA
 
G4int theZ
 
G4double Spin
 
const G4VCoulombBarriertheCoulombBarrierPtr
 

Detailed Description

Definition at line 54 of file G4GEMProbability.hh.

Constructor & Destructor Documentation

◆ G4GEMProbability() [1/3]

G4GEMProbability::G4GEMProbability ( G4int  anA,
G4int  aZ,
G4double  aSpin 
)

Definition at line 59 of file G4GEMProbability.cc.

59  :
60  theA(anA), theZ(aZ), Spin(aSpin), theCoulombBarrierPtr(0)
61 {
66 }
static G4Pow * GetInstance()
Definition: G4Pow.cc:55
G4double logZ(G4int Z) const
Definition: G4Pow.hh:166
G4PairingCorrection * fPairCorr
const G4VCoulombBarrier * theCoulombBarrierPtr
G4VLevelDensityParameter * theEvapLDPptr
static G4PairingCorrection * GetInstance()
static const double hbar_Planck
Here is the call graph for this function:

◆ ~G4GEMProbability()

G4GEMProbability::~G4GEMProbability ( )
virtual

Definition at line 68 of file G4GEMProbability.cc.

69 {
70  delete theEvapLDPptr;
71 }
G4VLevelDensityParameter * theEvapLDPptr

◆ G4GEMProbability() [2/3]

G4GEMProbability::G4GEMProbability ( )
private

◆ G4GEMProbability() [3/3]

G4GEMProbability::G4GEMProbability ( const G4GEMProbability right)
private

Member Function Documentation

◆ CalcAlphaParam()

G4double G4GEMProbability::CalcAlphaParam ( const G4Fragment fragment) const
inline

Definition at line 202 of file G4GEMProbability.hh.

203 {
204  //JMQ 190709 values according to Furihata's paper (based on notes added
205  //on proof in Dostrovskii's paper)
206  G4double res;
207  if(GetZ_asInt() == 0) {
208  res = 0.76+1.93/fG4pow->Z13(fragment.GetA_asInt()-GetA_asInt());
209  } else {
210  res = 1.0 + CCoeficient(fragment.GetZ_asInt()-GetZ_asInt());
211  }
212  return res;
213 }
G4int GetA_asInt() const
Definition: G4Fragment.hh:256
G4int GetZ_asInt() const
Definition: G4Fragment.hh:261
G4double CCoeficient(G4int) const
G4double Z13(G4int Z) const
Definition: G4Pow.hh:127
G4int GetZ_asInt(void) const
G4int GetA_asInt(void) const
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

◆ CalcBetaParam()

G4double G4GEMProbability::CalcBetaParam ( const G4Fragment fragment) const
inline

Definition at line 216 of file G4GEMProbability.hh.

217 {
218  //JMQ 190709 values according to Furihata's paper (based on notes added
219  //on proof in Dostrovskii's paper)
220  G4double res;
221  if(GetZ_asInt() == 0) {
222  res = (1.66/fG4pow->Z23(fragment.GetA_asInt()-GetA_asInt())-0.05)*CLHEP::MeV/
223  CalcAlphaParam(fragment);
224  } else {
225  res = -GetCoulombBarrier(fragment);
226  }
227  return res;
228 }
G4double CalcAlphaParam(const G4Fragment &) const
G4int GetA_asInt() const
Definition: G4Fragment.hh:256
G4double GetCoulombBarrier(const G4Fragment &fragment) const
G4int GetZ_asInt(void) const
G4int GetA_asInt(void) const
double G4double
Definition: G4Types.hh:76
G4double Z23(G4int Z) const
Definition: G4Pow.hh:154
static const double MeV
Here is the call graph for this function:
Here is the caller graph for this function:

◆ CalcProbability()

G4double G4GEMProbability::CalcProbability ( const G4Fragment fragment,
G4double  MaximalKineticEnergy,
G4double  V 
)
private

Definition at line 110 of file G4GEMProbability.cc.

115 {
116  G4int A = fragment.GetA_asInt();
117  G4int Z = fragment.GetZ_asInt();
118 
119  G4int ResidualA = A - theA;
120  G4int ResidualZ = Z - theZ;
121  G4double U = fragment.GetExcitationEnergy();
122 
123  G4double NuclearMass = fragment.ComputeGroundStateMass(theZ, theA);
124 
125  G4double Alpha = CalcAlphaParam(fragment);
126  G4double Beta = CalcBetaParam(fragment);
127 
128  // ***RESIDUAL***
129  //JMQ (September 2009) the following quantities refer to the RESIDUAL:
130 
131  G4double delta0 = fPairCorr->GetPairingCorrection(ResidualA, ResidualZ);
132 
134  LevelDensityParameter(ResidualA,ResidualZ,MaximalKineticEnergy+V-delta0);
135  G4double Ux = (2.5 + 150.0/G4double(ResidualA))*MeV;
136  G4double Ex = Ux + delta0;
137  G4double T = 1.0/(std::sqrt(a/Ux) - 1.5/Ux);
138  //JMQ fixed bug in units
139  G4double E0 = Ex - T*(G4Log(T/MeV) - G4Log(a*MeV)/4.0
140  - 1.25*G4Log(Ux/MeV) + 2.0*std::sqrt(a*Ux));
141  // ***end RESIDUAL ***
142  // ***PARENT***
143  //JMQ (September 2009) the following quantities refer to the PARENT:
144 
145  G4double deltaCN = fPairCorr->GetPairingCorrection(A, Z);
146  G4double aCN = theEvapLDPptr->LevelDensityParameter(A, Z, U-deltaCN);
147  G4double UxCN = (2.5 + 150.0/G4double(A))*MeV;
148  G4double ExCN = UxCN + deltaCN;
149  G4double TCN = 1.0/(std::sqrt(aCN/UxCN) - 1.5/UxCN);
150  // ***end PARENT***
151 
152  G4double Width;
153  G4double InitialLevelDensity;
154  G4double t = MaximalKineticEnergy/T;
155  if ( MaximalKineticEnergy < Ex ) {
156  //JMQ 190709 bug in I1 fixed (T was missing)
157  Width = (I1(t,t)*T + (Beta+V)*I0(t))/G4Exp(E0/T);
158  //JMQ 160909 fix: InitialLevelDensity has been taken away
159  //(different conditions for initial CN..)
160  } else {
161 
162  //VI minor speedup
163  G4double expE0T = G4Exp(E0/T);
164  static const G4double sqrt2 = std::sqrt(2.0);
165 
166  G4double tx = Ex/T;
167  G4double s0 = 2.0*std::sqrt(a*(MaximalKineticEnergy-delta0));
168  G4double sx = 2.0*std::sqrt(a*(Ex-delta0));
169  // VI: protection against FPE exception
170  if(s0 > 350.) { s0 = 350.; }
171  Width = I1(t,tx)*T/expE0T + I3(s0,sx)*G4Exp(s0)/(sqrt2*a);
172 
173  // VI this cannot happen!
174  // For charged particles (Beta+V) = 0 beacuse Beta = -V
175  //if (theZ == 0) {
176  // Width += (Beta+V)*(I0(tx)/expE0T + 2.0*sqrt2*I2(s0,sx)*G4Exp(s0));
177  //}
178  }
179 
180  //JMQ 14/07/2009 BIG BUG : NuclearMass is in MeV => hbarc instead of
181  // hbar_planck must be used
182  // G4double g = (2.0*Spin+1.0)*NuclearMass/(pi2* hbar_Planck*hbar_Planck);
183  G4double gg = (2.0*Spin+1.0)*NuclearMass/(pi2* hbarc*hbarc);
184 
185  //JMQ 190709 fix on Rb and geometrical cross sections according to
186  // Furihata's paper (JAERI-Data/Code 2001-105, p6)
187  G4double Rb = 0.0;
188  if (theA > 4)
189  {
190  G4double Ad = fG4pow->Z13(ResidualA);
191  G4double Aj = fG4pow->Z13(theA);
192  Rb = 1.12*(Aj + Ad) - 0.86*((Aj+Ad)/(Aj*Ad))+2.85;
193  Rb *= fermi;
194  }
195  else if (theA>1)
196  {
197  G4double Ad = fG4pow->Z13(ResidualA);
198  G4double Aj = fG4pow->Z13(theA);
199  Rb=1.5*(Aj+Ad)*fermi;
200  }
201  else
202  {
203  G4double Ad = fG4pow->Z13(ResidualA);
204  Rb = 1.5*Ad*fermi;
205  }
206  G4double GeometricalXS = pi*Rb*Rb;
207  //end of JMQ fix on Rb by 190709
208 
209  //JMQ 160909 fix: initial level density must be calculated according to the
210  // conditions at the initial compound nucleus
211  // (it has been removed from previous "if" for the residual)
212 
213  if ( U < ExCN )
214  {
215  //JMQ fixed bug in units
216  //VI moved the computation here
217  G4double E0CN = ExCN - TCN*(G4Log(TCN/MeV) - 0.25*G4Log(aCN*MeV)
218  - 1.25*G4Log(UxCN/MeV)
219  + 2.0*std::sqrt(aCN*UxCN));
220 
221  InitialLevelDensity = (pi/12.0)*G4Exp((U-E0CN)/TCN)/TCN;
222  }
223  else
224  {
225  //VI speedup
226  G4double x = U-deltaCN;
227  G4double x1 = std::sqrt(aCN*x);
228 
229  InitialLevelDensity = (pi/12.0)*G4Exp(2*x1)/(x*std::sqrt(x1));
230  }
231 
232  //JMQ 190709 BUG : pi instead of sqrt(pi) must be here according
233  // to Furihata's report:
234  Width *= pi*gg*GeometricalXS*Alpha/(12.0*InitialLevelDensity);
235 
236  return Width;
237 }
G4double I3(G4double s0, G4double sx)
G4double CalcAlphaParam(const G4Fragment &) const
G4double GetExcitationEnergy() const
Definition: G4Fragment.hh:273
static const double MeV
Definition: G4SIunits.hh:211
G4double GetPairingCorrection(G4int A, G4int Z) const
G4double I1(G4double t, G4double tx)
G4int GetA_asInt() const
Definition: G4Fragment.hh:256
G4PairingCorrection * fPairCorr
G4double ComputeGroundStateMass(G4int Z, G4int A) const
Definition: G4Fragment.hh:246
G4double CalcBetaParam(const G4Fragment &) const
static const double pi2
Definition: G4SIunits.hh:77
int G4int
Definition: G4Types.hh:78
double A(double temperature)
G4int GetZ_asInt() const
Definition: G4Fragment.hh:261
float hbarc
Definition: hepunit.py:265
Float_t Z
Double_t x1[nxs]
G4VLevelDensityParameter * theEvapLDPptr
G4double Z13(G4int Z) const
Definition: G4Pow.hh:127
G4double G4Log(G4double x)
Definition: G4Log.hh:230
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
static const double pi
Definition: G4SIunits.hh:74
virtual G4double LevelDensityParameter(G4int A, G4int Z, G4double U) const =0
G4double I0(G4double t)
double G4double
Definition: G4Types.hh:76
static const double fermi
Definition: G4SIunits.hh:102
Here is the call graph for this function:
Here is the caller graph for this function:

◆ CCoeficient()

G4double G4GEMProbability::CCoeficient ( G4int  aZ) const
inlineprivate

Definition at line 186 of file G4GEMProbability.hh.

187 {
188  //JMQ 190709 C's values from Furihata's paper
189  //(notes added on proof in Dostrovskii's paper)
190  //data = {{20, 0.}, {30, -0.06}, {40, -0.10}, {50, -0.10}};
191  G4double C = 0.0;
192  if (aZ >= 50){
193  C=-0.10/G4double(theA);
194  } else if (aZ > 20) {
195  C=(0.123482-0.00534691*aZ-0.0000610624*aZ*aZ+5.93719*1e-7*aZ*aZ*aZ+
196  1.95687*1e-8*aZ*aZ*aZ*aZ)/G4double(theA);
197  }
198  return C;
199 }
double C(double temp)
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

◆ Dump()

void G4GEMProbability::Dump ( ) const

Definition at line 261 of file G4GEMProbability.cc.

262 {
264  G4double efermi = 0.0;
265  if(theA > 1) {
267  + neutron_mass_c2 - mass;
268  }
269  G4int nlev = ExcitEnergies.size();
270  G4cout << "GEM: List of Excited States for Isotope Z= "
271  << theZ << " A= " << theA << " Nlevels= " << nlev
272  << " Efermi(MeV)= " << efermi
273  << G4endl;
274  for(G4int i=0; i< nlev; ++i) {
275  G4cout << "Z= " << theZ << " A= " << theA
276  << " Mass(GeV)= " << mass/GeV
277  << " Eexc(MeV)= " << ExcitEnergies[i]
278  << " Time(ns)= " << ExcitLifetimes[i]/ns
279  << G4endl;
280  }
281  G4cout << G4endl;
282 }
static G4double GetNuclearMass(const G4double A, const G4double Z)
std::vector< G4double > ExcitLifetimes
int G4int
Definition: G4Types.hh:78
G4GLOB_DLL std::ostream G4cout
static const double GeV
Definition: G4SIunits.hh:214
std::vector< G4double > ExcitEnergies
float neutron_mass_c2
Definition: hepunit.py:276
#define G4endl
Definition: G4ios.hh:61
double G4double
Definition: G4Types.hh:76
#define ns
Definition: xmlparse.cc:614
Here is the call graph for this function:
Here is the caller graph for this function:

◆ EmissionProbability()

G4double G4GEMProbability::EmissionProbability ( const G4Fragment fragment,
G4double  anEnergy 
)
virtual

Implements G4VEmissionProbability.

Definition at line 73 of file G4GEMProbability.cc.

75 {
76  G4double probability = 0.0;
77 
78  if (MaximalKineticEnergy > 0.0 && fragment.GetExcitationEnergy() > 0.0) {
79  G4double CoulombBarrier = GetCoulombBarrier(fragment);
80 
81  probability =
82  CalcProbability(fragment,MaximalKineticEnergy,CoulombBarrier);
83 
84  // Next there is a loop over excited states for this channel
85  // summing probabilities
86  size_t nn = ExcitEnergies.size();
87  if (0 < nn) {
88  G4double SavedSpin = Spin;
89  for (size_t i = 0; i <nn; ++i) {
90  Spin = ExcitSpins[i];
91  // substract excitation energies
92  G4double Tmax = MaximalKineticEnergy - ExcitEnergies[i];
93  if (Tmax > 0.0) {
94  G4double width = CalcProbability(fragment,Tmax,CoulombBarrier);
95  //JMQ April 2010 added condition to prevent reported crash
96  // update probability
97  if (width > 0. && fPlanck < width*ExcitLifetimes[i]) {
98  probability += width;
99  }
100  }
101  }
102  // Restore Spin
103  Spin = SavedSpin;
104  }
105  }
106  // Normalization = probability;
107  return probability;
108 }
G4double GetExcitationEnergy() const
Definition: G4Fragment.hh:273
#define width
G4double CalcProbability(const G4Fragment &fragment, G4double MaximalKineticEnergy, G4double V)
std::vector< G4double > ExcitLifetimes
G4double GetCoulombBarrier(const G4Fragment &fragment) const
std::vector< G4double > ExcitSpins
std::vector< G4double > ExcitEnergies
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:

◆ GetA()

G4double G4GEMProbability::GetA ( void  ) const
inline

Definition at line 151 of file G4GEMProbability.hh.

152 {
153  return theA;
154 }

◆ GetA_asInt()

G4int G4GEMProbability::GetA_asInt ( void  ) const
inline

Definition at line 141 of file G4GEMProbability.hh.

142 {
143  return theA;
144 }
Here is the caller graph for this function:

◆ GetCoulombBarrier()

G4double G4GEMProbability::GetCoulombBarrier ( const G4Fragment fragment) const
inline

Definition at line 173 of file G4GEMProbability.hh.

174 {
175  G4double res = 0.0;
176  if (theCoulombBarrierPtr) {
177  G4int Acomp = fragment.GetA_asInt();
178  G4int Zcomp = fragment.GetZ_asInt();
179  res = theCoulombBarrierPtr->GetCoulombBarrier(Acomp-theA, Zcomp-theZ,
180  fragment.GetExcitationEnergy() -
181  fPairCorr->GetPairingCorrection(Acomp,Zcomp));
182  }
183  return res;
184 }
G4double GetExcitationEnergy() const
Definition: G4Fragment.hh:273
G4double GetPairingCorrection(G4int A, G4int Z) const
G4int GetA_asInt() const
Definition: G4Fragment.hh:256
G4PairingCorrection * fPairCorr
int G4int
Definition: G4Types.hh:78
G4int GetZ_asInt() const
Definition: G4Fragment.hh:261
const G4VCoulombBarrier * theCoulombBarrierPtr
virtual G4double GetCoulombBarrier(G4int ARes, G4int ZRes, G4double U) const =0
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

◆ GetSpin()

G4double G4GEMProbability::GetSpin ( void  ) const
inline

Definition at line 156 of file G4GEMProbability.hh.

157 {
158  return Spin;
159 }
Here is the caller graph for this function:

◆ GetZ()

G4double G4GEMProbability::GetZ ( void  ) const
inline

Definition at line 146 of file G4GEMProbability.hh.

147 {
148  return theZ;
149 }

◆ GetZ_asInt()

G4int G4GEMProbability::GetZ_asInt ( void  ) const
inline

Definition at line 136 of file G4GEMProbability.hh.

137 {
138  return theZ;
139 }
Here is the caller graph for this function:

◆ I0()

G4double G4GEMProbability::I0 ( G4double  t)
inlineprivate

Definition at line 230 of file G4GEMProbability.hh.

231 {
232  return G4Exp(t) - 1.0;
233 }
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
Here is the call graph for this function:
Here is the caller graph for this function:

◆ I1()

G4double G4GEMProbability::I1 ( G4double  t,
G4double  tx 
)
inlineprivate

Definition at line 235 of file G4GEMProbability.hh.

236 {
237  return (t - tx + 1.0)*G4Exp(tx) - t - 1.0;
238 }
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
Here is the call graph for this function:
Here is the caller graph for this function:

◆ I2()

G4double G4GEMProbability::I2 ( G4double  s0,
G4double  sx 
)
inlineprivate

Definition at line 241 of file G4GEMProbability.hh.

242 {
243  G4double S = 1.0/std::sqrt(s0);
244  G4double Sx = 1.0/std::sqrt(sx);
245 
246  G4double p1 = S*S*S*( 1.0 + S*S*( 1.5 + 3.75*S*S) );
247  G4double p2 = Sx*Sx*Sx*( 1.0 + Sx*Sx*( 1.5 + 3.75*Sx*Sx) )*G4Exp(sx-s0);
248 
249  return p1-p2;
250 }
double S(double temp)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:

◆ I3()

G4double G4GEMProbability::I3 ( G4double  s0,
G4double  sx 
)
private

Definition at line 239 of file G4GEMProbability.cc.

240 {
241  G4double s2 = s0*s0;
242  G4double sx2 = sx*sx;
243  G4double S = 1.0/std::sqrt(s0);
244  G4double S2 = S*S;
245  G4double Sx = 1.0/std::sqrt(sx);
246  G4double Sx2 = Sx*Sx;
247 
248  G4double p1 = S *(2.0 + S2 *( 4.0 + S2 *( 13.5 + S2 *( 60.0 + S2 * 325.125 ))));
249  G4double p2 = Sx*Sx2 *(
250  (s2-sx2) + Sx2 *(
251  (1.5*s2+0.5*sx2) + Sx2 *(
252  (3.75*s2+0.25*sx2) + Sx2 *(
253  (12.875*s2+0.625*sx2) + Sx2 *(
254  (59.0625*s2+0.9375*sx2) + Sx2 *(324.8*s2+3.28*sx2))))));
255 
256  p2 *= G4Exp(sx-s0);
257 
258  return p1-p2;
259 }
double S(double temp)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

◆ operator!=()

G4bool G4GEMProbability::operator!= ( const G4GEMProbability right) const
private

◆ operator=()

const G4GEMProbability& G4GEMProbability::operator= ( const G4GEMProbability right)
private

◆ operator==()

G4bool G4GEMProbability::operator== ( const G4GEMProbability right) const
private

◆ SetCoulomBarrier()

void G4GEMProbability::SetCoulomBarrier ( const G4VCoulombBarrier aCoulombBarrierStrategy)
inline

Definition at line 167 of file G4GEMProbability.hh.

168 {
169  theCoulombBarrierPtr = aCoulombBarrierStrategy;
170 }
const G4VCoulombBarrier * theCoulombBarrierPtr

Member Data Documentation

◆ ExcitEnergies

std::vector<G4double> G4GEMProbability::ExcitEnergies
protected

Definition at line 126 of file G4GEMProbability.hh.

◆ ExcitLifetimes

std::vector<G4double> G4GEMProbability::ExcitLifetimes
protected

Definition at line 132 of file G4GEMProbability.hh.

◆ ExcitSpins

std::vector<G4double> G4GEMProbability::ExcitSpins
protected

Definition at line 129 of file G4GEMProbability.hh.

◆ fG4pow

G4Pow* G4GEMProbability::fG4pow
private

Definition at line 107 of file G4GEMProbability.hh.

◆ fPairCorr

G4PairingCorrection* G4GEMProbability::fPairCorr
private

Definition at line 108 of file G4GEMProbability.hh.

◆ fPlanck

G4double G4GEMProbability::fPlanck
protected

Definition at line 123 of file G4GEMProbability.hh.

◆ Spin

G4double G4GEMProbability::Spin
private

Definition at line 116 of file G4GEMProbability.hh.

◆ theA

G4int G4GEMProbability::theA
private

Definition at line 112 of file G4GEMProbability.hh.

◆ theCoulombBarrierPtr

const G4VCoulombBarrier* G4GEMProbability::theCoulombBarrierPtr
private

Definition at line 119 of file G4GEMProbability.hh.

◆ theEvapLDPptr

G4VLevelDensityParameter* G4GEMProbability::theEvapLDPptr
private

Definition at line 110 of file G4GEMProbability.hh.

◆ theZ

G4int G4GEMProbability::theZ
private

Definition at line 113 of file G4GEMProbability.hh.


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