Geant4  10.02.p03
G4KleinNishinaModel Class Reference

#include <G4KleinNishinaModel.hh>

Inheritance diagram for G4KleinNishinaModel:
Collaboration diagram for G4KleinNishinaModel:

Public Member Functions

 G4KleinNishinaModel (const G4String &nam="KleinNishina")
 
virtual ~G4KleinNishinaModel ()
 
virtual void Initialise (const G4ParticleDefinition *, const G4DataVector &)
 
virtual void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel)
 
virtual G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A, G4double cut, G4double emax)
 
virtual void SampleSecondaries (std::vector< G4DynamicParticle *> *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy)
 
- Public Member Functions inherited from G4VEmModel
 G4VEmModel (const G4String &nam)
 
virtual ~G4VEmModel ()
 
virtual void InitialiseForMaterial (const G4ParticleDefinition *, const G4Material *)
 
virtual void InitialiseForElement (const G4ParticleDefinition *, G4int Z)
 
virtual G4double ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX)
 
virtual G4double CrossSectionPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double GetPartialCrossSection (const G4Material *, G4int, const G4ParticleDefinition *, G4double)
 
virtual G4double ComputeCrossSectionPerShell (const G4ParticleDefinition *, G4int Z, G4int shellIdx, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double ChargeSquareRatio (const G4Track &)
 
virtual G4double GetChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual G4double GetParticleCharge (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void StartTracking (G4Track *)
 
virtual void CorrectionsAlongStep (const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double &eloss, G4double &niel, G4double length)
 
virtual G4double Value (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cut=0.0)
 
virtual G4double MinEnergyCut (const G4ParticleDefinition *, const G4MaterialCutsCouple *)
 
virtual void SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void DefineForRegion (const G4Region *)
 
virtual void ModelDescription (std::ostream &outFile) const
 
void InitialiseElementSelectors (const G4ParticleDefinition *, const G4DataVector &)
 
std::vector< G4EmElementSelector * > * GetElementSelectors ()
 
void SetElementSelectors (std::vector< G4EmElementSelector *> *)
 
G4double ComputeDEDX (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX)
 
G4double CrossSection (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4double ComputeMeanFreePath (const G4ParticleDefinition *, G4double kineticEnergy, const G4Material *, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, const G4Element *, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4int SelectIsotopeNumber (const G4Element *)
 
const G4ElementSelectRandomAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectRandomAtom (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4int SelectRandomAtomNumber (const G4Material *)
 
void SetParticleChange (G4VParticleChange *, G4VEmFluctuationModel *f=0)
 
void SetCrossSectionTable (G4PhysicsTable *, G4bool isLocal)
 
G4ElementDataGetElementData ()
 
G4PhysicsTableGetCrossSectionTable ()
 
G4VEmFluctuationModelGetModelOfFluctuations ()
 
G4VEmAngularDistributionGetAngularDistribution ()
 
void SetAngularDistribution (G4VEmAngularDistribution *)
 
G4double HighEnergyLimit () const
 
G4double LowEnergyLimit () const
 
G4double HighEnergyActivationLimit () const
 
G4double LowEnergyActivationLimit () const
 
G4double PolarAngleLimit () const
 
G4double SecondaryThreshold () const
 
G4bool LPMFlag () const
 
G4bool DeexcitationFlag () const
 
G4bool ForceBuildTableFlag () const
 
G4bool UseAngularGeneratorFlag () const
 
void SetAngularGeneratorFlag (G4bool)
 
void SetHighEnergyLimit (G4double)
 
void SetLowEnergyLimit (G4double)
 
void SetActivationHighEnergyLimit (G4double)
 
void SetActivationLowEnergyLimit (G4double)
 
G4bool IsActive (G4double kinEnergy)
 
void SetPolarAngleLimit (G4double)
 
void SetSecondaryThreshold (G4double)
 
void SetLPMFlag (G4bool val)
 
void SetDeexcitationFlag (G4bool val)
 
void SetForceBuildTable (G4bool val)
 
void SetMasterThread (G4bool val)
 
G4bool IsMaster () const
 
G4double MaxSecondaryKinEnergy (const G4DynamicParticle *dynParticle)
 
const G4StringGetName () const
 
void SetCurrentCouple (const G4MaterialCutsCouple *)
 
const G4ElementGetCurrentElement () const
 
const G4IsotopeGetCurrentIsotope () const
 
G4bool IsLocked () const
 
void SetLocked (G4bool)
 

Protected Attributes

G4ParticleDefinitiontheGamma
 
G4ParticleDefinitiontheElectron
 
G4ParticleChangeForGamma * fParticleChange
 
G4double lowestSecondaryEnergy
 
- Protected Attributes inherited from G4VEmModel
G4ElementDatafElementData
 
G4VParticleChange * pParticleChange
 
G4PhysicsTablexSectionTable
 
const std::vector< G4double > * theDensityFactor
 
const std::vector< G4int > * theDensityIdx
 
size_t idxTable
 

Private Member Functions

G4KleinNishinaModeloperator= (const G4KleinNishinaModel &right)
 
 G4KleinNishinaModel (const G4KleinNishinaModel &)
 

Private Attributes

G4LorentzVector lv1
 
G4LorentzVector lv2
 
G4ThreeVector bst
 
G4VAtomDeexcitationfAtomDeexcitation
 
G4double limitFactor
 
std::vector< G4doublefProbabilities
 

Additional Inherited Members

- Protected Member Functions inherited from G4VEmModel
G4ParticleChangeForLoss * GetParticleChangeForLoss ()
 
G4ParticleChangeForGamma * GetParticleChangeForGamma ()
 
virtual G4double MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kineticEnergy)
 
const G4MaterialCutsCoupleCurrentCouple () const
 
void SetCurrentElement (const G4Element *)
 
- Static Protected Attributes inherited from G4VEmModel
static const G4double inveplus = 1.0/CLHEP::eplus
 

Detailed Description

Definition at line 59 of file G4KleinNishinaModel.hh.

Constructor & Destructor Documentation

◆ G4KleinNishinaModel() [1/2]

G4KleinNishinaModel::G4KleinNishinaModel ( const G4String nam = "KleinNishina")

Definition at line 77 of file G4KleinNishinaModel.cc.

78  : G4VEmModel(nam),
79  lv1(0.,0.,0.,0.),
80  lv2(0.,0.,0.,0.),
81  bst(0.,0.,0.)
82 {
86  limitFactor = 4;
87  fProbabilities.resize(9,0.0);
88  SetDeexcitationFlag(true);
89  fParticleChange = nullptr;
90  fAtomDeexcitation = nullptr;
91 }
G4ParticleChangeForGamma * fParticleChange
G4VEmModel(const G4String &nam)
Definition: G4VEmModel.cc:69
std::vector< G4double > fProbabilities
static G4Gamma * Gamma()
Definition: G4Gamma.cc:86
static const double eV
Definition: G4SIunits.hh:212
G4ParticleDefinition * theElectron
G4VAtomDeexcitation * fAtomDeexcitation
G4ParticleDefinition * theGamma
static G4Electron * Electron()
Definition: G4Electron.cc:94
void SetDeexcitationFlag(G4bool val)
Definition: G4VEmModel.hh:781
Here is the call graph for this function:

◆ ~G4KleinNishinaModel()

G4KleinNishinaModel::~G4KleinNishinaModel ( )
virtual

Definition at line 95 of file G4KleinNishinaModel.cc.

96 {}

◆ G4KleinNishinaModel() [2/2]

G4KleinNishinaModel::G4KleinNishinaModel ( const G4KleinNishinaModel )
private

Member Function Documentation

◆ ComputeCrossSectionPerAtom()

G4double G4KleinNishinaModel::ComputeCrossSectionPerAtom ( const G4ParticleDefinition ,
G4double  kinEnergy,
G4double  Z,
G4double  A,
G4double  cut,
G4double  emax 
)
virtual

Reimplemented from G4VEmModel.

Definition at line 121 of file G4KleinNishinaModel.cc.

125 {
126  G4double xSection = 0.0 ;
127  if (gammaEnergy <= LowEnergyLimit()) { return xSection; }
128 
129  static const G4double a = 20.0 , b = 230.0 , c = 440.0;
130 
131  G4double p1Z = Z*(d1 + e1*Z + f1*Z*Z), p2Z = Z*(d2 + e2*Z + f2*Z*Z),
132  p3Z = Z*(d3 + e3*Z + f3*Z*Z), p4Z = Z*(d4 + e4*Z + f4*Z*Z);
133 
134  G4double T0 = 15.0*keV;
135  if (Z < 1.5) { T0 = 40.0*keV; }
136 
137  G4double X = max(gammaEnergy, T0) / electron_mass_c2;
138  xSection = p1Z*G4Log(1.+2.*X)/X
139  + (p2Z + p3Z*X + p4Z*X*X)/(1. + a*X + b*X*X + c*X*X*X);
140 
141  // modification for low energy. (special case for Hydrogen)
142  if (gammaEnergy < T0) {
143  X = (T0+dT0) / electron_mass_c2 ;
144  G4double sigma = p1Z*G4Log(1.+2*X)/X
145  + (p2Z + p3Z*X + p4Z*X*X)/(1. + a*X + b*X*X + c*X*X*X);
146  G4double c1 = -T0*(sigma-xSection)/(xSection*dT0);
147  G4double c2 = 0.150;
148  if (Z > 1.5) { c2 = 0.375-0.0556*G4Log(Z); }
149  G4double y = G4Log(gammaEnergy/T0);
150  xSection *= G4Exp(-y*(c1+c2*y));
151  }
152 
153  if(xSection < 0.0) { xSection = 0.0; }
154  // G4cout << "e= " << GammaEnergy << " Z= " << Z
155  // << " cross= " << xSection << G4endl;
156  return xSection;
157 }
G4double LowEnergyLimit() const
Definition: G4VEmModel.hh:641
static const G4double e3
static const G4double d1
static const G4double e4
static const G4double d4
Float_t X
static const G4double f4
Double_t y
Float_t Z
static const G4double d2
float electron_mass_c2
Definition: hepunit.py:274
static const G4double e1
G4double G4Log(G4double x)
Definition: G4Log.hh:230
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
static const G4double e2
TCanvas * c2
Definition: plot_hist.C:75
static const G4double f1
static const double keV
Definition: G4SIunits.hh:213
double G4double
Definition: G4Types.hh:76
static const G4double d3
static const G4double f2
static const G4double dT0
static const G4double f3
Here is the call graph for this function:

◆ Initialise()

void G4KleinNishinaModel::Initialise ( const G4ParticleDefinition p,
const G4DataVector cuts 
)
virtual

Implements G4VEmModel.

Definition at line 100 of file G4KleinNishinaModel.cc.

102 {
104  if(IsMaster()) { InitialiseElementSelectors(p, cuts); }
105  if(nullptr == fParticleChange) {
107  }
108 }
static G4LossTableManager * Instance()
void InitialiseElementSelectors(const G4ParticleDefinition *, const G4DataVector &)
Definition: G4VEmModel.cc:148
G4ParticleChangeForGamma * fParticleChange
G4bool IsMaster() const
Definition: G4VEmModel.hh:718
G4VAtomDeexcitation * fAtomDeexcitation
G4VAtomDeexcitation * AtomDeexcitation()
G4ParticleChangeForGamma * GetParticleChangeForGamma()
Definition: G4VEmModel.cc:134
Here is the call graph for this function:

◆ InitialiseLocal()

void G4KleinNishinaModel::InitialiseLocal ( const G4ParticleDefinition ,
G4VEmModel masterModel 
)
virtual

Reimplemented from G4VEmModel.

Definition at line 112 of file G4KleinNishinaModel.cc.

114 {
116 }
void SetElementSelectors(std::vector< G4EmElementSelector *> *)
Definition: G4VEmModel.hh:810
std::vector< G4EmElementSelector * > * GetElementSelectors()
Definition: G4VEmModel.hh:802
Here is the call graph for this function:

◆ operator=()

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

◆ SampleSecondaries()

void G4KleinNishinaModel::SampleSecondaries ( std::vector< G4DynamicParticle *> *  fvect,
const G4MaterialCutsCouple couple,
const G4DynamicParticle aDynamicGamma,
G4double  tmin,
G4double  maxEnergy 
)
virtual

Implements G4VEmModel.

Definition at line 161 of file G4KleinNishinaModel.cc.

167 {
168  // primary gamma
169  G4double energy = aDynamicGamma->GetKineticEnergy();
170 
171  // do nothing below the threshold
172  if(energy <= LowEnergyLimit()) { return; }
173 
174  G4ThreeVector direction = aDynamicGamma->GetMomentumDirection();
175 
176  // select atom
177  const G4Element* elm = SelectRandomAtom(couple, theGamma, energy);
178 
179  // select shell first
180  G4int nShells = elm->GetNbOfAtomicShells();
181  if(nShells > (G4int)fProbabilities.size()) { fProbabilities.resize(nShells); }
182  G4double totprob = 0.0;
183  G4int i;
184  for(i=0; i<nShells; ++i) {
185  //G4double bindingEnergy = elm->GetAtomicShell(i);
186  totprob += elm->GetNbOfShellElectrons(i);
187  //totprob += elm->GetNbOfShellElectrons(i)/(bindingEnergy*bindingEnergy);
188  fProbabilities[i] = totprob;
189  }
190 
191  // Loop on sampling
192  G4int nloop = 0;
193 
194  G4double bindingEnergy, ePotEnergy, eKinEnergy;
195  G4double gamEnergy0, gamEnergy1;
196 
197  CLHEP::HepRandomEngine* rndmEngineMod = G4Random::getTheEngine();
198  G4double rndm[4];
199 
200  do {
201  ++nloop;
202 
203  // 4 random numbers to select e-
204  rndmEngineMod->flatArray(4, rndm);
205  G4double xprob = totprob*rndm[0];
206 
207  // select shell
208  for(i=0; i<nShells; ++i) { if(xprob <= fProbabilities[i]) { break; } }
209 
210  bindingEnergy = elm->GetAtomicShell(i);
211  lv1.set(0.0,0.0,energy,energy);
212  /*
213  G4cout << "nShells= " << nShells << " i= " << i
214  << " Egamma= " << energy << " Ebind= " << bindingEnergy
215  << G4endl;
216  */
217  // for rest frame of the electron
218  G4double x = -G4Log(rndm[1]);
219  eKinEnergy = bindingEnergy*x;
220  ePotEnergy = bindingEnergy*(1.0 + x);
221 
222  // for rest frame of the electron
223  G4double eTotMomentum = sqrt(eKinEnergy*(eKinEnergy + 2*electron_mass_c2));
224  G4double phi = rndm[2]*twopi;
225  G4double costet = 2*rndm[3] - 1;
226  G4double sintet = sqrt((1 - costet)*(1 + costet));
227  lv2.set(eTotMomentum*sintet*cos(phi),eTotMomentum*sintet*sin(phi),
228  eTotMomentum*costet,eKinEnergy + electron_mass_c2);
229  bst = lv2.boostVector();
230  lv1.boost(-bst);
231 
232  gamEnergy0 = lv1.e();
233 
234  // In the rest frame of the electron
235  // The scattered gamma energy is sampled according to Klein-Nishina formula
236  // The random number techniques of Butcher & Messel are used
237  // (Nuc Phys 20(1960),15).
238  G4double E0_m = gamEnergy0/electron_mass_c2;
239 
240  //G4cout << "Nloop= "<< nloop << " Ecm(keV)= " << gamEnergy0/keV << G4endl;
241  //
242  // sample the energy rate of the scattered gamma
243  //
244 
245  G4double epsilon, epsilonsq, onecost, sint2, greject ;
246 
247  G4double eps0 = 1./(1 + 2*E0_m);
248  G4double epsilon0sq = eps0*eps0;
249  G4double alpha1 = - G4Log(eps0);
250  G4double alpha2 = alpha1 + 0.5*(1 - epsilon0sq);
251 
252  do {
253  ++nloop;
254  // false interaction if too many iterations
255  if(nloop > nlooplim) { return; }
256 
257  // 3 random numbers to sample scattering
258  rndmEngineMod->flatArray(3, rndm);
259 
260  if ( alpha1 > alpha2*rndm[0] ) {
261  epsilon = G4Exp(-alpha1*rndm[1]); // epsilon0**r
262  epsilonsq = epsilon*epsilon;
263 
264  } else {
265  epsilonsq = epsilon0sq + (1.- epsilon0sq)*rndm[1];
266  epsilon = sqrt(epsilonsq);
267  }
268 
269  onecost = (1.- epsilon)/(epsilon*E0_m);
270  sint2 = onecost*(2.-onecost);
271  greject = 1. - epsilon*sint2/(1.+ epsilonsq);
272 
273  // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
274  } while (greject < rndm[2]);
275  gamEnergy1 = epsilon*gamEnergy0;
276 
277  // before scattering total 4-momentum in e- system
278  lv2.set(0.0,0.0,0.0,electron_mass_c2);
279  lv2 += lv1;
280 
281  //
282  // scattered gamma angles. ( Z - axis along the parent gamma)
283  //
284  if(sint2 < 0.0) { sint2 = 0.0; }
285  costet = 1. - onecost;
286  sintet = sqrt(sint2);
287  phi = twopi * rndmEngineMod->flat();
288 
289  // e- recoil
290  //
291  // in rest frame of the electron
292  G4ThreeVector gamDir = lv1.vect().unit();
293  G4ThreeVector v = G4ThreeVector(sintet*cos(phi),sintet*sin(phi),costet);
294  v.rotateUz(gamDir);
295  lv1.set(gamEnergy1*v.x(),gamEnergy1*v.y(),gamEnergy1*v.z(),gamEnergy1);
296  lv2 -= lv1;
297  //G4cout<<"Egam(keV)= " << lv1.e()/keV
298  // <<" Ee(keV)= " << (lv2.e()-electron_mass_c2)/keV << G4endl;
299  lv2.boost(bst);
300  eKinEnergy = lv2.e() - electron_mass_c2 - ePotEnergy;
301  //G4cout << "Nloop= " << nloop << " eKinEnergy= " << eKinEnergy << G4endl;
302 
303  // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
304  } while ( eKinEnergy < 0.0 );
305 
306  //
307  // update G4VParticleChange for the scattered gamma
308  //
309 
310  lv1.boost(bst);
311  gamEnergy1 = lv1.e();
312  if(gamEnergy1 > lowestSecondaryEnergy) {
313  G4ThreeVector gamDirection1 = lv1.vect().unit();
314  gamDirection1.rotateUz(direction);
315  fParticleChange->ProposeMomentumDirection(gamDirection1);
316  } else {
317  fParticleChange->ProposeTrackStatus(fStopAndKill);
318  gamEnergy1 = 0.0;
319  }
320  fParticleChange->SetProposedKineticEnergy(gamEnergy1);
321 
322  //
323  // kinematic of the scattered electron
324  //
325 
326  if(eKinEnergy > lowestSecondaryEnergy) {
327  G4ThreeVector eDirection = lv2.vect().unit();
328  eDirection.rotateUz(direction);
329  G4DynamicParticle* dp =
330  new G4DynamicParticle(theElectron,eDirection,eKinEnergy);
331  fvect->push_back(dp);
332  } else { eKinEnergy = 0.0; }
333 
334  G4double edep = energy - gamEnergy1 - eKinEnergy;
335  G4double esec = 0.0;
336 
337  // sample deexcitation
338  //
339  if(fAtomDeexcitation) {
340  G4int index = couple->GetIndex();
342  G4int Z = G4lrint(elm->GetZ());
344  const G4AtomicShell* shell = fAtomDeexcitation->GetAtomicShell(Z, as);
345  G4int nbefore = fvect->size();
346  fAtomDeexcitation->GenerateParticles(fvect, shell, Z, index);
347  G4int nafter = fvect->size();
348  //G4cout << "N1= " << nbefore << " N2= " << nafter << G4endl;
349  for (G4int j=nbefore; j<nafter; ++j) {
350  G4double e = ((*fvect)[j])->GetKineticEnergy();
351  if(esec + e > edep) {
352  // correct energy in order to have energy balance
353  e = edep - esec;
354  ((*fvect)[j])->SetKineticEnergy(e);
355  esec += e;
356  /*
357  G4cout << "### G4KleinNishinaModel Edep(eV)= " << edep/eV
358  << " Esec(eV)= " << esec/eV
359  << " E["<< j << "](eV)= " << e/eV
360  << " N= " << nafter
361  << " Z= " << Z << " shell= " << i
362  << " Ebind(keV)= " << bindingEnergy/keV
363  << " Eshell(keV)= " << shell->BindingEnergy()/keV
364  << G4endl;
365  */
366  // delete the rest of secondaries (should not happens)
367  for (G4int jj=nafter-1; jj>j; --jj) {
368  delete (*fvect)[jj];
369  fvect->pop_back();
370  }
371  break;
372  }
373  esec += e;
374  }
375  edep -= esec;
376  }
377  }
378  if(fabs(energy - gamEnergy1 - eKinEnergy - esec - edep) > eV) {
379  G4cout << "### G4KleinNishinaModel dE(eV)= "
380  << (energy - gamEnergy1 - eKinEnergy - esec - edep)/eV
381  << " shell= " << i
382  << " E(keV)= " << energy/keV
383  << " Ebind(keV)= " << bindingEnergy/keV
384  << " Eg(keV)= " << gamEnergy1/keV
385  << " Ee(keV)= " << eKinEnergy/keV
386  << " Esec(keV)= " << esec/keV
387  << " Edep(keV)= " << edep/keV
388  << G4endl;
389  }
390  // energy balance
391  if(edep > 0.0) {
392  fParticleChange->ProposeLocalEnergyDeposit(edep);
393  }
394 }
G4double LowEnergyLimit() const
Definition: G4VEmModel.hh:641
G4double GetAtomicShell(G4int index) const
Definition: G4Element.cc:365
G4bool CheckDeexcitationActiveRegion(G4int coupleIndex)
CLHEP::Hep3Vector G4ThreeVector
Int_t index
G4ParticleChangeForGamma * fParticleChange
virtual double flat()=0
int G4int
Definition: G4Types.hh:78
Double_t edep
Hep3Vector vect() const
virtual const G4AtomicShell * GetAtomicShell(G4int Z, G4AtomicShellEnumerator shell)=0
G4double GetKineticEnergy() const
G4GLOB_DLL std::ostream G4cout
double energy
Definition: plottest35.C:25
Float_t Z
std::vector< G4double > fProbabilities
HepLorentzVector & boost(double, double, double)
Hep3Vector unit() const
Hep3Vector & rotateUz(const Hep3Vector &)
Definition: ThreeVector.cc:38
static const double twopi
Definition: G4SIunits.hh:75
G4int GetNbOfAtomicShells() const
Definition: G4Element.hh:146
float electron_mass_c2
Definition: hepunit.py:274
G4int GetNbOfShellElectrons(G4int index) const
Definition: G4Element.cc:380
double x() const
G4double G4Log(G4double x)
Definition: G4Log.hh:230
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
static const double eV
Definition: G4SIunits.hh:212
void set(double x, double y, double z, double t)
G4ParticleDefinition * theElectron
int G4lrint(double ad)
Definition: templates.hh:163
double y() const
const G4ThreeVector & GetMomentumDirection() const
void GenerateParticles(std::vector< G4DynamicParticle *> *secVect, const G4AtomicShell *, G4int Z, G4int coupleIndex)
static const G4int nlooplim
Hep3Vector boostVector() const
double z() const
G4VAtomDeexcitation * fAtomDeexcitation
G4ParticleDefinition * theGamma
#define G4endl
Definition: G4ios.hh:61
static const double keV
Definition: G4SIunits.hh:213
double G4double
Definition: G4Types.hh:76
virtual void flatArray(const int size, double *vect)=0
G4double GetZ() const
Definition: G4Element.hh:131
double epsilon(double density, double temperature)
G4AtomicShellEnumerator
const G4Element * SelectRandomAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
Definition: G4VEmModel.hh:544
Here is the call graph for this function:

Member Data Documentation

◆ bst

G4ThreeVector G4KleinNishinaModel::bst
private

Definition at line 101 of file G4KleinNishinaModel.hh.

◆ fAtomDeexcitation

G4VAtomDeexcitation* G4KleinNishinaModel::fAtomDeexcitation
private

Definition at line 103 of file G4KleinNishinaModel.hh.

◆ fParticleChange

G4ParticleChangeForGamma* G4KleinNishinaModel::fParticleChange
protected

Definition at line 91 of file G4KleinNishinaModel.hh.

◆ fProbabilities

std::vector<G4double> G4KleinNishinaModel::fProbabilities
private

Definition at line 105 of file G4KleinNishinaModel.hh.

◆ limitFactor

G4double G4KleinNishinaModel::limitFactor
private

Definition at line 104 of file G4KleinNishinaModel.hh.

◆ lowestSecondaryEnergy

G4double G4KleinNishinaModel::lowestSecondaryEnergy
protected

Definition at line 92 of file G4KleinNishinaModel.hh.

◆ lv1

G4LorentzVector G4KleinNishinaModel::lv1
private

Definition at line 100 of file G4KleinNishinaModel.hh.

◆ lv2

G4LorentzVector G4KleinNishinaModel::lv2
private

Definition at line 100 of file G4KleinNishinaModel.hh.

◆ theElectron

G4ParticleDefinition* G4KleinNishinaModel::theElectron
protected

Definition at line 90 of file G4KleinNishinaModel.hh.

◆ theGamma

G4ParticleDefinition* G4KleinNishinaModel::theGamma
protected

Definition at line 89 of file G4KleinNishinaModel.hh.


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