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

#include <G4LivermoreBremsstrahlungModel.hh>

+ Inheritance diagram for G4LivermoreBremsstrahlungModel:

Public Member Functions

 G4LivermoreBremsstrahlungModel (const G4ParticleDefinition *p=0, const G4String &nam="LowEnBrem")
 
virtual ~G4LivermoreBremsstrahlungModel ()
 
virtual void Initialise (const G4ParticleDefinition *, const G4DataVector &)
 
virtual void InitialiseForElement (const G4ParticleDefinition *, G4int Z)
 
virtual void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double cutEnergy, G4double maxEnergy)
 
void SetBicubicInterpolationFlag (G4bool)
 
- Public Member Functions inherited from G4eBremsstrahlungRelModel
 G4eBremsstrahlungRelModel (const G4ParticleDefinition *p=0, const G4String &nam="eBremLPM")
 
virtual ~G4eBremsstrahlungRelModel ()
 
virtual void Initialise (const G4ParticleDefinition *, const G4DataVector &) override
 
virtual void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel) override
 
virtual G4double ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double ekin, G4double cutEnergy) override
 
virtual G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double ekin, G4double zet, G4double, G4double cutEnergy, G4double maxEnergy=DBL_MAX) override
 
virtual void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double cutEnergy, G4double maxEnergy) override
 
virtual void SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double) override
 
virtual G4double MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cutEnergy) override
 
- Public Member Functions inherited from G4VEmModel
 G4VEmModel (const G4String &nam)
 
virtual ~G4VEmModel ()
 
virtual void Initialise (const G4ParticleDefinition *, const G4DataVector &)=0
 
virtual void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin=0.0, G4double tmax=DBL_MAX)=0
 
virtual void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel)
 
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 level, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A=0., G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
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 * > *)
 
virtual 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)
 
G4int SelectRandomAtomNumber (const G4Material *)
 
G4int SelectIsotopeNumber (const G4Element *)
 
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 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) const
 
void SetPolarAngleLimit (G4double)
 
void SetSecondaryThreshold (G4double)
 
void SetLPMFlag (G4bool val)
 
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 *)
 
const G4ElementGetCurrentElement () const
 
const G4IsotopeGetCurrentIsotope () const
 
G4bool IsLocked () const
 
void SetLocked (G4bool)
 
G4VEmModeloperator= (const G4VEmModel &right)=delete
 
 G4VEmModel (const G4VEmModel &)=delete
 

Protected Member Functions

virtual G4double ComputeDXSectionPerAtom (G4double gammaEnergy)
 
virtual G4String DirectoryPath () const
 
- Protected Member Functions inherited from G4eBremsstrahlungRelModel
virtual G4double ComputeDXSectionPerAtom (G4double gammaEnergy)
 
void SetParticle (const G4ParticleDefinition *p)
 
- Protected Member Functions inherited from G4VEmModel
G4ParticleChangeForLossGetParticleChangeForLoss ()
 
G4ParticleChangeForGammaGetParticleChangeForGamma ()
 
virtual G4double MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kineticEnergy)
 
const G4MaterialCutsCoupleCurrentCouple () const
 
void SetCurrentElement (const G4Element *)
 

Additional Inherited Members

- Protected Attributes inherited from G4eBremsstrahlungRelModel
G4bool fIsElectron
 
G4bool fIsScatOffElectron
 
G4bool fIsLPMActive
 
G4int fCurrentIZ
 
G4double fPrimaryParticleMass
 
G4double fPrimaryKinEnergy
 
G4double fPrimaryTotalEnergy
 
G4double fDensityFactor
 
G4double fDensityCorr
 
G4double fLowestKinEnergy
 
G4double fNucTerm
 
G4double fSumTerm
 
const G4ParticleDefinitionfPrimaryParticle
 
G4ParticleDefinitionfGammaParticle
 
G4ParticleChangeForLossfParticleChange
 
- Protected Attributes inherited from G4VEmModel
G4ElementDatafElementData
 
G4VParticleChangepParticleChange
 
G4PhysicsTablexSectionTable
 
const G4MaterialpBaseMaterial
 
const std::vector< G4double > * theDensityFactor
 
const std::vector< G4int > * theDensityIdx
 
size_t idxTable
 
G4bool lossFlucFlag
 
G4double inveplus
 
G4double pFactor
 
- Static Protected Attributes inherited from G4eBremsstrahlungRelModel
static const G4double gBremFactor
 
static const G4double gMigdalConstant
 

Detailed Description

Definition at line 60 of file G4LivermoreBremsstrahlungModel.hh.

Constructor & Destructor Documentation

◆ G4LivermoreBremsstrahlungModel()

G4LivermoreBremsstrahlungModel::G4LivermoreBremsstrahlungModel ( const G4ParticleDefinition p = 0,
const G4String nam = "LowEnBrem" 
)

Definition at line 82 of file G4LivermoreBremsstrahlungModel.cc.

84 : G4eBremsstrahlungRelModel(p,nam),useBicubicInterpolation(false)
85{
86 SetLowEnergyLimit(10.0*eV);
87 SetLPMFlag(false);
88 nwarn = 0;
89 idx = idy = 0;
91}
void SetLPMFlag(G4bool val)
Definition: G4VEmModel.hh:806
void SetLowEnergyLimit(G4double)
Definition: G4VEmModel.hh:764
void SetAngularDistribution(G4VEmAngularDistribution *)
Definition: G4VEmModel.hh:618

◆ ~G4LivermoreBremsstrahlungModel()

G4LivermoreBremsstrahlungModel::~G4LivermoreBremsstrahlungModel ( )
virtual

Definition at line 95 of file G4LivermoreBremsstrahlungModel.cc.

96{
97 if(IsMaster()) {
98 for(size_t i=0; i<101; ++i) {
99 if(dataSB[i]) {
100 delete dataSB[i];
101 dataSB[i] = 0;
102 }
103 }
104 }
105}
G4bool IsMaster() const
Definition: G4VEmModel.hh:736

Member Function Documentation

◆ ComputeDXSectionPerAtom()

G4double G4LivermoreBremsstrahlungModel::ComputeDXSectionPerAtom ( G4double  gammaEnergy)
protectedvirtual

Reimplemented from G4eBremsstrahlungRelModel.

Definition at line 195 of file G4LivermoreBremsstrahlungModel.cc.

196{
197
198 if(gammaEnergy < 0.0 || fPrimaryKinEnergy <= 0.0) { return 0.0; }
199 G4double x = gammaEnergy/fPrimaryKinEnergy;
201 G4int Z = fCurrentIZ;
202
203 //G4cout << "G4LivermoreBremsstrahlungModel::ComputeDXSectionPerAtom Z= " << Z
204 // << " x= " << x << " y= " << y << " " << dataSB[Z] << G4endl;
205 if(!dataSB[Z]) { InitialiseForElement(0, Z); }
206 /*
207 G4ExceptionDescription ed;
208 ed << "Bremsstrahlung data for Z= " << Z
209 << " are not initialized!";
210 G4Exception("G4LivermoreBremsstrahlungModel::ComputeDXSectionPerAtom()",
211 "em0005", FatalException, ed,
212 "G4LEDATA version should be G4EMLOW6.23 or later.");
213 }
214 */
217 G4double cross = dataSB[Z]->Value(x,y,idx,idy)*invb2*millibarn/gBremFactor;
218
219 if(!fIsElectron) {
220 G4double invbeta1 = sqrt(invb2);
221 G4double e2 = fPrimaryKinEnergy - gammaEnergy;
222 if(e2 > 0.0) {
223 G4double invbeta2 = (e2 + fPrimaryParticleMass)
224 /sqrt(e2*(e2 + 2.*fPrimaryParticleMass));
225 G4double xxx = alpha*fCurrentIZ*(invbeta1 - invbeta2);
226 if(xxx < expnumlim) { cross = 0.0; }
227 else { cross *= G4Exp(xxx); }
228 } else {
229 cross = 0.0;
230 }
231 }
232
233 return cross;
234}
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:179
G4double G4Log(G4double x)
Definition: G4Log.hh:226
double G4double
Definition: G4Types.hh:83
int G4int
Definition: G4Types.hh:85
virtual void InitialiseForElement(const G4ParticleDefinition *, G4int Z)
G4double Value(G4double x, G4double y, std::size_t &lastidx, std::size_t &lastidy) const

◆ DirectoryPath()

G4String G4LivermoreBremsstrahlungModel::DirectoryPath ( ) const
protectedvirtual

Definition at line 138 of file G4LivermoreBremsstrahlungModel.cc.

139{
140 return "/livermore/brem/br";
141}

◆ Initialise()

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

Reimplemented from G4eBremsstrahlungRelModel.

Definition at line 109 of file G4LivermoreBremsstrahlungModel.cc.

111{
112 // Access to elements
113 if(IsMaster()) {
114
115 // check environment variable
116 // Build the complete string identifying the file with the data set
117 char* path = std::getenv("G4LEDATA");
118
119 const G4ElementTable* theElmTable = G4Element::GetElementTable();
120 size_t numOfElm = G4Element::GetNumberOfElements();
121 if(numOfElm > 0) {
122 for(size_t i=0; i<numOfElm; ++i) {
123 G4int Z = (*theElmTable)[i]->GetZasInt();
124 if(Z < 1) { Z = 1; }
125 else if(Z > 100) { Z = 100; }
126 //G4cout << "Z= " << Z << G4endl;
127 // Initialisation
128 if(!dataSB[Z]) { ReadData(Z, path); }
129 }
130 }
131 }
132
134}
std::vector< G4Element * > G4ElementTable
static G4ElementTable * GetElementTable()
Definition: G4Element.cc:397
static size_t GetNumberOfElements()
Definition: G4Element.cc:404
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &) override

◆ InitialiseForElement()

void G4LivermoreBremsstrahlungModel::InitialiseForElement ( const G4ParticleDefinition ,
G4int  Z 
)
virtual

Reimplemented from G4VEmModel.

Definition at line 374 of file G4LivermoreBremsstrahlungModel.cc.

377{
378 G4AutoLock l(&LivermoreBremsstrahlungModelMutex);
379 //G4cout << "G4LivermoreBremsstrahlungModel::InitialiseForElement Z= "
380 //<< Z << G4endl;
381 if(!dataSB[Z]) { ReadData(Z); }
382 l.unlock();
383}

Referenced by ComputeDXSectionPerAtom().

◆ SampleSecondaries()

void G4LivermoreBremsstrahlungModel::SampleSecondaries ( std::vector< G4DynamicParticle * > *  vdp,
const G4MaterialCutsCouple couple,
const G4DynamicParticle dp,
G4double  cutEnergy,
G4double  maxEnergy 
)
virtual

Reimplemented from G4eBremsstrahlungRelModel.

Definition at line 239 of file G4LivermoreBremsstrahlungModel.cc.

245{
246 G4double kineticEnergy = dp->GetKineticEnergy();
247 G4double cut = std::min(cutEnergy, kineticEnergy);
248 G4double emax = std::min(maxEnergy, kineticEnergy);
249 if(cut >= emax) { return; }
250 // sets total energy, kinetic energy and density correction
251 SetupForMaterial(fPrimaryParticle, couple->GetMaterial(), kineticEnergy);
252
253 const G4Element* elm =
254 SelectRandomAtom(couple,fPrimaryParticle,kineticEnergy,cut,emax);
255 fCurrentIZ = elm->GetZasInt();
256 G4int Z = fCurrentIZ;
257
258 G4double totMomentum = sqrt(kineticEnergy*(fPrimaryTotalEnergy+electron_mass_c2));
259 /*
260 G4cout << "G4LivermoreBremsstrahlungModel::SampleSecondaries E(MeV)= "
261 << kineticEnergy/MeV
262 << " Z= " << Z << " cut(MeV)= " << cut/MeV
263 << " emax(MeV)= " << emax/MeV << " corr= " << fDensityCorr << G4endl;
264 */
265 G4double xmin = G4Log(cut*cut + fDensityCorr);
266 G4double xmax = G4Log(emax*emax + fDensityCorr);
267 G4double y = G4Log(kineticEnergy/MeV);
268
269 G4double gammaEnergy, v;
270
271 // majoranta
272 G4double x0 = cut/kineticEnergy;
273 G4double vmax = dataSB[Z]->Value(x0, y, idx, idy)*1.02;
274 // G4double invbeta1 = 0;
275
276 // majoranta corrected for e-
277 if(fIsElectron && x0 < 0.97 &&
278 ((kineticEnergy > epeaklimit) || (kineticEnergy < elowlimit))) {
279 G4double ylim = std::min(ylimit[Z],1.1*dataSB[Z]->Value(0.97,y,idx,idy));
280 if(ylim > vmax) { vmax = ylim; }
281 }
282 if(x0 < 0.05) { vmax *= 1.2; }
283
284 //G4cout<<"y= "<<y<<" xmin= "<<xmin<<" xmax= "<<xmax
285 //<<" vmax= "<<vmax<<G4endl;
286 // G4int ncount = 0;
287 do {
288 //++ncount;
289 G4double x = G4Exp(xmin + G4UniformRand()*(xmax - xmin)) - fDensityCorr;
290 if(x < 0.0) { x = 0.0; }
291 gammaEnergy = sqrt(x);
292 G4double x1 = gammaEnergy/kineticEnergy;
293 v = dataSB[Z]->Value(x1, y, idx, idy);
294
295 // correction for positrons
296 if(!fIsElectron) {
297 G4double e1 = kineticEnergy - cut;
298 G4double invbeta1 = (e1 + fPrimaryParticleMass)
299 /sqrt(e1*(e1 + 2*fPrimaryParticleMass));
300 G4double e2 = kineticEnergy - gammaEnergy;
301 G4double invbeta2 = (e2 + fPrimaryParticleMass)
302 /sqrt(e2*(e2 + 2*fPrimaryParticleMass));
303 G4double xxx = twopi*fine_structure_const*fCurrentIZ*(invbeta1 - invbeta2);
304
305 if(xxx < expnumlim) { v = 0.0; }
306 else { v *= G4Exp(xxx); }
307 }
308
309 if (v > 1.05*vmax && nwarn < 5) {
310 ++nwarn;
312 ed << "### G4LivermoreBremsstrahlungModel Warning: Majoranta exceeded! "
313 << v << " > " << vmax << " by " << v/vmax
314 << " Egamma(MeV)= " << gammaEnergy
315 << " Ee(MeV)= " << kineticEnergy
316 << " Z= " << Z << " " << fPrimaryParticle->GetParticleName();
317
318 if ( 20 == nwarn ) {
319 ed << "\n ### G4LivermoreBremsstrahlungModel Warnings stopped";
320 }
321 G4Exception("G4LivermoreBremsstrahlungModel::SampleScattering","em0044",
322 JustWarning, ed,"");
323
324 }
325 } while (v < vmax*G4UniformRand());
326
327 //
328 // angles of the emitted gamma. ( Z - axis along the parent particle)
329 // use general interface
330 //
331
332 G4ThreeVector gammaDirection =
334 Z, couple->GetMaterial());
335
336 // create G4DynamicParticle object for the Gamma
337 G4DynamicParticle* gamma =
338 new G4DynamicParticle(fGammaParticle,gammaDirection,gammaEnergy);
339 vdp->push_back(gamma);
340
341 G4ThreeVector direction = (totMomentum*dp->GetMomentumDirection()
342 - gammaEnergy*gammaDirection).unit();
343
344 /*
345 G4cout << "### G4SBModel: v= "
346 << " Eg(MeV)= " << gammaEnergy
347 << " Ee(MeV)= " << kineticEnergy
348 << " DirE " << direction << " DirG " << gammaDirection
349 << G4endl;
350 */
351 // energy of primary
352 G4double finalE = kineticEnergy - gammaEnergy;
353
354 // stop tracking and create new secondary instead of primary
355 if(gammaEnergy > SecondaryThreshold()) {
360 direction, finalE);
361 vdp->push_back(el);
362
363 // continue tracking
364 } else {
367 }
368}
@ JustWarning
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
Definition: G4Exception.cc:35
std::ostringstream G4ExceptionDescription
Definition: G4Exception.hh:40
@ fStopAndKill
#define G4UniformRand()
Definition: Randomize.hh:52
const G4ThreeVector & GetMomentumDirection() const
G4double GetKineticEnergy() const
G4int GetZasInt() const
Definition: G4Element.hh:131
const G4Material * GetMaterial() const
void SetProposedKineticEnergy(G4double proposedKinEnergy)
void SetProposedMomentumDirection(const G4ThreeVector &dir)
const G4String & GetParticleName() const
virtual G4ThreeVector & SampleDirection(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, const G4Material *)=0
G4VEmAngularDistribution * GetAngularDistribution()
Definition: G4VEmModel.hh:611
virtual G4double Value(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy)
Definition: G4VEmModel.cc:415
const G4Element * SelectRandomAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
Definition: G4VEmModel.hh:570
G4double SecondaryThreshold() const
Definition: G4VEmModel.hh:680
void ProposeTrackStatus(G4TrackStatus status)
const G4ParticleDefinition * fPrimaryParticle
G4ParticleDefinition * fGammaParticle
virtual void SetupForMaterial(const G4ParticleDefinition *, const G4Material *, G4double) override
G4ParticleChangeForLoss * fParticleChange

◆ SetBicubicInterpolationFlag()

void G4LivermoreBremsstrahlungModel::SetBicubicInterpolationFlag ( G4bool  val)
inline

Definition at line 105 of file G4LivermoreBremsstrahlungModel.hh.

106{
107 useBicubicInterpolation = val;
108}

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