Geant4-11
Public Member Functions | Static Public Member Functions | Protected Attributes | Private Member Functions | Private Attributes | Static Private Attributes
G4KokoulinMuonNuclearXS Class Reference

#include <G4KokoulinMuonNuclearXS.hh>

Inheritance diagram for G4KokoulinMuonNuclearXS:
G4VCrossSectionDataSet

Public Member Functions

void BuildCrossSectionTable ()
 
void BuildPhysicsTable (const G4ParticleDefinition &)
 
G4double ComputeCrossSection (const G4DynamicParticle *, const G4Element *, const G4Material *mat=nullptr)
 
G4double ComputeDDMicroscopicCrossSection (G4double incidentKE, G4double Z, G4double A, G4double epsilon)
 
virtual void CrossSectionDescription (std::ostream &) const
 
virtual void DumpPhysicsTable (const G4ParticleDefinition &)
 
bool ForAllAtomsAndEnergies () const
 
 G4KokoulinMuonNuclearXS ()
 
G4double GetCrossSection (const G4DynamicParticle *, const G4Element *, const G4Material *mat=nullptr)
 
G4double GetElementCrossSection (const G4DynamicParticle *particle, G4int Z, const G4Material *)
 
virtual G4double GetIsoCrossSection (const G4DynamicParticle *, G4int Z, G4int A, const G4Isotope *iso=nullptr, const G4Element *elm=nullptr, const G4Material *mat=nullptr)
 
G4double GetMaxKinEnergy () const
 
G4double GetMinKinEnergy () const
 
const G4StringGetName () const
 
virtual G4int GetVerboseLevel () const
 
G4bool IsElementApplicable (const G4DynamicParticle *particle, G4int Z, const G4Material *)
 
virtual G4bool IsIsoApplicable (const G4DynamicParticle *, G4int Z, G4int A, const G4Element *elm=nullptr, const G4Material *mat=nullptr)
 
virtual const G4IsotopeSelectIsotope (const G4Element *, G4double kinEnergy, G4double logE)
 
void SetForAllAtomsAndEnergies (G4bool val)
 
void SetMaxKinEnergy (G4double value)
 
void SetMinKinEnergy (G4double value)
 
void SetName (const G4String &nam)
 
virtual void SetVerboseLevel (G4int value)
 
virtual ~G4KokoulinMuonNuclearXS ()
 

Static Public Member Functions

static const char * Default_Name ()
 

Protected Attributes

G4String name
 
G4int verboseLevel
 

Private Member Functions

G4double ComputeMicroscopicCrossSection (G4double incidentKE, G4double A)
 
 G4KokoulinMuonNuclearXS (const G4KokoulinMuonNuclearXS &)
 
G4KokoulinMuonNuclearXSoperator= (const G4KokoulinMuonNuclearXS &right)
 

Private Attributes

G4double CutFixed
 
G4double HighestKineticEnergy
 
G4bool isForAllAtomsAndEnergies
 
G4bool isInitialized
 
G4bool isMaster
 
G4double LowestKineticEnergy
 
G4double maxKinEnergy
 
G4double minKinEnergy
 
G4CrossSectionDataSetRegistryregistry
 
G4int TotBin
 

Static Private Attributes

static G4PhysicsVectortheCrossSection [MAXZMUN] = {0}
 

Detailed Description

Definition at line 52 of file G4KokoulinMuonNuclearXS.hh.

Constructor & Destructor Documentation

◆ G4KokoulinMuonNuclearXS() [1/2]

G4KokoulinMuonNuclearXS::G4KokoulinMuonNuclearXS ( )

◆ ~G4KokoulinMuonNuclearXS()

G4KokoulinMuonNuclearXS::~G4KokoulinMuonNuclearXS ( )
virtual

Definition at line 64 of file G4KokoulinMuonNuclearXS.cc.

65{
66 if (isMaster) {
67 for(G4int i=0; i<MAXZMUN; ++i) {
68 delete theCrossSection[i];
69 theCrossSection[i] = 0;
70 }
71 }
72}
const G4int MAXZMUN
int G4int
Definition: G4Types.hh:85
static G4PhysicsVector * theCrossSection[MAXZMUN]

References isMaster, MAXZMUN, and theCrossSection.

◆ G4KokoulinMuonNuclearXS() [2/2]

G4KokoulinMuonNuclearXS::G4KokoulinMuonNuclearXS ( const G4KokoulinMuonNuclearXS )
private

Member Function Documentation

◆ BuildCrossSectionTable()

void G4KokoulinMuonNuclearXS::BuildCrossSectionTable ( )

Definition at line 107 of file G4KokoulinMuonNuclearXS.cc.

108{
109 G4double energy, A, Value;
110 G4int Z;
111
113 const G4ElementTable* theElementTable = G4Element::GetElementTable();
114 G4NistManager* nistManager = G4NistManager::Instance();
115
116 for (G4int j = 0; j < nEl; j++) {
117 Z = G4lrint((*theElementTable)[j]->GetZ());
118
119 //AR-24Apr2018 Switch to treat transuranic elements as uranium
120 const G4bool isHeavyElementAllowed = true; if ( isHeavyElementAllowed && Z>92 ) Z=92;
121
122 A = nistManager->GetAtomicMassAmu(Z);
123 if(Z < MAXZMUN && !theCrossSection[Z]) {
126 TotBin);
127 for (G4int i = 0; i <= TotBin; ++i) {
130 theCrossSection[Z]->PutValue(i,Value);
131 }
132 }
133 }
134}
std::vector< G4Element * > G4ElementTable
double G4double
Definition: G4Types.hh:83
bool G4bool
Definition: G4Types.hh:86
const G4int Z[17]
const G4double A[17]
static G4ElementTable * GetElementTable()
Definition: G4Element.cc:397
static size_t GetNumberOfElements()
Definition: G4Element.cc:404
G4double ComputeMicroscopicCrossSection(G4double incidentKE, G4double A)
static G4NistManager * Instance()
G4double GetAtomicMassAmu(const G4String &symb) const
void PutValue(const std::size_t index, const G4double value)
G4double Energy(const std::size_t index) const
G4double energy(const ThreeVector &p, const G4double m)
int G4lrint(double ad)
Definition: templates.hh:134

References A, ComputeMicroscopicCrossSection(), G4PhysicsVector::Energy(), G4INCL::KinematicsUtils::energy(), G4lrint(), G4NistManager::GetAtomicMassAmu(), G4Element::GetElementTable(), G4Element::GetNumberOfElements(), HighestKineticEnergy, G4NistManager::Instance(), LowestKineticEnergy, MAXZMUN, G4PhysicsVector::PutValue(), theCrossSection, TotBin, and Z.

Referenced by BuildPhysicsTable().

◆ BuildPhysicsTable()

void G4KokoulinMuonNuclearXS::BuildPhysicsTable ( const G4ParticleDefinition )
virtual

Reimplemented from G4VCrossSectionDataSet.

Definition at line 95 of file G4KokoulinMuonNuclearXS.cc.

96{
97 if(!isInitialized) {
98 isInitialized = true;
99 for(G4int i=0; i<MAXZMUN; ++i) {
100 if(theCrossSection[i]) { return; }
101 }
102 isMaster = true;
103 }
105}

References BuildCrossSectionTable(), isInitialized, isMaster, MAXZMUN, and theCrossSection.

◆ ComputeCrossSection()

G4double G4VCrossSectionDataSet::ComputeCrossSection ( const G4DynamicParticle part,
const G4Element elm,
const G4Material mat = nullptr 
)
inherited

Definition at line 81 of file G4VCrossSectionDataSet.cc.

84{
85 G4int Z = elm->GetZasInt();
86
87 if (IsElementApplicable(part, Z, mat)) {
88 return GetElementCrossSection(part, Z, mat);
89 }
90
91 // isotope-wise cross section making sum over available
92 // isotope cross sections, which may be incomplete, so
93 // the result is corrected
94 size_t nIso = elm->GetNumberOfIsotopes();
95 G4double fact = 0.0;
96 G4double xsec = 0.0;
97
98 // user-defined isotope abundances
99 const G4IsotopeVector* isoVector = elm->GetIsotopeVector();
100 const G4double* abundVector = elm->GetRelativeAbundanceVector();
101
102 for (size_t j=0; j<nIso; ++j) {
103 const G4Isotope* iso = (*isoVector)[j];
104 G4int A = iso->GetN();
105 if(abundVector[j] > 0.0 && IsIsoApplicable(part, Z, A, elm, mat)) {
106 fact += abundVector[j];
107 xsec += abundVector[j]*GetIsoCrossSection(part, Z, A, iso, elm, mat);
108 }
109 }
110 return (fact > 0.0) ? xsec/fact : 0.0;
111}
std::vector< G4Isotope * > G4IsotopeVector
G4double * GetRelativeAbundanceVector() const
Definition: G4Element.hh:167
size_t GetNumberOfIsotopes() const
Definition: G4Element.hh:159
G4int GetZasInt() const
Definition: G4Element.hh:132
G4IsotopeVector * GetIsotopeVector() const
Definition: G4Element.hh:163
G4int GetN() const
Definition: G4Isotope.hh:93
virtual G4double GetElementCrossSection(const G4DynamicParticle *, G4int Z, const G4Material *mat=nullptr)
virtual G4double GetIsoCrossSection(const G4DynamicParticle *, G4int Z, G4int A, const G4Isotope *iso=nullptr, const G4Element *elm=nullptr, const G4Material *mat=nullptr)
virtual G4bool IsIsoApplicable(const G4DynamicParticle *, G4int Z, G4int A, const G4Element *elm=nullptr, const G4Material *mat=nullptr)
virtual G4bool IsElementApplicable(const G4DynamicParticle *, G4int Z, const G4Material *mat=nullptr)

References A, G4VCrossSectionDataSet::GetElementCrossSection(), G4VCrossSectionDataSet::GetIsoCrossSection(), G4Element::GetIsotopeVector(), G4Isotope::GetN(), G4Element::GetNumberOfIsotopes(), G4Element::GetRelativeAbundanceVector(), G4Element::GetZasInt(), G4VCrossSectionDataSet::IsElementApplicable(), G4VCrossSectionDataSet::IsIsoApplicable(), and Z.

Referenced by G4VCrossSectionDataSet::GetCrossSection().

◆ ComputeDDMicroscopicCrossSection()

G4double G4KokoulinMuonNuclearXS::ComputeDDMicroscopicCrossSection ( G4double  incidentKE,
G4double  Z,
G4double  A,
G4double  epsilon 
)

Definition at line 181 of file G4KokoulinMuonNuclearXS.cc.

184{
185 // Calculate the double-differential microscopic cross section (in muon
186 // incident kinetic energy and energy loss) using the cross section formula
187 // of R.P. Kokoulin (18/01/98)
188
189 static const G4double alam2 = 0.400*GeV*GeV;
190 static const G4double alam = 0.632456*GeV;
191 static const G4double coeffn = fine_structure_const/pi;
192
193 G4double ParticleMass = G4MuonMinus::MuonMinus()->GetPDGMass();
194 G4double TotalEnergy = KineticEnergy + ParticleMass;
195
196 G4double DCrossSection = 0.;
197
198 if ((epsilon >= TotalEnergy - 0.5*proton_mass_c2) ||
199 (epsilon <= CutFixed) ) { return DCrossSection; }
200
201 G4double ep = epsilon/GeV;
202 G4double aeff = 0.22*A+0.78*G4Exp(0.89*G4Log(A)); //shadowing
203 G4double sigph = (49.2+11.1*G4Log(ep)+151.8/std::sqrt(ep))*microbarn;
204
205 G4double v = epsilon/TotalEnergy;
206 G4double v1 = 1.-v;
207 G4double v2 = v*v;
208 G4double mass2 = ParticleMass*ParticleMass;
209
210 G4double up = TotalEnergy*TotalEnergy*v1/mass2*(1.+mass2*v2/(alam2*v1));
211 G4double down = 1.+epsilon/alam*(1.+alam/(2.*proton_mass_c2)+epsilon/alam);
212
213 DCrossSection = coeffn*aeff*sigph/epsilon*
214 (-v1+(v1+0.5*v2*(1.+2.*mass2/alam2))*G4Log(up/down));
215
216 if (DCrossSection < 0.) { DCrossSection = 0.; }
217 return DCrossSection;
218}
G4double epsilon(G4double density, G4double temperature)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:179
static const G4double aeff[]
G4double G4Log(G4double x)
Definition: G4Log.hh:226
static constexpr double microbarn
Definition: G4SIunits.hh:87
static constexpr double pi
Definition: G4SIunits.hh:55
static G4MuonMinus * MuonMinus()
Definition: G4MuonMinus.cc:99
float proton_mass_c2
Definition: hepunit.py:274
int fine_structure_const
Definition: hepunit.py:286

References A, aeff, CutFixed, epsilon(), source.hepunit::fine_structure_const, G4Exp(), G4Log(), G4ParticleDefinition::GetPDGMass(), GeV, microbarn, G4MuonMinus::MuonMinus(), pi, and source.hepunit::proton_mass_c2.

Referenced by ComputeMicroscopicCrossSection(), and G4MuonVDNuclearModel::MakeSamplingTable().

◆ ComputeMicroscopicCrossSection()

G4double G4KokoulinMuonNuclearXS::ComputeMicroscopicCrossSection ( G4double  incidentKE,
G4double  A 
)
private

Definition at line 136 of file G4KokoulinMuonNuclearXS.cc.

138{
139 // Calculate cross section (differential in muon incident kinetic energy) by
140 // integrating the double differential cross section over the energy loss
141
142 static const G4double xgi[] =
143 {0.0199,0.1017,0.2372,0.4083,0.5917,0.7628,0.8983,0.9801};
144 static const G4double wgi[] =
145 {0.0506,0.1112,0.1569,0.1813,0.1813,0.1569,0.1112,0.0506};
146 static const G4double ak1 = 6.9;
147 static const G4double ak2 = 1.0;
148
150
151 G4double CrossSection = 0.0;
152 if (KineticEnergy <= CutFixed) return CrossSection;
153
154 G4double epmin = CutFixed;
155 G4double epmax = KineticEnergy + Mass - 0.5*proton_mass_c2;
156 if (epmax <= epmin) return CrossSection; // NaN bug correction
157
158 G4double aaa = G4Log(epmin);
159 G4double bbb = G4Log(epmax);
160 G4int kkk = std::max(1,G4int((bbb-aaa)/ak1 +ak2));
161 G4double hhh = (bbb-aaa)/kkk ;
162 G4double epln;
163 G4double ep;
164 G4double x;
165
166 for (G4int l = 0; l < kkk; ++l) {
167 x = aaa + hhh*l;
168 for (G4int ll = 0; ll < 8; ++ll) {
169 epln=x+xgi[ll]*hhh;
170 ep = G4Exp(epln);
171 CrossSection +=
172 ep*wgi[ll]*ComputeDDMicroscopicCrossSection(KineticEnergy, 0, A, ep);
173 }
174 }
175
176 CrossSection *= hhh ;
177 if (CrossSection < 0.) { CrossSection = 0.; }
178 return CrossSection;
179}
static const G4double ak2
static const G4double xgi[]
static const G4double wgi[]
static const G4double ak1
G4double ComputeDDMicroscopicCrossSection(G4double incidentKE, G4double Z, G4double A, G4double epsilon)
T max(const T t1, const T t2)
brief Return the largest of the two arguments

References A, ak1, ak2, ComputeDDMicroscopicCrossSection(), CutFixed, G4Exp(), G4Log(), G4ParticleDefinition::GetPDGMass(), G4INCL::Math::max(), G4MuonMinus::MuonMinus(), source.hepunit::proton_mass_c2, wgi, and xgi.

Referenced by BuildCrossSectionTable().

◆ CrossSectionDescription()

void G4KokoulinMuonNuclearXS::CrossSectionDescription ( std::ostream &  outFile) const
virtual

Reimplemented from G4VCrossSectionDataSet.

Definition at line 76 of file G4KokoulinMuonNuclearXS.cc.

77{
78 outFile << "G4KokoulinMuonNuclearXS provides the total inelastic\n"
79 << "cross section for mu- and mu+ interactions with nuclei.\n"
80 << "R. Kokoulin's approximation of the Borog and Petrukhin double\n"
81 << "differential cross section at high energy and low Q**2 is integrated\n"
82 << "over the muon energy loss to get the total cross section as a\n"
83 << "function of muon kinetic energy\n" ;
84}

◆ Default_Name()

static const char * G4KokoulinMuonNuclearXS::Default_Name ( )
inlinestatic

Definition at line 59 of file G4KokoulinMuonNuclearXS.hh.

59{return "KokoulinMuonNuclearXS";}

Referenced by G4MuonVDNuclearModel::G4MuonVDNuclearModel().

◆ DumpPhysicsTable()

void G4VCrossSectionDataSet::DumpPhysicsTable ( const G4ParticleDefinition )
virtualinherited

◆ ForAllAtomsAndEnergies()

bool G4VCrossSectionDataSet::ForAllAtomsAndEnergies ( ) const
inlineinherited

◆ GetCrossSection()

G4double G4VCrossSectionDataSet::GetCrossSection ( const G4DynamicParticle dp,
const G4Element elm,
const G4Material mat = nullptr 
)
inlineinherited

Definition at line 187 of file G4VCrossSectionDataSet.hh.

190{
191 return ComputeCrossSection(dp, elm, mat);
192}
G4double ComputeCrossSection(const G4DynamicParticle *, const G4Element *, const G4Material *mat=nullptr)

References G4VCrossSectionDataSet::ComputeCrossSection().

◆ GetElementCrossSection()

G4double G4KokoulinMuonNuclearXS::GetElementCrossSection ( const G4DynamicParticle particle,
G4int  Z,
const G4Material  
)
virtual

Reimplemented from G4VCrossSectionDataSet.

Definition at line 220 of file G4KokoulinMuonNuclearXS.cc.

223{
224 //AR-24Apr2018 Switch to treat transuranic elements as uranium
225 const G4bool isHeavyElementAllowed = true; if ( isHeavyElementAllowed && Z>92 ) Z=92;
226
227 return theCrossSection[Z]->Value(aPart->GetKineticEnergy());
228}
G4double Value(const G4double energy, std::size_t &lastidx) const

References G4DynamicParticle::GetKineticEnergy(), theCrossSection, G4PhysicsVector::Value(), and Z.

◆ GetIsoCrossSection()

G4double G4VCrossSectionDataSet::GetIsoCrossSection ( const G4DynamicParticle dynPart,
G4int  Z,
G4int  A,
const G4Isotope iso = nullptr,
const G4Element elm = nullptr,
const G4Material mat = nullptr 
)
virtualinherited

Reimplemented in G4ChipsAntiBaryonElasticXS, G4ChipsAntiBaryonInelasticXS, G4ChipsHyperonElasticXS, G4ChipsHyperonInelasticXS, G4ChipsKaonMinusElasticXS, G4ChipsKaonMinusInelasticXS, G4ChipsKaonPlusElasticXS, G4ChipsKaonPlusInelasticXS, G4ChipsKaonZeroElasticXS, G4ChipsKaonZeroInelasticXS, G4ChipsNeutronElasticXS, G4ChipsNeutronInelasticXS, G4ChipsPionMinusElasticXS, G4ChipsPionMinusInelasticXS, G4ChipsPionPlusElasticXS, G4ChipsPionPlusInelasticXS, G4ChipsProtonElasticXS, G4ChipsProtonInelasticXS, G4NeutronCaptureXS, G4NeutronElasticXS, G4NeutronInelasticXS, G4IonsShenCrossSection, G4ElNucleusSFcs, G4BGGNucleonElasticXS, G4BGGPionElasticXS, G4BGGPionInelasticXS, G4GammaNuclearXS, G4ParticleInelasticXS, G4BGGNucleonInelasticXS, G4LENDCombinedCrossSection, G4LENDCrossSection, G4LENDGammaCrossSection, G4ParticleHPCaptureData, G4ParticleHPElasticData, G4ParticleHPFissionData, G4ParticleHPInelasticData, G4ParticleHPThermalScatteringData, G4MuNeutrinoNucleusTotXsc, G4ElNeutrinoNucleusTotXsc, and G4PhotoNuclearCrossSection.

Definition at line 130 of file G4VCrossSectionDataSet.cc.

135{
137 ed << "GetIsoCrossSection is not implemented in <" << name << ">\n"
138 << "Particle: " << dynPart->GetDefinition()->GetParticleName()
139 << " Ekin(MeV)= " << dynPart->GetKineticEnergy()/MeV;
140 if(mat) { ed << " material: " << mat->GetName(); }
141 if(elm) { ed << " element: " << elm->GetName(); }
142 ed << " target Z= " << Z << " A= " << A << G4endl;
143 G4Exception("G4VCrossSectionDataSet::GetIsoCrossSection", "had001",
144 FatalException, ed);
145 return 0.0;
146}
@ FatalException
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
Definition: G4Exception.cc:35
std::ostringstream G4ExceptionDescription
Definition: G4Exception.hh:40
static constexpr double MeV
Definition: G4SIunits.hh:200
#define G4endl
Definition: G4ios.hh:57
G4ParticleDefinition * GetDefinition() const
G4double GetKineticEnergy() const
const G4String & GetName() const
Definition: G4Element.hh:127
const G4String & GetName() const
Definition: G4Material.hh:173
const G4String & GetParticleName() const

References A, FatalException, G4endl, G4Exception(), G4DynamicParticle::GetDefinition(), G4DynamicParticle::GetKineticEnergy(), G4Element::GetName(), G4Material::GetName(), G4ParticleDefinition::GetParticleName(), MeV, G4VCrossSectionDataSet::name, and Z.

Referenced by G4VCrossSectionDataSet::ComputeCrossSection(), G4GammaNuclearXS::GetIsoCrossSection(), and G4GammaNuclearXS::Initialise().

◆ GetMaxKinEnergy()

G4double G4VCrossSectionDataSet::GetMaxKinEnergy ( ) const
inlineinherited

◆ GetMinKinEnergy()

G4double G4VCrossSectionDataSet::GetMinKinEnergy ( ) const
inlineinherited

◆ GetName()

const G4String & G4VCrossSectionDataSet::GetName ( ) const
inlineinherited

◆ GetVerboseLevel()

G4int G4VCrossSectionDataSet::GetVerboseLevel ( ) const
inlinevirtualinherited

◆ IsElementApplicable()

G4bool G4KokoulinMuonNuclearXS::IsElementApplicable ( const G4DynamicParticle particle,
G4int  Z,
const G4Material  
)
virtual

Reimplemented from G4VCrossSectionDataSet.

Definition at line 88 of file G4KokoulinMuonNuclearXS.cc.

90{
91 return true;
92}

◆ IsIsoApplicable()

G4bool G4VCrossSectionDataSet::IsIsoApplicable ( const G4DynamicParticle ,
G4int  Z,
G4int  A,
const G4Element elm = nullptr,
const G4Material mat = nullptr 
)
virtualinherited

◆ operator=()

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

◆ SelectIsotope()

const G4Isotope * G4VCrossSectionDataSet::SelectIsotope ( const G4Element anElement,
G4double  kinEnergy,
G4double  logE 
)
virtualinherited

Reimplemented in G4GammaNuclearXS, G4NeutronCaptureXS, G4NeutronElasticXS, G4NeutronInelasticXS, and G4ParticleInelasticXS.

Definition at line 149 of file G4VCrossSectionDataSet.cc.

151{
152 size_t nIso = anElement->GetNumberOfIsotopes();
153 const G4Isotope* iso = anElement->GetIsotope(0);
154
155 // more than 1 isotope
156 if(1 < nIso) {
157 const G4double* abundVector = anElement->GetRelativeAbundanceVector();
158 G4double sum = 0.0;
160 for (size_t j=0; j<nIso; ++j) {
161 sum += abundVector[j];
162 if(q <= sum) {
163 iso = anElement->GetIsotope(j);
164 break;
165 }
166 }
167 }
168 return iso;
169}
#define G4UniformRand()
Definition: Randomize.hh:52
const G4Isotope * GetIsotope(G4int iso) const
Definition: G4Element.hh:170

References G4UniformRand, G4Element::GetIsotope(), G4Element::GetNumberOfIsotopes(), and G4Element::GetRelativeAbundanceVector().

◆ SetForAllAtomsAndEnergies()

void G4VCrossSectionDataSet::SetForAllAtomsAndEnergies ( G4bool  val)
inlineinherited

◆ SetMaxKinEnergy()

void G4VCrossSectionDataSet::SetMaxKinEnergy ( G4double  value)
inlineinherited

◆ SetMinKinEnergy()

void G4VCrossSectionDataSet::SetMinKinEnergy ( G4double  value)
inlineinherited

◆ SetName()

void G4VCrossSectionDataSet::SetName ( const G4String nam)
inlineinherited

Definition at line 240 of file G4VCrossSectionDataSet.hh.

241{
242 name = nam;
243}

References G4VCrossSectionDataSet::name.

Referenced by G4ParticleHPInelasticData::G4ParticleHPInelasticData().

◆ SetVerboseLevel()

void G4VCrossSectionDataSet::SetVerboseLevel ( G4int  value)
inlinevirtualinherited

Field Documentation

◆ CutFixed

G4double G4KokoulinMuonNuclearXS::CutFixed
private

◆ HighestKineticEnergy

G4double G4KokoulinMuonNuclearXS::HighestKineticEnergy
private

Definition at line 88 of file G4KokoulinMuonNuclearXS.hh.

Referenced by BuildCrossSectionTable().

◆ isForAllAtomsAndEnergies

G4bool G4VCrossSectionDataSet::isForAllAtomsAndEnergies
privateinherited

◆ isInitialized

G4bool G4KokoulinMuonNuclearXS::isInitialized
private

Definition at line 91 of file G4KokoulinMuonNuclearXS.hh.

Referenced by BuildPhysicsTable().

◆ isMaster

G4bool G4KokoulinMuonNuclearXS::isMaster
private

Definition at line 92 of file G4KokoulinMuonNuclearXS.hh.

Referenced by BuildPhysicsTable(), and ~G4KokoulinMuonNuclearXS().

◆ LowestKineticEnergy

G4double G4KokoulinMuonNuclearXS::LowestKineticEnergy
private

Definition at line 87 of file G4KokoulinMuonNuclearXS.hh.

Referenced by BuildCrossSectionTable().

◆ maxKinEnergy

G4double G4VCrossSectionDataSet::maxKinEnergy
privateinherited

◆ minKinEnergy

G4double G4VCrossSectionDataSet::minKinEnergy
privateinherited

◆ name

G4String G4VCrossSectionDataSet::name
protectedinherited

◆ registry

G4CrossSectionDataSetRegistry* G4VCrossSectionDataSet::registry
privateinherited

◆ theCrossSection

G4PhysicsVector * G4KokoulinMuonNuclearXS::theCrossSection = {0}
staticprivate

◆ TotBin

G4int G4KokoulinMuonNuclearXS::TotBin
private

Definition at line 89 of file G4KokoulinMuonNuclearXS.hh.

Referenced by BuildCrossSectionTable().

◆ verboseLevel

G4int G4VCrossSectionDataSet::verboseLevel
protectedinherited

Definition at line 168 of file G4VCrossSectionDataSet.hh.

Referenced by G4BGGNucleonElasticXS::BuildPhysicsTable(), G4BGGPionElasticXS::BuildPhysicsTable(), G4BGGPionInelasticXS::BuildPhysicsTable(), G4GammaNuclearXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4BGGNucleonInelasticXS::BuildPhysicsTable(), G4LENDCrossSection::create_used_target_map(), G4BGGNucleonElasticXS::G4BGGNucleonElasticXS(), G4BGGNucleonInelasticXS::G4BGGNucleonInelasticXS(), G4BGGPionElasticXS::G4BGGPionElasticXS(), G4BGGPionInelasticXS::G4BGGPionInelasticXS(), G4GammaNuclearXS::G4GammaNuclearXS(), G4NeutronCaptureXS::G4NeutronCaptureXS(), G4NeutronElasticXS::G4NeutronElasticXS(), G4NeutronInelasticXS::G4NeutronInelasticXS(), G4ParticleInelasticXS::G4ParticleInelasticXS(), G4NeutronCaptureXS::GetElementCrossSection(), G4NeutronElasticXS::GetElementCrossSection(), G4NeutronInelasticXS::GetElementCrossSection(), G4BGGNucleonElasticXS::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4BGGNucleonInelasticXS::GetElementCrossSection(), G4GammaNuclearXS::GetElementCrossSection(), G4ParticleInelasticXS::GetElementCrossSection(), G4BGGNucleonElasticXS::GetIsoCrossSection(), G4BGGPionElasticXS::GetIsoCrossSection(), G4BGGPionInelasticXS::GetIsoCrossSection(), G4GammaNuclearXS::GetIsoCrossSection(), G4BGGNucleonInelasticXS::GetIsoCrossSection(), G4VCrossSectionDataSet::GetVerboseLevel(), G4NeutronElasticXS::Initialise(), G4ParticleInelasticXS::IsoCrossSection(), G4NeutronCaptureXS::IsoCrossSection(), G4NeutronInelasticXS::IsoCrossSection(), G4GammaNuclearXS::RetrieveVector(), G4NeutronCaptureXS::RetrieveVector(), G4NeutronInelasticXS::RetrieveVector(), G4ParticleInelasticXS::RetrieveVector(), and G4VCrossSectionDataSet::SetVerboseLevel().


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