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::G4Track (  ) 

Definition at line 94 of file G4Track.cc.

00096   : fCurrentStepNumber(0),    
00097     fGlobalTime(0),           fLocalTime(0.),
00098     fTrackLength(0.),
00099     fParentID(0),             fTrackID(0),
00100     fVelocity(c_light),
00101     fpDynamicParticle(0),
00102     fTrackStatus(fAlive),
00103     fBelowThreshold(false),   fGoodForTracking(false),
00104     fStepLength(0.0),         fWeight(1.0),
00105     fpStep(0),
00106     fVtxKineticEnergy(0.0),
00107     fpLVAtVertex(0),          fpCreatorProcess(0),
00108     fpUserInformation(0),
00109     prev_mat(0),  groupvel(0),
00110     prev_velocity(0.0), prev_momentum(0.0),
00111     is_OpticalPhoton(false),
00112     useGivenVelocity(false)
00113 {
00114 }

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

Definition at line 55 of file G4Track.cc.

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

00059   : fCurrentStepNumber(0),    fPosition(aValuePosition),
00060     fGlobalTime(aValueTime),  fLocalTime(0.),
00061     fTrackLength(0.),
00062     fParentID(0),             fTrackID(0),
00063     fVelocity(c_light),
00064     fpDynamicParticle(apValueDynamicParticle),
00065     fTrackStatus(fAlive),
00066     fBelowThreshold(false),   fGoodForTracking(false),
00067     fStepLength(0.0),         fWeight(1.0),
00068     fpStep(0),
00069     fVtxKineticEnergy(0.0),
00070     fpLVAtVertex(0),          fpCreatorProcess(0),
00071     fpUserInformation(0),
00072     prev_mat(0),  groupvel(0),
00073     prev_velocity(0.0), prev_momentum(0.0),
00074     is_OpticalPhoton(false),
00075     useGivenVelocity(false)
00076 {    
00077   static G4bool isFirstTime = true;
00078   static G4ParticleDefinition* fOpticalPhoton =0;
00079   if ( isFirstTime ) {
00080     isFirstTime = false;
00081     // set  fOpticalPhoton
00082     fOpticalPhoton = G4ParticleTable::GetParticleTable()->FindParticle("opticalphoton");
00083   }
00084   // check if the particle type is Optical Photon
00085   is_OpticalPhoton = (fpDynamicParticle->GetDefinition() == fOpticalPhoton);
00086 
00087   if (velTable ==0 ) velTable = G4VelocityTable::GetVelocityTable();
00088 
00089   fVelocity = CalculateVelocity();
00090 
00091 }

G4Track::G4Track ( const G4Track  ) 

Definition at line 116 of file G4Track.cc.

00118   : fCurrentStepNumber(0),    
00119     fGlobalTime(0),           fLocalTime(0.),
00120     fTrackLength(0.),
00121     fParentID(0),             fTrackID(0),
00122     fVelocity(c_light),
00123     fpDynamicParticle(0),
00124     fTrackStatus(fAlive),
00125     fBelowThreshold(false),   fGoodForTracking(false),
00126     fStepLength(0.0),         fWeight(1.0),
00127     fpStep(0),
00128     fVtxKineticEnergy(0.0),
00129     fpLVAtVertex(0),          fpCreatorProcess(0),
00130     fpUserInformation(0),
00131     prev_mat(0),  groupvel(0),
00132     prev_velocity(0.0), prev_momentum(0.0),
00133     is_OpticalPhoton(false),
00134     useGivenVelocity(false)
00135 {
00136   *this = right;
00137 }

G4Track::~G4Track (  ) 

Definition at line 140 of file G4Track.cc.

00142 {
00143    delete fpDynamicParticle;
00144    delete fpUserInformation;
00145 }


Member Function Documentation

void G4Track::AddTrackLength ( const G4double  aValue  )  [inline]

Definition at line 251 of file G4Track.icc.

Referenced by G4ITStepProcessor::DoStepping(), and G4SteppingManager::Stepping().

00252    { fTrackLength += aValue; }

G4double G4Track::CalculateVelocity (  )  const

Definition at line 210 of file G4Track.cc.

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

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

00212 { 
00213   if (useGivenVelocity) return fVelocity;    
00214 
00215   G4double velocity = c_light ;
00216   
00217   G4double mass = fpDynamicParticle->GetMass();
00218 
00219   // special case for photons
00220   if ( is_OpticalPhoton ) return CalculateVelocityForOpticalPhoton();
00221 
00222   // particles other than optical photon
00223   if (mass<DBL_MIN) {
00224     // Zero Mass
00225     velocity = c_light;
00226   } else {
00227     G4double T = (fpDynamicParticle->GetKineticEnergy())/mass;
00228     if (T > GetMaxTOfVelocityTable()) {
00229       velocity = c_light;
00230     } else if (T<DBL_MIN) {
00231       velocity =0.;
00232     } else if (T<GetMinTOfVelocityTable()) {
00233       velocity = c_light*std::sqrt(T*(T+2.))/(T+1.0);
00234     } else {    
00235       velocity = velTable->Value(T);
00236     }
00237     
00238   }                                                                             
00239   return velocity ;
00240 }

G4double G4Track::CalculateVelocityForOpticalPhoton (  )  const

Definition at line 243 of file G4Track.cc.

References GetMaterial(), G4Material::GetMaterialPropertiesTable(), G4MaterialPropertiesTable::GetProperty(), G4DynamicParticle::GetTotalMomentum(), and G4PhysicsVector::Value().

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

00245 { 
00246     
00247   G4double velocity = c_light ;
00248   
00249 
00250   G4Material* mat=0; 
00251   G4bool update_groupvel = false;
00252   if ( fpStep !=0  ){
00253     mat= this->GetMaterial();         //   Fix for repeated volumes
00254   }else{
00255     if (fpTouchable!=0){ 
00256       mat=fpTouchable->GetVolume()->GetLogicalVolume()->GetMaterial();
00257     }
00258   }
00259   // check if previous step is in the same volume
00260     //  and get new GROUPVELOCITY table if necessary 
00261   if ((mat != 0) && ((mat != prev_mat)||(groupvel==0))) {
00262     groupvel = 0;
00263     if(mat->GetMaterialPropertiesTable() != 0)
00264       groupvel = mat->GetMaterialPropertiesTable()->GetProperty("GROUPVEL");
00265     update_groupvel = true;
00266   }
00267   prev_mat = mat;
00268   
00269   if  (groupvel != 0 ) {
00270     // light velocity = c/(rindex+d(rindex)/d(log(E_phot)))
00271     // values stored in GROUPVEL material properties vector
00272     velocity =  prev_velocity;
00273     
00274     // check if momentum is same as in the previous step
00275     //  and calculate group velocity if necessary 
00276     G4double current_momentum = fpDynamicParticle->GetTotalMomentum();
00277     if( update_groupvel || (current_momentum != prev_momentum) ) {
00278       velocity =
00279         groupvel->Value(current_momentum);
00280       prev_velocity = velocity;
00281       prev_momentum = current_momentum;
00282     }
00283   }   
00284   
00285   return velocity ;
00286 }

void G4Track::CopyTrackInfo ( const G4Track  ) 

Definition at line 203 of file G4Track.cc.

00205 {
00206   *this = right;
00207 }

const G4VProcess * G4Track::GetCreatorProcess (  )  const [inline]

Definition at line 293 of file G4Track.icc.

Referenced by G4StackChecker::ClassifyNewTrack(), G4RichTrajectory::G4RichTrajectory(), and G4SteppingVerbose::VerboseTrack().

00294    { return fpCreatorProcess; }

G4int G4Track::GetCurrentStepNumber (  )  const [inline]

Definition at line 256 of file G4Track.icc.

Referenced by G4CoupledTransportation::AlongStepDoIt(), G4WeightWindowProcess::AlongStepGetPhysicalInteractionLength(), G4WeightCutOffProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldScoringProcess::AlongStepGetPhysicalInteractionLength(), G4ParallelWorldProcess::AlongStepGetPhysicalInteractionLength(), G4ImportanceProcess::AlongStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4RichTrajectory::AppendStep(), G4DNABrownianTransportation::Diffusion(), G4RichTrajectoryPoint::G4RichTrajectoryPoint(), G4DNASecondOrderReaction::PostStepGetPhysicalInteractionLength(), G4PSNofSecondary::ProcessHits(), G4PSMinKinEAtGeneration::ProcessHits(), G4PSCellCharge::ProcessHits(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4SteppingVerbose::StepInfo(), G4SteppingVerbose::TrackingStarted(), and G4SteppingVerbose::VerboseTrack().

00257    { return fCurrentStepNumber; }

G4ParticleDefinition * G4Track::GetDefinition (  )  const [inline]

Definition at line 71 of file G4Track.icc.

References G4DynamicParticle::GetDefinition().

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

00072    { return fpDynamicParticle->GetDefinition(); }

const G4DynamicParticle * G4Track::GetDynamicParticle (  )  const [inline]

Definition at line 67 of file G4Track.icc.

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

00068    { return fpDynamicParticle; }

G4double G4Track::GetGlobalTime (  )  const [inline]

Definition at line 100 of file G4Track.icc.

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

00101    { return fGlobalTime; }

G4double G4Track::GetKineticEnergy (  )  const [inline]

Definition at line 210 of file G4Track.icc.

References G4DynamicParticle::GetKineticEnergy().

Referenced by G4VMultipleScattering::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4ErrorEnergyLoss::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4ITStepProcessor::ApplyProductionCut(), G4VEmModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4FastStep::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(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4AdjointAlongStepWeightCorrection::GetContinuousStepLimit(), G4VTransitionRadiation::GetMeanFreePath(), G4VAdjointReverseReaction::GetMeanFreePath(), G4ErrorPropagator::InitG4Track(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4Step::InitializeStep(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4VEnergyLossProcess::MeanFreePath(), G4VEmProcess::MeanFreePath(), GFlashShowerModel::ModelTrigger(), SpecialCuts::PostStepDoIt(), G4WHadronElasticProcess::PostStepDoIt(), G4WeightWindowProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4UserSpecialCuts::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4NeutronKiller::PostStepGetPhysicalInteractionLength(), G4ErrorPropagator::Propagate(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4SteppingVerbose::StepInfo(), G4SteppingVerbose::TrackingStarted(), G4FieldTrackUpdator::Update(), G4AdjointSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

00211    { return fpDynamicParticle->GetKineticEnergy(); }

G4double G4Track::GetLocalTime (  )  const [inline]

Definition at line 108 of file G4Track.icc.

Referenced by G4Transportation::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4ParticleChangeForDecay::CheckIt(), G4RadioactiveDecay::DecayIt(), G4Decay::DecayIt(), G4DNABrownianTransportation::Diffusion(), G4ParticleChangeForTransport::Initialize(), G4ParticleChangeForDecay::Initialize(), G4ParticleChange::Initialize(), G4Step::InitializeStep(), G4TrackingInformation::RecordCurrentPositionNTime(), and G4SteppingVerbose::VerboseTrack().

00109    { return fLocalTime; }

const G4LogicalVolume * G4Track::GetLogicalVolumeAtVertex (  )  const [inline]

Definition at line 287 of file G4Track.icc.

00288    { return fpLVAtVertex; } 

G4Material * G4Track::GetMaterial (  )  const [inline]

Definition at line 156 of file G4Track.icc.

References G4StepPoint::GetMaterial(), and G4Step::GetPreStepPoint().

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

00157    { return fpStep->GetPreStepPoint()->GetMaterial(); }

const G4MaterialCutsCouple * G4Track::GetMaterialCutsCouple (  )  const [inline]

Definition at line 148 of file G4Track.icc.

References G4StepPoint::GetMaterialCutsCouple(), and G4Step::GetPreStepPoint().

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

00149    { return fpStep->GetPreStepPoint()->GetMaterialCutsCouple(); }

G4double G4Track::GetMaxTOfVelocityTable (  )  [static]

Definition at line 297 of file G4Track.cc.

References G4VelocityTable::GetMaxTOfVelocityTable().

Referenced by CalculateVelocity().

G4double G4Track::GetMinTOfVelocityTable (  )  [static]

Definition at line 302 of file G4Track.cc.

References G4VelocityTable::GetMinTOfVelocityTable().

Referenced by CalculateVelocity().

G4ThreeVector G4Track::GetMomentum (  )  const [inline]

Definition at line 221 of file G4Track.icc.

References G4DynamicParticle::GetMomentum().

Referenced by G4HadronicProcess::CheckEnergyMomentumConservation(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4FastTrack::SetCurrentTrack(), G4ErrorFreeTrajState::Update(), G4ErrorFreeTrajParam::Update(), and G4AdjointSteppingAction::UserSteppingAction().

00222    { return fpDynamicParticle->GetMomentum(); }

const G4ThreeVector & G4Track::GetMomentumDirection (  )  const [inline]

Definition at line 225 of file G4Track.icc.

References G4DynamicParticle::GetMomentumDirection().

Referenced by G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4VParticleChange::CheckSecondary(), G4StackChecker::ClassifyNewTrack(), G4VMscModel::ComputeGeomLimit(), G4FieldTrackUpdator::CreateFieldTrack(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::DumpState(), G4VGFlashSensitiveDetector::Hit(), G4ITStepProcessor::InitDefineStep(), G4ParticleChangeForMSC::Initialize(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4Step::InitializeStep(), G4WHadronElasticProcess::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4WeightWindowProcess::StartTracking(), G4WeightCutOffProcess::StartTracking(), G4ParallelWorldScoringProcess::StartTracking(), G4ParallelWorldProcess::StartTracking(), G4ImportanceProcess::StartTracking(), G4FastSimulationManagerProcess::StartTracking(), G4CoupledTransportation::StartTracking(), G4FieldTrackUpdator::Update(), G4ScoreSplittingProcess::Verbose(), G4ParallelWorldScoringProcess::Verbose(), and G4SteppingVerbose::VerboseTrack().

00226    { return fpDynamicParticle->GetMomentumDirection(); }

G4int G4Track::GetNbinOfVelocityTable (  )  [static]

Definition at line 307 of file G4Track.cc.

References G4VelocityTable::GetNbinOfVelocityTable().

G4Material * G4Track::GetNextMaterial (  )  const [inline]

Definition at line 159 of file G4Track.icc.

References G4StepPoint::GetMaterial(), and G4Step::GetPostStepPoint().

00160    { return fpStep->GetPostStepPoint()->GetMaterial(); }

const G4MaterialCutsCouple * G4Track::GetNextMaterialCutsCouple (  )  const [inline]

Definition at line 152 of file G4Track.icc.

References G4StepPoint::GetMaterialCutsCouple(), and G4Step::GetPostStepPoint().

00153    { return fpStep->GetPostStepPoint()->GetMaterialCutsCouple(); }

const G4VTouchable * G4Track::GetNextTouchable (  )  const [inline]

Definition at line 179 of file G4Track.icc.

00180    {
00181      return fpNextTouchable();
00182    }

const G4TouchableHandle & G4Track::GetNextTouchableHandle (  )  const [inline]

Definition at line 184 of file G4Track.icc.

Referenced by G4RichTrajectory::AppendStep(), G4RichTrajectory::G4RichTrajectory(), G4ITStepProcessor::InitDefineStep(), G4ScoreSplittingProcess::PostStepDoIt(), and G4SteppingManager::Stepping().

00185    {
00186      return fpNextTouchable;
00187    }

G4VPhysicalVolume * G4Track::GetNextVolume (  )  const [inline]

Definition at line 142 of file G4Track.icc.

Referenced by G4ErrorPropagator::CheckIfLastStep(), G4ITStepProcessor::DoDefinePhysicalStepLength(), G4SteppingVerbose::StepInfo(), G4ErrorGeomVolumeTarget::TargetReached(), G4SteppingVerbose::TrackingStarted(), and G4SteppingVerbose::VerboseTrack().

00143    {  if ( fpNextTouchable ==0 ) return 0; 
00144      return fpNextTouchable->GetVolume(); }

const G4VTouchable * G4Track::GetOriginTouchable (  )  const [inline]

Definition at line 194 of file G4Track.icc.

00195    {
00196      return fpOriginTouchable();
00197    }

const G4TouchableHandle & G4Track::GetOriginTouchableHandle (  )  const [inline]

Definition at line 199 of file G4Track.icc.

00200    {
00201      return fpOriginTouchable;
00202    }

G4int G4Track::GetParentID (  )  const [inline]

Definition at line 79 of file G4Track.icc.

Referenced by G4StackChecker::ClassifyNewTrack(), G4HadronicProcess::DumpState(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4StackManager::PopNextTrack(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4PSNofSecondary::ProcessHits(), G4PSMinKinEAtGeneration::ProcessHits(), G4PSCellCharge::ProcessHits(), G4StackManager::PushOneTrack(), G4SmartTrackStack::PushToStack(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4VEnergyLossProcess::StartTracking(), G4VEmProcess::StartTracking(), G4ITTrackingInteractivity::TrackBanner(), and G4SteppingVerbose::VerboseTrack().

00080    { return fParentID; }

const G4ParticleDefinition * G4Track::GetParticleDefinition (  )  const [inline]

Definition at line 75 of file G4Track.icc.

References G4DynamicParticle::GetParticleDefinition().

Referenced by G4VEnergyLossProcess::AlongStepDoIt(), G4NuclearStopping::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4VEmModel::ChargeSquareRatio(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4ElectronIonPair::MeanNumberOfIonsAlongStep(), G4ElectronIonPair::ResidualeChargePostStep(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4VMultipleScattering::StartTracking(), G4VEmProcess::StartTracking(), G4ParticleChangeForGamma::UpdateStepForPostStep(), and G4EmSaturation::VisibleEnergyDeposition().

00076    { return fpDynamicParticle->GetParticleDefinition(); }

const G4ThreeVector & G4Track::GetPolarization (  )  const [inline]

Definition at line 232 of file G4Track.icc.

References G4DynamicParticle::GetPolarization().

Referenced by G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4PolarizedCompton::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4Step::InitializeStep(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4FastTrack::SetCurrentTrack(), and G4SteppingVerbose::VerboseTrack().

00233    { return fpDynamicParticle->GetPolarization(); }

const G4ThreeVector & G4Track::GetPosition (  )  const [inline]

Definition at line 93 of file G4Track.icc.

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

00094    { return fPosition; }

G4double G4Track::GetProperTime (  )  const [inline]

Definition at line 116 of file G4Track.icc.

References G4DynamicParticle::GetProperTime().

Referenced by G4Transportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Decay::AtRestGetPhysicalInteractionLength(), G4FastStep::CheckIt(), G4DNAMolecularDecay::GetMeanLifeTime(), G4Step::InitializeStep(), G4UnknownDecay::PostStepGetPhysicalInteractionLength(), and G4Decay::PostStepGetPhysicalInteractionLength().

00117    { return fpDynamicParticle->GetProperTime(); }

const G4Step * G4Track::GetStep (  )  const [inline]

Definition at line 329 of file G4Track.icc.

Referenced by G4VMscModel::ComputeGeomLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4UrbanMscModel96::ComputeTruePathLengthLimit(), G4UrbanMscModel95::ComputeTruePathLengthLimit(), G4UrbanMscModel93::ComputeTruePathLengthLimit(), G4UrbanMscModel92::ComputeTruePathLengthLimit(), G4UrbanMscModel90::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4TrackList::DeleteTrack(), G4DNASmoluchowskiReactionModel::FindReaction(), G4VParticleChange::InitializeParentGlobalTime(), G4VParticleChange::InitializeStepInVolumeFlags(), G4VParticleChange::InitializeTrueStepLength(), G4ErrorPropagator::MakeOneStep(), G4ParallelWorldProcess::PostStepDoIt(), G4PSDoseDeposit::ProcessHits(), G4ErrorFreeTrajState::PropagateError(), G4ScoreSplittingProcess::StartTracking(), and G4ParallelWorldProcess::StartTracking().

00330    { return fpStep; }

G4double G4Track::GetStepLength (  )  const [inline]

Definition at line 263 of file G4Track.icc.

Referenced by G4Transportation::AlongStepDoIt(), G4ITTransportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4ITStepProcessor::InitDefineStep(), G4ErrorPropagator::MakeOneStep(), G4OpBoundaryProcess::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), and G4SteppingVerbose::ShowStep().

00264    { return fStepLength; }

G4double G4Track::GetTotalEnergy (  )  const [inline]

Definition at line 217 of file G4Track.icc.

References G4DynamicParticle::GetTotalEnergy().

Referenced by G4Transportation::AlongStepDoIt(), and G4CoupledTransportation::AlongStepDoIt().

00218    { return fpDynamicParticle->GetTotalEnergy(); }

const G4VTouchable * G4Track::GetTouchable (  )  const [inline]

Definition at line 164 of file G4Track.icc.

Referenced by G4Step::InitializeStep().

00165    {
00166      return fpTouchable();
00167    }

const G4TouchableHandle & G4Track::GetTouchableHandle (  )  const [inline]

Definition at line 169 of file G4Track.icc.

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

00170    {
00171      return fpTouchable;
00172    }

G4int G4Track::GetTrackID (  )  const [inline]

Definition at line 86 of file G4Track.icc.

Referenced by G4DNAMoleculeEncounterStepper::CalculateStep(), G4TrackList::CheckFlag(), G4StackChecker::ClassifyNewTrack(), G4DNABrownianTransportation::ComputeStep(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4ITStepProcessor::DealWithSecondaries(), G4DNAMolecularDecay::DecayIt(), G4DNABrownianTransportation::Diffusion(), G4ITStepProcessor::DoStepping(), G4HadronicProcess::DumpState(), G4SmoothTrajectory::G4SmoothTrajectory(), G4Trajectory::G4Trajectory(), G4PSPassageTrackLength::IsPassed(), G4PSPassageCellFlux::IsPassed(), G4PSPassageCellCurrent::IsPassed(), G4DNAMolecularReaction::MakeReaction(), G4StackManager::PopNextTrack(), G4VXTRenergyLoss::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4DNABrownianTransportation::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4VITManager::iterator::PrintNext(), G4PSPopulation::ProcessHits(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4StackManager::PushOneTrack(), G4ITStepProcessor::SetTrack(), G4DNAMolecularReaction::TestReactibility(), G4ITTrackingInteractivity::TrackBanner(), and G4SteppingVerbose::VerboseTrack().

00087    { return fTrackID; }

G4double G4Track::GetTrackLength (  )  const [inline]

Definition at line 248 of file G4Track.icc.

Referenced by G4SteppingVerbose::StepInfo(), G4SteppingVerbose::TrackingStarted(), and G4SteppingVerbose::VerboseTrack().

00249    { return fTrackLength; }

G4TrackStatus G4Track::GetTrackStatus (  )  const [inline]

Definition at line 241 of file G4Track.icc.

Referenced by G4VEnergyLossProcess::AlongStepDoIt(), G4ErrorPropagator::CheckIfLastStep(), G4RadioactiveDecay::DecayIt(), G4Decay::DecayIt(), G4ITStepProcessor::DoStepping(), G4ITModelProcessor::FindReaction(), G4ParticleChangeForMSC::Initialize(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4VParticleChange::InitializeStatusChange(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4ITStepProcessor::InvokeTransportationProc(), G4WHadronElasticProcess::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4ImportanceProcess::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4PSTermination::ProcessHits(), G4TrackingManager::ProcessOneTrack(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::Stepping(), G4ParticleChangeForMSC::UpdateStepForAlongStep(), and G4SteppingVerbose::VerboseTrack().

00242    { return fTrackStatus; }

G4VUserTrackInformation * G4Track::GetUserInformation (  )  const [inline]

Definition at line 324 of file G4Track.icc.

Referenced by GetIT().

00325    { return fpUserInformation; }

G4double G4Track::GetVelocity (  )  const [inline]

Definition at line 124 of file G4Track.icc.

Referenced by G4CoupledTransportation::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::ComputeStep(), G4ParticleChangeForTransport::Initialize(), G4ParticleChange::Initialize(), and G4OpBoundaryProcess::PostStepDoIt().

00125    { return fVelocity; }

G4double G4Track::GetVertexKineticEnergy (  )  const [inline]

Definition at line 281 of file G4Track.icc.

Referenced by G4SteppingVerbose::VerboseTrack().

00282    { return fVtxKineticEnergy; }

const G4ThreeVector & G4Track::GetVertexMomentumDirection (  )  const [inline]

Definition at line 276 of file G4Track.icc.

Referenced by G4SteppingVerbose::VerboseTrack().

00277    { return fVtxMomentumDirection; }

const G4ThreeVector & G4Track::GetVertexPosition (  )  const [inline]

Definition at line 270 of file G4Track.icc.

Referenced by G4SteppingVerbose::VerboseTrack().

00271    { return fVtxPosition; }

G4VPhysicalVolume * G4Track::GetVolume (  )  const [inline]

Definition at line 138 of file G4Track.icc.

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

00139    { if ( fpTouchable ==0 ) return 0; 
00140      return fpTouchable->GetVolume(); }

G4double G4Track::GetWeight (  )  const [inline]

Definition at line 320 of file G4Track.icc.

Referenced by G4QCaptureAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4eplusAnnihilation::AtRestDoIt(), G4RadioactiveDecay::DecayIt(), G4HadronicProcess::FillResult(), G4FastStep::Initialize(), G4ParticleChangeForLoss::InitializeForAlongStep(), G4ParticleChangeForLoss::InitializeForPostStep(), G4ParticleChangeForGamma::InitializeForPostStep(), G4VParticleChange::InitializeParentWeight(), G4Step::InitializeStep(), G4WHadronElasticProcess::PostStepDoIt(), G4WeightWindowProcess::PostStepDoIt(), G4WeightCutOffProcess::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4ImportanceProcess::PostStepDoIt(), G4HadronicProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4CellScorer::ScoreAnInVolumeStep(), and G4AdjointSteppingAction::UserSteppingAction().

00321    { return fWeight; }

void G4Track::IncrementCurrentStepNumber (  )  [inline]

Definition at line 259 of file G4Track.icc.

Referenced by G4ITStepProcessor::DoStepping(), G4ErrorPropagator::MakeOneStep(), and G4TrackingManager::ProcessOneTrack().

00260    { fCurrentStepNumber++; }

G4bool G4Track::IsBelowThreshold (  )  const [inline]

Definition at line 303 of file G4Track.icc.

00304    { return fBelowThreshold; }

G4bool G4Track::IsGoodForTracking (  )  const [inline]

Definition at line 310 of file G4Track.icc.

Referenced by G4ITStepProcessor::ApplyProductionCut().

00311    { return fGoodForTracking; }

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

Definition at line 56 of file G4Track.icc.

References aTrackAllocator.

00057    { aTrackAllocator.FreeSingle((G4Track *) aTrack);}

void * G4Track::operator new ( size_t   )  [inline]

Definition at line 49 of file G4Track.icc.

References aTrackAllocator.

00050    { void *aTrack;
00051      aTrack = (void *) aTrackAllocator.MallocSingle();
00052      return aTrack;
00053    }

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

Definition at line 60 of file G4Track.icc.

00061    { return (this==&trk);  }

void G4Track::SetBelowThresholdFlag ( G4bool  value = true  )  [inline]

Definition at line 306 of file G4Track.icc.

00307    { fBelowThreshold = value; }

void G4Track::SetCreatorProcess ( const G4VProcess aValue  )  [inline]

Definition at line 299 of file G4Track.icc.

Referenced by G4ITStepProcessor::DealWithSecondaries().

00300    { fpCreatorProcess = aValue; }

void G4Track::SetGlobalTime ( const G4double  aValue  )  [inline]

Definition at line 103 of file G4Track.icc.

Referenced by G4Step::UpdateTrack().

00104    { fGlobalTime = aValue; }

void G4Track::SetGoodForTrackingFlag ( G4bool  value = true  )  [inline]

Definition at line 313 of file G4Track.icc.

Referenced by G4ParticleChange::AddSecondary(), G4UnknownDecay::DecayIt(), and G4Decay::DecayIt().

00314    { fGoodForTracking = value; }

void G4Track::SetKineticEnergy ( const G4double  aValue  )  [inline]

Definition at line 213 of file G4Track.icc.

References G4DynamicParticle::SetKineticEnergy().

Referenced by G4ITStepProcessor::ApplyProductionCut(), G4VParticleChange::CheckSecondary(), G4ParticleChangeForLoss::UpdateStepForAlongStep(), G4ParticleChange::UpdateStepForAlongStep(), G4ParticleChangeForLoss::UpdateStepForPostStep(), G4ParticleChange::UpdateStepForPostStep(), and G4Step::UpdateTrack().

00214    { fpDynamicParticle->SetKineticEnergy(aValue); }

void G4Track::SetLocalTime ( const G4double  aValue  )  [inline]

Definition at line 111 of file G4Track.icc.

Referenced by G4Step::UpdateTrack().

00112    { fLocalTime = aValue; }

void G4Track::SetLogicalVolumeAtVertex ( const G4LogicalVolume  )  [inline]

Definition at line 290 of file G4Track.icc.

Referenced by G4SteppingManager::SetInitialStep(), and G4ITStepProcessor::SetInitialStep().

00291    { fpLVAtVertex = aValue; }

void G4Track::SetMomentumDirection ( const G4ThreeVector aValue  )  [inline]

Definition at line 228 of file G4Track.icc.

References G4DynamicParticle::SetMomentumDirection().

Referenced by G4VParticleChange::CheckSecondary(), and G4Step::UpdateTrack().

00229    { fpDynamicParticle->SetMomentumDirection(aValue) ;}

void G4Track::SetNextTouchableHandle ( const G4TouchableHandle apValue  )  [inline]

Definition at line 189 of file G4Track.icc.

Referenced by G4ITStepProcessor::InitDefineStep(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), and G4Step::UpdateTrack().

00190    {
00191      fpNextTouchable = apValue;
00192    }

void G4Track::SetOriginTouchableHandle ( const G4TouchableHandle apValue  )  [inline]

Definition at line 204 of file G4Track.icc.

00205    {
00206      fpOriginTouchable = apValue;
00207    }

void G4Track::SetParentID ( const G4int  aValue  )  [inline]

Definition at line 82 of file G4Track.icc.

Referenced by G4ITStepProcessor::DealWithSecondaries(), G4PrimaryTransformer::GenerateSingleTrack(), G4ErrorPropagator::InitG4Track(), G4VXTRenergyLoss::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), and G4StackManager::PrepareNewEvent().

00083    { fParentID = aValue; }

void G4Track::SetPolarization ( const G4ThreeVector aValue  )  [inline]

Definition at line 235 of file G4Track.icc.

References G4DynamicParticle::SetPolarization().

Referenced by G4Step::UpdateTrack().

00236    { fpDynamicParticle->SetPolarization(aValue.x(),
00237                                         aValue.y(),
00238                                         aValue.z()); }

void G4Track::SetPosition ( const G4ThreeVector aValue  )  [inline]

Definition at line 96 of file G4Track.icc.

Referenced by G4Step::UpdateTrack().

00097    { fPosition = aValue; }

void G4Track::SetProperTime ( const G4double  aValue  )  [inline]

Definition at line 119 of file G4Track.icc.

References G4DynamicParticle::SetProperTime().

Referenced by G4Step::UpdateTrack().

00120    { fpDynamicParticle->SetProperTime(aValue); }

void G4Track::SetStep ( const G4Step aValue  )  [inline]

Definition at line 332 of file G4Track.icc.

Referenced by G4ITStepProcessor::InitDefineStep(), G4ErrorPropagator::InitG4Track(), and G4TrackingManager::ProcessOneTrack().

00333    { fpStep = aValue; }

void G4Track::SetStepLength ( G4double  value  )  [inline]

Definition at line 266 of file G4Track.icc.

Referenced by G4ITStepProcessor::DoStepping(), G4Step::InitializeStep(), G4ITStepProcessor::InvokeAtRestDoItProcs(), G4SteppingManager::Stepping(), and G4Step::UpdateTrack().

00267    { fStepLength = value; }

void G4Track::SetTouchableHandle ( const G4TouchableHandle apValue  )  [inline]

Definition at line 174 of file G4Track.icc.

Referenced by G4ParticleChangeForLoss::AddSecondary(), G4ParticleChangeForGamma::AddSecondary(), G4ParticleChange::AddSecondary(), G4QCaptureAtRest::AtRestDoIt(), G4PionMinusAbsorptionAtRest::AtRestDoIt(), G4NeutronCaptureAtRest::AtRestDoIt(), G4MuonMinusCaptureAtRest::AtRestDoIt(), G4KaonMinusAbsorption::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4AntiProtonAnnihilationAtRest::AtRestDoIt(), G4AntiNeutronAnnihilationAtRest::AtRestDoIt(), G4UnknownDecay::DecayIt(), G4Decay::DecayIt(), G4HadronicProcess::FillResult(), G4ITStepProcessor::InitDefineStep(), G4WHadronElasticProcess::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4QAtomicElectronScattering::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), and G4SteppingManager::Stepping().

00175    {
00176      fpTouchable = apValue;
00177    }

void G4Track::SetTrackID ( const G4int  aValue  )  [inline]

Definition at line 89 of file G4Track.icc.

Referenced by G4PrimaryTransformer::GenerateSingleTrack(), and G4StackManager::PrepareNewEvent().

00090    { fTrackID = aValue; }

void G4Track::SetTrackStatus ( const G4TrackStatus  aTrackStatus  )  [inline]

Definition at line 244 of file G4Track.icc.

Referenced by G4ITStepProcessor::DealWithSecondaries(), G4ITStepProcessor::DoStepping(), G4TrackingManager::EventAborted(), G4ITStepProcessor::InvokeAlongStepDoItProcs(), G4ITStepProcessor::InvokePSDIP(), G4DNAMolecularReaction::MakeReaction(), G4TrackingManager::ProcessOneTrack(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4TrackingMessenger::SetNewValue(), G4SteppingManager::Stepping(), and G4AdjointSteppingAction::UserSteppingAction().

00245    { fTrackStatus = aTrackStatus; }

void G4Track::SetUserInformation ( G4VUserTrackInformation aValue  )  [inline]

Definition at line 326 of file G4Track.icc.

Referenced by G4TrackingManager::SetUserTrackInformation().

00327    { fpUserInformation = aValue; }

void G4Track::SetVelocity ( G4double  val  )  [inline]

Definition at line 127 of file G4Track.icc.

Referenced by G4Step::UpdateTrack().

00128    { fVelocity = val; } 

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

Definition at line 289 of file G4Track.cc.

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

00291 {
00292   G4VelocityTable::SetVelocityTableProperties(t_max, t_min, nbin);
00293   velTable = G4VelocityTable::GetVelocityTable();
00294 }

void G4Track::SetVertexKineticEnergy ( const G4double  aValue  )  [inline]

Definition at line 284 of file G4Track.icc.

Referenced by G4SteppingManager::SetInitialStep(), and G4ITStepProcessor::SetInitialStep().

00285    { fVtxKineticEnergy = aValue; }

void G4Track::SetVertexMomentumDirection ( const G4ThreeVector aValue  )  [inline]

Definition at line 278 of file G4Track.icc.

Referenced by G4SteppingManager::SetInitialStep(), and G4ITStepProcessor::SetInitialStep().

00279    { fVtxMomentumDirection = aValue ;}

void G4Track::SetVertexPosition ( const G4ThreeVector aValue  )  [inline]

Definition at line 273 of file G4Track.icc.

Referenced by G4SteppingManager::SetInitialStep(), and G4ITStepProcessor::SetInitialStep().

00274    { fVtxPosition = aValue; }

void G4Track::SetWeight ( G4double  aValue  )  [inline]

Definition at line 317 of file G4Track.icc.

Referenced by G4QCaptureAtRest::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4HadronicProcess::FillResult(), G4PrimaryTransformer::GenerateSingleTrack(), G4WHadronElasticProcess::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4QNGamma::PostStepDoIt(), G4QLowEnergy::PostStepDoIt(), G4QIonIonElastic::PostStepDoIt(), G4QInelastic::PostStepDoIt(), G4QElastic::PostStepDoIt(), G4QDiffraction::PostStepDoIt(), G4QCoherentChargeExchange::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), and G4Step::UpdateTrack().

00318    { fWeight = aValue; }

void G4Track::UseGivenVelocity ( G4bool  val  )  [inline]

Definition at line 133 of file G4Track.icc.

00134    { useGivenVelocity = val;}

G4bool G4Track::UseGivenVelocity (  )  const [inline]

Definition at line 130 of file G4Track.icc.

00131    { return  useGivenVelocity;}


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