Geant4 11.2.2
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4BraggModel Class Reference

#include <G4BraggModel.hh>

+ Inheritance diagram for G4BraggModel:

Public Member Functions

 G4BraggModel (const G4ParticleDefinition *p=nullptr, const G4String &nam="Bragg")
 
 ~G4BraggModel () override
 
void Initialise (const G4ParticleDefinition *, const G4DataVector &) override
 
G4double MinEnergyCut (const G4ParticleDefinition *, const G4MaterialCutsCouple *couple) override
 
G4double ComputeCrossSectionPerElectron (const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy)
 
G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double kineticEnergy, G4double Z, G4double A, G4double cutEnergy, G4double maxEnergy) override
 
G4double CrossSectionPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy) override
 
G4double ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy) override
 
void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy) override
 
G4double GetChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy) override
 
G4double GetParticleCharge (const G4ParticleDefinition *p, const G4Material *mat, G4double kineticEnergy) override
 
G4BraggModeloperator= (const G4BraggModel &right)=delete
 
 G4BraggModel (const G4BraggModel &)=delete
 
- Public Member Functions inherited from G4VEmModel
 G4VEmModel (const G4String &nam)
 
virtual ~G4VEmModel ()
 
virtual void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel)
 
virtual void InitialiseForMaterial (const G4ParticleDefinition *, const G4Material *)
 
virtual void InitialiseForElement (const G4ParticleDefinition *, G4int Z)
 
virtual G4double GetPartialCrossSection (const G4Material *, G4int level, const G4ParticleDefinition *, G4double kineticEnergy)
 
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 void StartTracking (G4Track *)
 
virtual void CorrectionsAlongStep (const G4MaterialCutsCouple *, const G4DynamicParticle *, const G4double &length, G4double &eloss)
 
virtual G4double Value (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cut=0.0)
 
virtual void SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void DefineForRegion (const G4Region *)
 
virtual void FillNumberOfSecondaries (G4int &numberOfTriplets, G4int &numberOfRecoil)
 
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)
 
const G4ElementSelectRandomAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectTargetAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double logKineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectRandomAtom (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementGetCurrentElement (const G4Material *mat=nullptr) const
 
G4int SelectRandomAtomNumber (const G4Material *) const
 
const G4IsotopeGetCurrentIsotope (const G4Element *elm=nullptr) const
 
G4int SelectIsotopeNumber (const G4Element *) const
 
void SetParticleChange (G4VParticleChange *, G4VEmFluctuationModel *f=nullptr)
 
void SetCrossSectionTable (G4PhysicsTable *, G4bool isLocal)
 
G4ElementDataGetElementData ()
 
G4PhysicsTableGetCrossSectionTable ()
 
G4VEmFluctuationModelGetModelOfFluctuations ()
 
G4VEmAngularDistributionGetAngularDistribution ()
 
G4VEmModelGetTripletModel ()
 
void SetTripletModel (G4VEmModel *)
 
void SetAngularDistribution (G4VEmAngularDistribution *)
 
G4double HighEnergyLimit () const
 
G4double LowEnergyLimit () const
 
G4double HighEnergyActivationLimit () const
 
G4double LowEnergyActivationLimit () const
 
G4double PolarAngleLimit () const
 
G4double SecondaryThreshold () 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) const
 
void SetPolarAngleLimit (G4double)
 
void SetSecondaryThreshold (G4double)
 
void SetDeexcitationFlag (G4bool val)
 
void SetForceBuildTable (G4bool val)
 
void SetFluctuationFlag (G4bool val)
 
void SetMasterThread (G4bool val)
 
G4bool IsMaster () const
 
void SetUseBaseMaterials (G4bool val)
 
G4bool UseBaseMaterials () const
 
G4double MaxSecondaryKinEnergy (const G4DynamicParticle *dynParticle)
 
const G4StringGetName () const
 
void SetCurrentCouple (const G4MaterialCutsCouple *)
 
G4bool IsLocked () const
 
void SetLocked (G4bool)
 
void SetLPMFlag (G4bool)
 
G4VEmModeloperator= (const G4VEmModel &right)=delete
 
 G4VEmModel (const G4VEmModel &)=delete
 

Protected Member Functions

void SetParticle (const G4ParticleDefinition *p)
 
G4double MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kinEnergy) final
 
void SetChargeSquareRatio (G4double val)
 
- Protected Member Functions inherited from G4VEmModel
G4ParticleChangeForLossGetParticleChangeForLoss ()
 
G4ParticleChangeForGammaGetParticleChangeForGamma ()
 
const G4MaterialCutsCoupleCurrentCouple () const
 
void SetCurrentElement (const G4Element *)
 

Protected Attributes

const G4ParticleDefinitionparticle = nullptr
 
G4ParticleDefinitiontheElectron = nullptr
 
G4ParticleChangeForLossfParticleChange = nullptr
 
const G4MaterialcurrentMaterial = nullptr
 
const G4MaterialbaseMaterial = nullptr
 
G4EmCorrectionscorr = nullptr
 
G4double mass = 0.0
 
G4double spin = 0.0
 
G4double chargeSquare = 1.0
 
G4double massRate = 1.0
 
G4double ratio = 1.0
 
G4double protonMassAMU = 1.007276
 
G4double lowestKinEnergy
 
G4double theZieglerFactor
 
G4double expStopPower125
 
G4int iMolecula = -1
 
G4int iPSTAR = -1
 
G4int iICRU90 = -1
 
- Protected Attributes inherited from G4VEmModel
G4ElementDatafElementData = nullptr
 
G4VParticleChangepParticleChange = nullptr
 
G4PhysicsTablexSectionTable = nullptr
 
const G4MaterialpBaseMaterial = nullptr
 
const std::vector< G4double > * theDensityFactor = nullptr
 
const std::vector< G4int > * theDensityIdx = nullptr
 
G4double inveplus
 
G4double pFactor = 1.0
 
std::size_t currentCoupleIndex = 0
 
std::size_t basedCoupleIndex = 0
 
G4bool lossFlucFlag = true
 

Static Protected Attributes

static G4ICRU90StoppingDatafICRU90 = nullptr
 
static G4PSTARStoppingfPSTAR = nullptr
 

Detailed Description

Definition at line 70 of file G4BraggModel.hh.

Constructor & Destructor Documentation

◆ G4BraggModel() [1/2]

G4BraggModel::G4BraggModel ( const G4ParticleDefinition * p = nullptr,
const G4String & nam = "Bragg" )
explicit

Definition at line 91 of file G4BraggModel.cc.

92 : G4VEmModel(nam)
93{
94 SetHighEnergyLimit(2.0*CLHEP::MeV);
95
96 lowestKinEnergy = 0.25*CLHEP::keV;
97 theZieglerFactor = CLHEP::eV*CLHEP::cm2*1.0e-15;
99 expStopPower125 = 0.0;
100
102 if(nullptr != p) { SetParticle(p); }
103 else { SetParticle(theElectron); }
104}
G4double lowestKinEnergy
G4double theZieglerFactor
void SetParticle(const G4ParticleDefinition *p)
G4EmCorrections * corr
G4ParticleDefinition * theElectron
G4double expStopPower125
static G4Electron * Electron()
Definition G4Electron.cc:91
static G4LossTableManager * Instance()
G4EmCorrections * EmCorrections()
void SetHighEnergyLimit(G4double)
G4VEmModel(const G4String &nam)
Definition G4VEmModel.cc:67

◆ ~G4BraggModel()

G4BraggModel::~G4BraggModel ( )
override

Definition at line 108 of file G4BraggModel.cc.

109{
110 if(isFirst) {
111 delete fPSTAR;
112 fPSTAR = nullptr;
113 }
114}
static G4PSTARStopping * fPSTAR

◆ G4BraggModel() [2/2]

G4BraggModel::G4BraggModel ( const G4BraggModel & )
delete

Member Function Documentation

◆ ComputeCrossSectionPerAtom()

G4double G4BraggModel::ComputeCrossSectionPerAtom ( const G4ParticleDefinition * p,
G4double kineticEnergy,
G4double Z,
G4double A,
G4double cutEnergy,
G4double maxEnergy )
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 232 of file G4BraggModel.cc.

237{
238 return
239 Z*ComputeCrossSectionPerElectron(p,kineticEnergy,cutEnergy,maxEnergy);
240}
G4double ComputeCrossSectionPerElectron(const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy, G4double maxEnergy)

◆ ComputeCrossSectionPerElectron()

G4double G4BraggModel::ComputeCrossSectionPerElectron ( const G4ParticleDefinition * p,
G4double kineticEnergy,
G4double cutEnergy,
G4double maxEnergy )

Definition at line 202 of file G4BraggModel.cc.

207{
208 G4double cross = 0.0;
209 const G4double tmax = MaxSecondaryEnergy(p, kineticEnergy);
210 const G4double maxEnergy = std::min(tmax, maxKinEnergy);
211 const G4double cutEnergy = std::max(cut, lowestKinEnergy*massRate);
212 if(cutEnergy < maxEnergy) {
213
214 const G4double energy = kineticEnergy + mass;
215 const G4double energy2 = energy*energy;
216 const G4double beta2 = kineticEnergy*(kineticEnergy + 2.0*mass)/energy2;
217 cross = (maxEnergy - cutEnergy)/(cutEnergy*maxEnergy)
218 - beta2*G4Log(maxEnergy/cutEnergy)/tmax;
219
220 if( 0.0 < spin ) { cross += 0.5*(maxEnergy - cutEnergy)/energy2; }
221
222 cross *= CLHEP::twopi_mc2_rcl2*chargeSquare/beta2;
223 }
224 // G4cout << "BR: e= " << kineticEnergy << " tmin= " << cutEnergy
225 // << " tmax= " << tmax << " cross= " << cross << G4endl;
226 return cross;
227}
G4double G4Log(G4double x)
Definition G4Log.hh:227
double G4double
Definition G4Types.hh:83
G4double massRate
G4double MaxSecondaryEnergy(const G4ParticleDefinition *, G4double kinEnergy) final
G4double chargeSquare
G4double energy(const ThreeVector &p, const G4double m)

Referenced by G4BraggIonModel::ComputeCrossSectionPerAtom(), ComputeCrossSectionPerAtom(), G4LindhardSorensenIonModel::ComputeCrossSectionPerElectron(), G4BraggIonModel::CrossSectionPerVolume(), and CrossSectionPerVolume().

◆ ComputeDEDXPerVolume()

G4double G4BraggModel::ComputeDEDXPerVolume ( const G4Material * material,
const G4ParticleDefinition * p,
G4double kineticEnergy,
G4double cutEnergy )
overridevirtual

Reimplemented from G4VEmModel.

Reimplemented in G4BraggNoDeltaModel.

Definition at line 256 of file G4BraggModel.cc.

260{
261 const G4double tmax = MaxSecondaryEnergy(p, kinEnergy);
262 const G4double tlim = lowestKinEnergy*massRate;
263 const G4double tmin = std::max(std::min(cut, tmax), tlim);
264 G4double dedx = 0.0;
265
266 if(kinEnergy < tlim) {
267 dedx = DEDX(material, lowestKinEnergy)*std::sqrt(kinEnergy/tlim);
268 } else {
269 dedx = DEDX(material, kinEnergy);
270
271 if (tmin < tmax) {
272 const G4double tau = kinEnergy/mass;
273 const G4double x = tmin/tmax;
274
275 dedx += (G4Log(x)*(tau + 1.)*(tau + 1.)/(tau * (tau + 2.0)) + 1.0 - x) *
276 CLHEP::twopi_mc2_rcl2 * material->GetElectronDensity();
277 }
278 }
279 dedx = std::max(dedx, 0.0) * chargeSquare;
280
281 //G4cout << "E(MeV)= " << tkin/MeV << " dedx= " << dedx
282 // << " " << material->GetName() << G4endl;
283 return dedx;
284}
G4double GetElectronDensity() const

Referenced by G4LindhardSorensenIonModel::ComputeDEDXPerVolume().

◆ CrossSectionPerVolume()

G4double G4BraggModel::CrossSectionPerVolume ( const G4Material * material,
const G4ParticleDefinition * p,
G4double kineticEnergy,
G4double cutEnergy,
G4double maxEnergy )
overridevirtual

Reimplemented from G4VEmModel.

Reimplemented in G4BraggNoDeltaModel.

Definition at line 244 of file G4BraggModel.cc.

249{
250 return material->GetElectronDensity()
251 *ComputeCrossSectionPerElectron(p,kineticEnergy,cutEnergy,maxEnergy);
252}

◆ GetChargeSquareRatio()

G4double G4BraggModel::GetChargeSquareRatio ( const G4ParticleDefinition * p,
const G4Material * mat,
G4double kineticEnergy )
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 173 of file G4BraggModel.cc.

176{
177 // this method is called only for ions
178 chargeSquare = corr->EffectiveChargeSquareRatio(p, mat, kinEnergy);
179 return chargeSquare;
180}
G4double EffectiveChargeSquareRatio(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)

Referenced by G4BraggIonModel::GetChargeSquareRatio().

◆ GetParticleCharge()

G4double G4BraggModel::GetParticleCharge ( const G4ParticleDefinition * p,
const G4Material * mat,
G4double kineticEnergy )
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 192 of file G4BraggModel.cc.

195{
196 // this method is called only for ions, so no check if it is an ion
197 return corr->GetParticleCharge(p,mat,kineticEnergy);
198}
G4double GetParticleCharge(const G4ParticleDefinition *, const G4Material *, const G4double kineticEnergy)

◆ Initialise()

void G4BraggModel::Initialise ( const G4ParticleDefinition * p,
const G4DataVector &  )
overridevirtual

Implements G4VEmModel.

Definition at line 118 of file G4BraggModel.cc.

120{
121 if(p != particle) { SetParticle(p); }
122
123 // always false before the run
124 SetDeexcitationFlag(false);
125
126 // initialise data only once
127 if(nullptr == fPSTAR) {
128 G4AutoLock l(&ionMutex);
129 if(nullptr == fPSTAR) {
130 isFirst = true;
131 fPSTAR = new G4PSTARStopping();
132 if(G4EmParameters::Instance()->UseICRU90Data()) {
134 }
135 }
136 l.unlock();
137 }
138 if(isFirst) {
139 if(nullptr != fICRU90) { fICRU90->Initialise(); }
141 }
142
143 if(nullptr == fParticleChange) {
144
147 }
149 if(particle->GetParticleType() == "nucleus" &&
150 pname != "deuteron" && pname != "triton" &&
151 pname != "alpha+" && pname != "helium" &&
152 pname != "hydrogen") { isIon = true; }
153
155 }
156}
G4ParticleChangeForLoss * fParticleChange
const G4ParticleDefinition * particle
static G4ICRU90StoppingData * fICRU90
static G4EmParameters * Instance()
G4ICRU90StoppingData * GetICRU90StoppingData()
static G4NistManager * Instance()
const G4String & GetParticleType() const
const G4String & GetParticleName() const
G4VEmAngularDistribution * GetAngularDistribution()
void SetDeexcitationFlag(G4bool val)
void SetAngularDistribution(G4VEmAngularDistribution *)
G4bool UseAngularGeneratorFlag() const
G4ParticleChangeForLoss * GetParticleChangeForLoss()

Referenced by G4BraggIonModel::Initialise(), and G4LindhardSorensenIonModel::Initialise().

◆ MaxSecondaryEnergy()

G4double G4BraggModel::MaxSecondaryEnergy ( const G4ParticleDefinition * pd,
G4double kinEnergy )
finalprotectedvirtual

Reimplemented from G4VEmModel.

Definition at line 366 of file G4BraggModel.cc.

368{
369 if(pd != particle) { SetParticle(pd); }
370 G4double tau = kinEnergy/mass;
371 G4double tmax = 2.0*electron_mass_c2*tau*(tau + 2.) /
372 (1. + 2.0*(tau + 1.)*ratio + ratio*ratio);
373 return tmax;
374}

Referenced by ComputeCrossSectionPerElectron(), G4BraggIonModel::ComputeDEDXPerVolume(), and ComputeDEDXPerVolume().

◆ MinEnergyCut()

G4double G4BraggModel::MinEnergyCut ( const G4ParticleDefinition * ,
const G4MaterialCutsCouple * couple )
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 184 of file G4BraggModel.cc.

186{
188}
G4double GetMeanExcitationEnergy() const
const G4Material * GetMaterial() const
G4IonisParamMat * GetIonisation() const

◆ operator=()

G4BraggModel & G4BraggModel::operator= ( const G4BraggModel & right)
delete

◆ SampleSecondaries()

void G4BraggModel::SampleSecondaries ( std::vector< G4DynamicParticle * > * vdp,
const G4MaterialCutsCouple * couple,
const G4DynamicParticle * dp,
G4double tmin,
G4double maxEnergy )
overridevirtual

Implements G4VEmModel.

Definition at line 288 of file G4BraggModel.cc.

293{
294 const G4double tmax = MaxSecondaryKinEnergy(dp);
295 const G4double xmax = std::min(tmax, maxEnergy);
296 const G4double xmin = std::max(lowestKinEnergy*massRate, std::min(minEnergy, xmax));
297 if(xmin >= xmax) { return; }
298
299 G4double kineticEnergy = dp->GetKineticEnergy();
300 const G4double energy = kineticEnergy + mass;
301 const G4double energy2 = energy*energy;
302 const G4double beta2 = kineticEnergy*(kineticEnergy + 2.0*mass)/energy2;
303 const G4double grej = 1.0;
304 G4double deltaKinEnergy, f;
305
306 CLHEP::HepRandomEngine* rndmEngineMod = G4Random::getTheEngine();
307 G4double rndm[2];
308
309 // sampling follows ...
310 do {
311 rndmEngineMod->flatArray(2, rndm);
312 deltaKinEnergy = xmin*xmax/(xmin*(1.0 - rndm[0]) + xmax*rndm[0]);
313
314 f = 1.0 - beta2*deltaKinEnergy/tmax;
315
316 if(f > grej) {
317 G4cout << "G4BraggModel::SampleSecondary Warning! "
318 << "Majorant " << grej << " < "
319 << f << " for e= " << deltaKinEnergy
320 << G4endl;
321 }
322
323 // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
324 } while( grej*rndm[1] >= f );
325
326 G4ThreeVector deltaDirection;
327
329 const G4Material* mat = couple->GetMaterial();
331
332 deltaDirection =
333 GetAngularDistribution()->SampleDirection(dp, deltaKinEnergy, Z, mat);
334
335 } else {
336
337 G4double deltaMomentum =
338 std::sqrt(deltaKinEnergy * (deltaKinEnergy + 2.0*electron_mass_c2));
339 G4double cost = deltaKinEnergy * (energy + electron_mass_c2) /
340 (deltaMomentum * dp->GetTotalMomentum());
341 if(cost > 1.0) { cost = 1.0; }
342 G4double sint = std::sqrt((1.0 - cost)*(1.0 + cost));
343
344 G4double phi = twopi*rndmEngineMod->flat();
345
346 deltaDirection.set(sint*std::cos(phi),sint*std::sin(phi), cost) ;
347 deltaDirection.rotateUz(dp->GetMomentumDirection());
348 }
349
350 // create G4DynamicParticle object for delta ray
351 auto delta = new G4DynamicParticle(theElectron,deltaDirection,deltaKinEnergy);
352
353 // Change kinematics of primary particle
354 kineticEnergy -= deltaKinEnergy;
355 G4ThreeVector finalP = dp->GetMomentum() - delta->GetMomentum();
356 finalP = finalP.unit();
357
360
361 vdp->push_back(delta);
362}
int G4int
Definition G4Types.hh:85
#define G4endl
Definition G4ios.hh:67
G4GLOB_DLL std::ostream G4cout
Hep3Vector unit() const
void set(double x, double y, double z)
Hep3Vector & rotateUz(const Hep3Vector &)
virtual double flat()=0
virtual void flatArray(const int size, double *vect)=0
const G4ThreeVector & GetMomentumDirection() const
G4double GetKineticEnergy() const
G4ThreeVector GetMomentum() const
G4double GetTotalMomentum() const
void SetProposedKineticEnergy(G4double proposedKinEnergy)
void SetProposedMomentumDirection(const G4ThreeVector &dir)
virtual G4ThreeVector & SampleDirection(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, const G4Material *)=0
G4int SelectRandomAtomNumber(const G4Material *) const
G4double MaxSecondaryKinEnergy(const G4DynamicParticle *dynParticle)

◆ SetChargeSquareRatio()

void G4BraggModel::SetChargeSquareRatio ( G4double val)
inlineprotected

Definition at line 187 of file G4BraggModel.hh.

188{
189 chargeSquare = val;
190}

Referenced by G4BraggIonGasModel::ChargeSquareRatio().

◆ SetParticle()

void G4BraggModel::SetParticle ( const G4ParticleDefinition * p)
protected

Definition at line 160 of file G4BraggModel.cc.

161{
162 particle = p;
165 G4double q = particle->GetPDGCharge()/CLHEP::eplus;
166 chargeSquare = q*q;
167 massRate = mass/CLHEP::proton_mass_c2;
168 ratio = CLHEP::electron_mass_c2/mass;
169}

Referenced by G4BraggIonModel::CorrectionsAlongStep(), G4BraggModel(), Initialise(), and MaxSecondaryEnergy().

Member Data Documentation

◆ baseMaterial

const G4Material* G4BraggModel::baseMaterial = nullptr
protected

Definition at line 160 of file G4BraggModel.hh.

◆ chargeSquare

◆ corr

G4EmCorrections* G4BraggModel::corr = nullptr
protected

◆ currentMaterial

const G4Material* G4BraggModel::currentMaterial = nullptr
protected

Definition at line 159 of file G4BraggModel.hh.

◆ expStopPower125

G4double G4BraggModel::expStopPower125
protected

Definition at line 175 of file G4BraggModel.hh.

Referenced by G4BraggModel().

◆ fICRU90

G4ICRU90StoppingData * G4BraggModel::fICRU90 = nullptr
staticprotected

Definition at line 164 of file G4BraggModel.hh.

Referenced by Initialise().

◆ fParticleChange

G4ParticleChangeForLoss* G4BraggModel::fParticleChange = nullptr
protected

Definition at line 157 of file G4BraggModel.hh.

Referenced by Initialise(), and SampleSecondaries().

◆ fPSTAR

G4PSTARStopping * G4BraggModel::fPSTAR = nullptr
staticprotected

Definition at line 165 of file G4BraggModel.hh.

Referenced by Initialise(), and ~G4BraggModel().

◆ iICRU90

G4int G4BraggModel::iICRU90 = -1
protected

Definition at line 179 of file G4BraggModel.hh.

◆ iMolecula

G4int G4BraggModel::iMolecula = -1
protected

Definition at line 177 of file G4BraggModel.hh.

◆ iPSTAR

G4int G4BraggModel::iPSTAR = -1
protected

Definition at line 178 of file G4BraggModel.hh.

◆ lowestKinEnergy

◆ mass

◆ massRate

◆ particle

const G4ParticleDefinition* G4BraggModel::particle = nullptr
protected

◆ protonMassAMU

G4double G4BraggModel::protonMassAMU = 1.007276
protected

Definition at line 172 of file G4BraggModel.hh.

◆ ratio

G4double G4BraggModel::ratio = 1.0
protected

Definition at line 171 of file G4BraggModel.hh.

Referenced by MaxSecondaryEnergy(), and SetParticle().

◆ spin

G4double G4BraggModel::spin = 0.0
protected

Definition at line 168 of file G4BraggModel.hh.

Referenced by ComputeCrossSectionPerElectron(), and SetParticle().

◆ theElectron

G4ParticleDefinition* G4BraggModel::theElectron = nullptr
protected

Definition at line 156 of file G4BraggModel.hh.

Referenced by G4BraggModel(), and SampleSecondaries().

◆ theZieglerFactor

G4double G4BraggModel::theZieglerFactor
protected

Definition at line 174 of file G4BraggModel.hh.

Referenced by G4BraggModel().


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