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

#include <G4Track.hh>

Public Member Functions

 G4Track ()
 
 G4Track (G4DynamicParticle *apValueDynamicParticle, G4double aValueTime, const G4ThreeVector &aValuePosition)
 
 G4Track (const G4Track &)
 
 ~G4Track ()
 
void * operator new (size_t)
 
void operator delete (void *aTrack)
 
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)
 
G4double GetWeight () const
 
void SetWeight (G4double aValue)
 
G4VUserTrackInformationGetUserInformation () const
 
void SetUserInformation (G4VUserTrackInformation *aValue)
 

Static Public Member Functions

static void SetVelocityTableProperties (G4double t_max, G4double t_min, G4int nbin)
 
static G4double GetMaxTOfVelocityTable ()
 
static G4double GetMinTOfVelocityTable ()
 
static G4int GetNbinOfVelocityTable ()
 

Detailed Description

Definition at line 70 of file G4Track.hh.

Constructor & Destructor Documentation

◆ G4Track() [1/3]

G4Track::G4Track ( )

Definition at line 94 of file G4Track.cc.

96 : fCurrentStepNumber(0),
97 fGlobalTime(0), fLocalTime(0.),
98 fTrackLength(0.),
99 fParentID(0), fTrackID(0),
100 fVelocity(c_light),
101 fpDynamicParticle(0),
102 fTrackStatus(fAlive),
103 fBelowThreshold(false), fGoodForTracking(false),
104 fStepLength(0.0), fWeight(1.0),
105 fpStep(0),
106 fVtxKineticEnergy(0.0),
107 fpLVAtVertex(0), fpCreatorProcess(0),
108 fpUserInformation(0),
109 prev_mat(0), groupvel(0),
110 prev_velocity(0.0), prev_momentum(0.0),
111 is_OpticalPhoton(false),
112 useGivenVelocity(false)
113{
114}
@ fAlive

◆ G4Track() [2/3]

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

Definition at line 55 of file G4Track.cc.

59 : fCurrentStepNumber(0), fPosition(aValuePosition),
60 fGlobalTime(aValueTime), fLocalTime(0.),
61 fTrackLength(0.),
62 fParentID(0), fTrackID(0),
63 fVelocity(c_light),
64 fpDynamicParticle(apValueDynamicParticle),
65 fTrackStatus(fAlive),
66 fBelowThreshold(false), fGoodForTracking(false),
67 fStepLength(0.0), fWeight(1.0),
68 fpStep(0),
69 fVtxKineticEnergy(0.0),
70 fpLVAtVertex(0), fpCreatorProcess(0),
71 fpUserInformation(0),
72 prev_mat(0), groupvel(0),
73 prev_velocity(0.0), prev_momentum(0.0),
74 is_OpticalPhoton(false),
75 useGivenVelocity(false)
76{
77 static G4bool isFirstTime = true;
78 static G4ParticleDefinition* fOpticalPhoton =0;
79 if ( isFirstTime ) {
80 isFirstTime = false;
81 // set fOpticalPhoton
82 fOpticalPhoton = G4ParticleTable::GetParticleTable()->FindParticle("opticalphoton");
83 }
84 // check if the particle type is Optical Photon
85 is_OpticalPhoton = (fpDynamicParticle->GetDefinition() == fOpticalPhoton);
86
87 if (velTable ==0 ) velTable = G4VelocityTable::GetVelocityTable();
88
89 fVelocity = CalculateVelocity();
90
91}
bool G4bool
Definition: G4Types.hh:67
G4ParticleDefinition * GetDefinition() const
G4ParticleDefinition * FindParticle(G4int PDGEncoding)
static G4ParticleTable * GetParticleTable()
G4double CalculateVelocity() const
Definition: G4Track.cc:210
static G4VelocityTable * GetVelocityTable()

◆ G4Track() [3/3]

G4Track::G4Track ( const G4Track right)

Definition at line 116 of file G4Track.cc.

118 : fCurrentStepNumber(0),
119 fGlobalTime(0), fLocalTime(0.),
120 fTrackLength(0.),
121 fParentID(0), fTrackID(0),
122 fVelocity(c_light),
123 fpDynamicParticle(0),
124 fTrackStatus(fAlive),
125 fBelowThreshold(false), fGoodForTracking(false),
126 fStepLength(0.0), fWeight(1.0),
127 fpStep(0),
128 fVtxKineticEnergy(0.0),
129 fpLVAtVertex(0), fpCreatorProcess(0),
130 fpUserInformation(0),
131 prev_mat(0), groupvel(0),
132 prev_velocity(0.0), prev_momentum(0.0),
133 is_OpticalPhoton(false),
134 useGivenVelocity(false)
135{
136 *this = right;
137}

◆ ~G4Track()

G4Track::~G4Track ( )

Definition at line 140 of file G4Track.cc.

142{
143 delete fpDynamicParticle;
144 delete fpUserInformation;
145}

Member Function Documentation

◆ AddTrackLength()

void G4Track::AddTrackLength ( const G4double  aValue)

◆ CalculateVelocity()

G4double G4Track::CalculateVelocity ( ) const

Definition at line 210 of file G4Track.cc.

212{
213 if (useGivenVelocity) return fVelocity;
214
215 G4double velocity = c_light ;
216
217 G4double mass = fpDynamicParticle->GetMass();
218
219 // special case for photons
220 if ( is_OpticalPhoton ) return CalculateVelocityForOpticalPhoton();
221
222 // particles other than optical photon
223 if (mass<DBL_MIN) {
224 // Zero Mass
225 velocity = c_light;
226 } else {
227 G4double T = (fpDynamicParticle->GetKineticEnergy())/mass;
228 if (T > GetMaxTOfVelocityTable()) {
229 velocity = c_light;
230 } else if (T<DBL_MIN) {
231 velocity =0.;
232 } else if (T<GetMinTOfVelocityTable()) {
233 velocity = c_light*std::sqrt(T*(T+2.))/(T+1.0);
234 } else {
235 velocity = velTable->Value(T);
236 }
237
238 }
239 return velocity ;
240}
double G4double
Definition: G4Types.hh:64
G4double GetMass() const
G4double GetKineticEnergy() const
G4double CalculateVelocityForOpticalPhoton() const
Definition: G4Track.cc:243
static G4double GetMinTOfVelocityTable()
Definition: G4Track.cc:302
static G4double GetMaxTOfVelocityTable()
Definition: G4Track.cc:297
G4double Value(G4double theEnergy)
#define DBL_MIN
Definition: templates.hh:75

Referenced by G4ITTransportation::ComputeStep(), G4Track(), G4ParticleChange::UpdateStepForAlongStep(), G4ParticleChangeForLoss::UpdateStepForAlongStep(), G4ParticleChange::UpdateStepForAtRest(), G4ParticleChange::UpdateStepForPostStep(), and G4ParticleChangeForLoss::UpdateStepForPostStep().

◆ CalculateVelocityForOpticalPhoton()

G4double G4Track::CalculateVelocityForOpticalPhoton ( ) const

Definition at line 243 of file G4Track.cc.

245{
246
247 G4double velocity = c_light ;
248
249
250 G4Material* mat=0;
251 G4bool update_groupvel = false;
252 if ( fpStep !=0 ){
253 mat= this->GetMaterial(); // Fix for repeated volumes
254 }else{
255 if (fpTouchable!=0){
256 mat=fpTouchable->GetVolume()->GetLogicalVolume()->GetMaterial();
257 }
258 }
259 // check if previous step is in the same volume
260 // and get new GROUPVELOCITY table if necessary
261 if ((mat != 0) && ((mat != prev_mat)||(groupvel==0))) {
262 groupvel = 0;
263 if(mat->GetMaterialPropertiesTable() != 0)
264 groupvel = mat->GetMaterialPropertiesTable()->GetProperty("GROUPVEL");
265 update_groupvel = true;
266 }
267 prev_mat = mat;
268
269 if (groupvel != 0 ) {
270 // light velocity = c/(rindex+d(rindex)/d(log(E_phot)))
271 // values stored in GROUPVEL material properties vector
272 velocity = prev_velocity;
273
274 // check if momentum is same as in the previous step
275 // and calculate group velocity if necessary
276 G4double current_momentum = fpDynamicParticle->GetTotalMomentum();
277 if( update_groupvel || (current_momentum != prev_momentum) ) {
278 velocity =
279 groupvel->Value(current_momentum);
280 prev_velocity = velocity;
281 prev_momentum = current_momentum;
282 }
283 }
284
285 return velocity ;
286}
G4double GetTotalMomentum() const
G4Material * GetMaterial() const
G4MaterialPropertyVector * GetProperty(const char *key)
G4MaterialPropertiesTable * GetMaterialPropertiesTable() const
Definition: G4Material.hh:251
G4double Value(G4double theEnergy)
G4Material * GetMaterial() const
G4LogicalVolume * GetLogicalVolume() const
virtual G4VPhysicalVolume * GetVolume(G4int depth=0) const
Definition: G4VTouchable.cc:44

Referenced by G4ITTransportation::AlongStepDoIt(), and CalculateVelocity().

◆ CopyTrackInfo()

void G4Track::CopyTrackInfo ( const G4Track right)

Definition at line 203 of file G4Track.cc.

205{
206 *this = right;
207}

◆ GetCreatorProcess()

◆ GetCurrentStepNumber()

◆ GetDefinition()

G4ParticleDefinition * G4Track::GetDefinition ( ) const

Referenced by G4SDParticleFilter::Accept(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4ITStepProcessor::ApplyProductionCut(), G4FastSimulationManager::AtRestGetFastSimulationManagerTrigger(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChange::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4ITStepProcessor::DealWithSecondaries(), GFlashShowerModel::DoIt(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::FillResult(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4VAdjointReverseReaction::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4ITStepProcessor::GetProcessInfo(), G4SteppingManager::GetProcessNumber(), G4ErrorPropagator::InitG4Track(), G4HadProjectile::Initialise(), GFlashShowerModel::ModelTrigger(), G4hImpactIonisation::PostStepDoIt(), G4FastSimulationManager::PostStepGetFastSimulationManagerTrigger(), MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4PSNofSecondary::ProcessHits(), G4TrackingManager::ProcessOneTrack(), G4ErrorPropagator::Propagate(), G4EnergySplitter::SplitEnergyInVolumes(), G4ITTrackingManager::StartTracking(), G4VEnergyLossProcess::StartTracking(), G4ITTrackingInteractivity::TrackBanner(), and G4AdjointSteppingAction::UserSteppingAction().

◆ GetDynamicParticle()

const G4DynamicParticle * G4Track::GetDynamicParticle ( ) const

Referenced by G4AdjointAlongStepWeightCorrection::AlongStepDoIt(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4VMultipleScattering::AlongStepDoIt(), G4ErrorEnergyLoss::AlongStepDoIt(), G4AdjointProcessEquivalentToDirectProcess::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4hImpactIonisation::AlongStepDoIt(), G4IVContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::AlongStepGetPhysicalInteractionLength(), G4VContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4ITStepProcessor::ApplyProductionCut(), G4ProtonAntiProtonReaction::ApplyYourself(), G4PionMinusNuclearAtRestChips::AtRestDoIt(), G4ProtonAntiProtonAtRestChips::AtRestDoIt(), G4QCaptureAtRest::AtRestDoIt(), G4KaonMinusAbsorptionAtRest::AtRestDoIt(), G4PiMinusAbsorptionAtRest::AtRestDoIt(), G4AdjointProcessEquivalentToDirectProcess::AtRestDoIt(), G4VITRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestGetPhysicalInteractionLength(), G4AntiProtonAnnihilationAtRest::AtRestGetPhysicalInteractionLength(), G4KaonMinusAbsorption::AtRestGetPhysicalInteractionLength(), G4NeutronCaptureAtRest::AtRestGetPhysicalInteractionLength(), G4PionMinusAbsorptionAtRest::AtRestGetPhysicalInteractionLength(), G4IVRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousProcess::AtRestGetPhysicalInteractionLength(), G4VRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4Decay::AtRestGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::AtRestGetPhysicalInteractionLength(), G4VITRestProcess::AtRestGetPhysicalInteractionLength(), G4PionMinusNuclearAtRestChips::AtRestGetPhysicalInteractionLength(), G4ProtonAntiProtonAtRestChips::AtRestGetPhysicalInteractionLength(), G4VRestProcess::AtRestGetPhysicalInteractionLength(), G4BraggIonGasModel::ChargeSquareRatio(), G4BetheBlochIonGasModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ITTransportation::ComputeStep(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel90::ComputeTruePathLengthLimit(), G4UrbanMscModel92::ComputeTruePathLengthLimit(), G4UrbanMscModel93::ComputeTruePathLengthLimit(), G4UrbanMscModel95::ComputeTruePathLengthLimit(), G4UrbanMscModel96::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4FieldTrackUpdator::CreateFieldTrack(), G4PionDecayMakeSpin::DaughterPolarization(), G4Decay::DecayIt(), G4DecayWithSpin::DecayIt(), G4UnknownDecay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4hImpactIonisation::GetContinuousStepLimit(), G4AnnihiToMuPair::GetMeanFreePath(), G4Decay::GetMeanFreePath(), G4GammaConversionToMuons::GetMeanFreePath(), G4VLowEnergyDiscretePhotonProcess::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4QAtomicElectronScattering::GetMeanFreePath(), G4QCoherentChargeExchange::GetMeanFreePath(), G4QDiffraction::GetMeanFreePath(), G4QElastic::GetMeanFreePath(), G4QInelastic::GetMeanFreePath(), G4QIonIonElastic::GetMeanFreePath(), G4QLowEnergy::GetMeanFreePath(), G4QNGamma::GetMeanFreePath(), G4HadronicProcess::GetMeanFreePath(), G4OpAbsorption::GetMeanFreePath(), G4OpMieHG::GetMeanFreePath(), G4OpRayleigh::GetMeanFreePath(), G4OpWLS::GetMeanFreePath(), G4RadioactiveDecay::GetMeanFreePath(), G4hImpactIonisation::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4QSynchRad::GetMeanFreePath(), G4QCaptureAtRest::GetMeanLifeTime(), G4Decay::GetMeanLifeTime(), G4RadioactiveDecay::GetMeanLifeTime(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4QSynchRad::GetRadius(), G4HadProjectile::Initialise(), G4FastStep::Initialize(), G4ParticleChange::Initialize(), G4ParticleChangeForDecay::Initialize(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4SmartTrackStack::PopFromStack(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QDiscProcessMixer::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4QSynchRad::PostStepDoIt(), G4AdjointProcessEquivalentToDirectProcess::PostStepDoIt(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), MaxTimeCuts::PostStepGetPhysicalInteractionLength(), MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4Decay::PostStepGetPhysicalInteractionLength(), G4UnknownDecay::PostStepGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::PostStepGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4QDiscProcessMixer::PostStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4SmartTrackStack::PushToStack(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4SteppingManager::SetInitialStep(), G4AdjointProcessEquivalentToDirectProcess::StartTracking(), G4GoudsmitSaundersonMscModel::StartTracking(), G4UrbanMscModel90::StartTracking(), G4UrbanMscModel92::StartTracking(), G4UrbanMscModel93::StartTracking(), G4UrbanMscModel95::StartTracking(), G4UrbanMscModel96::StartTracking(), G4WentzelVIModel::StartTracking(), G4WentzelVIRelModel::StartTracking(), G4FieldTrackUpdator::Update(), and G4ParticleChangeForTransport::UpdateStepForAlongStep().

◆ GetGlobalTime()

G4double G4Track::GetGlobalTime ( ) const

Referenced by G4ParticleChangeForGamma::AddSecondary(), G4ParticleChangeForLoss::AddSecondary(), G4ITTransportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4AntiProtonAnnihilationAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4KaonMinusAbsorption::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4NeutronCaptureAtRest::AtRestDoIt(), G4PionMinusAbsorptionAtRest::AtRestDoIt(), G4QCaptureAtRest::AtRestDoIt(), G4FastStep::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4ITTransportation::ComputeStep(), G4FieldTrackUpdator::CreateFieldTrack(), G4Decay::DecayIt(), G4DecayWithSpin::DecayIt(), G4UnknownDecay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4DNABrownianTransportation::Diffusion(), G4HadronicProcess::FillResult(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4FastStep::Initialize(), G4ParticleChange::Initialize(), G4ParticleChangeForDecay::Initialize(), G4DNAMolecularReaction::MakeReaction(), G4DNASecondOrderReaction::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4DNABrownianTransportation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), MaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4TrackingInformation::RecordCurrentPositionNTime(), G4FieldTrackUpdator::Update(), G4FastStep::UpdateStepForAtRest(), G4FastStep::UpdateStepForPostStep(), G4SteppingVerbose::VerboseTrack(), and G4Molecule::~G4Molecule().

◆ GetKineticEnergy()

G4double G4Track::GetKineticEnergy ( ) const

Referenced by G4VMultipleScattering::AlongStepDoIt(), G4ErrorEnergyLoss::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4ITStepProcessor::ApplyProductionCut(), G4VEmModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4FastStep::CheckIt(), G4ParticleChange::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4FieldTrackUpdator::CreateFieldTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4ITStepProcessor::DealWithSecondaries(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4RichTrajectory::G4RichTrajectory(), G4RichTrajectoryPoint::G4RichTrajectoryPoint(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4VAdjointReverseReaction::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4ErrorPropagator::InitG4Track(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), GFlashShowerModel::ModelTrigger(), SpecialCuts::PostStepDoIt(), G4WeightWindowProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4UserSpecialCuts::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4ErrorPropagator::Propagate(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4SteppingVerbose::StepInfo(), G4SteppingVerbose::TrackingStarted(), G4FieldTrackUpdator::Update(), G4AdjointSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

◆ GetLocalTime()

◆ GetLogicalVolumeAtVertex()

const G4LogicalVolume * G4Track::GetLogicalVolumeAtVertex ( ) const

◆ GetMaterial()

G4Material * G4Track::GetMaterial ( ) const

Referenced by G4ErrorEnergyLoss::AlongStepDoIt(), G4IVContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4VContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4PionMinusNuclearAtRestChips::AtRestDoIt(), G4ProtonAntiProtonAtRestChips::AtRestDoIt(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4AntiProtonAnnihilationAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4KaonMinusAbsorption::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4NeutronCaptureAtRest::AtRestDoIt(), G4PionMinusAbsorptionAtRest::AtRestDoIt(), G4QCaptureAtRest::AtRestDoIt(), G4KaonMinusAbsorptionAtRest::AtRestDoIt(), G4PiMinusAbsorptionAtRest::AtRestDoIt(), G4VITRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestGetPhysicalInteractionLength(), G4AntiProtonAnnihilationAtRest::AtRestGetPhysicalInteractionLength(), G4KaonMinusAbsorption::AtRestGetPhysicalInteractionLength(), G4NeutronCaptureAtRest::AtRestGetPhysicalInteractionLength(), G4PionMinusAbsorptionAtRest::AtRestGetPhysicalInteractionLength(), G4IVRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousProcess::AtRestGetPhysicalInteractionLength(), G4VRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VITRestProcess::AtRestGetPhysicalInteractionLength(), G4PionMinusNuclearAtRestChips::AtRestGetPhysicalInteractionLength(), G4ProtonAntiProtonAtRestChips::AtRestGetPhysicalInteractionLength(), G4VRestProcess::AtRestGetPhysicalInteractionLength(), CalculateVelocityForOpticalPhoton(), G4VEmModel::ChargeSquareRatio(), G4DNABrownianTransportation::Diffusion(), G4HadronicProcess::DumpState(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4AnnihiToMuPair::GetMeanFreePath(), G4GammaConversionToMuons::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4QAtomicElectronScattering::GetMeanFreePath(), G4QCoherentChargeExchange::GetMeanFreePath(), G4QDiffraction::GetMeanFreePath(), G4QElastic::GetMeanFreePath(), G4QInelastic::GetMeanFreePath(), G4QIonIonElastic::GetMeanFreePath(), G4QLowEnergy::GetMeanFreePath(), G4QNGamma::GetMeanFreePath(), G4HadronicProcess::GetMeanFreePath(), G4OpAbsorption::GetMeanFreePath(), G4OpMieHG::GetMeanFreePath(), G4OpRayleigh::GetMeanFreePath(), G4OpWLS::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4KaonMinusAbsorptionAtRest::GetMeanLifeTime(), G4PiMinusAbsorptionAtRest::GetMeanLifeTime(), G4HadProjectile::Initialise(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4Decay::PostStepGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), and G4ElementSelector::SelectZandA().

◆ GetMaterialCutsCouple()

const G4MaterialCutsCouple * G4Track::GetMaterialCutsCouple ( ) const

Referenced by G4VMultipleScattering::AlongStepDoIt(), G4NuclearStopping::AlongStepDoIt(), G4hImpactIonisation::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel90::ComputeTruePathLengthLimit(), G4UrbanMscModel92::ComputeTruePathLengthLimit(), G4UrbanMscModel93::ComputeTruePathLengthLimit(), G4UrbanMscModel95::ComputeTruePathLengthLimit(), G4UrbanMscModel96::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4hImpactIonisation::GetContinuousStepLimit(), G4VLowEnergyDiscretePhotonProcess::GetMeanFreePath(), G4hImpactIonisation::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4VEnergyLossProcess::SampleSubCutSecondaries(), and G4EmSaturation::VisibleEnergyDeposition().

◆ GetMaxTOfVelocityTable()

G4double G4Track::GetMaxTOfVelocityTable ( )
static

Definition at line 297 of file G4Track.cc.

static G4double GetMaxTOfVelocityTable()

Referenced by CalculateVelocity().

◆ GetMinTOfVelocityTable()

G4double G4Track::GetMinTOfVelocityTable ( )
static

Definition at line 302 of file G4Track.cc.

static G4double GetMinTOfVelocityTable()

Referenced by CalculateVelocity().

◆ GetMomentum()

◆ GetMomentumDirection()

◆ GetNbinOfVelocityTable()

G4int G4Track::GetNbinOfVelocityTable ( )
static

Definition at line 307 of file G4Track.cc.

static G4int GetNbinOfVelocityTable()

◆ 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()

◆ GetParticleDefinition()

◆ GetPolarization()

◆ GetPosition()

const G4ThreeVector & G4Track::GetPosition ( ) const

Referenced by G4ParticleChangeForGamma::AddSecondary(), G4ParticleChangeForLoss::AddSecondary(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4AntiProtonAnnihilationAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4KaonMinusAbsorption::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4NeutronCaptureAtRest::AtRestDoIt(), G4PionMinusAbsorptionAtRest::AtRestDoIt(), G4QCaptureAtRest::AtRestDoIt(), G4ParticleChange::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4ITTransportation::ComputeStep(), G4DNABrownianTransportation::ComputeStep(), G4FieldTrackUpdator::CreateFieldTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4DNAMolecularDecay::DecayIt(), G4Decay::DecayIt(), G4UnknownDecay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4DNASmoluchowskiReactionModel::FindReaction(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4GFlashSpot::GetPosition(), G4QSynchRad::GetRadius(), G4ITStepProcessor::InitDefineStep(), G4FastStep::Initialize(), G4ParticleChange::Initialize(), G4DNAMolecularReaction::MakeReaction(), G4DNASecondOrderReaction::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4TrackingInformation::RecordCurrentPositionNTime(), G4DNASancheSolvatationModel::SampleSecondaries(), G4FastTrack::SetCurrentTrack(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4ImportanceProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4WeightWindowProcess::StartTracking(), G4FastSimulationManagerProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4CoupledTransportation::StartTracking(), G4SteppingVerbose::StepInfo(), G4DNAMolecularReaction::TestReactibility(), G4SteppingVerbose::TrackingStarted(), G4ErrorFreeTrajParam::Update(), G4ErrorFreeTrajState::Update(), G4FieldTrackUpdator::Update(), and G4SteppingVerbose::VerboseTrack().

◆ GetProperTime()

◆ GetStep()

◆ GetStepLength()

◆ GetTotalEnergy()

◆ GetTouchable()

const G4VTouchable * G4Track::GetTouchable ( ) const

◆ GetTouchableHandle()

const G4TouchableHandle & G4Track::GetTouchableHandle ( ) const

Referenced by G4ParticleChangeForGamma::AddSecondary(), G4ParticleChangeForLoss::AddSecondary(), G4ParticleChange::AddSecondary(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4RichTrajectory::AppendStep(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4AntiProtonAnnihilationAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4KaonMinusAbsorption::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4NeutronCaptureAtRest::AtRestDoIt(), G4PionMinusAbsorptionAtRest::AtRestDoIt(), G4QCaptureAtRest::AtRestDoIt(), G4Decay::DecayIt(), G4UnknownDecay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::FillResult(), G4RichTrajectory::G4RichTrajectory(), G4ITStepProcessor::InitDefineStep(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4ScoreSplittingProcess::StartTracking(), G4ITTransportation::StartTracking(), G4CoupledTransportation::StartTracking(), and G4Transportation::StartTracking().

◆ GetTrackID()

◆ GetTrackLength()

◆ GetTrackStatus()

◆ GetUserInformation()

G4VUserTrackInformation * G4Track::GetUserInformation ( ) const

Referenced by GetIT().

◆ GetVelocity()

◆ GetVertexKineticEnergy()

G4double G4Track::GetVertexKineticEnergy ( ) const

◆ GetVertexMomentumDirection()

const G4ThreeVector & G4Track::GetVertexMomentumDirection ( ) const

◆ GetVertexPosition()

const G4ThreeVector & G4Track::GetVertexPosition ( ) const

◆ GetVolume()

G4VPhysicalVolume * G4Track::GetVolume ( ) const

Referenced by G4ImportanceProcess::AlongStepGetPhysicalInteractionLength(), G4WeightCutOffProcess::AlongStepGetPhysicalInteractionLength(), G4WeightWindowProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldScoringProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AtRestGetPhysicalInteractionLength(), G4VMscModel::ComputeGeomLimit(), G4DecayWithSpin::DecayIt(), G4RadioactiveDecay::DecayIt(), G4HadronicProcess::DumpState(), G4PolarizedCompton::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4QSynchRad::GetRadius(), G4ScoreSplittingProcess::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), MaxTimeCuts::PostStepGetPhysicalInteractionLength(), MinEkineCuts::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::PostStepGetPhysicalInteractionLength(), G4StepLimiter::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4ITStepProcessor::SetInitialStep(), and G4SteppingManager::SetInitialStep().

◆ GetWeight()

◆ 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 ( size_t  )
inline

◆ operator==()

G4bool G4Track::operator== ( const G4Track )

◆ SetBelowThresholdFlag()

void G4Track::SetBelowThresholdFlag ( G4bool  value = true)

◆ SetCreatorProcess()

void G4Track::SetCreatorProcess ( const G4VProcess aValue)

◆ SetGlobalTime()

void G4Track::SetGlobalTime ( const G4double  aValue)

◆ SetGoodForTrackingFlag()

void G4Track::SetGoodForTrackingFlag ( G4bool  value = true)

◆ SetKineticEnergy()

◆ SetLocalTime()

void G4Track::SetLocalTime ( const G4double  aValue)

◆ SetLogicalVolumeAtVertex()

void G4Track::SetLogicalVolumeAtVertex ( const G4LogicalVolume )

◆ SetMomentumDirection()

void G4Track::SetMomentumDirection ( const G4ThreeVector aValue)

◆ SetNextTouchableHandle()

◆ SetOriginTouchableHandle()

void G4Track::SetOriginTouchableHandle ( const G4TouchableHandle apValue)

◆ SetParentID()

◆ SetPolarization()

void G4Track::SetPolarization ( const G4ThreeVector aValue)

◆ SetPosition()

void G4Track::SetPosition ( const G4ThreeVector aValue)

◆ SetProperTime()

void G4Track::SetProperTime ( const G4double  aValue)

◆ SetStep()

◆ SetStepLength()

◆ SetTouchableHandle()

◆ SetTrackID()

void G4Track::SetTrackID ( const G4int  aValue)

◆ SetTrackStatus()

◆ SetUserInformation()

void G4Track::SetUserInformation ( G4VUserTrackInformation aValue)

◆ SetVelocity()

void G4Track::SetVelocity ( G4double  val)

◆ SetVelocityTableProperties()

void G4Track::SetVelocityTableProperties ( G4double  t_max,
G4double  t_min,
G4int  nbin 
)
static

Definition at line 289 of file G4Track.cc.

291{
294}
static void SetVelocityTableProperties(G4double t_max, G4double t_min, G4int nbin)

◆ 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: