#include <GsfTransientTrack.h>
Public Member Functions | |
TrackCharge | charge () const override |
double | dtErrorExt () const override |
const MagneticField * | field () const override |
GsfTransientTrack () | |
GsfTransientTrack (const GsfTrack &tk, const MagneticField *field) | |
GsfTransientTrack (const GsfTrack &tk, const double time, const double dtime, const MagneticField *field) | |
GsfTransientTrack (const GsfTrackRef &tk, const MagneticField *field) | |
GsfTransientTrack (const GsfTrackRef &tk, const double time, const double dtime, const MagneticField *field) | |
GsfTransientTrack (const GsfTrackRef &tk, const MagneticField *field, const edm::ESHandle< GlobalTrackingGeometry > &trackingGeometry) | |
GsfTransientTrack (const GsfTrackRef &tk, const double time, const double dtime, const MagneticField *field, const edm::ESHandle< GlobalTrackingGeometry > &trackingGeometry) | |
GsfTransientTrack (const GsfTrack &tk, const MagneticField *field, const edm::ESHandle< GlobalTrackingGeometry > &trackingGeometry) | |
GsfTransientTrack (const GsfTrack &tk, const double time, const double dtime, const MagneticField *field, const edm::ESHandle< GlobalTrackingGeometry > &trackingGeometry) | |
GsfTransientTrack (const GsfTransientTrack &tt) | |
TrajectoryStateOnSurface | impactPointState () const override |
bool | impactPointStateAvailable () const override |
TrajectoryStateClosestToPoint | impactPointTSCP () const override |
FreeTrajectoryState | initialFreeState () const override |
TrajectoryStateOnSurface | innermostMeasurementState () const override |
GsfTransientTrack & | operator= (const GsfTransientTrack &tt) |
TrajectoryStateOnSurface | outermostMeasurementState () const override |
GsfTrackRef | persistentTrackRef () const |
void | setBeamSpot (const reco::BeamSpot &beamSpot) override |
void | setES (const edm::EventSetup &) override |
void | setTrackingGeometry (const edm::ESHandle< GlobalTrackingGeometry > &) override |
TrajectoryStateClosestToBeamLine | stateAtBeamLine () const override |
TrajectoryStateOnSurface | stateOnSurface (const GlobalPoint &point) const override |
double | timeExt () const override |
const Track & | track () const override |
TrackBaseRef | trackBaseRef () const override |
TrajectoryStateClosestToPoint | trajectoryStateClosestToPoint (const GlobalPoint &point) const override |
Public Member Functions inherited from reco::GsfTrack | |
int | chargeMode () const |
track electric charge from mode More... | |
CovarianceMatrixMode | covarianceMode () const |
return track covariance matrix from mode More... | |
double | covarianceMode (int i, int j) const |
(i,j)-th element of covarianve matrix ( i, j = 0, ... 2 ) from mode More... | |
double | errorMode (int i) const |
error on specified element from mode More... | |
double | etaMode () const |
pseudorapidity of momentum vector from mode More... | |
double | etaModeError () const |
error on eta from mode More... | |
const GsfTrackExtraRef & | gsfExtra () const |
reference to "extra" object More... | |
GsfTrack () | |
default constructor More... | |
GsfTrack (double chi2, double ndof, const Point &, const Vector &, int charge, const CovarianceMatrix &) | |
double | lambdaMode () const |
Lambda angle from mode. More... | |
double | lambdaModeError () const |
error on lambda from mode More... | |
const Vector & | momentumMode () const |
track momentum vector from mode More... | |
double | parameterMode (int i) const |
i-th parameter ( i = 0, ... 2 ) from mode More... | |
ParameterVectorMode | parametersMode () const |
Track parameters with one-to-one correspondence to the covariance matrix from mode. More... | |
double | phiMode () const |
azimuthal angle of momentum vector from mode More... | |
double | phiModeError () const |
error on phi from mode More... | |
double | pMode () const |
momentum vector magnitude from mode More... | |
double | ptMode () const |
track transverse momentum from mode More... | |
double | ptModeError () const |
error on Pt (set to 1000 TeV if charge==0 for safety) from mode More... | |
double | pxMode () const |
x coordinate of momentum vector from mode More... | |
double | pyMode () const |
y coordinate of momentum vector from mode More... | |
double | pzMode () const |
z coordinate of momentum vector from mode More... | |
double | qoverpMode () const |
q/p from mode More... | |
double | qoverpModeError () const |
error on signed transverse curvature from mode More... | |
void | setGsfExtra (const GsfTrackExtraRef &ref) |
set reference to GSF "extra" object More... | |
void | setMode (int chargeMode, const Vector &momentumMode, const CovarianceMatrixMode &covarianceMode) |
set mode parameters More... | |
double | thetaMode () const |
polar angle from mode More... | |
double | thetaModeError () const |
error on theta from mode More... | |
Public Member Functions inherited from reco::Track | |
const TrackExtraRef & | extra () const |
reference to "extra" object More... | |
CovarianceMatrix & | fillInner (CovarianceMatrix &v) const |
CovarianceMatrix & | fillOuter (CovarianceMatrix &v) const |
fill outermost trajectory state curvilinear errors More... | |
unsigned short | found () const |
Number of valid hits on track. More... | |
unsigned int | innerDetId () const |
DetId of the detector on which surface the innermost state is located. More... | |
const math::XYZVector & | innerMomentum () const |
momentum vector at the innermost hit position More... | |
bool | innerOk () const |
return true if the innermost hit is valid More... | |
const math::XYZPoint & | innerPosition () const |
position of the innermost hit More... | |
CovarianceMatrix | innerStateCovariance () const |
innermost trajectory state curvilinear errors More... | |
unsigned short | lost () const |
Number of lost (=invalid) hits on track. More... | |
unsigned int | outerDetId () const |
DetId of the detector on which surface the outermost state is located. More... | |
double | outerEta () const |
pseudorapidity of the momentum vector at the outermost hit position More... | |
const math::XYZVector & | outerMomentum () const |
momentum vector at the outermost hit position More... | |
bool | outerOk () const |
return true if the outermost hit is valid More... | |
double | outerP () const |
magnitude of momentum vector at the outermost hit position More... | |
double | outerPhi () const |
azimuthal angle of the momentum vector at the outermost hit position More... | |
const math::XYZPoint & | outerPosition () const |
position of the outermost hit More... | |
double | outerPt () const |
transverse momentum at the outermost hit position More... | |
double | outerPx () const |
x coordinate of momentum vector at the outermost hit position More... | |
double | outerPy () const |
y coordinate of momentum vector at the outermost hit position More... | |
double | outerPz () const |
z coordinate of momentum vector at the outermost hit position More... | |
double | outerRadius () const |
polar radius of the outermost hit position More... | |
CovarianceMatrix | outerStateCovariance () const |
outermost trajectory state curvilinear errors More... | |
double | outerTheta () const |
polar angle of the momentum vector at the outermost hit position More... | |
double | outerX () const |
x coordinate of the outermost hit position More... | |
double | outerY () const |
y coordinate of the outermost hit position More... | |
double | outerZ () const |
z coordinate of the outermost hit position More... | |
TrackingRecHitRef | recHit (size_t i) const |
Get i-th hit on the track. More... | |
auto | recHits () const |
Access to reconstructed hits on the track. More... | |
trackingRecHit_iterator | recHitsBegin () const |
Iterator to first hit on the track. More... | |
trackingRecHit_iterator | recHitsEnd () const |
Iterator to last hit on the track. More... | |
size_t | recHitsSize () const |
Get number of RecHits. (Warning, this includes invalid hits, which are not physical hits). More... | |
const TrackResiduals & | residuals () const |
get the residuals More... | |
const PropagationDirection & | seedDirection () const |
direction of how the hits were sorted in the original seed More... | |
const edm::RefToBase< TrajectorySeed > & | seedRef () const |
void | setExtra (const TrackExtraRef &ref) |
set reference to "extra" object More... | |
Track () | |
default constructor More... | |
Track (double chi2, double ndof, const Point &referencePoint, const Vector &momentum, int charge, const CovarianceMatrix &, TrackAlgorithm=undefAlgorithm, TrackQuality quality=undefQuality, float t0=0, float beta=0, float covt0t0=-1., float covbetabeta=-1.) | |
constructor from fit parameters and error matrix More... | |
~Track () override | |
virtual destructor More... | |
Public Member Functions inherited from reco::TrackBase | |
TrackAlgorithm | algo () const |
AlgoMask | algoMask () const |
unsigned long long | algoMaskUL () const |
std::string | algoName () const |
bool | appendHitPattern (const TrackingRecHit &hit, const TrackerTopology &ttopo) |
append a single hit to the HitPattern More... | |
bool | appendHitPattern (const DetId &id, TrackingRecHit::Type hitType, const TrackerTopology &ttopo) |
bool | appendHitPattern (const uint16_t pattern, TrackingRecHit::Type hitType) |
template<typename C > | |
bool | appendHits (const C &c, const TrackerTopology &ttopo) |
append hit patterns from vector of hit references More... | |
template<typename I > | |
bool | appendHits (const I &begin, const I &end, const TrackerTopology &ttopo) |
bool | appendMuonHitPattern (const DetId &id, TrackingRecHit::Type hitType) |
bool | appendTrackerHitPattern (uint16_t subdet, uint16_t layer, uint16_t stereo, TrackingRecHit::Type hitType) |
double | beta () const |
velocity at the reference point in natural units More... | |
double | betaError () const |
error on beta More... | |
int | charge () const |
track electric charge More... | |
double | chi2 () const |
chi-squared of the fit More... | |
CovarianceMatrix | covariance () const |
return track covariance matrix More... | |
double | covariance (int i, int j) const |
(i,j)-th element of covariance matrix (i, j = 0, ... 4) More... | |
double | covBetaBeta () const |
error on beta More... | |
double | covt0t0 () const |
error on t0 More... | |
double | d0 () const |
dxy parameter in perigee convention (d0 = -dxy) More... | |
double | d0Error () const |
error on d0 More... | |
double | dsz () const |
dsz parameter (THIS IS NOT the SZ impact parameter to (0,0,0) if refPoint is far from (0,0,0): see parametrization definition above for details) More... | |
double | dsz (const Point &myBeamSpot) const |
dsz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the distance in the S-Z plane to the beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dszError () const |
error on dsz More... | |
double | dxy () const |
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close to (0,0,0): see parametrization definition above for details). See also function dxy(myBeamSpot). More... | |
double | dxy (const Point &myBeamSpot) const |
dxy parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dxy (const BeamSpot &theBeamSpot) const |
dxy parameter with respect to the beamSpot taking into account the beamspot slopes (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dxyError () const |
error on dxy More... | |
double | dz () const |
dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to (0,0,0). See also function dz(myBeamSpot) More... | |
double | dz (const Point &myBeamSpot) const |
dz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the track z0, if the beamSpot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dzError () const |
error on dz More... | |
double | error (int i) const |
error on specified element More... | |
double | eta () const |
pseudorapidity of momentum vector More... | |
double | etaError () const |
error on eta More... | |
CovarianceMatrix & | fill (CovarianceMatrix &v) const |
fill SMatrix More... | |
const HitPattern & | hitPattern () const |
Access the hit pattern, indicating in which Tracker layers the track has hits. More... | |
bool | isAlgoInMask (TrackAlgorithm a) const |
bool | isLooper () const |
bool | isTimeOk () const |
return true if timing measurement is usable More... | |
double | lambda () const |
Lambda angle. More... | |
double | lambdaError () const |
error on lambda More... | |
const Vector & | momentum () const |
track momentum vector More... | |
double | ndof () const |
number of degrees of freedom of the fit More... | |
signed char | nLoops () const |
double | normalizedChi2 () const |
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero) More... | |
unsigned short | numberOfLostHits () const |
number of cases where track crossed a layer without getting a hit. More... | |
unsigned short | numberOfValidHits () const |
number of valid hits found More... | |
TrackAlgorithm | originalAlgo () const |
double | p () const |
momentum vector magnitude More... | |
double | parameter (int i) const |
i-th parameter ( i = 0, ... 4 ) More... | |
ParameterVector | parameters () const |
Track parameters with one-to-one correspondence to the covariance matrix. More... | |
double | phi () const |
azimuthal angle of momentum vector More... | |
double | phiError () const |
error on phi More... | |
double | pt () const |
track transverse momentum More... | |
double | ptError () const |
error on Pt (set to 1000 TeV if charge==0 for safety) More... | |
double | px () const |
x coordinate of momentum vector More... | |
double | py () const |
y coordinate of momentum vector More... | |
double | pz () const |
z coordinate of momentum vector More... | |
double | qoverp () const |
q / p More... | |
double | qoverpError () const |
error on signed transverse curvature More... | |
bool | quality (const TrackQuality) const |
Track quality. More... | |
int | qualityMask () const |
const Point & | referencePoint () const |
Reference point on the track. More... | |
void | resetHitPattern () |
Sets HitPattern as empty. More... | |
void | setAlgoMask (AlgoMask a) |
void | setAlgorithm (const TrackAlgorithm a) |
Track algorithm. More... | |
void | setNLoops (signed char value) |
void | setOriginalAlgorithm (const TrackAlgorithm a) |
void | setQuality (const TrackQuality) |
void | setQualityMask (int qualMask) |
void | setStopReason (uint8_t value) |
uint8_t | stopReason () const |
double | t0 () const |
time at the reference point More... | |
double | t0Error () const |
error on t0 More... | |
double | theta () const |
polar angle More... | |
double | thetaError () const |
error on theta More... | |
TrackBase () | |
default constructor More... | |
TrackBase (double chi2, double ndof, const Point &vertex, const Vector &momentum, int charge, const CovarianceMatrix &cov, TrackAlgorithm=undefAlgorithm, TrackQuality quality=undefQuality, signed char nloops=0, uint8_t stopReason=0, float t0=0.f, float beta=0.f, float covt0t0=-1.f, float covbetabeta=-1.f) | |
constructor from fit parameters and error matrix More... | |
double | validFraction () const |
fraction of valid hits on the track More... | |
const Point & | vertex () const |
reference point on the track. This method is DEPRECATED, please use referencePoint() instead More... | |
double | vx () const |
x coordinate of the reference point on track More... | |
double | vy () const |
y coordinate of the reference point on track More... | |
double | vz () const |
z coordinate of the reference point on track More... | |
virtual | ~TrackBase () |
virtual destructor More... | |
Public Member Functions inherited from reco::BasicTransientTrack | |
virtual CandidatePtr | candidate () const |
virtual | ~BasicTransientTrack () |
Private Member Functions | |
void | calculateTSOSAtVertex () const |
void | init () |
Definition at line 19 of file GsfTransientTrack.h.
GsfTransientTrack::GsfTransientTrack | ( | ) |
Definition at line 15 of file GsfTransientTrack.cc.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrack & | tk, |
const MagneticField * | field | ||
) |
Definition at line 21 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrack & | tk, |
const double | time, | ||
const double | dtime, | ||
const MagneticField * | field | ||
) |
Definition at line 31 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrackRef & | tk, |
const MagneticField * | field | ||
) |
Definition at line 44 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrackRef & | tk, |
const double | time, | ||
const double | dtime, | ||
const MagneticField * | field | ||
) |
Definition at line 55 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrackRef & | tk, |
const MagneticField * | field, | ||
const edm::ESHandle< GlobalTrackingGeometry > & | trackingGeometry | ||
) |
Definition at line 96 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrackRef & | tk, |
const double | time, | ||
const double | dtime, | ||
const MagneticField * | field, | ||
const edm::ESHandle< GlobalTrackingGeometry > & | trackingGeometry | ||
) |
Definition at line 108 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrack & | tk, |
const MagneticField * | field, | ||
const edm::ESHandle< GlobalTrackingGeometry > & | trackingGeometry | ||
) |
Definition at line 69 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTrack & | tk, |
const double | time, | ||
const double | dtime, | ||
const MagneticField * | field, | ||
const edm::ESHandle< GlobalTrackingGeometry > & | trackingGeometry | ||
) |
Definition at line 81 of file GsfTransientTrack.cc.
References trajectoryStateTransform::initialFreeState(), and initialFTS.
GsfTransientTrack::GsfTransientTrack | ( | const GsfTransientTrack & | tt | ) |
Definition at line 123 of file GsfTransientTrack.cc.
References impactPointState(), impactPointTSCP(), initialTSCP, initialTSCPAvailable, initialTSOS, and initialTSOSAvailable.
|
private |
Definition at line 190 of file GsfTransientTrack.cc.
References TransverseImpactPointExtrapolator::extrapolate(), initialFTS, initialTSOS, initialTSOSAvailable, FreeTrajectoryState::position(), and theField.
Referenced by dtErrorExt(), and impactPointState().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 88 of file GsfTransientTrack.h.
References reco::TrackBase::charge().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 98 of file GsfTransientTrack.h.
References calculateTSOSAtVertex(), dtErrorExt_, hasTime, and init().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 90 of file GsfTransientTrack.h.
References theField.
|
overridevirtual |
The TSOS at the initial state, made from the stored singl-component state.
Implements reco::BasicTransientTrack.
Definition at line 163 of file GsfTransientTrack.cc.
References calculateTSOSAtVertex(), initialTSOS, and initialTSOSAvailable.
Referenced by GsfTransientTrack(), and initialFreeState().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 79 of file GsfTransientTrack.h.
References initialTSOSAvailable.
|
overridevirtual |
The TrajectoryStateClosestToPoint at the initial state, made from the stored singl-component state.
Implements reco::BasicTransientTrack.
Definition at line 169 of file GsfTransientTrack.cc.
References builder, initialFTS, initialTSCP, initialTSCPAvailable, and FreeTrajectoryState::position().
Referenced by GsfTransientTrack(), and initialFreeState().
|
private |
Referenced by dtErrorExt().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 47 of file GsfTransientTrack.h.
References impactPointState(), impactPointTSCP(), initialFTS, innermostMeasurementState(), outermostMeasurementState(), point, stateOnSurface(), and trajectoryStateClosestToPoint().
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 184 of file GsfTransientTrack.cc.
References MultiTrajectoryStateTransform::innerStateOnSurface(), theField, and theTrackingGeometry.
Referenced by initialFreeState(), and stateOnSurface().
GsfTransientTrack& reco::GsfTransientTrack::operator= | ( | const GsfTransientTrack & | tt | ) |
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 178 of file GsfTransientTrack.cc.
References MultiTrajectoryStateTransform::outerStateOnSurface(), theField, and theTrackingGeometry.
Referenced by initialFreeState().
|
inline |
access to original persistent track
Definition at line 84 of file GsfTransientTrack.h.
References tkr_.
Referenced by KinematicVertex::operator reco::Vertex().
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 156 of file GsfTransientTrack.cc.
References ecalDrivenElectronSeedsParameters_cff::beamSpot, blStateAvailable, and theBeamSpot.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 144 of file GsfTransientTrack.cc.
References edm::EventSetup::get(), and theTrackingGeometry.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 150 of file GsfTransientTrack.cc.
References theTrackingGeometry.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 210 of file GsfTransientTrack.cc.
References blStateAvailable, initialFTS, theBeamSpot, and trajectoryStateClosestToBeamLine.
Referenced by track().
|
overridevirtual |
The TSOS at any point. The inner-most multi-state state will be used for the propagation. The TSOS will therefore have multiple components.
Implements reco::BasicTransientTrack.
Definition at line 198 of file GsfTransientTrack.cc.
References TransverseImpactPointExtrapolator::extrapolate(), innermostMeasurementState(), and theTIPExtrapolator.
Referenced by initialFreeState(), and trajectoryStateClosestToPoint().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 96 of file GsfTransientTrack.h.
References hasTime, and timeExt_.
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 92 of file GsfTransientTrack.h.
References stateAtBeamLine().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 86 of file GsfTransientTrack.h.
References tkr_.
|
overridevirtual |
The TrajectoryStateClosestToPoint at any point. The inner-most multi-state state will be used for the propagation. The TSCP will be built out of the collapsed mult-component TSOS.
Implements reco::BasicTransientTrack.
Definition at line 205 of file GsfTransientTrack.cc.
References builder, and stateOnSurface().
Referenced by initialFreeState().
|
mutableprivate |
Definition at line 111 of file GsfTransientTrack.h.
Referenced by setBeamSpot(), and stateAtBeamLine().
|
private |
Definition at line 114 of file GsfTransientTrack.h.
Referenced by impactPointTSCP(), and trajectoryStateClosestToPoint().
|
private |
Definition at line 107 of file GsfTransientTrack.h.
Referenced by dtErrorExt().
|
private |
Definition at line 106 of file GsfTransientTrack.h.
Referenced by dtErrorExt(), and timeExt().
|
private |
Definition at line 110 of file GsfTransientTrack.h.
Referenced by calculateTSOSAtVertex(), GsfTransientTrack(), impactPointTSCP(), initialFreeState(), and stateAtBeamLine().
|
mutableprivate |
Definition at line 113 of file GsfTransientTrack.h.
Referenced by GsfTransientTrack(), and impactPointTSCP().
|
mutableprivate |
Definition at line 111 of file GsfTransientTrack.h.
Referenced by GsfTransientTrack(), and impactPointTSCP().
|
mutableprivate |
Definition at line 112 of file GsfTransientTrack.h.
Referenced by calculateTSOSAtVertex(), GsfTransientTrack(), and impactPointState().
|
mutableprivate |
Definition at line 111 of file GsfTransientTrack.h.
Referenced by calculateTSOSAtVertex(), GsfTransientTrack(), impactPointState(), and impactPointStateAvailable().
|
private |
Definition at line 116 of file GsfTransientTrack.h.
Referenced by setBeamSpot(), and stateAtBeamLine().
|
private |
Definition at line 108 of file GsfTransientTrack.h.
Referenced by calculateTSOSAtVertex(), field(), innermostMeasurementState(), and outermostMeasurementState().
|
private |
Definition at line 119 of file GsfTransientTrack.h.
Referenced by stateOnSurface().
|
private |
Definition at line 115 of file GsfTransientTrack.h.
Referenced by innermostMeasurementState(), outermostMeasurementState(), setES(), and setTrackingGeometry().
|
private |
Definition at line 107 of file GsfTransientTrack.h.
Referenced by timeExt().
|
private |
Definition at line 105 of file GsfTransientTrack.h.
Referenced by persistentTrackRef(), and trackBaseRef().
|
mutableprivate |
Definition at line 117 of file GsfTransientTrack.h.
Referenced by stateAtBeamLine().