Geant4 11.1.1
Toolkit for the simulation of the passage of particles through matter
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
G4BetheBlochModel.cc
Go to the documentation of this file.
1//
2// ********************************************************************
3// * License and Disclaimer *
4// * *
5// * The Geant4 software is copyright of the Copyright Holders of *
6// * the Geant4 Collaboration. It is provided under the terms and *
7// * conditions of the Geant4 Software License, included in the file *
8// * LICENSE and available at http://cern.ch/geant4/license . These *
9// * include a list of copyright holders. *
10// * *
11// * Neither the authors of this software system, nor their employing *
12// * institutes,nor the agencies providing financial support for this *
13// * work make any representation or warranty, express or implied, *
14// * regarding this software system or assume any liability for its *
15// * use. Please see the license in the file LICENSE and URL above *
16// * for the full disclaimer and the limitation of liability. *
17// * *
18// * This code implementation is the result of the scientific and *
19// * technical work of the GEANT4 collaboration. *
20// * By using, copying, modifying or distributing the software (or *
21// * any work based on the software) you agree to acknowledge its *
22// * use in resulting scientific publications, and indicate your *
23// * acceptance of all terms of the Geant4 Software license. *
24// ********************************************************************
25//
26// -------------------------------------------------------------------
27//
28// GEANT4 Class header file
29//
30//
31// File name: G4BetheBlochModel
32//
33// Author: Vladimir Ivanchenko on base of Laszlo Urban code
34//
35// Creation date: 03.01.2002
36//
37// Modifications:
38//
39// 04-12-02 Fix problem of G4DynamicParticle constructor (V.Ivanchenko)
40// 23-12-02 Change interface in order to move to cut per region (V.Ivanchenko)
41// 27-01-03 Make models region aware (V.Ivanchenko)
42// 13-02-03 Add name (V.Ivanchenko)
43// 24-03-05 Add G4EmCorrections (V.Ivanchenko)
44// 11-04-05 Major optimisation of internal interfaces (V.Ivanchenko)
45// 11-02-06 ComputeCrossSectionPerElectron, ComputeCrossSectionPerAtom (mma)
46// 12-02-06 move G4LossTableManager::Instance()->EmCorrections()
47// in constructor (mma)
48// 12-08-08 Added methods GetParticleCharge, GetChargeSquareRatio,
49// CorrectionsAlongStep needed for ions(V.Ivanchenko)
50//
51// -------------------------------------------------------------------
52//
53
54
55//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
56//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
57
58#include "G4BetheBlochModel.hh"
59#include "Randomize.hh"
61#include "G4SystemOfUnits.hh"
62#include "G4NistManager.hh"
63#include "G4Electron.hh"
64#include "G4LossTableManager.hh"
65#include "G4EmCorrections.hh"
66#include "G4EmParameters.hh"
69#include "G4Log.hh"
70#include "G4DeltaAngle.hh"
71
72//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
73
74using namespace std;
75
77 const G4String& nam)
78 : G4VEmModel(nam),
79 twoln10(2.0*G4Log(10.0)),
80 fAlphaTlimit(1*CLHEP::GeV),
81 fProtonTlimit(10*CLHEP::GeV)
82{
83 theElectron = G4Electron::Electron();
86 SetLowEnergyLimit(2.0*CLHEP::MeV);
87}
88
89//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
90
92
93//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
94
96 const G4DataVector&)
97{
98 if(p != particle) { SetupParameters(p); }
99
100 //G4cout << "G4BetheBlochModel::Initialise for " << p->GetParticleName()
101 // << " isIon= " << isIon
102 // << G4endl;
103
104 // always false before the run
105 SetDeexcitationFlag(false);
106
107 // initialisation once
108 if(nullptr == fParticleChange) {
109 const G4String& pname = particle->GetParticleName();
110 if(IsMaster() && G4EmParameters::Instance()->UseICRU90Data() &&
111 (pname == "proton" || pname == "GenericIon" || pname == "alpha")) {
112 fICRU90 = nist->GetICRU90StoppingData();
113 fICRU90->Initialise();
114 }
115 if(particle->GetPDGCharge() > CLHEP::eplus ||
116 pname == "GenericIon") { isIon = true; }
117 if(pname == "alpha") { isAlpha = true; }
118
119 fParticleChange = GetParticleChangeForLoss();
120 if(UseAngularGeneratorFlag() && nullptr == GetAngularDistribution()) {
122 }
123 }
124}
125
126//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
127
129 const G4Material* mat,
130 G4double kineticEnergy)
131{
132 // this method is called only for ions, so no check if it is an ion
133 return
134 (!isAlpha) ? corr->EffectiveChargeSquareRatio(p,mat,kineticEnergy) : 1.0;
135}
136
137//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
138
140 const G4Material* mat,
141 G4double kineticEnergy)
142{
143 // this method is called only for ions, so no check if it is an ion
144 return corr->GetParticleCharge(p,mat,kineticEnergy);
145}
146
147//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo....
148
149void G4BetheBlochModel::SetupParameters(const G4ParticleDefinition* p)
150{
151 particle = p;
152 mass = particle->GetPDGMass();
153 spin = particle->GetPDGSpin();
154 G4double q = particle->GetPDGCharge()*inveplus;
155 isIon = (!isAlpha && q > 1.1);
156 chargeSquare = q*q;
157 ratio = electron_mass_c2/mass;
158 static const G4double aMag = 1./(0.5*eplus*CLHEP::hbar_Planck*CLHEP::c_squared);
159 G4double magmom = particle->GetPDGMagneticMoment()*mass*aMag;
160 magMoment2 = magmom*magmom - 1.0;
161 formfact = 0.0;
162 tlimit = DBL_MAX;
163 if(particle->GetLeptonNumber() == 0) {
164 G4double x = 0.8426*CLHEP::GeV;
165 if(spin == 0.0 && mass < CLHEP::GeV) { x = 0.736*CLHEP::GeV; }
166 else if (mass > CLHEP::GeV) {
167 G4int iz = G4lrint(std::abs(q));
168 if(iz > 1) { x /= nist->GetA27(iz); }
169 }
170 formfact = 2.0*CLHEP::electron_mass_c2/(x*x);
171 tlimit = 2.0/formfact;
172 }
173}
174
175//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
176
178 const G4MaterialCutsCouple* couple)
179{
181}
182
183//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
184
187 G4double kineticEnergy,
188 G4double cutEnergy,
189 G4double maxKinEnergy)
190{
191 G4double cross = 0.0;
192 G4double tmax = MaxSecondaryEnergy(p, kineticEnergy);
193 G4double maxEnergy = std::min(tmax, maxKinEnergy);
194 if(cutEnergy < maxEnergy) {
195
196 G4double totEnergy = kineticEnergy + mass;
197 G4double energy2 = totEnergy*totEnergy;
198 G4double beta2 = kineticEnergy*(kineticEnergy + 2.0*mass)/energy2;
199
200 cross = (maxEnergy - cutEnergy)/(cutEnergy*maxEnergy)
201 - beta2*G4Log(maxEnergy/cutEnergy)/tmax;
202
203 // +term for spin=1/2 particle
204 if( 0.0 < spin ) { cross += 0.5*(maxEnergy - cutEnergy)/energy2; }
205
206 cross *= CLHEP::twopi_mc2_rcl2*chargeSquare/beta2;
207 }
208
209 // G4cout << "BB: e= " << kineticEnergy << " tmin= " << cutEnergy
210 // << " tmax= " << tmax << " cross= " << cross << G4endl;
211
212 return cross;
213}
214
215//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
216
218 const G4ParticleDefinition* p,
219 G4double kinEnergy,
221 G4double cutEnergy,
222 G4double maxEnergy)
223{
224 return Z*ComputeCrossSectionPerElectron(p,kinEnergy,cutEnergy,maxEnergy);
225}
226
227//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
228
230 const G4Material* mat,
231 const G4ParticleDefinition* p,
232 G4double kinEnergy,
233 G4double cutEnergy,
234 G4double maxEnergy)
235{
236 G4double sigma = mat->GetElectronDensity()
237 *ComputeCrossSectionPerElectron(p,kinEnergy,cutEnergy,maxEnergy);
238 if(isAlpha) {
239 sigma *= corr->EffectiveChargeSquareRatio(p,mat,kinEnergy)/chargeSquare;
240 }
241 return sigma;
242}
243
244//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
245
247 const G4ParticleDefinition* p,
248 G4double kineticEnergy,
249 G4double cut)
250{
251 const G4double tmax = MaxSecondaryEnergy(p, kineticEnergy);
252 // projectile formfactor limit energy loss
253 const G4double cutEnergy = std::min(std::min(cut,tmax), tlimit);
254
255 G4double tau = kineticEnergy/mass;
256 G4double gam = tau + 1.0;
257 G4double bg2 = tau * (tau+2.0);
258 G4double beta2 = bg2/(gam*gam);
259 G4double xc = cutEnergy/tmax;
260
261 G4double eexc = material->GetIonisation()->GetMeanExcitationEnergy();
262 G4double eexc2 = eexc*eexc;
263
264 G4double eDensity = material->GetElectronDensity();
265
266 // added ICRU90 stopping data for limited list of materials
267 /*
268 G4cout << "### DEDX ICRI90:" << (nullptr != fICRU90)
269 << " Ekin=" << kineticEnergy
270 << " " << p->GetParticleName()
271 << " q2=" << chargeSquare
272 << " inside " << material->GetName() << G4endl;
273 */
274 if(nullptr != fICRU90 && kineticEnergy < fProtonTlimit) {
275 if(material != currentMaterial) {
276 currentMaterial = material;
277 baseMaterial = material->GetBaseMaterial()
278 ? material->GetBaseMaterial() : material;
279 iICRU90 = fICRU90->GetIndex(baseMaterial);
280 }
281 if(iICRU90 >= 0) {
282 G4double dedx = 0.0;
283 // only for alpha
284 if(isAlpha) {
285 if(kineticEnergy <= fAlphaTlimit) {
286 dedx = fICRU90->GetElectronicDEDXforAlpha(iICRU90, kineticEnergy);
287 } else {
288 const G4double e = kineticEnergy*CLHEP::proton_mass_c2/mass;
289 dedx = fICRU90->GetElectronicDEDXforProton(iICRU90, e)*chargeSquare;
290 }
291 } else {
292 dedx = fICRU90->GetElectronicDEDXforProton(iICRU90, kineticEnergy)
293 *chargeSquare;
294 }
295 dedx *= material->GetDensity();
296 if(cutEnergy < tmax) {
297 dedx += (G4Log(xc) + (1.0 - xc)*beta2)*CLHEP::twopi_mc2_rcl2
298 *(eDensity*chargeSquare/beta2);
299 }
300 //G4cout << " iICRU90=" << iICRU90 << " dedx=" << dedx << G4endl;
301 if(dedx > 0.0) { return dedx; }
302 }
303 }
304 // general Bethe-Bloch formula
305 G4double dedx = G4Log(2.0*CLHEP::electron_mass_c2*bg2*cutEnergy/eexc2)
306 - (1.0 + xc)*beta2;
307
308 if(0.0 < spin) {
309 G4double del = 0.5*cutEnergy/(kineticEnergy + mass);
310 dedx += del*del;
311 }
312
313 // density correction
314 G4double x = G4Log(bg2)/twoln10;
315 dedx -= material->GetIonisation()->DensityCorrection(x);
316
317 // shell correction
318 dedx -= 2.0*corr->ShellCorrection(p,material,kineticEnergy);
319
320 // now compute the total ionization loss
321 dedx *= CLHEP::twopi_mc2_rcl2*chargeSquare*eDensity/beta2;
322
323 //High order correction different for hadrons and ions
324 if(isIon) {
325 dedx += corr->IonBarkasCorrection(p,material,kineticEnergy);
326 } else {
327 dedx += corr->HighOrderCorrections(p,material,kineticEnergy,cutEnergy);
328 }
329
330 dedx = std::max(dedx, 0.0);
331 /*
332 G4cout << "E(MeV)= " << kineticEnergy/CLHEP::MeV << " dedx= " << dedx
333 << " " << material->GetName() << G4endl;
334 */
335 return dedx;
336}
337
338//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
339
341 const G4DynamicParticle* dp,
342 const G4double& /*length*/,
343 G4double& eloss)
344{
345 // no correction for alpha
346 if(isAlpha) { return; }
347
348 // no correction at the last step or at small step
349 const G4double preKinEnergy = dp->GetKineticEnergy();
350 if(eloss >= preKinEnergy || eloss < preKinEnergy*0.05) { return; }
351
352 // corrections for all charged particles with Q > 1
353 const G4ParticleDefinition* p = dp->GetDefinition();
354 if(p != particle) { SetupParameters(p); }
355 if(!isIon) { return; }
356
357 // effective energy and charge at a step
358 const G4double e = std::max(preKinEnergy - eloss*0.5, preKinEnergy*0.5);
359 const G4Material* mat = couple->GetMaterial();
360 const G4double q20 = corr->EffectiveChargeSquareRatio(p, mat, preKinEnergy);
361 const G4double q2 = corr->EffectiveChargeSquareRatio(p, mat, e);
362 const G4double qfactor = q2/q20;
363
364 /*
365 G4cout << "G4BetheBlochModel::CorrectionsAlongStep: Epre(MeV)="
366 << preKinEnergy << " Eeff(MeV)=" << e
367 << " eloss=" << eloss << " elossnew=" << eloss*qfactor
368 << " qfactor=" << qfactor << " Qpre=" << q20
369 << p->GetParticleName() <<G4endl;
370 */
371 eloss *= qfactor;
372}
373
374//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
375
376void G4BetheBlochModel::SampleSecondaries(vector<G4DynamicParticle*>* vdp,
377 const G4MaterialCutsCouple* couple,
378 const G4DynamicParticle* dp,
379 G4double minKinEnergy,
380 G4double maxEnergy)
381{
382 G4double kineticEnergy = dp->GetKineticEnergy();
383 const G4double tmax = MaxSecondaryEnergy(dp->GetDefinition(),kineticEnergy);
384 const G4double maxKinEnergy = std::min(maxEnergy,tmax);
385 if(minKinEnergy >= maxKinEnergy) { return; }
386
387 //G4cout << "G4BetheBlochModel::SampleSecondaries Emin= " << minKinEnergy
388 // << " Emax= " << maxKinEnergy << G4endl;
389
390 const G4double totEnergy = kineticEnergy + mass;
391 const G4double etot2 = totEnergy*totEnergy;
392 const G4double beta2 = kineticEnergy*(kineticEnergy + 2.0*mass)/etot2;
393
394 G4double deltaKinEnergy, f;
395 G4double f1 = 0.0;
396 G4double fmax = 1.0;
397 if( 0.0 < spin ) { fmax += 0.5*maxKinEnergy*maxKinEnergy/etot2; }
398
399 CLHEP::HepRandomEngine* rndmEngineMod = G4Random::getTheEngine();
400 G4double rndm[2];
401
402 // sampling without nuclear size effect
403 do {
404 rndmEngineMod->flatArray(2, rndm);
405 deltaKinEnergy = minKinEnergy*maxKinEnergy
406 /(minKinEnergy*(1.0 - rndm[0]) + maxKinEnergy*rndm[0]);
407
408 f = 1.0 - beta2*deltaKinEnergy/tmax;
409 if( 0.0 < spin ) {
410 f1 = 0.5*deltaKinEnergy*deltaKinEnergy/etot2;
411 f += f1;
412 }
413
414 // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
415 } while( fmax*rndm[1] > f);
416
417 // projectile formfactor - suppresion of high energy
418 // delta-electron production at high energy
419
420 G4double x = formfact*deltaKinEnergy;
421 if(x > 1.e-6) {
422
423 G4double x1 = 1.0 + x;
424 G4double grej = 1.0/(x1*x1);
425 if( 0.0 < spin ) {
426 G4double x2 = 0.5*electron_mass_c2*deltaKinEnergy/(mass*mass);
427 grej *= (1.0 + magMoment2*(x2 - f1/f)/(1.0 + x2));
428 }
429 if(grej > 1.1) {
430 G4cout << "### G4BetheBlochModel WARNING: grej= " << grej
431 << " " << dp->GetDefinition()->GetParticleName()
432 << " Ekin(MeV)= " << kineticEnergy
433 << " delEkin(MeV)= " << deltaKinEnergy
434 << G4endl;
435 }
436 if(rndmEngineMod->flat() > grej) { return; }
437 }
438
439 G4ThreeVector deltaDirection;
440
442 const G4Material* mat = couple->GetMaterial();
443 deltaDirection =
444 GetAngularDistribution()->SampleDirection(dp, deltaKinEnergy,
446 mat);
447 } else {
448
449 G4double deltaMomentum =
450 sqrt(deltaKinEnergy * (deltaKinEnergy + 2.0*electron_mass_c2));
451 G4double cost = deltaKinEnergy * (totEnergy + electron_mass_c2) /
452 (deltaMomentum * dp->GetTotalMomentum());
453 cost = std::min(cost, 1.0);
454 const G4double sint = std::sqrt((1.0 - cost)*(1.0 + cost));
455 const G4double phi = twopi*rndmEngineMod->flat();
456
457 deltaDirection.set(sint*std::cos(phi),sint*std::sin(phi), cost) ;
458 deltaDirection.rotateUz(dp->GetMomentumDirection());
459 }
460 /*
461 G4cout << "### G4BetheBlochModel "
462 << dp->GetDefinition()->GetParticleName()
463 << " Ekin(MeV)= " << kineticEnergy
464 << " delEkin(MeV)= " << deltaKinEnergy
465 << " tmin(MeV)= " << minKinEnergy
466 << " tmax(MeV)= " << maxKinEnergy
467 << " dir= " << dp->GetMomentumDirection()
468 << " dirDelta= " << deltaDirection
469 << G4endl;
470 */
471 // create G4DynamicParticle object for delta ray
472 auto delta = new G4DynamicParticle(theElectron,deltaDirection,deltaKinEnergy);
473
474 vdp->push_back(delta);
475
476 // Change kinematics of primary particle
477 kineticEnergy -= deltaKinEnergy;
478 G4ThreeVector finalP = dp->GetMomentum() - delta->GetMomentum();
479 finalP = finalP.unit();
480
481 fParticleChange->SetProposedKineticEnergy(kineticEnergy);
482 fParticleChange->SetProposedMomentumDirection(finalP);
483}
484
485//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo....
486
488 G4double kinEnergy)
489{
490 // here particle type is checked for the case,
491 // when this model is shared between particles
492 if(pd != particle) { SetupParameters(pd); }
493 G4double tau = kinEnergy/mass;
494 return 2.0*CLHEP::electron_mass_c2*tau*(tau + 2.) /
495 (1. + 2.0*(tau + 1.)*ratio + ratio*ratio);
496}
497
498//....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
G4double G4Log(G4double x)
Definition: G4Log.hh:227
double G4double
Definition: G4Types.hh:83
int G4int
Definition: G4Types.hh:85
const G4int Z[17]
#define G4endl
Definition: G4ios.hh:57
G4GLOB_DLL std::ostream G4cout
Hep3Vector unit() const
void set(double x, double y, double z)
Hep3Vector & rotateUz(const Hep3Vector &)
Definition: ThreeVector.cc:33
virtual double flat()=0
virtual void flatArray(const int size, double *vect)=0
void CorrectionsAlongStep(const G4MaterialCutsCouple *couple, const G4DynamicParticle *dp, const G4double &length, G4double &eloss) override
void Initialise(const G4ParticleDefinition *, const G4DataVector &) override
G4double ComputeDEDXPerVolume(const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy) override
virtual G4double ComputeCrossSectionPerElectron(const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy)
void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy) override
G4double GetParticleCharge(const G4ParticleDefinition *p, const G4Material *mat, G4double kineticEnergy) override
G4double GetChargeSquareRatio() const
~G4BetheBlochModel() override
G4double MinEnergyCut(const G4ParticleDefinition *, const G4MaterialCutsCouple *couple) override
G4double ComputeCrossSectionPerAtom(const G4ParticleDefinition *, G4double kineticEnergy, G4double Z, G4double A, G4double cutEnergy, G4double maxEnergy) override
G4double MaxSecondaryEnergy(const G4ParticleDefinition *, G4double kinEnergy) override
G4double CrossSectionPerVolume(const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy) override
G4BetheBlochModel(const G4ParticleDefinition *p=nullptr, const G4String &nam="BetheBloch")
const G4ThreeVector & GetMomentumDirection() const
G4ParticleDefinition * GetDefinition() const
G4double GetKineticEnergy() const
G4ThreeVector GetMomentum() const
G4double GetTotalMomentum() const
static G4Electron * Electron()
Definition: G4Electron.cc:93
G4double EffectiveChargeSquareRatio(const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
G4double IonBarkasCorrection(const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
G4double HighOrderCorrections(const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy, G4double cutEnergy)
G4double ShellCorrection(const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
G4double GetParticleCharge(const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
static G4EmParameters * Instance()
G4double GetElectronicDEDXforProton(const G4Material *, G4double kinEnergy) const
G4int GetIndex(const G4Material *) const
G4double GetElectronicDEDXforAlpha(const G4Material *, G4double scaledKinEnergy) const
G4double DensityCorrection(G4double x) const
G4double GetMeanExcitationEnergy() const
static G4LossTableManager * Instance()
G4EmCorrections * EmCorrections()
const G4Material * GetMaterial() const
G4double GetDensity() const
Definition: G4Material.hh:175
const G4Material * GetBaseMaterial() const
Definition: G4Material.hh:228
G4IonisParamMat * GetIonisation() const
Definition: G4Material.hh:221
G4double GetElectronDensity() const
Definition: G4Material.hh:212
G4ICRU90StoppingData * GetICRU90StoppingData()
G4double GetA27(G4int Z) const
static G4NistManager * Instance()
void SetProposedKineticEnergy(G4double proposedKinEnergy)
void SetProposedMomentumDirection(const G4ThreeVector &dir)
G4double GetPDGMagneticMoment() const
G4double GetPDGCharge() const
const G4String & GetParticleName() const
virtual G4ThreeVector & SampleDirection(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, const G4Material *)=0
G4VEmAngularDistribution * GetAngularDistribution()
Definition: G4VEmModel.hh:600
G4double inveplus
Definition: G4VEmModel.hh:427
G4int SelectRandomAtomNumber(const G4Material *) const
Definition: G4VEmModel.cc:253
G4bool IsMaster() const
Definition: G4VEmModel.hh:725
void SetLowEnergyLimit(G4double)
Definition: G4VEmModel.hh:753
void SetDeexcitationFlag(G4bool val)
Definition: G4VEmModel.hh:802
void SetAngularDistribution(G4VEmAngularDistribution *)
Definition: G4VEmModel.hh:607
G4bool UseAngularGeneratorFlag() const
Definition: G4VEmModel.hh:697
G4ParticleChangeForLoss * GetParticleChangeForLoss()
Definition: G4VEmModel.cc:109
Definition: DoubConv.h:17
int G4lrint(double ad)
Definition: templates.hh:134
#define DBL_MAX
Definition: templates.hh:62