#include <CandidatePtrTransientTrack.h>
Public Member Functions | |
CandidatePtr | candidate () const override |
CandidatePtrTransientTrack () | |
CandidatePtrTransientTrack (const CandidatePtr &tk, const MagneticField *field) | |
CandidatePtrTransientTrack (const CandidatePtr &tk, const double time, const double dtime, const MagneticField *field) | |
CandidatePtrTransientTrack (const CandidatePtr &tk, const MagneticField *field, const edm::ESHandle< GlobalTrackingGeometry > &trackingGeometry) | |
CandidatePtrTransientTrack (const CandidatePtr &tk, const double time, const double dtime, const MagneticField *field, const edm::ESHandle< GlobalTrackingGeometry > &trackingGeometry) | |
CandidatePtrTransientTrack (const CandidatePtrTransientTrack &tt) | |
TrackCharge | charge () const override |
double | dtErrorExt () const override |
const MagneticField * | field () const override |
TrajectoryStateOnSurface | impactPointState () const override |
bool | impactPointStateAvailable () const override |
TrajectoryStateClosestToPoint | impactPointTSCP () const override |
FreeTrajectoryState | initialFreeState () const override |
TrajectoryStateOnSurface | innermostMeasurementState () const override |
CandidatePtrTransientTrack & | operator= (const CandidatePtrTransientTrack &tt) |
TrajectoryStateOnSurface | outermostMeasurementState () const override |
TrackRef | 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::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 | dxyError (Point const &vtx, math::Error< 3 >::type const &vertexCov) const |
error on dxy with respect to a user-given reference point + uncertainty (i.e. reco::Vertex position) More... | |
double | dxyError (const BeamSpot &theBeamSpot) const |
error on dxy with respect to a user-given beamspot 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 | ~BasicTransientTrack () |
Private Types | |
enum | CacheStates { kUnset, kSetting, kSet } |
Private Attributes | |
TSCPBuilderNoMaterial | builder |
double | dtErrorExt_ |
bool | hasTime |
FreeTrajectoryState | initialFTS |
TrajectoryStateClosestToPoint | initialTSCP |
TrajectoryStateOnSurface | initialTSOS |
std::atomic< char > | m_SCTBL |
std::atomic< char > | m_TSCP |
std::atomic< char > | m_TSOS |
CandidatePtr | ptr_ |
reco::BeamSpot | theBeamSpot |
const MagneticField * | theField |
edm::ESHandle< GlobalTrackingGeometry > | theTrackingGeometry |
double | timeExt_ |
TrajectoryStateClosestToBeamLine | trajectoryStateClosestToBeamLine |
Definition at line 19 of file CandidatePtrTransientTrack.h.
|
private |
Enumerator | |
---|---|
kUnset | |
kSetting | |
kSet |
Definition at line 106 of file CandidatePtrTransientTrack.h.
CandidatePtrTransientTrack::CandidatePtrTransientTrack | ( | ) |
Definition at line 23 of file CandidatePtrTransientTrack.cc.
CandidatePtrTransientTrack::CandidatePtrTransientTrack | ( | const CandidatePtr & | tk, |
const MagneticField * | field | ||
) |
Definition at line 29 of file CandidatePtrTransientTrack.cc.
References reco::Candidate::bestTrack(), field(), trajectoryStateTransform::initialFreeState(), and initialFTS.
CandidatePtrTransientTrack::CandidatePtrTransientTrack | ( | const CandidatePtr & | tk, |
const double | time, | ||
const double | dtime, | ||
const MagneticField * | field | ||
) |
Definition at line 36 of file CandidatePtrTransientTrack.cc.
References reco::Candidate::bestTrack(), field(), trajectoryStateTransform::initialFreeState(), and initialFTS.
CandidatePtrTransientTrack::CandidatePtrTransientTrack | ( | const CandidatePtr & | tk, |
const MagneticField * | field, | ||
const edm::ESHandle< GlobalTrackingGeometry > & | trackingGeometry | ||
) |
Definition at line 43 of file CandidatePtrTransientTrack.cc.
References reco::Candidate::bestTrack(), field(), trajectoryStateTransform::initialFreeState(), and initialFTS.
CandidatePtrTransientTrack::CandidatePtrTransientTrack | ( | const CandidatePtr & | tk, |
const double | time, | ||
const double | dtime, | ||
const MagneticField * | field, | ||
const edm::ESHandle< GlobalTrackingGeometry > & | trackingGeometry | ||
) |
Definition at line 50 of file CandidatePtrTransientTrack.cc.
References reco::Candidate::bestTrack(), field(), trajectoryStateTransform::initialFreeState(), and initialFTS.
CandidatePtrTransientTrack::CandidatePtrTransientTrack | ( | const CandidatePtrTransientTrack & | tt | ) |
Definition at line 58 of file CandidatePtrTransientTrack.cc.
References impactPointState(), impactPointTSCP(), initialTSCP, initialTSOS, kSet, m_TSCP, and m_TSOS.
|
inlineoverridevirtual |
Reimplemented from reco::BasicTransientTrack.
Definition at line 71 of file CandidatePtrTransientTrack.h.
References ptr_.
Referenced by TransientVertex::operator reco::VertexCompositePtrCandidate(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), and trackWeight().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 69 of file CandidatePtrTransientTrack.h.
References reco::TrackBase::charge().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 80 of file CandidatePtrTransientTrack.h.
References dtErrorExt_, and hasTime.
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 73 of file CandidatePtrTransientTrack.h.
References theField.
Referenced by CandidatePtrTransientTrack().
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 95 of file CandidatePtrTransientTrack.cc.
References TransverseImpactPointExtrapolator::extrapolate(), initialFTS, initialTSOS, kSet, kSetting, kUnset, m_TSOS, FreeTrajectoryState::position(), theField, and tmp.
Referenced by CandidatePtrTransientTrack(), and trajectoryStateClosestToPoint().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 60 of file CandidatePtrTransientTrack.h.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 110 of file CandidatePtrTransientTrack.cc.
References builder, initialFTS, initialTSCP, kSet, kSetting, kUnset, m_TSCP, FreeTrajectoryState::position(), and tmp.
Referenced by CandidatePtrTransientTrack(), and trajectoryStateClosestToPoint().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 41 of file CandidatePtrTransientTrack.h.
References initialFTS, innermostMeasurementState(), and outermostMeasurementState().
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 130 of file CandidatePtrTransientTrack.cc.
References trajectoryStateTransform::innerStateOnSurface(), theField, and theTrackingGeometry.
Referenced by initialFreeState().
CandidatePtrTransientTrack& reco::CandidatePtrTransientTrack::operator= | ( | const CandidatePtrTransientTrack & | tt | ) |
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 124 of file CandidatePtrTransientTrack.cc.
References trajectoryStateTransform::outerStateOnSurface(), theField, and theTrackingGeometry.
Referenced by initialFreeState().
|
inline |
access to original persistent track
Definition at line 65 of file CandidatePtrTransientTrack.h.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 89 of file CandidatePtrTransientTrack.cc.
References ecalDrivenElectronSeedsParameters_cff::beamSpot, kUnset, m_SCTBL, and theBeamSpot.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 77 of file CandidatePtrTransientTrack.cc.
References edm::EventSetup::get(), and theTrackingGeometry.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 83 of file CandidatePtrTransientTrack.cc.
References theTrackingGeometry.
|
overridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 143 of file CandidatePtrTransientTrack.cc.
References initialFTS, kSet, kSetting, kUnset, m_SCTBL, theBeamSpot, tmp, and trajectoryStateClosestToBeamLine.
Referenced by track().
|
overridevirtual |
The TSOS at any point. The initial state will be used for the propagation.
Implements reco::BasicTransientTrack.
Definition at line 137 of file CandidatePtrTransientTrack.cc.
References TransverseImpactPointExtrapolator::extrapolate(), initialFTS, and theField.
Referenced by trajectoryStateClosestToPoint().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 79 of file CandidatePtrTransientTrack.h.
References hasTime, and timeExt_.
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 75 of file CandidatePtrTransientTrack.h.
References stateAtBeamLine().
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 67 of file CandidatePtrTransientTrack.h.
|
inlineoverridevirtual |
Implements reco::BasicTransientTrack.
Definition at line 48 of file CandidatePtrTransientTrack.h.
References builder, impactPointState(), impactPointTSCP(), initialFTS, point, and stateOnSurface().
|
private |
Definition at line 101 of file CandidatePtrTransientTrack.h.
Referenced by impactPointTSCP(), and trajectoryStateClosestToPoint().
|
private |
Definition at line 86 of file CandidatePtrTransientTrack.h.
Referenced by dtErrorExt().
|
private |
Definition at line 85 of file CandidatePtrTransientTrack.h.
Referenced by dtErrorExt(), and timeExt().
|
private |
Definition at line 89 of file CandidatePtrTransientTrack.h.
Referenced by CandidatePtrTransientTrack(), impactPointState(), impactPointTSCP(), initialFreeState(), stateAtBeamLine(), stateOnSurface(), and trajectoryStateClosestToPoint().
|
mutableprivate |
Definition at line 94 of file CandidatePtrTransientTrack.h.
Referenced by CandidatePtrTransientTrack(), and impactPointTSCP().
|
mutableprivate |
Definition at line 93 of file CandidatePtrTransientTrack.h.
Referenced by CandidatePtrTransientTrack(), and impactPointState().
|
mutableprivate |
Definition at line 99 of file CandidatePtrTransientTrack.h.
Referenced by setBeamSpot(), and stateAtBeamLine().
|
mutableprivate |
Definition at line 98 of file CandidatePtrTransientTrack.h.
Referenced by CandidatePtrTransientTrack(), and impactPointTSCP().
|
mutableprivate |
Definition at line 97 of file CandidatePtrTransientTrack.h.
Referenced by CandidatePtrTransientTrack(), impactPointState(), and impactPointStateAvailable().
|
private |
Definition at line 84 of file CandidatePtrTransientTrack.h.
Referenced by candidate().
|
private |
Definition at line 103 of file CandidatePtrTransientTrack.h.
Referenced by setBeamSpot(), and stateAtBeamLine().
|
private |
Definition at line 87 of file CandidatePtrTransientTrack.h.
Referenced by field(), impactPointState(), innermostMeasurementState(), outermostMeasurementState(), and stateOnSurface().
|
private |
Definition at line 102 of file CandidatePtrTransientTrack.h.
Referenced by innermostMeasurementState(), outermostMeasurementState(), setES(), and setTrackingGeometry().
|
private |
Definition at line 86 of file CandidatePtrTransientTrack.h.
Referenced by timeExt().
|
mutableprivate |
Definition at line 95 of file CandidatePtrTransientTrack.h.
Referenced by stateAtBeamLine().