Geant4.10
 All Data Structures Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Static Public Member Functions
G4Track Class Reference

#include <G4Track.hh>

Public Member Functions

 G4Track ()
 
 G4Track (G4DynamicParticle *apValueDynamicParticle, G4double aValueTime, const G4ThreeVector &aValuePosition)
 
 G4Track (const G4Track &)
 
 ~G4Track ()
 
voidoperator 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)
 
void SetCreatorModelIndex (G4int idx)
 
G4StringGetCreatorModelName ()
 
G4int GetCreatorModelID ()
 
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 73 of file G4Track.hh.

Constructor & Destructor Documentation

G4Track::G4Track ( )

Definition at line 95 of file G4Track.cc.

97  : fCurrentStepNumber(0),
98  fGlobalTime(0), fLocalTime(0.),
99  fTrackLength(0.),
100  fParentID(0), fTrackID(0),
101  fVelocity(c_light),
102  fpDynamicParticle(0),
103  fTrackStatus(fAlive),
104  fBelowThreshold(false), fGoodForTracking(false),
105  fStepLength(0.0), fWeight(1.0),
106  fpStep(0),
107  fVtxKineticEnergy(0.0),
108  fpLVAtVertex(0), fpCreatorProcess(0),
109  fCreatorModelIndex(-1),
110  fpUserInformation(0),
111  prev_mat(0), groupvel(0),
112  prev_velocity(0.0), prev_momentum(0.0),
113  is_OpticalPhoton(false),
114  useGivenVelocity(false)
115 {
116 }
float c_light
Definition: hepunit.py:257
G4Track::G4Track ( G4DynamicParticle apValueDynamicParticle,
G4double  aValueTime,
const G4ThreeVector aValuePosition 
)

Definition at line 55 of file G4Track.cc.

References CalculateVelocity(), G4ParticleTable::FindParticle(), G4ThreadLocal, G4DynamicParticle::GetDefinition(), G4ParticleTable::GetParticleTable(), and G4VelocityTable::GetVelocityTable().

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  fCreatorModelIndex(-1),
72  fpUserInformation(0),
73  prev_mat(0), groupvel(0),
74  prev_velocity(0.0), prev_momentum(0.0),
75  is_OpticalPhoton(false),
76  useGivenVelocity(false)
77 {
78  static G4ThreadLocal G4bool isFirstTime = true;
79  static G4ThreadLocal G4ParticleDefinition* fOpticalPhoton =0;
80  if ( isFirstTime ) {
81  isFirstTime = false;
82  // set fOpticalPhoton
83  fOpticalPhoton = G4ParticleTable::GetParticleTable()->FindParticle("opticalphoton");
84  }
85  // check if the particle type is Optical Photon
86  is_OpticalPhoton = (fpDynamicParticle->GetDefinition() == fOpticalPhoton);
87 
88  if (velTable ==0 ) velTable = G4VelocityTable::GetVelocityTable();
89 
90  fVelocity = CalculateVelocity();
91 
92 }
static G4VelocityTable * GetVelocityTable()
G4ParticleDefinition * FindParticle(G4int PDGEncoding)
G4ParticleDefinition * GetDefinition() const
#define G4ThreadLocal
Definition: tls.hh:52
bool G4bool
Definition: G4Types.hh:79
G4double CalculateVelocity() const
Definition: G4Track.cc:214
static G4ParticleTable * GetParticleTable()
float c_light
Definition: hepunit.py:257
G4Track::G4Track ( const G4Track right)

Definition at line 119 of file G4Track.cc.

References right.

121  : fCurrentStepNumber(0),
122  fGlobalTime(0), fLocalTime(0.),
123  fTrackLength(0.),
124  fParentID(0), fTrackID(0),
125  fVelocity(c_light),
126  fpDynamicParticle(0),
127  fTrackStatus(fAlive),
128  fBelowThreshold(false), fGoodForTracking(false),
129  fStepLength(0.0), fWeight(1.0),
130  fpStep(0),
131  fVtxKineticEnergy(0.0),
132  fpLVAtVertex(0), fpCreatorProcess(0),
133  fCreatorModelIndex(-1),
134  fpUserInformation(0),
135  prev_mat(0), groupvel(0),
136  prev_velocity(0.0), prev_momentum(0.0),
137  is_OpticalPhoton(false),
138  useGivenVelocity(false)
139 {
140  *this = right;
141 }
float c_light
Definition: hepunit.py:257
G4Track::~G4Track ( )

Definition at line 144 of file G4Track.cc.

146 {
147  delete fpDynamicParticle;
148  delete fpUserInformation;
149 }

Member Function Documentation

void G4Track::AddTrackLength ( const G4double  aValue)
G4double G4Track::CalculateVelocity ( ) const

Definition at line 214 of file G4Track.cc.

References python.hepunit::c_light, CalculateVelocityForOpticalPhoton(), DBL_MIN, G4DynamicParticle::GetKineticEnergy(), G4DynamicParticle::GetMass(), GetMaxTOfVelocityTable(), GetMinTOfVelocityTable(), and G4VelocityTable::Value().

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

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

Definition at line 247 of file G4Track.cc.

References python.hepunit::c_light, G4VPhysicalVolume::GetLogicalVolume(), GetMaterial(), G4LogicalVolume::GetMaterial(), G4Material::GetMaterialPropertiesTable(), G4MaterialPropertiesTable::GetProperty(), G4DynamicParticle::GetTotalMomentum(), G4VTouchable::GetVolume(), and G4PhysicsVector::Value().

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

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

Definition at line 207 of file G4Track.cc.

References right.

209 {
210  *this = right;
211 }
G4int G4Track::GetCreatorModelID ( )
inline

Definition at line 249 of file G4Track.hh.

250  { return fCreatorModelIndex; }
G4String& G4Track::GetCreatorModelName ( )
inline

Definition at line 247 of file G4Track.hh.

References G4PhysicsModelCatalog::GetModelName().

248  { return G4PhysicsModelCatalog::GetModelName(fCreatorModelIndex); }
static G4String & GetModelName(G4int)
const G4VProcess* G4Track::GetCreatorProcess ( ) const
G4int G4Track::GetCurrentStepNumber ( ) const

Referenced by G4CoupledTransportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4WeightCutOffProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldProcess::AlongStepGetPhysicalInteractionLength(), G4ImportanceProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldScoringProcess::AlongStepGetPhysicalInteractionLength(), G4WeightWindowProcess::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AlongStepGetPhysicalInteractionLength(), G4RichTrajectory::AppendStep(), G4DNABrownianTransportation::Diffusion(), export_G4Track(), G4RichTrajectoryPoint::G4RichTrajectoryPoint(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4BiasingProcessInterface::PostStepGetPhysicalInteractionLength(), G4PSCellCharge::ProcessHits(), G4PSMinKinEAtGeneration::ProcessHits(), G4PSNofSecondary::ProcessHits(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), LXeSteppingVerbose::StepInfo(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), LXeSteppingVerbose::TrackingStarted(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), exrdmSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), LXeSteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), DMXSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

G4ParticleDefinition* G4Track::GetDefinition ( ) const

Referenced by G4SDParticleFilter::Accept(), CML2ExpVoxels::add(), HistoManager::AddLeakingParticle(), RunAction::AddSecondaryTrack(), HistoManager::AddTargetStep(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4ITStepProcessor::ApplyProductionCut(), G4FastSimulationManager::AtRestGetFastSimulationManagerTrigger(), SteppingAction::BirksAttenuation(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), F04StackingAction::ClassifyNewTrack(), LXeStackingAction::ClassifyNewTrack(), OpNoviceStackingAction::ClassifyNewTrack(), XPhononStackingAction::ClassifyNewTrack(), B3StackingAction::ClassifyNewTrack(), StackingAction::ClassifyNewTrack(), ExN04StackingAction::ClassifyNewTrack(), WLSStackingAction::ClassifyNewTrack(), CCalStackingAction::ClassifyNewTrack(), RE05StackingAction::ClassifyNewTrack(), G4StackChecker::ClassifyNewTrack(), DMXStackingAction::ClassifyNewTrack(), G4ITStepProcessor::DealWithSecondaries(), G4ScreenedCoulombClassicalKinematics::DoCollisionStep(), GFlashShowerModel::DoIt(), G4ITStepProcessor::DoStepping(), export_G4Track(), F04Trajectory::F04Trajectory(), G4HadronicProcess::FillResult(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4VTransitionRadiation::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4ITStepProcessor::GetProcessInfo(), G4SteppingManager::GetProcessNumber(), G4Pythia6Decayer::ImportDecayProducts(), G4ErrorPropagator::InitG4Track(), G4HadProjectile::Initialise(), LXeTrajectory::LXeTrajectory(), GFlashShowerModel::ModelTrigger(), RE06SteppingVerbose::NewStep(), G4hImpactIonisation::PostStepDoIt(), G4ScreenedNuclearRecoil::PostStepDoIt(), G4FastSimulationManager::PostStepGetFastSimulationManagerTrigger(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), DMXMinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), F04TrackingAction::PostUserTrackingAction(), LXeTrackingAction::PostUserTrackingAction(), WLSTrackingAction::PostUserTrackingAction(), TrackingAction::PostUserTrackingAction(), MCTruthTrackingAction::PostUserTrackingAction(), CexmcTrackingAction::PreUserTrackingAction(), eRositaTrackerSD::ProcessHits(), B5DriftChamberSD::ProcessHits(), Em10CalorimeterSD::ProcessHits(), CML2SDWithParticle::ProcessHits(), B4cCalorimeterSD::ProcessHits(), DMXScintSD::ProcessHits(), UltraPMTSD::ProcessHits(), G4PSNofSecondary::ProcessHits(), RMC01SD::ProcessHits(), LXePMTSD::ProcessHits_constStep(), WLSPhotonDetSD::ProcessHits_constStep(), G4TrackingManager::ProcessOneTrack(), G4ErrorPropagator::Propagate(), RE01TrackInformation::RE01TrackInformation(), RE01Trajectory::RE01Trajectory(), RE04Trajectory::RE04Trajectory(), HistoManager::ScoreNewTrack(), RE01TrackInformation::SetSourceTrackInformation(), G4EnergySplitter::SplitEnergyInVolumes(), G4ITTrackingManager::StartTracking(), G4VEnergyLossProcess::StartTracking(), F04SteppingVerbose::StepInfo(), G4ITTrackingInteractivity::TrackBanner(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingAction::UserSteppingAction(), RE05SteppingAction::UserSteppingAction(), exrdmSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), LXeSteppingAction::UserSteppingAction(), B4bSteppingAction::UserSteppingAction(), B4aSteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), DMXSteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), G4AdjointSteppingAction::UserSteppingAction(), and WLSTrajectory::WLSTrajectory().

const G4DynamicParticle* G4Track::GetDynamicParticle ( ) const

Referenced by G4ErrorEnergyLoss::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4AdjointProcessEquivalentToDirectProcess::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4MonopoleTransportation::AlongStepDoIt(), G4AdjointAlongStepWeightCorrection::AlongStepDoIt(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4eLowEnergyLoss::AlongStepDoIt(), G4hImpactIonisation::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4VContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4ITStepProcessor::ApplyProductionCut(), G4AdjointProcessEquivalentToDirectProcess::AtRestDoIt(), G4VITRestProcess::AtRestGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestGetPhysicalInteractionLength(), G4VRestContinuousProcess::AtRestGetPhysicalInteractionLength(), G4VRestProcess::AtRestGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::AtRestGetPhysicalInteractionLength(), G4Decay::AtRestGetPhysicalInteractionLength(), G4BetheBlochIonGasModel::ChargeSquareRatio(), G4BraggIonGasModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ITTransportation::ComputeStep(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4FieldTrackUpdator::CreateFieldTrack(), G4PionDecayMakeSpin::DaughterPolarization(), G4DecayWithSpin::DecayIt(), G4UnknownDecay::DecayIt(), G4Decay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ScreenedCoulombClassicalKinematics::DoCollisionStep(), G4SingleScatter::DoCollisionStep(), export_G4Track(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4hImpactIonisation::GetContinuousStepLimit(), G4SynchrotronRadiation::GetMeanFreePath(), G4OpMieHG::GetMeanFreePath(), G4LowEnergyRayleigh::GetMeanFreePath(), G4LowEnergyCompton::GetMeanFreePath(), G4LowEnergyGammaConversion::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4GammaConversionToMuons::GetMeanFreePath(), G4hImpactIonisation::GetMeanFreePath(), G4AnnihiToMuPair::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4LowEnergyPolarizedCompton::GetMeanFreePath(), G4LowEnergyPhotoElectric::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4OpAbsorption::GetMeanFreePath(), G4OpRayleigh::GetMeanFreePath(), G4OpWLS::GetMeanFreePath(), G4HadronicProcess::GetMeanFreePath(), G4Decay::GetMeanFreePath(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4RadioactiveDecay::GetMeanFreePath(), G4Decay::GetMeanLifeTime(), G4RadioactiveDecay::GetMeanLifeTime(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4Scintillation::GetScintillationYieldByParticleType(), G4Pythia6Decayer::ImportDecayProducts(), G4HadProjectile::Initialise(), G4ParticleChangeForDecay::Initialize(), G4ParticleChange::Initialize(), G4FastStep::Initialize(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4SmartTrackStack::PopFromStack(), G4HadronElasticProcess::PostStepDoIt(), G4LowEnergyRayleigh::PostStepDoIt(), G4LowEnergyCompton::PostStepDoIt(), G4AdjointProcessEquivalentToDirectProcess::PostStepDoIt(), G4LowEnergyGammaConversion::PostStepDoIt(), G4LowEnergyPhotoElectric::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4ScreenedNuclearRecoil::PostStepDoIt(), Em10StepCut::PostStepGetPhysicalInteractionLength(), F03StepCut::PostStepGetPhysicalInteractionLength(), F02StepCut::PostStepGetPhysicalInteractionLength(), F01StepCut::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), DMXMinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), DMXMaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), XrayTelStepCut::PostStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4UnknownDecay::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4AdjointProcessEquivalentToDirectProcess::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4Decay::PostStepGetPhysicalInteractionLength(), Em10TrackingAction::PreUserTrackingAction(), G4AdjointTrackingAction::PreUserTrackingAction(), G4ErrorFreeTrajState::PropagateError(), G4SmartTrackStack::PushToStack(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), RE01Trajectory::RE01Trajectory(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4VEnergyLossProcess::SampleSubCutSecondaries(), Histo::ScoreNewTrack(), HistoManager::ScoreNewTrack(), G4SteppingManager::SetInitialStep(), G4WentzelVIModel::StartTracking(), G4WentzelVIRelModel::StartTracking(), G4GoudsmitSaundersonMscModel::StartTracking(), G4UrbanMscModel::StartTracking(), G4AdjointProcessEquivalentToDirectProcess::StartTracking(), G4FieldTrackUpdator::Update(), G4ParticleChangeForTransport::UpdateStepForAlongStep(), OpNoviceSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), and Em10SteppingAction::UserSteppingAction().

G4double G4Track::GetGlobalTime ( ) const

Referenced by G4ParticleChangeForGamma::AddSecondary(), G4Transportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4MonopoleTransportation::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4eplusAnnihilation::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4ITTransportation::ComputeStep(), G4FieldTrackUpdator::CreateFieldTrack(), G4VPhononProcess::CreateSecondary(), G4DecayWithSpin::DecayIt(), G4UnknownDecay::DecayIt(), G4Decay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4DNABrownianTransportation::Diffusion(), Par01PiModel::DoIt(), export_G4Track(), F04TrajectoryPoint::F04TrajectoryPoint(), G4HadronicProcess::FillResult(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4ParticleChangeForDecay::Initialize(), G4ParticleChange::Initialize(), G4FastStep::Initialize(), G4DNAMolecularReaction::MakeReaction(), G4HadronElasticProcess::PostStepDoIt(), G4DNASecondOrderReaction::PostStepDoIt(), G4DNABrownianTransportation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), DMXMaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), MCTruthTrackingAction::PostUserTrackingAction(), Em10TrackingAction::PreUserTrackingAction(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), RE01TrackInformation::RE01TrackInformation(), RE01Trajectory::RE01Trajectory(), G4TrackingInformation::RecordCurrentPositionNTime(), RE01TrackInformation::SetSourceTrackInformation(), F05SteppingVerbose::StepInfo(), F05SteppingVerbose::TrackingStarted(), G4FieldTrackUpdator::Update(), G4FastStep::UpdateStepForAtRest(), G4FastStep::UpdateStepForPostStep(), F05SteppingAction::UserSteppingAction(), G4SteppingVerbose::VerboseTrack(), WLSTrajectoryPoint::WLSTrajectoryPoint(), and G4Molecule::~G4Molecule().

G4double G4Track::GetKineticEnergy ( ) const

Referenced by HistoManager::AddLeakingParticle(), HistoManager::AddTargetStep(), G4ErrorEnergyLoss::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4MonopoleTransportation::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4VMultipleScattering::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), XrayTelAnalysis::analyseStepping(), G4ITStepProcessor::ApplyProductionCut(), G4VEmModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4VParticleChange::CheckSecondary(), StackingAction::ClassifyNewTrack(), CCalStackingAction::ClassifyNewTrack(), G4StackChecker::ClassifyNewTrack(), G4FieldTrackUpdator::CreateFieldTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4ITStepProcessor::DealWithSecondaries(), Par01PionShowerModel::DoIt(), Par01EMShowerModel::DoIt(), G4HadronicProcess::DumpState(), export_G4Track(), G4HadronicProcess::FillResult(), G4RichTrajectory::G4RichTrajectory(), G4RichTrajectoryPoint::G4RichTrajectoryPoint(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PhononScattering::GetMeanFreePath(), G4PhononDownconversion::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4LowEnergyIonisation::GetMeanFreePath(), G4LowEnergyBremsstrahlung::GetMeanFreePath(), G4Scintillation::GetScintillationYieldByParticleType(), G4ErrorPropagator::InitG4Track(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), Par01EMShowerModel::ModelTrigger(), GFlashShowerModel::ModelTrigger(), G4PhononScattering::PostStepDoIt(), G4PhononReflection::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4UserSpecialCuts::PostStepDoIt(), DMXSpecialCuts::PostStepDoIt(), G4SpecialCuts::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4ElectronCapture::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4WeightWindowProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4ElectronCapture::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), TrackingAction::PostUserTrackingAction(), Em10TrackingAction::PreUserTrackingAction(), CML2SDWithParticle::ProcessHits(), UltraPMTSD::ProcessHits(), G4ErrorPropagator::Propagate(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), RE04Trajectory::RE04Trajectory(), G4VEnergyLossProcess::SampleSubCutSecondaries(), Histo::ScoreNewTrack(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4FieldTrackUpdator::Update(), PurgMagSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), XrayTelSteppingAction::UserSteppingAction(), G4AdjointSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

G4double G4Track::GetLocalTime ( ) const
const G4LogicalVolume* G4Track::GetLogicalVolumeAtVertex ( ) const

Referenced by export_G4Track().

G4Material* G4Track::GetMaterial ( ) const

Referenced by G4ErrorEnergyLoss::AlongStepDoIt(), G4VContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AlongStepGetPhysicalInteractionLength(), G4VRestContinuousProcess::AlongStepGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4VITRestProcess::AtRestGetPhysicalInteractionLength(), G4AntiNeutronAnnihilationAtRest::AtRestGetPhysicalInteractionLength(), G4VRestContinuousProcess::AtRestGetPhysicalInteractionLength(), G4VRestProcess::AtRestGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestDiscreteProcess::AtRestGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::AtRestGetPhysicalInteractionLength(), SteppingAction::BirksAttenuation(), CalculateVelocityForOpticalPhoton(), G4VEmModel::ChargeSquareRatio(), G4DNABrownianTransportation::Diffusion(), G4HadronicProcess::DumpState(), export_G4Track(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4OpMieHG::GetMeanFreePath(), G4GammaConversionToMuons::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4AnnihiToMuPair::GetMeanFreePath(), G4LowEnergyPhotoElectric::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4OpAbsorption::GetMeanFreePath(), G4OpRayleigh::GetMeanFreePath(), G4OpWLS::GetMeanFreePath(), G4HadronicProcess::GetMeanFreePath(), G4Scintillation::GetScintillationYieldByParticleType(), G4HadProjectile::Initialise(), G4HadronElasticProcess::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), CexmcHadronicProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4VITRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VRestContinuousDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4VDiscreteProcess::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4Decay::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), RE04Trajectory::RE04Trajectory(), G4ElementSelector::SelectZandA(), RE04SteppingAction::UserSteppingAction(), and FCALSteppingAction::UserSteppingAction().

const G4MaterialCutsCouple* G4Track::GetMaterialCutsCouple ( ) const

Referenced by G4NuclearStopping::AlongStepDoIt(), G4eLowEnergyLoss::AlongStepDoIt(), G4hImpactIonisation::AlongStepDoIt(), G4VMultipleScattering::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4hImpactIonisation::GetContinuousStepLimit(), G4LowEnergyRayleigh::GetMeanFreePath(), G4LowEnergyCompton::GetMeanFreePath(), G4LowEnergyGammaConversion::GetMeanFreePath(), G4hImpactIonisation::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4LowEnergyIonisation::GetMeanFreePath(), G4LowEnergyPolarizedCompton::GetMeanFreePath(), G4LowEnergyBremsstrahlung::GetMeanFreePath(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4VEmProcess::MeanFreePath(), G4VEnergyLossProcess::MeanFreePath(), G4HadronElasticProcess::PostStepDoIt(), G4LowEnergyRayleigh::PostStepDoIt(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyGammaConversion::PostStepDoIt(), G4LowEnergyPhotoElectric::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ScreenedNuclearRecoil::PostStepDoIt(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), DMXMinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4Cerenkov::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4VEnergyLossProcess::SampleSubCutSecondaries(), and G4EmSaturation::VisibleEnergyDeposition().

G4double G4Track::GetMaxTOfVelocityTable ( )
static

Definition at line 301 of file G4Track.cc.

References G4VelocityTable::GetMaxTOfVelocityTable().

Referenced by CalculateVelocity().

static G4double GetMaxTOfVelocityTable()
G4double G4Track::GetMinTOfVelocityTable ( )
static

Definition at line 306 of file G4Track.cc.

References G4VelocityTable::GetMinTOfVelocityTable().

Referenced by CalculateVelocity().

static G4double GetMinTOfVelocityTable()
G4ThreeVector G4Track::GetMomentum ( ) const
const G4ThreeVector& G4Track::GetMomentumDirection ( ) const

Referenced by HistoManager::AddLeakingParticle(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), XrayTelAnalysis::analyseStepping(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4VMscModel::ComputeGeomLimit(), G4FieldTrackUpdator::CreateFieldTrack(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::DumpState(), export_G4Track(), G4VGFlashSensitiveDetector::Hit(), G4ITStepProcessor::InitDefineStep(), G4BOptnForceCommonTruncatedExp::Initialize(), G4ParticleChangeForGamma::InitializeForPostStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4PhononReflection::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4MonopoleTransportation::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), F04TrackingAction::PreUserTrackingAction(), WLSTrackingAction::PreUserTrackingAction(), CexmcPhysicsList< BasePhysics, StudiedPhysics, ProductionModel >::ResampleTrackLengthInTarget(), Histo::ScoreNewTrack(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4VPhononProcess::StartTracking(), G4ImportanceProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4WeightWindowProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4FastSimulationManagerProcess::StartTracking(), G4CoupledTransportation::StartTracking(), F05SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F05SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), G4FieldTrackUpdator::Update(), F05SteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), G4ScoreSplittingProcess::Verbose(), G4ParallelWorldScoringProcess::Verbose(), and G4SteppingVerbose::VerboseTrack().

G4int G4Track::GetNbinOfVelocityTable ( )
static

Definition at line 311 of file G4Track.cc.

References G4VelocityTable::GetNbinOfVelocityTable().

static G4int GetNbinOfVelocityTable()
G4Material* G4Track::GetNextMaterial ( ) const
const G4MaterialCutsCouple* G4Track::GetNextMaterialCutsCouple ( ) const
const G4VTouchable* G4Track::GetNextTouchable ( ) const
const G4TouchableHandle& G4Track::GetNextTouchableHandle ( ) const
G4VPhysicalVolume* G4Track::GetNextVolume ( ) const

Referenced by G4ErrorPropagator::CheckIfLastStep(), G4ITStepProcessor::DoDefinePhysicalStepLength(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), G4ErrorGeomVolumeTarget::TargetReached(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), FCALSteppingAction::UserSteppingAction(), XrayFluoSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), XrayTelSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

const G4VTouchable* G4Track::GetOriginTouchable ( ) const
const G4TouchableHandle& G4Track::GetOriginTouchableHandle ( ) const
G4int G4Track::GetParentID ( ) const

Referenced by F04StackingAction::ClassifyNewTrack(), LXeStackingAction::ClassifyNewTrack(), OpNoviceStackingAction::ClassifyNewTrack(), XPhononStackingAction::ClassifyNewTrack(), B3StackingAction::ClassifyNewTrack(), RE01StackingAction::ClassifyNewTrack(), StackingAction::ClassifyNewTrack(), ExN04StackingAction::ClassifyNewTrack(), CCalStackingAction::ClassifyNewTrack(), WLSStackingAction::ClassifyNewTrack(), RE05StackingAction::ClassifyNewTrack(), G4StackChecker::ClassifyNewTrack(), G4HadronicProcess::DumpState(), export_G4Track(), F04Trajectory::F04Trajectory(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4Scintillation::GetScintillationYieldByParticleType(), G4StackManager::PopNextTrack(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), WLSTrackingAction::PostUserTrackingAction(), MCTruthTrackingAction::PostUserTrackingAction(), RE05TrackingAction::PreUserTrackingAction(), Em10TrackingAction::PreUserTrackingAction(), CML2TrackingAction::PreUserTrackingAction(), CexmcTrackingAction::PreUserTrackingAction(), G4PSCellCharge::ProcessHits(), G4PSMinKinEAtGeneration::ProcessHits(), G4PSNofSecondary::ProcessHits(), G4StackManager::PushOneTrack(), G4SmartTrackStack::PushToStack(), RE01Trajectory::RE01Trajectory(), RE04Trajectory::RE04Trajectory(), Histo::ScoreNewTrack(), HistoManager::ScoreNewTrack(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4VEmProcess::StartTracking(), G4VEnergyLossProcess::StartTracking(), G4ITTrackingInteractivity::TrackBanner(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingAction::UserSteppingAction(), RE05SteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), LXeSteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), G4SteppingVerbose::VerboseTrack(), and WLSTrajectory::WLSTrajectory().

const G4ParticleDefinition* G4Track::GetParticleDefinition ( ) const
const G4ThreeVector& G4Track::GetPolarization ( ) const
const G4ThreeVector& G4Track::GetPosition ( ) const

Referenced by HistoManager::AddLeakingParticle(), G4ParticleChangeForGamma::AddSecondary(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), XrayTelAnalysis::analyseStepping(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4eplusAnnihilation::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), DMXStackingAction::ClassifyNewTrack(), G4DNABrownianTransportation::ComputeStep(), G4ITTransportation::ComputeStep(), G4FieldTrackUpdator::CreateFieldTrack(), G4VPhononProcess::CreateSecondary(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4UnknownDecay::DecayIt(), G4DNAMolecularDissociation::DecayIt(), G4Decay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::DumpState(), export_G4Track(), G4HadronicProcess::FillResult(), G4DNASmoluchowskiReactionModel::FindReaction(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4GFlashSpot::GetPosition(), G4ITStepProcessor::InitDefineStep(), G4BOptnForceCommonTruncatedExp::Initialize(), G4ParticleChange::Initialize(), G4FastStep::Initialize(), G4DNAMolecularReaction::MakeReaction(), Par01PiModel::ModelTrigger(), G4HadronElasticProcess::PostStepDoIt(), G4DNASecondOrderReaction::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4MonopoleTransportation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), TrackingAction::PostUserTrackingAction(), MCTruthTrackingAction::PostUserTrackingAction(), G4ErrorFreeTrajState::PropagateError(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), RE01TrackInformation::RE01TrackInformation(), RE01Trajectory::RE01Trajectory(), RE04Trajectory::RE04Trajectory(), G4TrackingInformation::RecordCurrentPositionNTime(), CexmcPhysicsList< BasePhysics, StudiedPhysics, ProductionModel >::ResampleTrackLengthInTarget(), G4DNAOneStepSolvatationModel::SampleSecondaries(), G4FastTrack::SetCurrentTrack(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), RE01TrackInformation::SetSourceTrackInformation(), G4ImportanceProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4WeightWindowProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4FastSimulationManagerProcess::StartTracking(), G4CoupledTransportation::StartTracking(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), G4DNAMolecularReaction::TestReactibility(), LXeSteppingVerbose::TrackingStarted(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), G4FieldTrackUpdator::Update(), G4ErrorFreeTrajParam::Update(), G4ErrorFreeTrajState::Update(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

G4double G4Track::GetProperTime ( ) const
const G4Step* G4Track::GetStep ( ) const
G4double G4Track::GetStepLength ( ) const
G4double G4Track::GetTotalEnergy ( ) const
const G4VTouchable* G4Track::GetTouchable ( ) const
const G4TouchableHandle& G4Track::GetTouchableHandle ( ) const
G4int G4Track::GetTrackID ( ) const

Referenced by HistoManager::AddEnergy(), G4DNAMoleculeEncounterStepper::CalculateStep(), G4TrackList::CheckFlag(), CCalStackingAction::ClassifyNewTrack(), G4StackChecker::ClassifyNewTrack(), G4DNABrownianTransportation::ComputeStep(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4ITStepProcessor::DealWithSecondaries(), G4DNAMolecularDissociation::DecayIt(), G4DNABrownianTransportation::Diffusion(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::DumpState(), export_G4Track(), F04Trajectory::F04Trajectory(), G4DNASmoluchowskiReactionModel::FindReaction(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4Scintillation::GetScintillationYieldByParticleType(), G4PSPassageTrackLength::IsPassed(), G4PSPassageCellCurrent::IsPassed(), G4PSPassageCellFlux::IsPassed(), G4DNAMolecularReaction::MakeReaction(), G4StackManager::PopNextTrack(), G4DNABrownianTransportation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), MCTruthTrackingAction::PostUserTrackingAction(), Em10TrackingAction::PreUserTrackingAction(), CexmcTrackingAction::PreUserTrackingAction(), ExTGTrackerSD::ProcessHits(), eRositaTrackerSD::ProcessHits(), RE01TrackerSD::ProcessHits(), ExN02TrackerSD::ProcessHits(), ExP01TrackerSD::ProcessHits(), G4PSPopulation::ProcessHits(), B2TrackerSD::ProcessHits(), CheckVolumeSD::ProcessHits(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4StackManager::PushOneTrack(), RE01TrackInformation::RE01TrackInformation(), RE01Trajectory::RE01Trajectory(), RE04Trajectory::RE04Trajectory(), RE01TrackInformation::SetSourceTrackInformation(), G4ITStepProcessor::SetTrack(), G4DNAMolecularReaction::TestReactibility(), G4ITTrackingInteractivity::TrackBanner(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), exrdmSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), G4SteppingVerbose::VerboseTrack(), and WLSTrajectory::WLSTrajectory().

G4double G4Track::GetTrackLength ( ) const

Referenced by export_G4Track(), G4ErrorTrackLengthTarget::GetMeanFreePath(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), and G4SteppingVerbose::VerboseTrack().

G4TrackStatus G4Track::GetTrackStatus ( ) const

Referenced by G4BiasingProcessInterface::AlongStepDoIt(), G4ErrorPropagator::CheckIfLastStep(), RE01StackingAction::ClassifyNewTrack(), ExN04StackingAction::ClassifyNewTrack(), CCalStackingAction::ClassifyNewTrack(), RE05StackingAction::ClassifyNewTrack(), G4Decay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4ITStepProcessor::DoStepping(), G4BiasingProcessInterface::EndTracking(), export_G4Track(), G4ITModelProcessor::FindReaction(), G4Scintillation::GetScintillationYieldByParticleType(), G4ParticleChangeForNothing::Initialize(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4ITStepProcessor::InvokePostStepDoItProcs(), G4ITStepProcessor::InvokeTransportationProc(), G4HadronElasticProcess::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), CexmcHadronicProcess::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Decay::PostStepDoIt(), G4MonopoleTransportation::PostStepDoIt(), G4ImportanceProcess::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4PSTermination::ProcessHits(), G4TrackingManager::ProcessOneTrack(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4SteppingManager::Stepping(), G4ParticleChangeForMSC::UpdateStepForAlongStep(), ExN04SteppingAction::UserSteppingAction(), RE01SteppingAction::UserSteppingAction(), RE05SteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

G4VUserTrackInformation* G4Track::GetUserInformation ( ) const
G4double G4Track::GetVelocity ( ) const
G4double G4Track::GetVertexKineticEnergy ( ) const
const G4ThreeVector& G4Track::GetVertexMomentumDirection ( ) const
const G4ThreeVector& G4Track::GetVertexPosition ( ) const
G4VPhysicalVolume* G4Track::GetVolume ( ) const

Referenced by G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4WeightCutOffProcess::AlongStepGetPhysicalInteractionLength(), G4ImportanceProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldScoringProcess::AlongStepGetPhysicalInteractionLength(), G4WeightWindowProcess::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AtRestGetPhysicalInteractionLength(), XPhononStackingAction::ClassifyNewTrack(), G4VMscModel::ComputeGeomLimit(), G4DecayWithSpin::DecayIt(), G4RadioactiveDecay::DecayIt(), G4HadronicProcess::DumpState(), export_G4Track(), F04TrajectoryPoint::F04TrajectoryPoint(), G4VTransitionRadiation::GetMeanFreePath(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4BOptnForceCommonTruncatedExp::Initialize(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4ScoreSplittingProcess::PostStepDoIt(), Em10StepCut::PostStepGetPhysicalInteractionLength(), F02StepCut::PostStepGetPhysicalInteractionLength(), F03StepCut::PostStepGetPhysicalInteractionLength(), F01StepCut::PostStepGetPhysicalInteractionLength(), G4StepLimiter::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), DMXMinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), HadrontherapyStepMax::PostStepGetPhysicalInteractionLength(), DMXMaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), IORTStepMax::PostStepGetPhysicalInteractionLength(), ML2StepMax::PostStepGetPhysicalInteractionLength(), XrayTelStepCut::PostStepGetPhysicalInteractionLength(), G4ElectronCapture::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::PostStepGetPhysicalInteractionLength(), G4BiasingProcessInterface::PostStepGetPhysicalInteractionLength(), TrackingAction::PostUserTrackingAction(), Em10TrackingAction::PreUserTrackingAction(), WLSTrackingAction::PreUserTrackingAction(), UltraPMTSD::ProcessHits(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), Histo::ScoreNewTrack(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4VPhononProcess::StartTracking(), LXeSteppingVerbose::StepInfo(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), XrayTelSteppingAction::UserSteppingAction(), and WLSTrajectoryPoint::WLSTrajectoryPoint().

G4double G4Track::GetWeight ( ) const
void G4Track::IncrementCurrentStepNumber ( )
G4bool G4Track::IsBelowThreshold ( ) const
G4bool G4Track::IsGoodForTracking ( ) const
void G4Track::operator delete ( void aTrack)
inline
void* G4Track::operator new ( size_t  )
inline
G4bool G4Track::operator== ( const G4Track )
void G4Track::SetBelowThresholdFlag ( G4bool  value = true)
void G4Track::SetCreatorModelIndex ( G4int  idx)
inline
void G4Track::SetCreatorProcess ( const G4VProcess aValue)
void G4Track::SetGlobalTime ( const G4double  aValue)
void G4Track::SetGoodForTrackingFlag ( G4bool  value = true)
void G4Track::SetKineticEnergy ( const G4double  aValue)
void G4Track::SetLocalTime ( const G4double  aValue)
void G4Track::SetLogicalVolumeAtVertex ( const G4LogicalVolume )
void G4Track::SetMomentumDirection ( const G4ThreeVector aValue)
void G4Track::SetNextTouchableHandle ( const G4TouchableHandle apValue)
void G4Track::SetOriginTouchableHandle ( const G4TouchableHandle apValue)
void G4Track::SetParentID ( const G4int  aValue)
void G4Track::SetPolarization ( const G4ThreeVector aValue)
void G4Track::SetPosition ( const G4ThreeVector aValue)
void G4Track::SetProperTime ( const G4double  aValue)
void G4Track::SetStep ( const G4Step aValue)
void G4Track::SetStepLength ( G4double  value)
void G4Track::SetTouchableHandle ( const G4TouchableHandle apValue)
void G4Track::SetTrackID ( const G4int  aValue)
void G4Track::SetTrackStatus ( const G4TrackStatus  aTrackStatus)
void G4Track::SetUserInformation ( G4VUserTrackInformation aValue)
void G4Track::SetVelocity ( G4double  val)
void G4Track::SetVelocityTableProperties ( G4double  t_max,
G4double  t_min,
G4int  nbin 
)
static

Definition at line 293 of file G4Track.cc.

References G4VelocityTable::GetVelocityTable(), and G4VelocityTable::SetVelocityTableProperties().

295 {
298 }
static G4VelocityTable * GetVelocityTable()
static void SetVelocityTableProperties(G4double t_max, G4double t_min, G4int nbin)
void G4Track::SetVertexKineticEnergy ( const G4double  aValue)
void G4Track::SetVertexMomentumDirection ( const G4ThreeVector aValue)
void G4Track::SetVertexPosition ( const G4ThreeVector aValue)
void G4Track::SetWeight ( G4double  aValue)
G4bool G4Track::UseGivenVelocity ( ) const
void G4Track::UseGivenVelocity ( G4bool  val)

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