globals.hh File Reference

#include "G4ios.hh"
#include <algorithm>
#include "G4Types.hh"
#include "G4String.hh"
#include "templates.hh"
#include "G4PhysicalConstants.hh"
#include "G4SystemOfUnits.hh"
#include "G4ExceptionSeverity.hh"

Go to the source code of this file.

Defines

#define FALSE   0
#define TRUE   1

Typedefs

typedef std::ostringstream G4ExceptionDescription

Functions

void G4Exception (const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *comments)
void G4Exception (const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, G4ExceptionDescription &description)
void G4Exception (const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, G4ExceptionDescription &description, const char *comments)


Define Documentation

#define FALSE   0

Definition at line 52 of file globals.hh.

Referenced by G4SDParticleWithEnergyFilter::Accept(), G4SDParticleFilter::Accept(), G4SDNeutralFilter::Accept(), G4SDKineticEnergyFilter::Accept(), G4SDChargedFilter::Accept(), G4NeutronHPJENDLHEData::BuildPhysicsTable(), G4VInteractorManager::DisableSecondaryLoop(), G3CalcParamsFn(), G3NegVolPars(), G4MoleculeCounter::G4MoleculeCounter(), G4UIGainServer::G4UIGainServer(), G4UIterminal::G4UIterminal(), G4UIGAG::GetCommand(), G4UItcsh::GetCommandLineString(), G4UIcsh::GetCommandLineString(), G4VUIshell::GetCommandPathTail(), G4UItcsh::IsCursorLast(), G4PSPassageTrackLength::IsPassed(), G4PSPassageCellFlux::IsPassed(), G4PSPassageCellCurrent::IsPassed(), G4NeutronHPorLFission::IsThisElementOK(), G4NeutronHPorLElastic::IsThisElementOK(), G4NeutronHPorLEInelastic::IsThisElementOK(), G4NeutronHPorLCapture::IsThisElementOK(), G4VUIshell::ListCommand(), G4PSTrackLength::ProcessHits(), G4PSTrackCounter::ProcessHits(), G4PSTermination::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSNofStep::ProcessHits(), G4PSNofSecondary::ProcessHits(), G4PSMinKinEAtGeneration::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4PSEnergyDeposit::ProcessHits(), G4PSDoseDeposit::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSCellFlux::ProcessHits(), G4OpenInventorXtExaminerViewer::processSoEvent(), G4VInteractorManager::RequireExitSecondaryLoop(), G4VInteractorManager::SecondaryLoop(), G4ITModelManager::SetModel(), G4BaryonSplitter::SplitBarion(), G4EnergySplitter::SplitEnergyInVolumes(), and G4VInteractorManager::~G4VInteractorManager().

#define TRUE   1

Definition at line 55 of file globals.hh.

Referenced by G4SDParticleWithEnergyFilter::Accept(), G4SDParticleFilter::Accept(), G4SDNeutralFilter::Accept(), G4SDKineticEnergyFilter::Accept(), G4SDChargedFilter::Accept(), G4NeutronHPCaptureFS::ApplyYourself(), G4NeutronHPJENDLHEData::BuildPhysicsTable(), G4ErrorPropagatorManager::CloseGeometry(), G4OpenInventorXtExaminerViewer::createViewerButtons(), G4VInteractorManager::EnableSecondaryLoop(), G3CalcParamsFn(), G3NegVolPars(), G4OpenInventorXtExaminerViewer::G4OpenInventorXtExaminerViewer(), G4UItcsh::GetCommandLineString(), G4VUIshell::GetCommandPathTail(), G4EnergySplitter::GetVoxelMaterial(), G4UItcsh::IsCursorLast(), G4PSPassageTrackLength::IsPassed(), G4PSPassageCellFlux::IsPassed(), G4PSPassageCellCurrent::IsPassed(), G4NeutronHPorLFission::IsThisElementOK(), G4NeutronHPorLElastic::IsThisElementOK(), G4NeutronHPorLEInelastic::IsThisElementOK(), G4NeutronHPorLCapture::IsThisElementOK(), G4VUIshell::ListCommand(), G4UIterminal::PauseSessionStart(), G4UIGainServer::PauseSessionStart(), G4DNAMolecularReactionTable::PrintTable(), G4PSTrackLength::ProcessHits(), G4PSTrackCounter::ProcessHits(), G4PSTermination::ProcessHits(), G4PSStepChecker::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSSphereSurfaceCurrent::ProcessHits(), G4PSPopulation::ProcessHits(), G4PSPassageTrackLength::ProcessHits(), G4PSPassageCellFlux::ProcessHits(), G4PSPassageCellCurrent::ProcessHits(), G4PSNofStep::ProcessHits(), G4PSNofSecondary::ProcessHits(), G4PSNofCollision::ProcessHits(), G4PSMinKinEAtGeneration::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4PSFlatSurfaceCurrent::ProcessHits(), G4PSEnergyDeposit::ProcessHits(), G4PSDoseDeposit::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSCylinderSurfaceCurrent::ProcessHits(), G4PSCellFlux::ProcessHits(), G4PSCellCharge::ProcessHits(), G4OpenInventorXtExaminerViewer::processSoEvent(), G4VInteractorManager::SecondaryLoop(), G4QGSParticipants::SelectInteractions(), G4UIterminal::SessionStart(), G4UIGainServer::SessionStart(), G4UItcsh::SetLsColor(), G4NeutronHPDataUsed::SetNaturalAbundanceFlag(), G4BaryonSplitter::SplitBarion(), G4EnergySplitter::SplitEnergyInVolumes(), and G4VInteractorManager::~G4VInteractorManager().


Typedef Documentation

typedef std::ostringstream G4ExceptionDescription

Definition at line 76 of file globals.hh.


Function Documentation

void G4Exception ( const char *  originOfException,
const char *  exceptionCode,
G4ExceptionSeverity  severity,
G4ExceptionDescription description,
const char *  comments 
)

Definition at line 119 of file G4Exception.cc.

00124 {
00125   description << comments << G4endl;
00126   G4Exception(originOfException, exceptionCode, severity, description);
00127 }

void G4Exception ( const char *  originOfException,
const char *  exceptionCode,
G4ExceptionSeverity  severity,
G4ExceptionDescription description 
)

Definition at line 110 of file G4Exception.cc.

00114 {
00115   G4String des = description.str();
00116   G4Exception(originOfException, exceptionCode, severity, des.c_str());
00117 }

void G4Exception ( const char *  originOfException,
const char *  exceptionCode,
G4ExceptionSeverity  severity,
const char *  comments 
)

Definition at line 41 of file G4Exception.cc.

Referenced by G4MagInt_Driver::AccurateAdvance(), G4TransportationManager::ActivateNavigator(), G4VCrossSectionHandler::ActiveElements(), G4ITStepProcessor::ActiveOnlyITProcess(), G4SimpleIntegration::AdaptGauss(), G4TrajectoryChargeFilter::Add(), G4SDParticleFilter::add(), G4CellScorerStore::AddCellScorer(), G4ElementData::AddComponent(), G4VSceneHandler::AddCompound(), G4HepRepFileSceneHandler::AddCompound(), G4GMocrenFileSceneHandler::AddCompound(), G4LogicalVolume::AddDaughter(), G4QDiscProcessMixer::AddDiscreteProcess(), G4MolecularDecayTable::AddeConfToExcitedState(), G4Material::AddElement(), G4MaterialPropertiesTable::AddEntry(), G4MolecularDecayTable::AddExcitedState(), G4TessellatedSolid::AddFacet(), G4AttributeFilterT< T >::AddInterval(), G4TrajectoryDrawByAttribute::AddIntervalContext(), G4Element::AddIsotope(), G4Material::AddMaterial(), G4GDMLWrite::AddModule(), G4SDManager::AddNewCollection(), G4XmlAnalysisManager::AddNtupleRow(), G4RootAnalysisManager::AddNtupleRow(), G4CsvAnalysisManager::AddNtupleRow(), G4tgrVolume::AddPlace(), G4tgrVolume::AddPlaceReplica(), G4HepRepSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddPrimitive(), G4ProcessManager::AddProcess(), G4VUserPhysicsList::AddProcessManager(), G4tgrRotationMatrixFactory::AddRotMatrix(), G4VParticleChange::AddSecondary(), G4ParticleChangeForRadDecay::AddSecondary(), G4GMocrenFileSceneHandler::AddSolid(), G4GDMLWriteSolids::AddSolid(), G4Colour::AddToMap(), G4PhysicsListHelper::AddTransportation(), G4AttributeFilterT< T >::AddValue(), G4TrajectoryDrawByAttribute::AddValueContext(), G4NavigationLogger::AlongComputeStepLog(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4ModelCmdSetAuxPtsFillStyle< M >::Apply(), G4ModelCmdSetStepPtsFillStyle< M >::Apply(), G4ModelCmdSetAuxPtsSizeType< M >::Apply(), G4ModelCmdSetStepPtsSizeType< M >::Apply(), G4ModelCmdSetAuxPtsType< M >::Apply(), G4ModelCmdSetStepPtsType< M >::Apply(), G4MuMinusCapturePrecompound::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4Tubs::ApproxSurfaceNormal(), G4CutTubs::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHistoFile(), G4tgrUtils::AreWordsEquivalent(), G4GDMLReadStructure::AssemblyRead(), G4GDMLReadMaterials::AtomRead(), G4QCaptureAtRest::AtRestDoIt(), G4PiMinusAbsorptionAtRest::AtRestDoIt(), G4KaonMinusAbsorptionAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4AugerData::AugerShellId(), G4AugerTransition::AugerTransitionEnergies(), G4AugerTransition::AugerTransitionProbabilities(), G4GDMLReadStructure::AuxiliaryRead(), G4GDMLReadStructure::AxisRead(), G4ReplicaNavigation::BackLocate(), G4VisManager::BeginDraw(), G4VisManager::BeginDraw2D(), G4VSceneHandler::BeginPrimitives(), G4VSceneHandler::BeginPrimitives2D(), G4HadronicProcess::BiasCrossSectionByFactor(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4GDMLWriteStructure::BorderSurfaceCache(), G4GDMLReadStructure::BorderSurfaceRead(), G4GDMLReadParamvol::Box_dimensionsRead(), G4GDMLReadSolids::BoxRead(), G4QIonIonCollision::Breeder(), G4QFragmentation::Breeder(), G4tgrPlaceDivRep::BuildAxis(), G4ErrorTrajState::BuildCharge(), G4SmartVoxelHeader::BuildConsumedNodes(), G4tgbElement::BuildG4ElementFromIsotopes(), G4tgbMaterialMixtureByWeight::BuildG4Material(), G4tgbMaterialMixtureByVolume::BuildG4Material(), G4tgbMaterialMixtureByNoAtoms::BuildG4Material(), G4tgbRotationMatrix::BuildG4RotMatrix(), G4NistManager::BuildMaterialWithNewDensity(), G4VCrossSectionHandler::BuildMeanFreePathForMaterials(), G4SmartVoxelHeader::BuildNodes(), G4VXTRenergyLoss::BuildPhysicsTable(), G4VUserPhysicsList::BuildPhysicsTable(), G4HadronicProcess::BuildPhysicsTable(), G4IonStoppingData::BuildPhysicsVector(), G4SmartVoxelHeader::BuildReplicaVoxels(), G4tgbVolume::BuildSolidForDivision(), G4Molecule::BuildTrack(), G4SmartVoxelHeader::BuildVoxelsWithinLimits(), G4BREPSolid::CalcBBoxes(), G4QFreeScattering::CalcElTot(), G4Scene::CalculateExtent(), G4ReflectedSolid::CalculateExtent(), G4SmartVoxelHeader::CalculateQuality(), G4ITModelProcessor::CalculateTimeStep(), G4DNAMolecularReactionTable::CanReactWith(), G4ChebyshevApproximation::ChebyshevEvaluation(), G4Trd::CheckAndSetAllParameters(), G4VPrimitiveScorer::CheckAndSetUnit(), G4MolecularDecayTable::CheckDataConsistency(), G4Tubs::CheckDPhiAngle(), G4PrimaryTransformer::CheckDynamicParticle(), G4TrackList::CheckFlag(), G4ErrorPropagator::CheckIfLastStep(), G4tgrParameterMgr::CheckIfNewParameter(), G4VParticleChange::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4MultiNavigator::CheckMassWorld(), G4ProductionCutsTable::CheckMaterialCutsCoupleInfo(), G4ProductionCutsTable::CheckMaterialInfo(), G4VDivisionParameterisation::CheckNDivAndWidth(), G4tgbPlaceParameterisation::CheckNExtraData(), G4tgbVolume::CheckNoSolidParams(), G4VDivisionParameterisation::CheckOffset(), G4ProcessManager::CheckOrderingParameters(), G4PVPlacement::CheckOverlaps(), G4PVParameterised::CheckOverlaps(), G4ParameterisationTrdY::CheckParametersValidity(), G4ParameterisationPolyhedraZ::CheckParametersValidity(), G4ParameterisationPolyhedraPhi::CheckParametersValidity(), G4ParameterisationPolyhedraRho::CheckParametersValidity(), G4ParameterisationPolyconeZ::CheckParametersValidity(), G4ParameterisationPolyconeRho::CheckParametersValidity(), G4PhysicsListHelper::CheckParticleList(), G4HadronicProcess::CheckResult(), G4VParticleChange::CheckSecondary(), G4PhantomParameterisation::CheckVoxelsFillContainer(), G4tgrUtils::CheckWLsize(), G4QuasiFreeRatios::ChExer(), G4QuasiElRatios::ChExer(), G4QIonIonCollision::ChooseX(), G4QFragmentation::ChooseX(), G4ShortLivedTable::clear(), G4IonTable::clear(), G4Region::ClearFastSimulationManager(), G4VSolid::Clone(), G4XmlAnalysisManager::CloseFile(), G4RootAnalysisManager::CloseFile(), G4CsvAnalysisManager::CloseFile(), G4GDMLReadMaterials::CompositeRead(), G4WentzelVIRelModel::ComputeCrossSectionPerAtom(), G4WentzelVIModel::ComputeCrossSectionPerAtom(), G4PenelopeRayleighModel::ComputeCrossSectionPerAtom(), G4PenelopePhotoElectricModel::ComputeCrossSectionPerAtom(), G4PenelopeGammaConversionModel::ComputeCrossSectionPerAtom(), G4LivermoreIonisationModel::ComputeCrossSectionPerAtom(), G4LivermoreBremsstrahlungModel::ComputeCrossSectionPerAtom(), G4VTwistedFaceted::ComputeDimensions(), G4VSolid::ComputeDimensions(), G4TwistedTubs::ComputeDimensions(), G4ReflectedSolid::ComputeDimensions(), G4DisplacedSolid::ComputeDimensions(), G4VoxelSafety::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator::ComputeSafety(), G4ReplicaNavigation::ComputeStep(), G4PropagatorInField::ComputeStep(), G4PathFinder::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ITNavigator::ComputeStep(), G4DNABrownianTransportation::ComputeStep(), G4ParameterisationTrdZ::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationBoxY::ComputeTransformation(), G4ParameterisationBoxX::ComputeTransformation(), G4PSPassageCellFlux::ComputeVolume(), G4PSDoseDeposit::ComputeVolume(), G4PSCellFlux::ComputeVolume(), G4GDMLReadParamvol::Cone_dimensionsRead(), G4GDMLReadSolids::ConeRead(), G4ImportanceConfigurator::Configure(), G4GDMLReadDefine::ConstantRead(), G4tgbVolume::ConstructG4LogVol(), G4tgbVolume::ConstructG4PhysVol(), G4OpticalPhysics::ConstructProcess(), G4ErrorPhysicsList::ConstructProcess(), G4ReduciblePolygon::Create(), G4Polyhedra::Create(), G4Polycone::Create(), G4CreatorFactoryT< T, Identifier, Creator >::Create(), G4PhysicalVolumeModel::CreateCurrentAttValues(), G4IonTable::CreateIon(), G4XmlAnalysisManager::CreateNtuple(), G4RootAnalysisManager::CreateNtuple(), G4CsvAnalysisManager::CreateNtuple(), G4XmlAnalysisManager::CreateNtupleDColumn(), G4RootAnalysisManager::CreateNtupleDColumn(), G4CsvAnalysisManager::CreateNtupleDColumn(), G4XmlAnalysisManager::CreateNtupleFColumn(), G4RootAnalysisManager::CreateNtupleFColumn(), G4CsvAnalysisManager::CreateNtupleFColumn(), G4XmlAnalysisManager::CreateNtupleIColumn(), G4RootAnalysisManager::CreateNtupleIColumn(), G4CsvAnalysisManager::CreateNtupleIColumn(), G4ReflectedSolid::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), G4Polycone::CreatePolyhedron(), G4PVDivisionFactory::CreatePVDivision(), G4VTwistedFaceted::CreateRotatedVertices(), G4Tubs::CreateRotatedVertices(), G4Trd::CreateRotatedVertices(), G4Trap::CreateRotatedVertices(), G4Tet::CreateRotatedVertices(), G4Para::CreateRotatedVertices(), G4Ellipsoid::CreateRotatedVertices(), G4CutTubs::CreateRotatedVertices(), G4BREPSolid::CreateRotatedVertices(), G4Box::CreateRotatedVertices(), G4tgrVolumeMgr::CreateSolid(), G4MultiNavigator::CreateTouchableHistoryHandle(), G4PenelopeIonisationCrossSection::CrossSection(), G4MuElecInelasticModel::CrossSectionPerVolume(), G4MuElecElasticModel::CrossSectionPerVolume(), G4DNARuddIonisationModel::CrossSectionPerVolume(), G4DNARuddIonisationExtendedModel::CrossSectionPerVolume(), G4DNAMeltonAttachmentModel::CrossSectionPerVolume(), G4DNAChampionElasticModel::CrossSectionPerVolume(), G4DNABornIonisationModel::CrossSectionPerVolume(), G4DNABornExcitationModel::CrossSectionPerVolume(), G4DataInterpolation::CubicSplineInterpolation(), G4GDMLReadSolids::CutTubeRead(), G4TransportationManager::DeActivateNavigator(), G4QNucleus::DecayAlphaAlpha(), G4QNucleus::DecayAlphaDiN(), G4QNucleus::DecayAntiDibaryon(), G4QNucleus::DecayAntiStrange(), G4QEnvironment::DecayAntistrange(), G4QEnvironment::DecayBaryon(), G4QNucleus::DecayDibaryon(), G4NuclearDecayChannel::DecayIt(), G4DNAMolecularDecay::DecayIt(), G4Decay::DecayIt(), G4QEnvironment::DecayMeson(), G4QNucleus::DecayMultyBaryon(), G4QString::DecayPt(), G4GDMLEvaluator::DefineConstant(), G4GDMLEvaluator::DefineMatrix(), G4GDMLReadDefine::DefineRead(), G4GDMLEvaluator::DefineVariable(), G4RunManagerKernel::DefineWorldVolume(), G4TransportationManager::DeRegisterNavigator(), G4LogicalVolumeModel::DescribeSolid(), G4PhysicalVolumeModel::DescribeYourselfTo(), G4NullModel::DescribeYourselfTo(), G4PolyPhiFace::Diagnose(), G4VTwistSurface::DistanceToBoundary(), G4VTwistedFaceted::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4SubtractionSolid::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Orb::DistanceToIn(), G4VTwistedFaceted::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Tubs::DistanceToOut(), G4Trd::DistanceToOut(), G4Trap::DistanceToOut(), G4Torus::DistanceToOut(), G4Tet::DistanceToOut(), G4Sphere::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Para::DistanceToOut(), G4Orb::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Box::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4GDMLReadStructure::DivisionvolRead(), G4ITStepProcessor::DoDefinePhysicalStepLength(), G4SamplingPostStepAction::DoIt(), G4PathFinder::DoNextCurvedStep(), G4ITStepProcessor::DoStepping(), G4TrajectoryDrawByAttribute::Draw(), G4TrajectoryDrawerUtils::DrawLineAndPoints(), G4VTrajectory::DrawTrajectory(), G4DrawVoxels::DrawVoxels(), G4GDMLReadMaterials::DRead(), G4ExactHelixStepper::DumbStepper(), G4HadronicWhiteBoard::Dump(), G4tgrFileIn::DumpException(), G4tgbGeometryDumper::DumpPVReplica(), G4tgbGeometryDumper::DumpSolid(), G4MaterialPropertiesTable::DumpTable(), G4GDMLReadSolids::ElconeRead(), G4GDMLReadMaterials::ElementRead(), G4GDMLReadSolids::EllipsoidRead(), G4GDMLReadSolids::EltubeRead(), G4VSceneHandler::EndPrimitives(), G4VSceneHandler::EndPrimitives2D(), G4SimpleLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4BrentLocator::EstimateIntersectionPoint(), G4CellScoreComposer::EstimatorCalculation(), G4GDMLEvaluator::Evaluate(), G4AttributeFilterT< T >::Evaluate(), G4GDMLEvaluator::EvaluateInteger(), G4QNucleus::EvaporateNucleus(), G4QFragmentation::EvaporateResidual(), G4GDMLReadDefine::ExpressionRead(), G4DNASancheExcitationModel::ExtendLowEnergyLimit(), G4GDMLRead::ExtensionRead(), G4HEInelastic::Factorial(), G4DataInterpolation::FastCubicSpline(), G4QuasiElRatios::FetchElTot(), G4QFreeScattering::FetchElTot(), G4GDMLReadStructure::FileRead(), G4VDecayChannel::FillDaughters(), G4CsvAnalysisManager::FillH1(), G4CsvAnalysisManager::FillH2(), G4XmlAnalysisManager::FillNtupleDColumn(), G4RootAnalysisManager::FillNtupleDColumn(), G4CsvAnalysisManager::FillNtupleDColumn(), G4XmlAnalysisManager::FillNtupleFColumn(), G4RootAnalysisManager::FillNtupleFColumn(), G4CsvAnalysisManager::FillNtupleFColumn(), G4XmlAnalysisManager::FillNtupleIColumn(), G4RootAnalysisManager::FillNtupleIColumn(), G4CsvAnalysisManager::FillNtupleIColumn(), G4VDecayChannel::FillParent(), G4ParticleDefinition::FillQuarkContents(), G4HadronicProcess::FillResult(), G4tgbVolumeMgr::FindG4LogVol(), G4tgbVolumeMgr::FindG4PhysVol(), G4tgbMaterialMgr::FindG4tgbElement(), G4tgbMaterialMgr::FindG4tgbIsotope(), G4tgbMaterialMgr::FindG4tgbMaterial(), G4IonTable::FindIon(), G4tgbMaterialMgr::FindOrBuildG4Element(), G4tgbMaterialMgr::FindOrBuildG4Material(), G4tgbRotationMatrixMgr::FindOrBuildTgbRotMatrix(), G4tgbVolume::FindOrConstructG4Solid(), G4tgrParameterMgr::FindParameter(), G4ITModelProcessor::FindReaction(), G4DNASmoluchowskiReactionModel::FindReaction(), G4tgrVolumeMgr::FindSolid(), G4ITStepProcessor::FindTransportationStep(), G4EMDataSet::FindValue(), G4DataSet::FindValue(), G4CompositeEMDataSet::FindValue(), G4CompositeDataSet::FindValue(), G4tgrVolumeMgr::FindVolume(), G4tgrLineProcessor::FindVolume(), G4tgbVolumeMgr::FindVolume(), G4tgrVolumeMgr::FindVolumes(), G4TrackList::Flag(), G4GDMLReadMaterials::FractionRead(), G4QIonIonCollision::Fragment(), G4QFragmentation::Fragment(), G4QEnvironment::Fragment(), G3toG4BuildLVTree(), G3toG4BuildPVTree(), G3toG4MANY(), G4alphaIonisation::G4alphaIonisation(), G4AxesModel::G4AxesModel(), G4BestUnit::G4BestUnit(), G4Box::G4Box(), G4BREPSolidPolyhedra::G4BREPSolidPolyhedra(), G4ChebyshevApproximation::G4ChebyshevApproximation(), G4CompositeDataSet::G4CompositeDataSet(), G4CompositeEMDataSet::G4CompositeEMDataSet(), G4ConicalSurface::G4ConicalSurface(), G4Cons::G4Cons(), G4ConstRK4::G4ConstRK4(), G4CsvAnalysisManager::G4CsvAnalysisManager(), G4CutTubs::G4CutTubs(), G4CylindricalSurface::G4CylindricalSurface(), G4DataQuestionaire::G4DataQuestionaire(), G4DataSet::G4DataSet(), G4ecpssrBaseKxsModel::G4ecpssrBaseKxsModel(), G4ecpssrBaseLixsModel::G4ecpssrBaseLixsModel(), G4Element::G4Element(), G4Ellipsoid::G4Ellipsoid(), G4EllipticalCone::G4EllipticalCone(), G4EMDataSet::G4EMDataSet(), G4ErrorRunManagerHelper::G4ErrorRunManagerHelper(), G4ErrorTrackLengthTarget::G4ErrorTrackLengthTarget(), G4EventManager::G4EventManager(), G4Exception(), G4ExtrudedSolid::G4ExtrudedSolid(), G4FConicalSurface::G4FConicalSurface(), G4FCylindricalSurface::G4FCylindricalSurface(), G4ForwardXrayTR::G4ForwardXrayTR(), G4GaussHermiteQ::G4GaussHermiteQ(), G4GaussJacobiQ::G4GaussJacobiQ(), G4GaussLaguerreQ::G4GaussLaguerreQ(), G4GaussLegendreQ::G4GaussLegendreQ(), G4GDMLMatrix::G4GDMLMatrix(), G4GenericTrap::G4GenericTrap(), G4GRSSolid::G4GRSSolid(), G4GRSVolume::G4GRSVolume(), G4gsbool(), G4gsdvn(), G4gsdvn2(), G4gsdvt(), G4gsdvt2(), G4gsmixt(), G4gspos(), G4gsposp(), G4gsrotm(), G4gsvolu(), G4HadronicException::G4HadronicException(), G4HEPEvtInterface::G4HEPEvtInterface(), G4Hype::G4Hype(), G4ImportanceProcess::G4ImportanceProcess(), G4IonisParamElm::G4IonisParamElm(), G4Isotope::G4Isotope(), G4IsotopeMagneticMomentTable::G4IsotopeMagneticMomentTable(), G4NURBS::G4NURBS(), G4OpticalSurface::G4OpticalSurface(), G4Orb::G4Orb(), G4Para::G4Para(), G4Paraboloid::G4Paraboloid(), G4ParameterisationConsRho::G4ParameterisationConsRho(), G4ParticleDefinition::G4ParticleDefinition(), G4ParticleTable::G4ParticleTable(), G4PenelopeCrossSection::G4PenelopeCrossSection(), G4PhotoElectricAngularGeneratorPolarized::G4PhotoElectricAngularGeneratorPolarized(), G4PixeShellDataSet::G4PixeShellDataSet(), G4Polycone::G4Polycone(), G4Polyhedra::G4Polyhedra(), G4ProcessDaughters(), G4ProcessManager::G4ProcessManager(), G4PVDivision::G4PVDivision(), G4PVParameterised::G4PVParameterised(), G4PVPlacement::G4PVPlacement(), G4PVReplica::G4PVReplica(), G4QContent::G4QContent(), G4QEnvironment::G4QEnvironment(), G4QFragmentation::G4QFragmentation(), G4QIonIonCollision::G4QIonIonCollision(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Region::G4Region(), G4RootAnalysisManager::G4RootAnalysisManager(), G4RunManager::G4RunManager(), G4RunManagerKernel::G4RunManagerKernel(), G4SandiaTable::G4SandiaTable(), G4SDParticleFilter::G4SDParticleFilter(), G4ShellEMDataSet::G4ShellEMDataSet(), G4Sphere::G4Sphere(), G4SphericalSurface::G4SphericalSurface(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4tgbPlaceParamLinear::G4tgbPlaceParamLinear(), G4tgbPlaceParamSquare::G4tgbPlaceParamSquare(), G4tgrRotationMatrix::G4tgrRotationMatrix(), G4tgrSolidBoolean::G4tgrSolidBoolean(), G4tgrVolumeDivision::G4tgrVolumeDivision(), G4TransportationManager::G4TransportationManager(), G4Trap::G4Trap(), G4TriangularFacet::G4TriangularFacet(), G4Tubs::G4Tubs(), G4TwistBoxSide::G4TwistBoxSide(), G4TwistedTubs::G4TwistedTubs(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4TwistTubsHypeSide::G4TwistTubsHypeSide(), G4TwistTubsSide::G4TwistTubsSide(), G4UIExecutive::G4UIExecutive(), G4UniformElectricField::G4UniformElectricField(), G4UniformMagField::G4UniformMagField(), G4UserEventAction::G4UserEventAction(), G4UserRunAction::G4UserRunAction(), G4UserStackingAction::G4UserStackingAction(), G4UserSteppingAction::G4UserSteppingAction(), G4UserTrackingAction::G4UserTrackingAction(), G4VisManager::G4VisManager(), G4VITRestProcess::G4VITRestProcess(), G4VParameterisationPolycone::G4VParameterisationPolycone(), G4VParameterisationPolyhedra::G4VParameterisationPolyhedra(), G4VSteppingVerbose::G4VSteppingVerbose(), G4VTwistedFaceted::G4VTwistedFaceted(), G4VUserPrimaryGeneratorAction::G4VUserPrimaryGeneratorAction(), G4VXTRenergyLoss::G4VXTRenergyLoss(), G4WeightCutOffConfigurator::G4WeightCutOffConfigurator(), G4WeightCutOffProcess::G4WeightCutOffProcess(), G4WeightWindowProcess::G4WeightWindowProcess(), G4XmlAnalysisManager::G4XmlAnalysisManager(), G4RunManager::GenerateEvent(), GFlashSamplingShowerParameterisation::GenerateLongitudinalProfile(), GFlashHomoShowerParameterisation::GenerateLongitudinalProfile(), G4UAtomicDeexcitation::GenerateParticles(), G4AtomicDeexcitation::GenerateParticles(), G4HEPEvtInterface::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4ReactionDynamics::GenerateXandPt(), G4GDMLReadSolids::GenTrapRead(), G4GDMLMatrix::Get(), G4Material::GetA(), G4VDecayChannel::GetAngularMomentum(), G4TwistTubsFlatSide::GetAreaCode(), G4TwistTrapFlatSide::GetAreaCode(), G4Element::GetAtomicShell(), G4VTwistSurface::GetAxisType(), G4QContent::GetBaryonNumber(), G4tgrUtils::GetBool(), G4VTwistSurface::GetBoundaryAtPZ(), G4VTwistSurface::GetBoundaryAxis(), G4VTwistSurface::GetBoundaryLimit(), G4VTwistSurface::Boundary::GetBoundaryParameters(), G4VTwistSurface::GetBoundaryParameters(), G4ITManager< T >::GetBox(), G4UnitDefinition::GetCategory(), G4ChebyshevApproximation::GetChebyshevCof(), G4tgrMaterialSimple::GetComponent(), G4GDMLEvaluator::GetConstant(), G4BooleanSolid::GetConstituentSolid(), G4MaterialPropertiesTable::GetConstProperty(), G4VTwistSurface::GetCorner(), G4CrossSectionDataSetRegistry::GetCrossSectionDataSet(), G4PenelopeIonisationXSHandler::GetCrossSectionTableForCouple(), G4VUserPhysicsList::GetCutValue(), G4MoleculeDefinition::GetDecayChannels(), G4QString::GetDecayDirection(), G4Step::GetDeltaEnergy(), G4Step::GetDeltaMomentum(), G4PenelopeIonisationXSHandler::GetDensityCorrection(), G4DNAMolecularMaterial::GetDensityTableFor(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4ErrorCylSurfaceTarget::GetDistanceFromPoint(), G4tgrUtils::GetDouble(), G4TrajectoriesModel::GetDrawingMode(), G4VTwistSurface::GetEdgeVisibility(), G4PenelopeBremsstrahlungFS::GetEffectiveZSquared(), G4DynamicParticle::GetElectronMass(), G4MolecularDecayTable::GetElectronOccupancy(), G4GDMLReadMaterials::GetElement(), G4QuasiFreeRatios::GetElTotXS(), G4QuasiElRatios::GetElTotXS(), G4QFreeScattering::GetElTotXS(), G4MoleculeDefinition::GetExcitedState(), G4MolecularDecayTable::GetExcitedState(), G4VTwistSurface::GetFace(), G4ErrorPropagator::GetFinalTrajState(), G4tgrMaterialSimple::GetFraction(), G4VAnalysisManager::GetFunction(), G4Navigator::GetGlobalExitNormal(), G4MultiNavigator::GetGlobalExitNormal(), G4VIntersectionLocator::GetGlobalSurfaceNormal(), G4XmlAnalysisManager::GetH1Id(), G4RootAnalysisManager::GetH1Id(), G4VAnalysisManager::GetH1Information(), G4XmlAnalysisManager::GetH1Width(), G4RootAnalysisManager::GetH1Width(), G4XmlAnalysisManager::GetH1XAxisTitle(), G4RootAnalysisManager::GetH1XAxisTitle(), G4XmlAnalysisManager::GetH1YAxisTitle(), G4RootAnalysisManager::GetH1YAxisTitle(), G4XmlAnalysisManager::GetH2Id(), G4RootAnalysisManager::GetH2Id(), G4VAnalysisManager::GetH2Information(), G4XmlAnalysisManager::GetH2XAxisTitle(), G4RootAnalysisManager::GetH2XAxisTitle(), G4XmlAnalysisManager::GetH2XWidth(), G4RootAnalysisManager::GetH2XWidth(), G4XmlAnalysisManager::GetH2YAxisTitle(), G4RootAnalysisManager::GetH2YAxisTitle(), G4XmlAnalysisManager::GetH2YWidth(), G4RootAnalysisManager::GetH2YWidth(), G4XmlAnalysisManager::GetH2ZAxisTitle(), G4RootAnalysisManager::GetH2ZAxisTitle(), G4VTouchable::GetHistory(), G4VTouchable::GetHistoryDepth(), G4PSEnergyDeposit3D::GetIndex(), G4PSDoseDeposit3D::GetIndex(), G4VAnalysisManager::GetInformation(), G4tgrFileIn::GetInstanceOpened(), G4tgrUtils::GetInt(), G4IonTable::GetIon(), G4GDMLReadMaterials::GetIsotope(), G4Navigator::GetLocalExitNormal(), G4MultiNavigator::GetLocalExitNormal(), G4ITNavigator::GetLocalExitNormal(), G4ScoreLogColorMap::GetMapColor(), G4LogicalVolume::GetMass(), G4GDMLReadMaterials::GetMaterial(), G4GDMLReadDefine::GetMatrix(), G4ClippablePolygon::GetMaxPoint(), G4HadronicProcess::GetMeanFreePath(), G4ClippablePolygon::GetMinPoint(), G4ITModelManager::GetModel(), G4MolecularConfiguration::GetMoleculeID(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4TransportationManager::GetNavigator(), G4Element::GetNbOfShellElectrons(), G4VTwistSurface::GetNode(), G4IonTable::GetNucleusMass(), G4PenelopePhotoElectricModel::GetNumberOfShellXS(), G4PenelopeSamplingData::GetNumberOfStoredPoints(), G4DNAMolecularMaterial::GetNumMolPerVolTableFor(), G4PhysicsConstructorRegistry::GetPhysicsConstructor(), G4GDMLReadStructure::GetPhysvol(), G4CompositeCurve::GetPMax(), G4CompositeCurve::GetPoint(), G4VSolid::GetPointOnSurface(), G4GDMLReadDefine::GetPosition(), G4CompositeCurve::GetPPoint(), G4ITStepProcessor::GetProcessInfo(), G4SteppingManager::GetProcessNumber(), G4TrackingInformation::GetProcessState(), G4GDMLReadDefine::GetQuantity(), G4Event::GetRandomNumberStatus(), G4Event::GetRandomNumberStatusForProcessing(), G4RunManager::GetRandomNumberStatusForThisEvent(), G4DNAMolecularReactionTable::GetReactionData(), G4Timer::GetRealElapsed(), G4DNAMolecularReactionTable::GetReativesNData(), G4RegionStore::GetRegion(), G4PhantomParameterisation::GetReplicaNo(), G4PartialPhantomParameterisation::GetReplicaNo(), G4VTouchable::GetReplicaNumber(), G4PhysicalVolumeModel::G4PhysicalVolumeModelTouchable::GetReplicaNumber(), G4GMocrenTouchable::GetReplicaNumber(), G4PhysicalVolumeModel::G4PhysicalVolumeModelTouchable::GetRotation(), G4GRSVolume::GetRotation(), G4GRSSolid::GetRotation(), G4GDMLReadDefine::GetRotation(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetScale(), G4PenelopeBremsstrahlungFS::GetScaledXSTable(), G4GDMLReadSetup::GetSetup(), G4PenelopePhotoElectricModel::GetShellCrossSection(), G4QProtonElasticCrossSection::GetSlope(), G4QPionPlusElasticCrossSection::GetSlope(), G4QPionMinusElasticCrossSection::GetSlope(), G4QNeutronElasticCrossSection::GetSlope(), G4QKaonPlusElasticCrossSection::GetSlope(), G4QHyperonPlusElasticCrossSection::GetSlope(), G4QHyperonElasticCrossSection::GetSlope(), G4QAntiBaryonElasticCrossSection::GetSlope(), G4VTouchable::GetSolid(), G4tgrSolidBoolean::GetSolid(), G4SolidStore::GetSolid(), G4PhysicalVolumeModel::G4PhysicalVolumeModelTouchable::GetSolid(), G4GRSVolume::GetSolid(), G4GRSSolid::GetSolid(), G4GDMLReadSolids::GetSolid(), G4tgbGeometryDumper::GetSolidParams(), G4VIntersectionLocator::GetSurfaceNormal(), G4GDMLReadSolids::GetSurfaceProperty(), G4Timer::GetSystemElapsed(), G4ErrorCylSurfaceTarget::GetTangentPlane(), G4ErrorPropagatorData::GetTarget(), G4tgbVolumeMgr::GetTopLogVol(), G4tgrVolumeMgr::GetTopVolume(), G4ITReactionChange::GetTrackA(), G4ITReactionChange::GetTrackB(), G4PhysicalVolumeModel::G4PhysicalVolumeModelTouchable::GetTranslation(), G4GRSVolume::GetTranslation(), G4GRSSolid::GetTranslation(), G4GenericTrap::GetTwistAngle(), G4Timer::GetUserElapsed(), G4UnitDefinition::GetValueOf(), G4GDMLEvaluator::GetVariable(), G4GenericTrap::GetVertex(), G4ExtrudedSolid::GetVertex(), G4VTouchable::GetVolume(), G4tgrVolume::GetVolume(), G4PhysicalVolumeStore::GetVolume(), G4PhysicalVolumeModel::G4PhysicalVolumeModelTouchable::GetVolume(), G4LogicalVolumeStore::GetVolume(), G4GRSVolume::GetVolume(), G4GDMLReadStructure::GetVolume(), G4EnergySplitter::GetVoxelID(), G4tgrFileIn::GetWordsInLine(), G4Material::GetZ(), G4ExtrudedSolid::GetZSection(), G4Integrator< T, F >::Hermite(), G4VGFlashSensitiveDetector::Hit(), G4GDMLReadParamvol::Hype_dimensionsRead(), G4GDMLReadSolids::HypeRead(), G4QFreeScattering::InElF(), G4Abla::initEvapora(), G4ErrorPropagator::InitFreeTrajState(), G4ErrorPropagator::InitG4Track(), G4MuElecInelasticModel::Initialise(), G4MuElecElasticModel::Initialise(), G4LivermoreIonisationModel::Initialise(), G4LivermoreBremsstrahlungModel::Initialise(), G4EmModelManager::Initialise(), G4DNATransformElectronModel::Initialise(), G4DNASancheSolvatationModel::Initialise(), G4DNASancheExcitationModel::Initialise(), G4DNAChampionElasticModel::Initialise(), G4DNABornIonisationModel::Initialise(), G4ElementData::InitialiseForComponent(), G4ElementData::InitialiseForElement(), G4SafetyHelper::InitialiseNavigator(), G4ITReactionChange::Initialize(), G4DNAMolecularMaterial::InitializeDensity(), G4RunManager::InitializeGeometry(), G4ErrorRunManagerHelper::InitializeGeometry(), G4DNAMolecularMaterial::InitializeNumMolPerVol(), G4RunManagerKernel::InitializePhysics(), G4RunManager::InitializePhysics(), G4ITModelProcessor::InitializeStepper(), G4ReplicaNavigation::Inside(), G4Surface::Intersect(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4CircularCurve::IntersectRay2D(), G4BSplineCurve::IntersectRay2D(), G4MolecularConfiguration::IonizeMolecule(), G4GDMLReadMaterials::IsotopeRead(), G4Integrator< T, F >::Jacobi(), G4Integrator< T, F >::Laguerre(), G4Integrator< T, F >::Legendre(), G4FastSimulationManager::ListModels(), G4VCrossSectionHandler::LoadData(), G4ShellEMDataSet::LoadData(), G4ShellData::LoadData(), G4MuElecCrossSectionDataSet::LoadData(), G4FluoData::LoadData(), G4EMDataSet::LoadData(), G4DNACrossSectionDataSet::LoadData(), G4DataSet::LoadData(), G4CrossSectionDataSet::LoadData(), G4AugerData::LoadData(), G4RadioactiveDecay::LoadDecayTable(), G4VCrossSectionHandler::LoadNonLogData(), G4ShellEMDataSet::LoadNonLogData(), G4MuElecCrossSectionDataSet::LoadNonLogData(), G4EMDataSet::LoadNonLogData(), G4DNACrossSectionDataSet::LoadNonLogData(), G4CrossSectionDataSet::LoadNonLogData(), G4Navigator::LocateGlobalPointWithinVolume(), G4ITNavigator::LocateGlobalPointWithinVolume(), G4GDMLRead::LoopRead(), GFlashHitMaker::make(), G4Trap::MakePlane(), G4Trap::MakePlanes(), G4GDMLReadMaterials::MaterialRead(), G4GDMLReadMaterials::MaterialsRead(), G4GDMLReadDefine::MatrixRead(), G4GDMLReadMaterials::MEERead(), G4ScoringMessenger::MeshBinCommand(), G4GDMLReadMaterials::MixtureRead(), G4VIntraNuclearTransportModel::ModelDescription(), G4MolecularConfiguration::MoveOneElectron(), G4VTouchable::MoveUpHistory(), G4TessellatedSolid::Normal(), G4AugerData::NumberOfAuger(), G4AtomicTransitionManager::NumberOfReachableShells(), G4AtomicTransitionManager::NumberOfShells(), G4FluoData::NumberOfTransitions(), G4AugerData::NumberOfTransitions(), G4MultiNavigator::ObtainFinalStep(), G4XmlAnalysisManager::OpenFile(), G4VAnalysisManager::OpenFile(), G4RootAnalysisManager::OpenFile(), G4CsvAnalysisManager::OpenFile(), G4tgrFileIn::OpenNewFile(), G4ParticleTable::operator=(), G4IT::operator=(), G4GDMLReadSolids::OpticalSurfaceRead(), G4GDMLReadParamvol::Orb_dimensionsRead(), G4GDMLReadSolids::OrbRead(), G4GDMLReadParamvol::Para_dimensionsRead(), G4GDMLReadSolids::ParaboloidRead(), G4BremsstrahlungParameters::ParameterC(), G4GDMLReadParamvol::ParameterisedRead(), G4GDMLReadParamvol::ParametersRead(), G4GDMLWriteParamvol::ParametersWrite(), G4GDMLReadParamvol::Paramvol_contentRead(), G4GDMLReadParamvol::ParamvolRead(), G4GDMLReadSolids::ParaRead(), G4GDMLReadStructure::PhysvolRead(), G4PenelopeBremsstrahlungAngular::PolarAngle(), G4GDMLReadSolids::PolyconeRead(), G4GDMLReadSolids::PolyhedraRead(), G4DataInterpolation::PolynomInterpolation(), G4GDMLReadDefine::PositionRead(), G4NavigationLogger::PostComputeStepLog(), G4WHadronElasticProcess::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4GDMLReadMaterials::PRead(), G4NavigationLogger::PreComputeStepLog(), G4GeometrySampler::PrepareImportanceSampling(), G4MultiNavigator::PrepareNavigators(), G4StackManager::PrepareNewEvent(), G4PathFinder::PrepareNewTrack(), G4VUserPhysicsList::PreparePhysicsTable(), G4PhysicsTableHelper::PreparePhysicsTable(), G4GeometrySampler::PrepareWeightRoulett(), G4DNAMolecularMaterial::PrintNotAMolecularMaterial(), G4tgrLineProcessor::ProcessLine(), G4DopplerProfile::Profiles(), G4Hyperbola::Project(), G4QDiffractionRatio::ProjFragment(), G4ErrorTrajState::PropagateError(), G4ErrorPropagator::PropagateOneStep(), G4GDMLReadMaterials::PropertyRead(), G4GDMLWriteMaterials::PropertyWrite(), G4StackManager::PushOneTrack(), G4GDMLReadSolids::QuadrangularRead(), G4GDMLReadStructure::QuantityRead(), G4GDMLReadDefine::QuantityRead(), G4MagInt_Driver::QuickAdvance(), G4QHadron::RandomizeMass(), G4EMDataSet::RandomSelect(), G4DataSet::RandomSelect(), G4DataInterpolation::RationalPolInterpolation(), G4Ray::RayCheck(), G4AtomicTransitionManager::ReachableShell(), G4STRead::Read(), G4GDMLRead::Read(), G4AblaDataFile::readData(), G4OpticalSurface::ReadFile(), G4tgrFileReader::ReadFiles(), G4StackManager::ReClassify(), G4SmartVoxelHeader::RefineNodes(), G4GDMLReadSolids::ReflectedSolidRead(), G4GDMLReadDefine::RefRead(), G4CreatorFactoryT< T, Identifier, Creator >::Register(), G4tgrVolumeMgr::RegisterMe(), G4HadronicProcess::RegisterMe(), G4VUserDetectorConstruction::RegisterParallelWorld(), G4VModularPhysicsList::RegisterPhysics(), G4MultiFunctionalDetector::RegisterPrimitive(), G4PhysicsListHelper::RegisterProcess(), G4PathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4ShortLivedTable::Remove(), G4ParticleTable::Remove(), G4IonTable::Remove(), G4ParticleTable::RemoveAllParticles(), G4MoleculeCounter::RemoveAMoleculeAtTime(), G4MolecularConfiguration::RemoveElectron(), G4VModularPhysicsList::RemovePhysics(), G4ProcessManager::RemoveProcess(), G3VolTableEntry::ReplaceDaughter(), G3VolTableEntry::ReplaceMother(), G4VModularPhysicsList::ReplacePhysics(), G4GDMLReadStructure::ReplicaRead(), G4GDMLReadStructure::ReplicavolRead(), G4ConversionFatalError::ReportError(), G4PathFinder::ReportMove(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4Polyhedra::Reset(), G4Polycone::Reset(), G4MultiNavigator::ResetHierarchyAndLocate(), G4MultiNavigator::ResetState(), G4SphericalSurface::resize(), G4FCylindricalSurface::resize(), G4FConicalSurface::resize(), G4ProductionCutsTable::RetrieveCutsInfo(), G4PhysicsTableHelper::RetrievePhysicsTable(), G4GDMLReadDefine::RotationRead(), G4RunManagerKernel::RunInitialization(), G4VoxelSafety::SafetyForVoxelHeader(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4UrbanMscModel92::SampleScattering(), G4UrbanMscModel90::SampleScattering(), G4PenelopeRayleighModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4DNADingfelderChargeIncreaseModel::SampleSecondaries(), G4DNADingfelderChargeDecreaseModel::SampleSecondaries(), G4ShellEMDataSet::SaveData(), G4MuElecCrossSectionDataSet::SaveData(), G4EMDataSet::SaveData(), G4DNACrossSectionDataSet::SaveData(), G4DataSet::SaveData(), G4CrossSectionDataSet::SaveData(), G4CompositeEMDataSet::SaveData(), G4CompositeDataSet::SaveData(), G4GDMLReadDefine::ScaleRead(), G4Region::ScanVolumeTree(), G4Scatterer::Scatter(), G4QuasiFreeRatios::Scatter(), G4QuasiElRatios::Scatter(), G4QFreeScattering::Scatter(), G4GDMLReadSolids::SectionRead(), G4VCrossSectionHandler::SelectRandomShell(), G4ShellData::SelectRandomShell(), G4TrajectoryDrawByCharge::Set(), G4ModelColourMap< T >::Set(), G4GDMLMatrix::Set(), G4VAnalysisManager::SetActivation(), G4Trap::SetAllParameters(), G4Torus::SetAllParameters(), G4Para::SetAllParameters(), G4ConicalSurface::SetAngle(), G4AssemblyTriplet::SetAssembly(), G4VTwistSurface::SetBoundary(), G4VTwistSurface::SetCorner(), G4VisListManager< T >::SetCurrent(), G4VTwistSurface::CurrentStatus::SetCurrentStatus(), G4RadioactiveDecay::SetDecayBias(), G4TrajectoryDrawByParticleID::SetDefault(), G4TrajectoryDrawByOriginVolume::SetDefault(), G4TrajectoriesModel::SetDrawingMode(), G4ShellEMDataSet::SetEnergiesData(), G4PixeShellDataSet::SetEnergiesData(), G4MuElecCrossSectionDataSet::SetEnergiesData(), G4EMDataSet::SetEnergiesData(), G4DNACrossSectionDataSet::SetEnergiesData(), G4DataSet::SetEnergiesData(), G4CrossSectionDataSet::SetEnergiesData(), G4CompositeEMDataSet::SetEnergiesData(), G4CompositeDataSet::SetEnergiesData(), G4VRangeToEnergyConverter::SetEnergyRange(), G4VAnalysisManager::SetFileName(), G4VAnalysisManager::SetFirstHistoId(), G4VAnalysisManager::SetFirstNtupleColumnId(), G4VAnalysisManager::SetHistoDirectoryName(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4Tubs::SetInnerRadius(), G4MuElecElasticModel::SetKillBelowThreshold(), G4DNAScreenedRutherfordElasticModel::SetKillBelowThreshold(), G4DNAChampionElasticModel::SetKillBelowThreshold(), G4ShellEMDataSet::SetLogEnergiesData(), G4MuElecCrossSectionDataSet::SetLogEnergiesData(), G4EMDataSet::SetLogEnergiesData(), G4DNACrossSectionDataSet::SetLogEnergiesData(), G4CrossSectionDataSet::SetLogEnergiesData(), G4CompositeEMDataSet::SetLogEnergiesData(), G4VisFilterManager< T >::SetMode(), G4ITModelManager::SetModel(), G4ITModelProcessor::SetModelHandler(), G4ModelCmdApplyColour< M >::SetNewValue(), G4ModelCmdApplyStringColour< M >::SetNewValue(), G4VAnalysisManager::SetNtupleDirectoryName(), G4VScoringMesh::SetNumberOfSegments(), G4Polyhedra::SetOriginalParameters(), G4Polycone::SetOriginalParameters(), G4Tubs::SetOuterRadius(), G4PSNofSecondary::SetParticle(), G4VUserPhysicsList::SetParticleCuts(), G4ParticleGun::SetParticleDefinition(), G4QParton::SetPDGCode(), G4PhysicsTableHelper::SetPhysicsVector(), G4ProcessManager::SetProcessOrderingToFirst(), G4ProcessManager::SetProcessOrderingToLast(), G4ProductionCuts::SetProductionCuts(), G4QHadron::SetQPDG(), G4CylindricalSurface::SetRadius(), G4Paraboloid::SetRadiusMinusZ(), G4Paraboloid::SetRadiusPlusZ(), G4RunManager::SetRandomNumberStoreDir(), G4DNASecondOrderReaction::SetReaction(), G4Scintillation::SetScintillationByParticleType(), G4VScoringMesh::SetSize(), G4RadioactiveDecay::SetSourceTimeProfile(), G4tgrMaterial::SetState(), G4GeometryTolerance::SetSurfaceTolerance(), G4ITStepProcessor::SetTrack(), G4TrackingManager::SetTrajectory(), G4PSTrackCounter::SetUnit(), G4PSTermination::SetUnit(), G4PSSphereSurfaceFlux::SetUnit(), G4PSSphereSurfaceCurrent::SetUnit(), G4PSPopulation::SetUnit(), G4PSPassageCellCurrent::SetUnit(), G4PSNofStep::SetUnit(), G4PSNofSecondary::SetUnit(), G4PSNofCollision::SetUnit(), G4PSFlatSurfaceFlux::SetUnit(), G4PSFlatSurfaceCurrent::SetUnit(), G4PSCylinderSurfaceFlux::SetUnit(), G4PSCylinderSurfaceCurrent::SetUnit(), G4ITStepProcessor::SetupGeneralProcessInfo(), G4MultiNavigator::SetupHierarchy(), G4GDMLReadSetup::SetupRead(), G4EventManager::SetUserInformation(), G4GDMLEvaluator::SetVariable(), G4VelocityTable::SetVelocityTableProperties(), G4AssemblyTriplet::SetVolume(), G4GeometryManager::SetWorldMaximumExtent(), G4Navigator::SetWorldVolume(), G4ITNavigator::SetWorldVolume(), G4FastSimulationManagerProcess::SetWorldVolume(), G4Box::SetXHalfLength(), G4Box::SetYHalfLength(), G4Tubs::SetZHalfLength(), G4Paraboloid::SetZHalfLength(), G4Box::SetZHalfLength(), G4BetaDecayCorrections::ShapeFactor(), G4AtomicTransitionManager::Shell(), G4ShellData::ShellIdVector(), G4RayShooter::Shoot(), G4GDMLWriteStructure::SkinSurfaceCache(), G4GDMLReadStructure::SkinSurfaceRead(), G4GDMLReadSolids::SolidsRead(), G4GDMLEvaluator::SolveBrackets(), G4GDMLReadParamvol::Sphere_dimensionsRead(), G4GDMLReadSolids::SphereRead(), G4QString::SplitEandP(), G4QHadron::SplitInTwoPartons(), G4QString::Splitup(), G4QHadron::SplitUp(), G4SurfaceBoundary::SplitWithCylinder(), G4SurfaceBoundary::SplitWithPlane(), G4BooleanSolid::StackPolyhedron(), G4FluoData::StartShellEnergy(), G4AugerData::StartShellEnergy(), G4FluoData::StartShellId(), G4AugerData::StartShellId(), G4FluoData::StartShellProb(), G4AugerData::StartShellProb(), G4WeightWindowProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4ImportanceProcess::StartTracking(), G4ProductionCutsTable::StoreCutsInfo(), G4ProductionCutsTable::StoreMaterialCutsCoupleInfo(), G4ProductionCutsTable::StoreMaterialInfo(), G4VUserPhysicsList::StorePhysicsTable(), G4GDMLReadStructure::StructureRead(), G4tgrUtils::SubColon(), SubstractSolids(), G4QNucleus::SubtractNucleon(), G4VProcess::SubtractNumberOfInteractionLengthLeft(), G4VITProcess::SubtractNumberOfInteractionLengthLeft(), G4QIonIonCollision::SumPartonPDG(), G4QFragmentation::SumPartonPDG(), G4Tubs::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Trap::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Para::SurfaceNormal(), G4Orb::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Box::SurfaceNormal(), G4BSplineCurve::Tangent(), G4QDiffractionRatio::TargFragment(), G4GDMLReadSolids::TessellatedRead(), G4GDMLWriteSolids::TessellatedWrite(), G4GeomTestVolume::TestCartGrid(), G4DNAMolecularReaction::TestReactibility(), G4GDMLReadSolids::TetRead(), G4GDMLReadParamvol::Torus_dimensionsRead(), G4GDMLReadSolids::TorusRead(), G4AtomicTransitionManager::TotalNonRadiativeTransitionProbability(), G4AtomicTransitionManager::TotalRadiativeTransitionProbability(), G4tgbMaterialMixtureByVolume::TransformToFractionsByWeight(), G4GDMLReadParamvol::Trap_dimensionsRead(), G4GDMLReadSolids::TrapRead(), G4GDMLWriteStructure::TraverseVolumeTree(), G4GDMLReadParamvol::Trd_dimensionsRead(), G4GDMLReadSolids::TrdRead(), G4GDMLReadMaterials::TRead(), G4GDMLReadSolids::TriangularRead(), G4PolyPhiFace::Triangulate(), G4GDMLReadParamvol::Tube_dimensionsRead(), G4GDMLReadSolids::TubeRead(), G4GDMLReadSolids::TwistedboxRead(), G4GDMLReadSolids::TwistedtrapRead(), G4GDMLReadSolids::TwistedtrdRead(), G4GDMLReadSolids::TwistedtubsRead(), G4GDMLReadSolids::TwoDimVertexRead(), G4TrackList::Unflag(), G4tgrVolumeMgr::UnRegisterMe(), G4RunManagerKernel::UpdateRegion(), G4VTouchable::UpdateYourself(), G4OpWLS::UseTimeProfile(), G4FluoData::VacancyId(), G4AugerData::VacancyId(), G4GDMLReadDefine::VariableRead(), G4GDMLReadDefine::VectorRead(), G4GDMLReadStructure::Volume_contentRead(), G4GDMLReadStructure::VolumeRead(), G4MagInt_Driver::WarnEndPointTooFar(), G4MagInt_Driver::WarnSmallStepSize(), G4MagInt_Driver::WarnTooManyStep(), G4XmlAnalysisManager::Write(), G4RootAnalysisManager::Write(), G4GDMLWrite::Write(), G4VAnalysisManager::WriteAscii(), G4GDMLReadSolids::XtruRead(), G4GDMLReadSolids::ZplaneRead(), G4NavigationLevelRep::~G4NavigationLevelRep(), and G4ParticleDefinition::~G4ParticleDefinition().

00045 {
00046   G4VExceptionHandler* exceptionHandler
00047     = G4StateManager::GetStateManager()->GetExceptionHandler();
00048   G4bool toBeAborted = true;
00049   if(exceptionHandler)
00050   {
00051     toBeAborted = exceptionHandler
00052      ->Notify(originOfException,exceptionCode,severity,description);
00053   }
00054   else
00055   {
00056     static const G4String es_banner
00057       = "\n-------- EEEE ------- G4Exception-START -------- EEEE -------\n";
00058     static const G4String ee_banner
00059       = "\n-------- EEEE -------- G4Exception-END --------- EEEE -------\n";
00060     static const G4String ws_banner
00061       = "\n-------- WWWW ------- G4Exception-START -------- WWWW -------\n";
00062     static const G4String we_banner
00063       = "\n-------- WWWW -------- G4Exception-END --------- WWWW -------\n";
00064     std::ostringstream message;
00065     message << "\n*** ExceptionHandler is not defined ***\n"
00066             << "*** G4Exception : " << exceptionCode << G4endl
00067             << "      issued by : " << originOfException << G4endl
00068             << description << G4endl;
00069     switch(severity)
00070     {
00071      case FatalException:
00072       G4cerr << es_banner << message.str() << "*** Fatal Exception ***"
00073              << ee_banner << G4endl;
00074       break;
00075      case FatalErrorInArgument:
00076       G4cerr << es_banner << message.str() << "*** Fatal Error In Argument ***"
00077              << ee_banner << G4endl;
00078       break;
00079      case RunMustBeAborted:
00080       G4cerr << es_banner << message.str() << "*** Run Must Be Aborted ***"
00081              << ee_banner << G4endl;
00082       break;
00083      case EventMustBeAborted:
00084       G4cerr << es_banner << message.str() << "*** Event Must Be Aborted ***"
00085              << ee_banner << G4endl;
00086       break;
00087      default:
00088       G4cout << ws_banner << message.str()
00089              << "*** This is just a warning message. ***"
00090              << we_banner << G4endl;
00091       toBeAborted = false;
00092       break;
00093     }
00094   }
00095   if(toBeAborted)
00096   {
00097    if(G4StateManager::GetStateManager()->SetNewState(G4State_Abort))
00098    {
00099      G4cerr << G4endl << "*** G4Exception: Aborting execution ***" << G4endl;
00100      abort();
00101    }
00102    else
00103    {
00104      G4cerr << G4endl << "*** G4Exception: Abortion suppressed ***"
00105             << G4endl << "*** No guarantee for further execution ***" << G4endl;
00106    }
00107   }
00108 }


Generated on Mon May 27 17:51:15 2013 for Geant4 by  doxygen 1.4.7