G4NistManager Class Reference

#include <G4NistManager.hh>


Public Member Functions

 ~G4NistManager ()
G4ElementGetElement (size_t index)
G4ElementFindOrBuildElement (G4int Z, G4bool isotopes=true)
G4ElementFindOrBuildElement (const G4String &symb, G4bool isotopes=true)
size_t GetNumberOfElements () const
G4int GetZ (const G4String &symb) const
G4double GetAtomicMassAmu (const G4String &symb) const
G4double GetAtomicMassAmu (G4int Z) const
G4double GetIsotopeMass (G4int Z, G4int N) const
G4double GetAtomicMass (G4int Z, G4int N) const
G4double GetTotalElectronBindingEnergy (G4int Z) const
G4int GetNistFirstIsotopeN (G4int Z) const
G4int GetNumberOfNistIsotopes (G4int Z) const
G4double GetIsotopeAbundance (G4int Z, G4int N) const
void PrintElement (G4int Z)
void PrintElement (const G4String &)
void PrintG4Element (const G4String &)
const std::vector< G4String > & GetNistElementNames () const
G4double GetMeanIonisationEnergy (G4int Z) const
G4MaterialGetMaterial (size_t index)
G4MaterialFindOrBuildMaterial (const G4String &name, G4bool isotopes=true, G4bool warning=false)
G4MaterialBuildMaterialWithNewDensity (const G4String &name, const G4String &basename, G4double density=0.0, G4double temp=CLHEP::STP_Temperature, G4double pres=CLHEP::STP_Pressure)
G4MaterialConstructNewMaterial (const G4String &name, const std::vector< G4String > &elm, const std::vector< G4int > &nbAtoms, G4double dens, G4bool isotopes=true, G4State state=kStateSolid, G4double temp=CLHEP::STP_Temperature, G4double pressure=CLHEP::STP_Pressure)
G4MaterialConstructNewMaterial (const G4String &name, const std::vector< G4String > &elm, const std::vector< G4double > &weight, G4double dens, G4bool isotopes=true, G4State state=kStateSolid, G4double temp=CLHEP::STP_Temperature, G4double pressure=CLHEP::STP_Pressure)
G4MaterialConstructNewGasMaterial (const G4String &name, const G4String &nameNist, G4double temp, G4double pres, G4bool isotopes=true)
G4MaterialConstructNewIdealGasMaterial (const G4String &name, const std::vector< G4String > &elm, const std::vector< G4int > &nbAtoms, G4bool isotopes=true, G4double temp=CLHEP::STP_Temperature, G4double pressure=CLHEP::STP_Pressure)
size_t GetNumberOfMaterials ()
G4int GetVerbose ()
void SetVerbose (G4int)
void PrintG4Material (const G4String &)
void ListMaterials (const G4String &)
const std::vector< G4String > & GetNistMaterialNames () const
G4double GetZ13 (G4double Z)
G4double GetZ13 (G4int Z)
G4double GetA27 (G4int Z)
G4double GetLOGA (G4double A)
G4double GetLOGZ (G4int Z)
G4double GetLOGA (G4int Z)

Static Public Member Functions

static G4NistManagerInstance ()


Detailed Description

Definition at line 82 of file G4NistManager.hh.


Constructor & Destructor Documentation

G4NistManager::~G4NistManager (  ) 

Definition at line 103 of file G4NistManager.cc.

References G4Element::GetElementTable(), G4Isotope::GetIsotopeTable(), and G4Material::GetMaterialTable().

00104 {
00105   //  G4cout << "NistManager: start material destruction" << G4endl;
00106   const G4MaterialTable* theMaterialTable = G4Material::GetMaterialTable();
00107   size_t nmat = theMaterialTable->size();
00108   size_t i;
00109   for(i=0; i<nmat; i++) {
00110     if((*theMaterialTable)[i]) { delete (*theMaterialTable)[i]; }
00111   }
00112   //  G4cout << "NistManager: start element destruction" << G4endl;
00113   const G4ElementTable* theElementTable = G4Element::GetElementTable();
00114   size_t nelm = theElementTable->size();
00115   for(i=0; i<nelm; i++) {
00116     if((*theElementTable)[i]) { delete (*theElementTable)[i]; }
00117   }
00118   //  G4cout << "NistManager: start isotope destruction" << G4endl;
00119   const G4IsotopeTable* theIsotopeTable = G4Isotope::GetIsotopeTable();
00120   size_t niso = theIsotopeTable->size();
00121   for(i=0; i<niso; i++) {
00122     if((*theIsotopeTable)[i]) { delete (*theIsotopeTable)[i]; }
00123   }
00124   //  G4cout << "NistManager: end isotope destruction" << G4endl;
00125   delete messenger;
00126   delete matBuilder;
00127   delete elmBuilder;  
00128   // G4cout << "NistManager: end destruction" << G4endl;
00129 }


Member Function Documentation

G4Material * G4NistManager::BuildMaterialWithNewDensity ( const G4String name,
const G4String basename,
G4double  density = 0.0,
G4double  temp = CLHEP::STP_Temperature,
G4double  pres = CLHEP::STP_Pressure 
)

Definition at line 134 of file G4NistManager.cc.

References FatalException, FindOrBuildMaterial(), G4cout, G4endl, G4Exception(), G4Material::GetDensity(), G4Material::GetPressure(), G4Material::GetState(), and G4Material::GetTemperature().

00139 {
00140   G4Material* bmat = FindOrBuildMaterial(name);
00141   if(bmat) {
00142     G4cout << "G4NistManager::BuildMaterialWithNewDensity ERROR: " << G4endl;
00143     G4cout << " New material <" << name << "> cannot be built because material"
00144            << " with the same name already exist" << G4endl;
00145     G4Exception("G4NistManager::BuildMaterialWithNewDensity()", "mat101",
00146                  FatalException, "Wrong material name");
00147     return 0;
00148   }
00149   bmat = FindOrBuildMaterial(basename);
00150   if(!bmat) {
00151     G4cout << "G4NistManager::BuildMaterialWithNewDensity ERROR: " << G4endl;
00152     G4cout << " New material <" << name << "> cannot be built because " << G4endl;
00153     G4cout << " base material <" << basename << "> does not exist" << G4endl;
00154     G4Exception("G4NistManager::BuildMaterialWithNewDensity()", "mat102",
00155                  FatalException, "Wrong material name");    
00156     return 0;
00157   }
00158   G4double dens = density;
00159   G4double temp = temperature;
00160   G4double pres = pressure;
00161   if(dens == 0.0) { 
00162     dens = bmat->GetDensity();
00163     temp = bmat->GetTemperature();
00164     pres = bmat->GetPressure(); 
00165   }
00166   G4Material* mat = new G4Material(name, dens, bmat, bmat->GetState(),
00167                                    temp, pres);
00168   return mat;
00169 }

G4Material * G4NistManager::ConstructNewGasMaterial ( const G4String name,
const G4String nameNist,
G4double  temp,
G4double  pres,
G4bool  isotopes = true 
) [inline]

Definition at line 486 of file G4NistManager.hh.

References G4NistMaterialBuilder::ConstructNewGasMaterial().

00491 {
00492   return matBuilder->ConstructNewGasMaterial(name,nameNist,
00493                                              temp,pres,isotopes);
00494 }

G4Material * G4NistManager::ConstructNewIdealGasMaterial ( const G4String name,
const std::vector< G4String > &  elm,
const std::vector< G4int > &  nbAtoms,
G4bool  isotopes = true,
G4double  temp = CLHEP::STP_Temperature,
G4double  pressure = CLHEP::STP_Pressure 
) [inline]

Definition at line 498 of file G4NistManager.hh.

References G4NistMaterialBuilder::ConstructNewIdealGasMaterial().

00505 {
00506   return
00507     matBuilder->ConstructNewIdealGasMaterial(name,elm,nbAtoms,isotopes,T,P);
00508 }

G4Material * G4NistManager::ConstructNewMaterial ( const G4String name,
const std::vector< G4String > &  elm,
const std::vector< G4double > &  weight,
G4double  dens,
G4bool  isotopes = true,
G4State  state = kStateSolid,
G4double  temp = CLHEP::STP_Temperature,
G4double  pressure = CLHEP::STP_Pressure 
) [inline]

Definition at line 471 of file G4NistManager.hh.

References G4NistMaterialBuilder::ConstructNewMaterial().

00480 {
00481   return matBuilder->ConstructNewMaterial(name,elm,w,dens,isotopes,state,T,P);
00482 }

G4Material * G4NistManager::ConstructNewMaterial ( const G4String name,
const std::vector< G4String > &  elm,
const std::vector< G4int > &  nbAtoms,
G4double  dens,
G4bool  isotopes = true,
G4State  state = kStateSolid,
G4double  temp = CLHEP::STP_Temperature,
G4double  pressure = CLHEP::STP_Pressure 
) [inline]

Definition at line 454 of file G4NistManager.hh.

References G4NistMaterialBuilder::ConstructNewMaterial().

00464 {
00465   return 
00466     matBuilder->ConstructNewMaterial(name,elm,nbAtoms,dens,isotopes,state,T,P);
00467 }

G4Element * G4NistManager::FindOrBuildElement ( const G4String symb,
G4bool  isotopes = true 
) [inline]

Definition at line 321 of file G4NistManager.hh.

References G4NistElementBuilder::FindOrBuildElement().

00323 {
00324   return elmBuilder->FindOrBuildElement(symb, isotopes);
00325 }

G4Element * G4NistManager::FindOrBuildElement ( G4int  Z,
G4bool  isotopes = true 
) [inline]

Definition at line 313 of file G4NistManager.hh.

References G4NistElementBuilder::FindOrBuildElement().

Referenced by G4tgbMaterialMgr::FindOrBuildG4Element(), and G4GDMLReadMaterials::GetElement().

00314 {
00315   return elmBuilder->FindOrBuildElement(Z, isotopes);
00316 }

G4Material * G4NistManager::FindOrBuildMaterial ( const G4String name,
G4bool  isotopes = true,
G4bool  warning = false 
) [inline]

Definition at line 445 of file G4NistManager.hh.

References G4NistMaterialBuilder::FindOrBuildMaterial().

Referenced by BuildMaterialWithNewDensity(), G4tgbMaterialMgr::FindOrBuildG4Material(), G4DNABrownianTransportation::G4DNABrownianTransportation(), G4MuElecElasticModel::G4MuElecElasticModel(), G4MuElecInelasticModel::G4MuElecInelasticModel(), and G4GDMLReadMaterials::GetMaterial().

00448 {
00449   return matBuilder->FindOrBuildMaterial(name, isotopes, warning);  
00450 }

G4double G4NistManager::GetA27 ( G4int  Z  )  [inline]

Definition at line 541 of file G4NistManager.hh.

Referenced by G4hBremsstrahlungModel::ComputeDMicroscopicCrossSection(), G4MuBremsstrahlungModel::G4MuBremsstrahlungModel(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), and G4WentzelVIRelXSection::G4WentzelVIRelXSection().

00542 {
00543   G4double res = 0.0;
00544   if(Z < 101) { res = POWERA27[Z]; } 
00545   return res;
00546 }

G4double G4NistManager::GetAtomicMass ( G4int  Z,
G4int  N 
) const [inline]

Definition at line 366 of file G4NistManager.hh.

References G4NistElementBuilder::GetAtomicMass().

Referenced by G4Isotope::G4Isotope().

00367 {
00368   return elmBuilder->GetAtomicMass(Z, N);
00369 }

G4double G4NistManager::GetAtomicMassAmu ( G4int  Z  )  const [inline]

Definition at line 350 of file G4NistManager.hh.

References G4NistElementBuilder::GetAtomicMassAmu().

00351 {
00352   return elmBuilder->GetAtomicMassAmu(Z);
00353 }

G4double G4NistManager::GetAtomicMassAmu ( const G4String symb  )  const [inline]

Definition at line 343 of file G4NistManager.hh.

References G4NistElementBuilder::GetAtomicMassAmu().

Referenced by G4UPiNuclearCrossSection::BuildPhysicsTable(), G4CrossSectionPairGG::BuildPhysicsTable(), G4BGGPionInelasticXS::BuildPhysicsTable(), G4BGGPionElasticXS::BuildPhysicsTable(), G4BGGNucleonInelasticXS::BuildPhysicsTable(), G4BGGNucleonElasticXS::BuildPhysicsTable(), G4ecpssrBaseKxsModel::CalculateCrossSection(), G4ecpssrBaseLixsModel::CalculateL1CrossSection(), G4ecpssrBaseLixsModel::CalculateL2CrossSection(), G4ecpssrBaseLixsModel::CalculateL3CrossSection(), G4UPiNuclearCrossSection::G4UPiNuclearCrossSection(), G4TripathiLightCrossSection::GetElementCrossSection(), G4TripathiCrossSection::GetElementCrossSection(), G4EMDissociationCrossSection::GetElementCrossSection(), G4CrossSectionPairGG::GetElementCrossSection(), G4CrossSectionInelastic::GetElementCrossSection(), G4CrossSectionElastic::GetElementCrossSection(), G4ProtonInelasticCrossSection::GetProtonCrossSection(), G4ElasticHadrNucleusHE::HadrNucDifferCrSec(), G4ElasticHadrNucleusHE::SampleInvariantT(), G4ScreeningMottCrossSection::SetupKinematic(), G4IonCoulombCrossSection::SetupKinematic(), G4WentzelVIRelXSection::SetupTarget(), and G4WentzelOKandVIxSection::SetupTarget().

00344 {
00345   return elmBuilder->GetAtomicMassAmu(symb);
00346 }

G4Element * G4NistManager::GetElement ( size_t  index  )  [inline]

Definition at line 302 of file G4NistManager.hh.

References G4Element::GetElementTable().

00303 {
00304   G4Element* elm = 0; 
00305   const G4ElementTable* theElementTable = G4Element::GetElementTable();
00306   if(index < theElementTable->size()) { elm = (*theElementTable)[index]; }
00307   return elm;
00308 }

G4double G4NistManager::GetIsotopeAbundance ( G4int  Z,
G4int  N 
) const [inline]

Definition at line 382 of file G4NistManager.hh.

References G4NistElementBuilder::GetIsotopeAbundance().

Referenced by G4ExcitationHandler::BreakItUp(), G4Evaporation::BreakItUp(), and G4VCrossSectionDataSet::ComputeCrossSection().

00383 {
00384   return elmBuilder->GetIsotopeAbundance(Z, N);
00385 }

G4double G4NistManager::GetIsotopeMass ( G4int  Z,
G4int  N 
) const [inline]

Definition at line 358 of file G4NistManager.hh.

References G4NistElementBuilder::GetIsotopeMass().

00359 {
00360   return elmBuilder->GetIsotopeMass(Z, N);
00361 }

G4double G4NistManager::GetLOGA ( G4int  Z  )  [inline]

Definition at line 564 of file G4NistManager.hh.

00565 {
00566   G4double res = 0.0;
00567   if(Z < 101) { res = LOGAZ[Z]; } 
00568   return res;
00569 }

G4double G4NistManager::GetLOGA ( G4double  A  )  [inline]

Definition at line 557 of file G4NistManager.hh.

References G4Pow::logA().

00558 {
00559   return g4pow->logA(A);
00560 }

G4double G4NistManager::GetLOGZ ( G4int  Z  )  [inline]

Definition at line 550 of file G4NistManager.hh.

References G4Pow::logZ().

Referenced by G4PairProductionRelModel::SetCurrentElement(), G4MuPairProductionModel::SetCurrentElement(), and G4eBremsstrahlungRelModel::SetCurrentElement().

00551 {
00552   return g4pow->logZ(Z);
00553 }

G4Material * G4NistManager::GetMaterial ( size_t  index  )  [inline]

Definition at line 427 of file G4NistManager.hh.

References G4Material::GetMaterialTable().

00428 {
00429   const G4MaterialTable* theMaterialTable = G4Material::GetMaterialTable();
00430   G4Material* mat = 0;
00431   if(index < theMaterialTable->size()) mat = (*theMaterialTable)[index];
00432   return mat;
00433 }

G4double G4NistManager::GetMeanIonisationEnergy ( G4int  Z  )  const [inline]

Definition at line 413 of file G4NistManager.hh.

References G4NistMaterialBuilder::GetMeanIonisationEnergy().

Referenced by G4IonisParamElm::G4IonisParamElm().

00414 {
00415   return matBuilder->GetMeanIonisationEnergy(Z-1);
00416 }

const std::vector< G4String > & G4NistManager::GetNistElementNames (  )  const [inline]

Definition at line 406 of file G4NistManager.hh.

References G4NistElementBuilder::GetElementNames().

00407 {
00408   return elmBuilder->GetElementNames();
00409 }

G4int G4NistManager::GetNistFirstIsotopeN ( G4int  Z  )  const [inline]

Definition at line 390 of file G4NistManager.hh.

References G4NistElementBuilder::GetNistFirstIsotopeN().

Referenced by G4VCrossSectionDataSet::ComputeCrossSection().

00391 {
00392   return elmBuilder->GetNistFirstIsotopeN(Z);
00393 }

const std::vector< G4String > & G4NistManager::GetNistMaterialNames (  )  const [inline]

Definition at line 520 of file G4NistManager.hh.

References G4NistMaterialBuilder::GetMaterialNames().

00521 {
00522   return matBuilder->GetMaterialNames();
00523 }

size_t G4NistManager::GetNumberOfElements (  )  const [inline]

Definition at line 329 of file G4NistManager.hh.

00330 { 
00331   return nElements;
00332 }

size_t G4NistManager::GetNumberOfMaterials (  )  [inline]

Definition at line 295 of file G4NistManager.hh.

00296 {
00297   return nMaterials;
00298 }

G4int G4NistManager::GetNumberOfNistIsotopes ( G4int  Z  )  const [inline]

Definition at line 398 of file G4NistManager.hh.

References G4NistElementBuilder::GetNumberOfNistIsotopes().

Referenced by G4VCrossSectionDataSet::ComputeCrossSection().

00399 {
00400   return elmBuilder->GetNumberOfNistIsotopes(Z);
00401 }

G4double G4NistManager::GetTotalElectronBindingEnergy ( G4int  Z  )  const [inline]

Definition at line 374 of file G4NistManager.hh.

References G4NistElementBuilder::GetTotalElectronBindingEnergy().

00375 {
00376   return elmBuilder->GetTotalElectronBindingEnergy(Z);
00377 }

G4int G4NistManager::GetVerbose (  )  [inline]

Definition at line 437 of file G4NistManager.hh.

00438 {
00439   return verbose;
00440 }

G4int G4NistManager::GetZ ( const G4String symb  )  const [inline]

Definition at line 336 of file G4NistManager.hh.

References G4NistElementBuilder::GetZ().

00337 {
00338   return elmBuilder->GetZ(symb);
00339 }

G4double G4NistManager::GetZ13 ( G4int  Z  )  [inline]

Definition at line 534 of file G4NistManager.hh.

References G4Pow::Z13().

00535 {
00536   return g4pow->Z13(Z);
00537 }

G4double G4NistManager::GetZ13 ( G4double  Z  )  [inline]

Definition at line 527 of file G4NistManager.hh.

References G4Pow::A13().

Referenced by G4MuBremsstrahlungModel::ComputeDMicroscopicCrossSection(), G4hBremsstrahlungModel::ComputeDMicroscopicCrossSection(), G4ionEffectiveCharge::EffectiveCharge(), G4PairProductionRelModel::SetCurrentElement(), G4MuPairProductionModel::SetCurrentElement(), and G4eBremsstrahlungRelModel::SetCurrentElement().

00528 {
00529   return g4pow->A13(A);
00530 }

G4NistManager * G4NistManager::Instance (  )  [static]

Definition at line 68 of file G4NistManager.cc.

Referenced by G4ExcitationHandler::BreakItUp(), G4UPiNuclearCrossSection::BuildPhysicsTable(), G4BGGPionInelasticXS::BuildPhysicsTable(), G4BGGPionElasticXS::BuildPhysicsTable(), G4BGGNucleonInelasticXS::BuildPhysicsTable(), G4BGGNucleonElasticXS::BuildPhysicsTable(), G4ecpssrBaseKxsModel::CalculateCrossSection(), G4ecpssrBaseLixsModel::CalculateL1CrossSection(), G4ecpssrBaseLixsModel::CalculateL2CrossSection(), G4ecpssrBaseLixsModel::CalculateL3CrossSection(), G4VCrossSectionDataSet::ComputeCrossSection(), G4tgbMaterialMgr::FindOrBuildG4Element(), G4tgbMaterialMgr::FindOrBuildG4Material(), G4BetheBlochModel::G4BetheBlochModel(), G4CrossSectionDataStore::G4CrossSectionDataStore(), G4CrossSectionElastic::G4CrossSectionElastic(), G4CrossSectionInelastic::G4CrossSectionInelastic(), G4CrossSectionPairGG::G4CrossSectionPairGG(), G4DNABrownianTransportation::G4DNABrownianTransportation(), G4eBremParametrizedModel::G4eBremParametrizedModel(), G4eBremsstrahlungRelModel::G4eBremsstrahlungRelModel(), G4eCoulombScatteringModel::G4eCoulombScatteringModel(), G4ElasticHadrNucleusHE::G4ElasticHadrNucleusHE(), G4EmCorrections::G4EmCorrections(), G4EmSaturation::G4EmSaturation(), G4eSingleCoulombScatteringModel::G4eSingleCoulombScatteringModel(), G4hCoulombScatteringModel::G4hCoulombScatteringModel(), G4IonCoulombCrossSection::G4IonCoulombCrossSection(), G4IonCoulombScatteringModel::G4IonCoulombScatteringModel(), G4ionEffectiveCharge::G4ionEffectiveCharge(), G4IonisParamElm::G4IonisParamElm(), G4Isotope::G4Isotope(), G4MuBremsstrahlungModel::G4MuBremsstrahlungModel(), G4MuElecElasticModel::G4MuElecElasticModel(), G4MuElecInelasticModel::G4MuElecInelasticModel(), G4MuPairProductionModel::G4MuPairProductionModel(), G4PairProductionRelModel::G4PairProductionRelModel(), G4ProtonInelasticCrossSection::G4ProtonInelasticCrossSection(), G4ScreeningMottCrossSection::G4ScreeningMottCrossSection(), G4UnstableFragmentBreakUp::G4UnstableFragmentBreakUp(), G4UPiNuclearCrossSection::G4UPiNuclearCrossSection(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4WentzelVIModel::G4WentzelVIModel(), G4WentzelVIRelModel::G4WentzelVIRelModel(), G4WentzelVIRelXSection::G4WentzelVIRelXSection(), G4GDMLReadMaterials::GetElement(), G4TripathiLightCrossSection::GetElementCrossSection(), G4TripathiCrossSection::GetElementCrossSection(), G4NeutronInelasticXS::GetElementCrossSection(), G4NeutronInelasticCrossSection::GetElementCrossSection(), G4NeutronElasticXS::GetElementCrossSection(), G4IonsSihverCrossSection::GetElementCrossSection(), G4IonsShenCrossSection::GetElementCrossSection(), G4IonsKoxCrossSection::GetElementCrossSection(), G4HadronInelasticDataSet::GetElementCrossSection(), G4HadronElasticDataSet::GetElementCrossSection(), G4GGNuclNuclCrossSection::GetElementCrossSection(), G4EMDissociationCrossSection::GetElementCrossSection(), G4ComponentGGNuclNuclXsc::GetElementCrossSection(), G4GDMLReadMaterials::GetMaterial(), G4TripathiLightCrossSection::IsElementApplicable(), and G4IonisParamMat::SetMeanExcitationEnergy().

00069 {
00070   if (instance == 0) {
00071     static G4NistManager manager;
00072     instance = &manager;
00073   }
00074   return instance;
00075 }

void G4NistManager::ListMaterials ( const G4String  )  [inline]

Definition at line 512 of file G4NistManager.hh.

References G4NistMaterialBuilder::ListMaterials().

Referenced by G4NistMessenger::SetNewValue().

00513 {
00514   matBuilder->ListMaterials(list);
00515 }

void G4NistManager::PrintElement ( const G4String  ) 

Definition at line 173 of file G4NistManager.cc.

References G4NistElementBuilder::GetZ(), and G4NistElementBuilder::PrintElement().

00174 {
00175   if (symbol == "all") { elmBuilder->PrintElement(0); }
00176   else                 { elmBuilder->PrintElement(elmBuilder->GetZ(symbol)); }
00177 }

void G4NistManager::PrintElement ( G4int  Z  )  [inline]

Definition at line 420 of file G4NistManager.hh.

References G4NistElementBuilder::PrintElement().

Referenced by G4NistMessenger::SetNewValue().

00421 {
00422   elmBuilder->PrintElement(Z);
00423 }

void G4NistManager::PrintG4Element ( const G4String  ) 

Definition at line 181 of file G4NistManager.cc.

References G4cout, G4endl, and G4Element::GetElementTable().

Referenced by G4NistMessenger::SetNewValue().

00182 {
00183   const G4ElementTable* theElementTable = G4Element::GetElementTable();
00184   size_t nelm = theElementTable->size();
00185   for(size_t i=0; i<nelm; i++) {
00186     G4Element* elm = (*theElementTable)[i];
00187     if ( name == elm->GetName() || "all" == name) {
00188       G4cout << *elm << G4endl;
00189       return;
00190     }
00191   }
00192 }

void G4NistManager::PrintG4Material ( const G4String  ) 

Definition at line 196 of file G4NistManager.cc.

References G4cout, G4endl, and G4Material::GetMaterialTable().

Referenced by G4NistMessenger::SetNewValue().

00197 {
00198   const G4MaterialTable* theMaterialTable = G4Material::GetMaterialTable();
00199   size_t nmat = theMaterialTable->size();
00200   for(size_t i=0; i<nmat; i++) {
00201     G4Material* mat = (*theMaterialTable)[i];
00202     if ( name == mat->GetName() || "all" == name) {
00203       G4cout << *mat << G4endl;
00204       return;
00205     }
00206   }
00207 }

void G4NistManager::SetVerbose ( G4int   ) 

Definition at line 211 of file G4NistManager.cc.

References G4NistMaterialBuilder::SetVerbose(), and G4NistElementBuilder::SetVerbose().

Referenced by G4NistMessenger::SetNewValue().

00212 {
00213   verbose = val;
00214   elmBuilder->SetVerbose(val);
00215   matBuilder->SetVerbose(val);
00216 }


The documentation for this class was generated from the following files:
Generated on Mon May 27 17:52:44 2013 for Geant4 by  doxygen 1.4.7