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

#include <G4Track.hh>

Public Types

using ProfilerConfig = G4ProfilerConfig< G4ProfileType::Track >
 

Public Member Functions

 G4Track ()
 
 G4Track (G4DynamicParticle *apValueDynamicParticle, G4double aValueTime, const G4ThreeVector &aValuePosition)
 
 G4Track (const G4Track &)
 
 ~G4Track ()
 
void * operator new (std::size_t)
 
void operator delete (void *aTrack)
 
G4Trackoperator= (const G4Track &)
 
G4bool operator== (const G4Track &)
 
G4bool operator!= (const G4Track &)
 
void CopyTrackInfo (const G4Track &)
 
G4int GetTrackID () const
 
void SetTrackID (const G4int aValue)
 
G4int GetParentID () const
 
void SetParentID (const G4int aValue)
 
const G4DynamicParticleGetDynamicParticle () const
 
const G4ParticleDefinitionGetParticleDefinition () const
 
G4ParticleDefinitionGetDefinition () const
 
const G4ThreeVectorGetPosition () const
 
void SetPosition (const G4ThreeVector &aValue)
 
G4double GetGlobalTime () const
 
void SetGlobalTime (const G4double aValue)
 
G4double GetLocalTime () const
 
void SetLocalTime (const G4double aValue)
 
G4double GetProperTime () const
 
void SetProperTime (const G4double aValue)
 
G4VPhysicalVolumeGetVolume () const
 
G4VPhysicalVolumeGetNextVolume () const
 
G4MaterialGetMaterial () const
 
G4MaterialGetNextMaterial () const
 
const G4MaterialCutsCoupleGetMaterialCutsCouple () const
 
const G4MaterialCutsCoupleGetNextMaterialCutsCouple () const
 
const G4VTouchableGetTouchable () const
 
const G4TouchableHandleGetTouchableHandle () const
 
void SetTouchableHandle (const G4TouchableHandle &apValue)
 
const G4VTouchableGetNextTouchable () const
 
const G4TouchableHandleGetNextTouchableHandle () const
 
void SetNextTouchableHandle (const G4TouchableHandle &apValue)
 
const G4VTouchableGetOriginTouchable () const
 
const G4TouchableHandleGetOriginTouchableHandle () const
 
void SetOriginTouchableHandle (const G4TouchableHandle &apValue)
 
G4double GetKineticEnergy () const
 
void SetKineticEnergy (const G4double aValue)
 
G4double GetTotalEnergy () const
 
const G4ThreeVectorGetMomentumDirection () const
 
void SetMomentumDirection (const G4ThreeVector &aValue)
 
G4ThreeVector GetMomentum () const
 
G4double GetVelocity () const
 
void SetVelocity (G4double val)
 
G4double CalculateVelocity () const
 
G4double CalculateVelocityForOpticalPhoton () const
 
G4bool UseGivenVelocity () const
 
void UseGivenVelocity (G4bool val)
 
const G4ThreeVectorGetPolarization () const
 
void SetPolarization (const G4ThreeVector &aValue)
 
G4TrackStatus GetTrackStatus () const
 
void SetTrackStatus (const G4TrackStatus aTrackStatus)
 
G4bool IsBelowThreshold () const
 
void SetBelowThresholdFlag (G4bool value=true)
 
G4bool IsGoodForTracking () const
 
void SetGoodForTrackingFlag (G4bool value=true)
 
G4double GetTrackLength () const
 
void AddTrackLength (const G4double aValue)
 
const G4StepGetStep () const
 
void SetStep (const G4Step *aValue)
 
G4int GetCurrentStepNumber () const
 
void IncrementCurrentStepNumber ()
 
G4double GetStepLength () const
 
void SetStepLength (G4double value)
 
const G4ThreeVectorGetVertexPosition () const
 
void SetVertexPosition (const G4ThreeVector &aValue)
 
const G4ThreeVectorGetVertexMomentumDirection () const
 
void SetVertexMomentumDirection (const G4ThreeVector &aValue)
 
G4double GetVertexKineticEnergy () const
 
void SetVertexKineticEnergy (const G4double aValue)
 
const G4LogicalVolumeGetLogicalVolumeAtVertex () const
 
void SetLogicalVolumeAtVertex (const G4LogicalVolume *)
 
const G4VProcessGetCreatorProcess () const
 
void SetCreatorProcess (const G4VProcess *aValue)
 
void SetCreatorModelID (const G4int id)
 
G4int GetCreatorModelID () const
 
G4int GetCreatorModelIndex () const
 
const G4String GetCreatorModelName () const
 
const G4ParticleDefinitionGetParentResonanceDef () const
 
void SetParentResonanceDef (const G4ParticleDefinition *parent)
 
G4int GetParentResonanceID () const
 
void SetParentResonanceID (const G4int parentID)
 
G4bool HasParentResonance () const
 
G4int GetParentResonancePDGEncoding () const
 
G4String GetParentResonanceName () const
 
G4double GetParentResonanceMass () const
 
G4double GetWeight () const
 
void SetWeight (G4double aValue)
 
G4VUserTrackInformationGetUserInformation () const
 
void SetUserInformation (G4VUserTrackInformation *aValue) const
 
void SetAuxiliaryTrackInformation (G4int id, G4VAuxiliaryTrackInformation *info) const
 
G4VAuxiliaryTrackInformationGetAuxiliaryTrackInformation (G4int id) const
 
std::map< G4int, G4VAuxiliaryTrackInformation * > * GetAuxiliaryTrackInformationMap () const
 
void RemoveAuxiliaryTrackInformation (G4int id)
 
void RemoveAuxiliaryTrackInformation (G4String &name)
 

Detailed Description

Definition at line 66 of file G4Track.hh.

Member Typedef Documentation

◆ ProfilerConfig

Constructor & Destructor Documentation

◆ G4Track() [1/3]

G4Track::G4Track ( )

Definition at line 62 of file G4Track.cc.

63 : fVelocity(c_light)
64 , fpDynamicParticle(new G4DynamicParticle())
65{}

◆ G4Track() [2/3]

G4Track::G4Track ( G4DynamicParticle apValueDynamicParticle,
G4double  aValueTime,
const G4ThreeVector aValuePosition 
)

Definition at line 47 of file G4Track.cc.

50 : fPosition(aValuePosition)
51 , fGlobalTime(aValueTime)
52 , fVelocity(c_light)
53{
54 fpDynamicParticle = (apValueDynamicParticle) != nullptr
55 ? apValueDynamicParticle : new G4DynamicParticle();
56 // check if the particle type is Optical Photon
57 is_OpticalPhoton =
58 (fpDynamicParticle->GetDefinition()->GetPDGEncoding() == -22);
59}
G4ParticleDefinition * GetDefinition() const

◆ G4Track() [3/3]

G4Track::G4Track ( const G4Track right)

Definition at line 68 of file G4Track.cc.

69 : fVelocity(c_light)
70{
71 *this = right;
72}

◆ ~G4Track()

G4Track::~G4Track ( )

Definition at line 75 of file G4Track.cc.

76{
77 delete fpDynamicParticle;
78 delete fpUserInformation;
79 ClearAuxiliaryTrackInformation();
80}

Member Function Documentation

◆ AddTrackLength()

void G4Track::AddTrackLength ( const G4double  aValue)

◆ CalculateVelocity()

◆ CalculateVelocityForOpticalPhoton()

G4double G4Track::CalculateVelocityForOpticalPhoton ( ) const

Definition at line 160 of file G4Track.cc.

161{
162 G4double velocity = c_light;
163
164 G4Material* mat = nullptr;
165 G4bool update_groupvel = false;
166 if(fpStep != nullptr)
167 {
168 mat = this->GetMaterial(); // Fix for repeated volumes
169 }
170 else
171 {
172 if(fpTouchable)
173 {
174 mat = fpTouchable->GetVolume()->GetLogicalVolume()->GetMaterial();
175 }
176 }
177 // check if previous step is in the same volume
178 // and get new GROUPVELOCITY table if necessary
179 if((mat != nullptr) && ((mat != prev_mat) || (groupvel == nullptr)))
180 {
181 groupvel = nullptr;
182 if(mat->GetMaterialPropertiesTable() != nullptr)
184 update_groupvel = true;
185 }
186 prev_mat = mat;
187
188 if(groupvel != nullptr)
189 {
190 // light velocity = c/(rindex+d(rindex)/d(log(E_phot)))
191 // values stored in GROUPVEL material properties vector
192 velocity = prev_velocity;
193
194 // check if momentum is same as in the previous step
195 // and calculate group velocity if necessary
196 G4double current_momentum = fpDynamicParticle->GetTotalMomentum();
197 if(update_groupvel || (current_momentum != prev_momentum))
198 {
199 velocity = groupvel->Value(current_momentum);
200 prev_velocity = velocity;
201 prev_momentum = current_momentum;
202 }
203 }
204
205 return velocity;
206}
double G4double
Definition: G4Types.hh:83
bool G4bool
Definition: G4Types.hh:86
G4double GetTotalMomentum() const
G4Material * GetMaterial() const
G4MaterialPropertyVector * GetProperty(const char *key) const
G4MaterialPropertiesTable * GetMaterialPropertiesTable() const
Definition: G4Material.hh:251
G4double Value(const G4double energy, std::size_t &lastidx) const
G4Material * GetMaterial() const
G4LogicalVolume * GetLogicalVolume() const
virtual G4VPhysicalVolume * GetVolume(G4int depth=0) const
Definition: G4VTouchable.cc:34

Referenced by G4ITTransportation::AlongStepDoIt(), and G4ParticleChange::UpdateStepForAlongStep().

◆ CopyTrackInfo()

void G4Track::CopyTrackInfo ( const G4Track right)

Definition at line 154 of file G4Track.cc.

155{
156 *this = right;
157}

◆ GetAuxiliaryTrackInformation()

G4VAuxiliaryTrackInformation * G4Track::GetAuxiliaryTrackInformation ( G4int  id) const

Definition at line 229 of file G4Track.cc.

230{
231 if(fpAuxiliaryTrackInformationMap == nullptr)
232 return nullptr;
233
234 auto itr = fpAuxiliaryTrackInformationMap->find(id);
235 if(itr == fpAuxiliaryTrackInformationMap->cend())
236 return nullptr;
237 return (*itr).second;
238}

Referenced by G4LivermorePolarizedComptonModel::SampleSecondaries().

◆ GetAuxiliaryTrackInformationMap()

std::map< G4int, G4VAuxiliaryTrackInformation * > * G4Track::GetAuxiliaryTrackInformationMap ( ) const
inline

◆ GetCreatorModelID()

G4int G4Track::GetCreatorModelID ( ) const
inline

◆ GetCreatorModelIndex()

G4int G4Track::GetCreatorModelIndex ( ) const
inline

◆ GetCreatorModelName()

const G4String G4Track::GetCreatorModelName ( ) const
inline

◆ GetCreatorProcess()

◆ GetCurrentStepNumber()

◆ GetDefinition()

G4ParticleDefinition * G4Track::GetDefinition ( ) const

Referenced by G4SDParticleFilter::Accept(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4AdjointForcedInteractionForGamma::AlongStepDoIt(), G4ITStepProcessor::ApplyProductionCut(), G4eplusAnnihilation::AtRestDoIt(), G4FastSimulationManager::AtRestGetFastSimulationManagerTrigger(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4StackChecker::ClassifyNewTrack(), G4ITStepProcessor::DealWithSecondaries(), GFlashShowerModel::DoIt(), G4ITStepProcessor::DoStepping(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4VAdjointReverseReaction::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4ITStepProcessor::GetProcessInfo(), G4SteppingManager::GetProcessNumber(), G4ErrorPropagator::InitG4Track(), GFlashShowerModel::ModelTrigger(), G4hImpactIonisation::PostStepDoIt(), G4FastSimulationManager::PostStepGetFastSimulationManagerTrigger(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4LowECapture::PostStepGetPhysicalInteractionLength(), G4PSNofSecondary::ProcessHits(), G4TrackingManager::ProcessOneTrack(), G4ErrorPropagator::Propagate(), G4EnergySplitter::SplitEnergyInVolumes(), G4ITTrackingManager::StartTracking(), G4VEnergyLossProcess::StartTracking(), G4HadronicProcess::StartTracking(), G4ITTrackingInteractivity::TrackBanner(), G4VITSteppingVerbose::TrackBanner(), G4ITSteppingVerbose::TrackingEnded(), G4ParticleChangeForGamma::UpdateStepForPostStep(), and G4AdjointSteppingAction::UserSteppingAction().

◆ GetDynamicParticle()

const G4DynamicParticle * G4Track::GetDynamicParticle ( ) const

Referenced by G4AdjointAlongStepWeightCorrection::AlongStepDoIt(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4ErrorEnergyLoss::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4AdjointProcessEquivalentToDirectProcess::AlongStepDoIt(), G4hImpactIonisation::AlongStepDoIt(), G4VContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4VContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4ITStepProcessor::ApplyProductionCut(), G4DecayWithSpin::AtRestDoIt(), G4AdjointProcessEquivalentToDirectProcess::AtRestDoIt(), G4eplusAnnihilation::AtRestDoIt(), G4VRestContinuousDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousProcess::AtRestGetPhysicalInteractionLength(), G4VRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VITRestProcess::AtRestGetPhysicalInteractionLength(), G4VRestProcess::AtRestGetPhysicalInteractionLength(), G4Decay::AtRestGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::AtRestGetPhysicalInteractionLength(), G4BraggIonGasModel::ChargeSquareRatio(), G4BetheBlochIonGasModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ITTransportation::ComputeStep(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4FieldTrackUpdator::CreateFieldTrack(), G4PionDecayMakeSpin::DaughterPolarization(), G4RadioactiveDecay::DecayAnalog(), G4Decay::DecayIt(), G4UnknownDecay::DecayIt(), G4Radioactivation::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4hImpactIonisation::GetContinuousStepLimit(), G4AnnihiToMuPair::GetMeanFreePath(), G4MuonicAtomDecay::GetMeanFreePath(), G4Decay::GetMeanFreePath(), G4GammaConversionToMuons::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4NeutrinoElectronProcess::GetMeanFreePath(), G4HadronicProcess::GetMeanFreePath(), G4ElNeutrinoNucleusProcess::GetMeanFreePath(), G4MuNeutrinoNucleusProcess::GetMeanFreePath(), G4TauNeutrinoNucleusProcess::GetMeanFreePath(), G4OpAbsorption::GetMeanFreePath(), G4OpMieHG::GetMeanFreePath(), G4OpRayleigh::GetMeanFreePath(), G4OpWLS::GetMeanFreePath(), G4OpWLS2::GetMeanFreePath(), G4RadioactiveDecay::GetMeanFreePath(), G4hImpactIonisation::GetMeanFreePath(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4MuonicAtomDecay::GetMeanLifeTime(), G4Decay::GetMeanLifeTime(), G4RadioactiveDecay::GetMeanLifeTime(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4Scintillation::GetScintillationYieldByParticleType(), G4HadProjectile::Initialise(), G4FastStep::Initialize(), G4ParticleChangeForDecay::Initialize(), G4ParticleChange::Initialize(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), G4SmartTrackStack::PopFromStack(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4NeutronGeneralProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4UCNBoundaryProcess::PostStepDoIt(), G4DecayWithSpin::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4MicroElecSurface::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4OpAbsorption::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4OpWLS2::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4AdjointProcessEquivalentToDirectProcess::PostStepDoIt(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4VITDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength(), G4Decay::PostStepGetPhysicalInteractionLength(), G4UnknownDecay::PostStepGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::PostStepGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4SmartTrackStack::PushToStack(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4GammaGeneralProcess::SelectHadProcess(), G4SteppingManager::SetInitialStep(), G4AdjointProcessEquivalentToDirectProcess::StartTracking(), G4UrbanAdjointMscModel::StartTracking(), G4GoudsmitSaundersonMscModel::StartTracking(), G4UrbanMscModel::StartTracking(), G4HadronicProcess::StartTracking(), and G4FieldTrackUpdator::Update().

◆ GetGlobalTime()

G4double G4Track::GetGlobalTime ( ) const

Referenced by G4ITTrackHolder::_PushTrack(), G4ParticleChangeForGamma::AddSecondary(), G4ITTransportation::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4HadronStoppingProcess::AtRestDoIt(), G4MuonMinusAtomicCapture::AtRestDoIt(), G4DecayWithSpin::AtRestDoIt(), G4eplusAnnihilation::AtRestDoIt(), G4FastStep::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4ITStepProcessor::ComputeInteractionLength(), G4ITTransportation::ComputeStep(), G4ITModelProcessor::ComputeTrackReaction(), G4FieldTrackUpdator::CreateFieldTrack(), G4VPhononProcess::CreateSecondary(), G4RadioactiveDecay::DecayAnalog(), G4DNAMolecularDissociation::DecayIt(), G4Decay::DecayIt(), G4UnknownDecay::DecayIt(), G4Radioactivation::DecayIt(), G4DNABrownianTransportation::Diffusion(), G4ParticleChangeForDecay::DumpInfo(), G4HadronicProcess::FillResult(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4FastStep::Initialize(), G4ParticleChangeForDecay::Initialize(), G4ParticleChange::Initialize(), G4FastSimHitMaker::make(), GFlashHitMaker::make(), G4DNAIRT::MakeReaction(), G4DNAMakeReaction::MakeReaction(), G4DNAMolecularReaction::MakeReaction(), G4DNASecondOrderReaction::PostStepDoIt(), G4DNAScavengerProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4UCNAbsorption::PostStepDoIt(), G4UCNMultiScattering::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4DNABrownianTransportation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4DNAPolyNucleotideReactionProcess::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), G4DNAScavengerProcess::PostStepGetPhysicalInteractionLength(), G4NeutronGeneralProcess::PostStepGetPhysicalInteractionLength(), G4ITSteppingVerbose::PreStepVerbose(), G4ITTrackHolder::PushDelayed(), G4TrackingInformation::RecordCurrentPositionNTime(), G4DNAIRT::Sampling(), G4FieldTrackUpdator::Update(), G4FastStep::UpdateStepForAtRest(), G4FastStep::UpdateStepForPostStep(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), G4SteppingVerboseWithUnits::VerboseTrack(), and G4Molecule::~G4Molecule().

◆ GetKineticEnergy()

G4double G4Track::GetKineticEnergy ( ) const

Referenced by G4VMultipleScattering::AlongStepDoIt(), G4ErrorEnergyLoss::AlongStepDoIt(), G4AdjointForcedInteractionForGamma::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4TransportationWithMsc::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4BOptnLeadingParticle::ApplyFinalStateBiasing(), G4ITStepProcessor::ApplyProductionCut(), G4VEmModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4FastStep::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4FieldTrackUpdator::CreateFieldTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4ITStepProcessor::DealWithSecondaries(), G4VParticleChange::DumpInfo(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4RichTrajectory::G4RichTrajectory(), G4RichTrajectoryPoint::G4RichTrajectoryPoint(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PhononDownconversion::GetMeanFreePath(), G4PhononScattering::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4Scintillation::GetScintillationYieldByParticleType(), G4ErrorPropagator::InitG4Track(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), GFlashShowerModel::ModelTrigger(), G4SpecialCuts::PostStepDoIt(), G4UserSpecialCuts::PostStepDoIt(), G4WeightWindowProcess::PostStepDoIt(), G4PhononReflection::PostStepDoIt(), G4PhononScattering::PostStepDoIt(), G4AdjointForcedInteractionForGamma::PostStepDoIt(), G4LowECapture::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4UCNBoundaryProcess::PostStepDoIt(), G4MicroElecSurface::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength(), G4AdjointForcedInteractionForGamma::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4LowECapture::PostStepGetPhysicalInteractionLength(), G4HadronicProcess::PostStepGetPhysicalInteractionLength(), G4ErrorPropagator::Propagate(), G4TransportationLogger::ReportLoopingTrack(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4ITSteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4SteppingVerboseWithUnits::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4SteppingVerbose::TrackingStarted(), G4SteppingVerboseWithUnits::TrackingStarted(), G4FieldTrackUpdator::Update(), G4ParticleChange::UpdateStepForAlongStep(), G4AdjointSteppingAction::UserSteppingAction(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

◆ GetLocalTime()

◆ GetLogicalVolumeAtVertex()

const G4LogicalVolume * G4Track::GetLogicalVolumeAtVertex ( ) const

◆ GetMaterial()

G4Material * G4Track::GetMaterial ( ) const

Referenced by G4ErrorEnergyLoss::AlongStepDoIt(), G4VContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4VContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4HadronStoppingProcess::AtRestDoIt(), G4VRestContinuousDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousProcess::AtRestGetPhysicalInteractionLength(), G4VRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VITRestProcess::AtRestGetPhysicalInteractionLength(), G4VRestProcess::AtRestGetPhysicalInteractionLength(), CalculateVelocityForOpticalPhoton(), G4VEmModel::ChargeSquareRatio(), G4DNABrownianTransportation::ComputeStep(), G4DNABrownianTransportation::Diffusion(), G4VParticleChange::DumpInfo(), G4HadronicProcess::DumpState(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4AnnihiToMuPair::GetMeanFreePath(), G4GammaConversionToMuons::GetMeanFreePath(), G4NeutrinoElectronProcess::GetMeanFreePath(), G4HadronicProcess::GetMeanFreePath(), G4ElNeutrinoNucleusProcess::GetMeanFreePath(), G4MuNeutrinoNucleusProcess::GetMeanFreePath(), G4TauNeutrinoNucleusProcess::GetMeanFreePath(), G4OpAbsorption::GetMeanFreePath(), G4OpMieHG::GetMeanFreePath(), G4OpRayleigh::GetMeanFreePath(), G4OpWLS::GetMeanFreePath(), G4OpWLS2::GetMeanFreePath(), G4UCNAbsorption::GetMeanFreePath(), G4UCNLoss::GetMeanFreePath(), G4UCNMultiScattering::GetMeanFreePath(), G4Scintillation::GetScintillationYieldByParticleType(), G4HadProjectile::Initialise(), G4NeutrinoElectronProcess::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4OpWLS2::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4VITDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4Decay::PostStepGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4HadronicProcess::PostStepGetPhysicalInteractionLength(), and G4ElementSelector::SelectZandA().

◆ GetMaterialCutsCouple()

const G4MaterialCutsCouple * G4Track::GetMaterialCutsCouple ( ) const

Referenced by G4VMultipleScattering::AlongStepDoIt(), G4NuclearStopping::AlongStepDoIt(), G4AdjointForcedInteractionForGamma::AlongStepDoIt(), G4hImpactIonisation::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4TransportationWithMsc::AlongStepGetPhysicalInteractionLength(), G4eplusAnnihilation::AtRestDoIt(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4hImpactIonisation::GetContinuousStepLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4hImpactIonisation::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), G4AdjointForcedInteractionForGamma::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), and G4EmSaturation::VisibleEnergyDepositionAtAStep().

◆ GetMomentum()

◆ GetMomentumDirection()

const G4ThreeVector & G4Track::GetMomentumDirection ( ) const

Referenced by G4DNABrownianTransportation::AlongStepDoIt(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4BOptnLeadingParticle::ApplyFinalStateBiasing(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4VMscModel::ComputeGeomLimit(), G4DNABrownianTransportation::ComputeGeomLimit(), G4DNABrownianTransportation::ComputeStep(), G4FieldTrackUpdator::CreateFieldTrack(), G4VParticleChange::DumpInfo(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4VFastSimSensitiveDetector::Hit(), G4VGFlashSensitiveDetector::Hit(), G4BOptnForceCommonTruncatedExp::Initialize(), G4ParticleChangeForGamma::InitializeForPostStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4PhononReflection::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4UCNBoundaryProcess::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4ParallelGeometriesLimiterProcess::StartTracking(), G4ImportanceProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4WeightWindowProcess::StartTracking(), G4FastSimulationManagerProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4CoupledTransportation::StartTracking(), G4VPhononProcess::StartTracking(), G4FieldTrackUpdator::Update(), G4ParallelWorldScoringProcess::Verbose(), G4ScoreSplittingProcess::Verbose(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

◆ GetNextMaterial()

G4Material * G4Track::GetNextMaterial ( ) const

◆ GetNextMaterialCutsCouple()

const G4MaterialCutsCouple * G4Track::GetNextMaterialCutsCouple ( ) const

◆ GetNextTouchable()

const G4VTouchable * G4Track::GetNextTouchable ( ) const

◆ GetNextTouchableHandle()

◆ GetNextVolume()

◆ GetOriginTouchable()

const G4VTouchable * G4Track::GetOriginTouchable ( ) const

◆ GetOriginTouchableHandle()

const G4TouchableHandle & G4Track::GetOriginTouchableHandle ( ) const

◆ GetParentID()

◆ GetParentResonanceDef()

const G4ParticleDefinition * G4Track::GetParentResonanceDef ( ) const
inline

◆ GetParentResonanceID()

G4int G4Track::GetParentResonanceID ( ) const
inline

◆ GetParentResonanceMass()

G4double G4Track::GetParentResonanceMass ( ) const
inline

◆ GetParentResonanceName()

G4String G4Track::GetParentResonanceName ( ) const
inline

◆ GetParentResonancePDGEncoding()

G4int G4Track::GetParentResonancePDGEncoding ( ) const
inline

◆ GetParticleDefinition()

◆ GetPolarization()

◆ GetPosition()

const G4ThreeVector & G4Track::GetPosition ( ) const

Referenced by G4ParticleChangeForGamma::AddSecondary(), G4DNABrownianTransportation::AlongStepDoIt(), G4AdjointForcedInteractionForGamma::AlongStepDoIt(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4HadronStoppingProcess::AtRestDoIt(), G4MuonMinusAtomicCapture::AtRestDoIt(), G4eplusAnnihilation::AtRestDoIt(), G4Molecule::BuildTrack(), G4DNAIndependentReactionTimeStepper::CalculateStep(), G4StackChecker::ClassifyNewTrack(), G4ITTransportation::ComputeStep(), G4DNABrownianTransportation::ComputeStep(), G4FieldTrackUpdator::CreateFieldTrack(), G4VPhononProcess::CreateSecondary(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4RadioactiveDecay::DecayAnalog(), G4DNAMolecularDissociation::DecayIt(), G4Decay::DecayIt(), G4UnknownDecay::DecayIt(), G4Radioactivation::DecayIt(), G4VParticleChange::DumpInfo(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4DNASmoluchowskiReactionModel::FindReaction(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4GFlashSpot::GetPosition(), G4IT::GetPosition(), G4DiffusionControlledReactionModel::GetTimeToEncounter(), G4FastStep::Initialize(), G4ParticleChange::Initialize(), G4BOptnForceCommonTruncatedExp::Initialize(), G4FastSimHitMaker::make(), G4DNAIRT::MakeReaction(), G4DNAMakeReaction::MakeReaction(), G4DNAMolecularReaction::MakeReaction(), G4IT::operator[](), G4DNASecondOrderReaction::PostStepDoIt(), G4DNAScavengerProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4DNAScavengerProcess::PostStepGetPhysicalInteractionLength(), G4ITSteppingVerbose::PostStepVerbose(), G4ITSteppingVerbose::PreStepVerbose(), G4ErrorFreeTrajState::PropagateError(), G4TrackingInformation::RecordCurrentPositionNTime(), G4TransportationLogger::ReportLoopingTrack(), G4TDNAOneStepThermalizationModel< MODEL >::SampleSecondaries(), G4DNAIRT::Sampling(), G4FastTrack::SetCurrentTrack(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4ParallelGeometriesLimiterProcess::StartTracking(), G4ImportanceProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4WeightWindowProcess::StartTracking(), G4FastSimulationManagerProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4CoupledTransportation::StartTracking(), G4ITSteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4SteppingVerboseWithUnits::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4SteppingVerbose::TrackingStarted(), G4SteppingVerboseWithUnits::TrackingStarted(), G4ITSteppingVerbose::TrackingStarted(), G4ErrorFreeTrajParam::Update(), G4ErrorFreeTrajState::Update(), G4FieldTrackUpdator::Update(), G4DNAMakeReaction::UpdatePositionForReaction(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), G4SteppingVerboseWithUnits::VerboseTrack(), and G4Molecule::~G4Molecule().

◆ GetProperTime()

◆ GetStep()

◆ GetStepLength()

◆ GetTotalEnergy()

◆ GetTouchable()

◆ GetTouchableHandle()

◆ GetTrackID()

G4int G4Track::GetTrackID ( ) const

Referenced by G4ITTrackHolder::_PushTrack(), G4DNABrownianTransportation::AlongStepDoIt(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4DNAIRTMoleculeEncounterStepper::CalculateStep(), G4DNAMoleculeEncounterStepper::CalculateStep(), G4DNAIndependentReactionTimeStepper::CalculateStep(), G4DNAPolyNucleotideReactionProcess::CalculateTimeStep(), G4ITReactionSet::CanAddThisReaction(), G4StackChecker::ClassifyNewTrack(), G4ITStepProcessor::ComputeInteractionLength(), G4DNABrownianTransportation::ComputeStep(), G4ITModelProcessor::ComputeTrackReaction(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4ITStepProcessor::DealWithSecondaries(), G4DNAMolecularDissociation::DecayIt(), G4DNABrownianTransportation::Diffusion(), G4ITStepProcessor::DoIt(), G4ITStepProcessor::DoStepping(), G4VParticleChange::DumpInfo(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4DNAIndependentReactionTimeStepper::FindReaction(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4VAdjointReverseReaction::GetMeanFreePath(), G4Scintillation::GetScintillationYieldByParticleType(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4PSPassageCellCurrent::IsPassed(), G4PSPassageCellFlux::IsPassed(), G4PSPassageTrackLength::IsPassed(), G4ITTrackHolder::KillTracks(), compTrackPerID::operator()(), G4StackManager::PopNextTrack(), G4DNAScavengerProcess::PostStepDoIt(), G4MicroElecSurface::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4OpWLS2::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4DNABrownianTransportation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4AdjointForcedInteractionForGamma::PostStepGetPhysicalInteractionLength(), G4DNAScavengerProcess::PostStepGetPhysicalInteractionLength(), G4ITSteppingVerbose::PostStepVerbose(), G4ITSteppingVerbose::PreStepVerbose(), G4PSPopulation::ProcessHits(), G4StackManager::PushOneTrack(), G4DNAIRT::Sampling(), G4ITStepProcessor::SetTrack(), G4ITSteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4ITStepProcessor::Stepping(), G4ITTrackingInteractivity::TrackBanner(), G4VITSteppingVerbose::TrackBanner(), G4ITSteppingVerbose::TrackingEnded(), G4ITSteppingVerbose::TrackingStarted(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

◆ GetTrackLength()

◆ GetTrackStatus()

G4TrackStatus G4Track::GetTrackStatus ( ) const

Referenced by G4BiasingProcessInterface::AlongStepDoIt(), G4ErrorPropagator::CheckIfLastStep(), G4RadioactiveDecay::DecayAnalog(), G4Decay::DecayIt(), G4ITStepProcessor::DoDefinePhysicalStepLength(), G4ITStepProcessor::DoIt(), G4ITStepProcessor::DoStepping(), G4BOptrForceCollision::EndTracking(), G4ITStepProcessor::ExtractDoItData(), G4ITStepProcessor::ExtractILData(), G4DNAMolecularReaction::FindReaction(), G4DNAIndependentReactionTimeStepper::FindReaction(), G4Scintillation::GetScintillationYieldByParticleType(), G4ParticleChangeForMSC::InitialiseMSC(), G4ParticleChangeForNothing::Initialize(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4ITStepProcessor::InvokePostStepDoItProcs(), G4ITStepProcessor::InvokeTransportationProc(), G4ImportanceProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4Decay::PostStepDoIt(), G4DecayWithSpin::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4PSTermination::ProcessHits(), G4TrackingManager::ProcessOneTrack(), G4ITTrackHolder::PushToKill(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4SteppingManager::Stepping(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

◆ GetUserInformation()

G4VUserTrackInformation * G4Track::GetUserInformation ( ) const

Referenced by GetIT().

◆ GetVelocity()

◆ GetVertexKineticEnergy()

◆ GetVertexMomentumDirection()

◆ GetVertexPosition()

◆ GetVolume()

G4VPhysicalVolume * G4Track::GetVolume ( ) const

Referenced by G4ImportanceProcess::AlongStepGetPhysicalInteractionLength(), G4WeightCutOffProcess::AlongStepGetPhysicalInteractionLength(), G4WeightWindowProcess::AlongStepGetPhysicalInteractionLength(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldScoringProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ParallelGeometriesLimiterProcess::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4DecayWithSpin::AtRestDoIt(), G4FastSimulationManagerProcess::AtRestGetPhysicalInteractionLength(), G4DNABrownianTransportation::ComputeGeomLimit(), G4Radioactivation::DecayIt(), G4RadioactiveDecay::DecayIt(), G4VParticleChange::DumpInfo(), G4HadronicProcess::DumpState(), G4Channeling::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4BOptnForceCommonTruncatedExp::Initialize(), G4ScoreSplittingProcess::PostStepDoIt(), G4Channeling::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4TauNeutrinoNucleusProcess::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4BiasingProcessInterface::PostStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::PostStepGetPhysicalInteractionLength(), G4StepLimiter::PostStepGetPhysicalInteractionLength(), G4LowECapture::PostStepGetPhysicalInteractionLength(), G4TransportationLogger::ReportLoopingTrack(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4VPhononProcess::StartTracking(), G4SteppingVerboseWithUnits::StepInfo(), and G4SteppingVerboseWithUnits::TrackingStarted().

◆ GetWeight()

◆ HasParentResonance()

G4bool G4Track::HasParentResonance ( ) const
inline

◆ IncrementCurrentStepNumber()

void G4Track::IncrementCurrentStepNumber ( )

◆ IsBelowThreshold()

G4bool G4Track::IsBelowThreshold ( ) const

◆ IsGoodForTracking()

G4bool G4Track::IsGoodForTracking ( ) const

◆ operator delete()

void G4Track::operator delete ( void *  aTrack)
inline

◆ operator new()

void * G4Track::operator new ( std::size_t  )
inline

◆ operator!=()

G4bool G4Track::operator!= ( const G4Track )
inline

◆ operator=()

G4Track & G4Track::operator= ( const G4Track right)

Definition at line 83 of file G4Track.cc.

84{
85 if(this != &right)
86 {
87 fPosition = right.fPosition;
88 fGlobalTime = right.fGlobalTime;
89 fLocalTime = right.fLocalTime;
90 fTrackLength = right.fTrackLength;
91 fWeight = right.fWeight;
92 fStepLength = right.fStepLength;
93
94 // additional fields required for geometrical splitting
95 fpTouchable = right.fpTouchable;
96 fpNextTouchable = right.fpNextTouchable;
97 fpOriginTouchable = right.fpOriginTouchable;
98
99 // Track ID (and Parent ID) is not copied and set to zero for new track
100 fTrackID = 0;
101 fParentID = 0;
102
103 // CurrentStepNumber is set to be 0
104 fCurrentStepNumber = 0;
105
106 // Creator model ID
107 fCreatorModelID = right.fCreatorModelID;
108
109 // Parent resonance
110 fParentResonanceDef = right.fParentResonanceDef;
111 fParentResonanceID = right.fParentResonanceID;
112
113 // velocity information
114 fVelocity = right.fVelocity;
115
116 // dynamic particle information
117 delete fpDynamicParticle;
118 fpDynamicParticle = new G4DynamicParticle(*(right.fpDynamicParticle));
119
120 // track status and flags for tracking
121 fTrackStatus = right.fTrackStatus;
122 fBelowThreshold = right.fBelowThreshold;
123 fGoodForTracking = right.fGoodForTracking;
124
125 // Step information (Step Length, Step Number, pointer to the Step,)
126 // are not copied
127 fpStep = nullptr;
128
129 // vertex information
130 fVtxPosition = right.fVtxPosition;
131 fpLVAtVertex = right.fpLVAtVertex;
132 fVtxKineticEnergy = right.fVtxKineticEnergy;
133 fVtxMomentumDirection = right.fVtxMomentumDirection;
134
135 // CreatorProcess and UserInformation are not copied
136 fpCreatorProcess = nullptr;
137 delete fpUserInformation;
138 fpUserInformation = nullptr;
139
140 prev_mat = right.prev_mat;
141 groupvel = right.groupvel;
142 prev_velocity = right.prev_velocity;
143 prev_momentum = right.prev_momentum;
144
145 is_OpticalPhoton = right.is_OpticalPhoton;
146 useGivenVelocity = right.useGivenVelocity;
147
148 ClearAuxiliaryTrackInformation();
149 }
150 return *this;
151}

◆ operator==()

G4bool G4Track::operator== ( const G4Track )
inline

◆ RemoveAuxiliaryTrackInformation() [1/2]

void G4Track::RemoveAuxiliaryTrackInformation ( G4int  id)

Definition at line 241 of file G4Track.cc.

242{
243 if(fpAuxiliaryTrackInformationMap != nullptr &&
244 fpAuxiliaryTrackInformationMap->find(id) != fpAuxiliaryTrackInformationMap->cend())
245 {
246 fpAuxiliaryTrackInformationMap->erase(id);
247 }
248}

Referenced by RemoveAuxiliaryTrackInformation().

◆ RemoveAuxiliaryTrackInformation() [2/2]

void G4Track::RemoveAuxiliaryTrackInformation ( G4String name)

Definition at line 251 of file G4Track.cc.

252{
253 if(fpAuxiliaryTrackInformationMap != nullptr)
254 {
257 }
258}
int G4int
Definition: G4Types.hh:85
static G4int GetModelID(const G4int modelIndex)
void RemoveAuxiliaryTrackInformation(G4int id)
Definition: G4Track.cc:241

◆ SetAuxiliaryTrackInformation()

void G4Track::SetAuxiliaryTrackInformation ( G4int  id,
G4VAuxiliaryTrackInformation info 
) const

Definition at line 209 of file G4Track.cc.

211{
212 if(fpAuxiliaryTrackInformationMap == nullptr)
213 {
214 fpAuxiliaryTrackInformationMap =
215 new std::map<G4int, G4VAuxiliaryTrackInformation*>;
216 }
218 {
220 ED << "Process/model ID <" << id << "> is invalid.";
221 G4Exception("G4VAuxiliaryTrackInformation::G4VAuxiliaryTrackInformation()",
222 "TRACK0982", FatalException, ED);
223 }
224 (*fpAuxiliaryTrackInformationMap)[id] = info;
225}
@ FatalException
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
Definition: G4Exception.cc:59
std::ostringstream G4ExceptionDescription
Definition: G4Exception.hh:40
static G4int GetModelIndex(const G4int modelID)

Referenced by G4eplusAnnihilation::AtRestDoIt(), and G4BOptrForceCollision::OperationApplied().

◆ SetBelowThresholdFlag()

void G4Track::SetBelowThresholdFlag ( G4bool  value = true)

◆ SetCreatorModelID()

◆ SetCreatorProcess()

void G4Track::SetCreatorProcess ( const G4VProcess aValue)

◆ SetGlobalTime()

void G4Track::SetGlobalTime ( const G4double  aValue)

◆ SetGoodForTrackingFlag()

◆ SetKineticEnergy()

◆ SetLocalTime()

void G4Track::SetLocalTime ( const G4double  aValue)

◆ SetLogicalVolumeAtVertex()

void G4Track::SetLogicalVolumeAtVertex ( const G4LogicalVolume )

◆ SetMomentumDirection()

void G4Track::SetMomentumDirection ( const G4ThreeVector aValue)

◆ SetNextTouchableHandle()

void G4Track::SetNextTouchableHandle ( const G4TouchableHandle apValue)

◆ SetOriginTouchableHandle()

void G4Track::SetOriginTouchableHandle ( const G4TouchableHandle apValue)

◆ SetParentID()

◆ SetParentResonanceDef()

void G4Track::SetParentResonanceDef ( const G4ParticleDefinition parent)
inline

◆ SetParentResonanceID()

void G4Track::SetParentResonanceID ( const G4int  parentID)
inline

◆ SetPolarization()

void G4Track::SetPolarization ( const G4ThreeVector aValue)

◆ SetPosition()

◆ SetProperTime()

void G4Track::SetProperTime ( const G4double  aValue)

◆ SetStep()

◆ SetStepLength()

◆ SetTouchableHandle()

◆ SetTrackID()

◆ SetTrackStatus()

◆ SetUserInformation()

◆ SetVelocity()

void G4Track::SetVelocity ( G4double  val)

◆ SetVertexKineticEnergy()

void G4Track::SetVertexKineticEnergy ( const G4double  aValue)

◆ SetVertexMomentumDirection()

void G4Track::SetVertexMomentumDirection ( const G4ThreeVector aValue)

◆ SetVertexPosition()

void G4Track::SetVertexPosition ( const G4ThreeVector aValue)

◆ SetWeight()

◆ UseGivenVelocity() [1/2]

G4bool G4Track::UseGivenVelocity ( ) const

◆ UseGivenVelocity() [2/2]

void G4Track::UseGivenVelocity ( G4bool  val)

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