#include <DataFormats/TrackReco/interface/TrackBase.h>
Public Member Functions | |
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) |
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) |
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 | 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 |
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 | 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) | |
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... | |
Static Public Member Functions | |
static TrackAlgorithm | algoByName (const std::string &name) |
static std::string | algoName (TrackAlgorithm) |
static index | covIndex (index i, index j) |
covariance matrix index in array More... | |
static TrackQuality | qualityByName (const std::string &name) |
static std::string | qualityName (TrackQuality) |
Static Public Attributes | |
static const std::string | algoNames [] |
static const std::string | qualityNames [] |
Private Attributes | |
std::bitset< algoSize > | algoMask_ |
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping by the listmerger More... | |
uint8_t | algorithm_ |
track algorithm More... | |
char | charge_ |
electric charge More... | |
float | chi2_ |
chi-squared More... | |
float | covariance_ [covarianceSize] |
perigee 5x5 covariance matrix More... | |
HitPattern | hitPattern_ |
hit pattern More... | |
Vector | momentum_ |
momentum vector at innermost point More... | |
float | ndof_ |
number of degrees of freedom More... | |
signed char | nLoops_ |
number of loops made during the building of the trajectory of a looper particle More... | |
uint8_t | originalAlgorithm_ |
track algorithm More... | |
uint8_t | quality_ |
track quality More... | |
uint8_t | stopReason_ |
Stop Reason. More... | |
Point | vertex_ |
innermost (reference) point on track More... | |
Common base class to all track types, including Muon fits. Internally, the following information is stored:
A reference position on the track: (vx,vy,vz)
Momentum at this given reference point on track: (px,py,pz)
5D curvilinear covariance matrix from the track fit
Charge
Chi-square and number of degrees of freedom
Summary information of the hit pattern
For tracks reconstructed in the CMS Tracker, the reference position is the point of closest approach to the centre of CMS. For muons, this is not necessarily true.
Parameters associated to the 5D curvilinear covariance matrix:
(qoverp, lambda, phi, dxy, dsz)
defined as:
qoverp = q / abs(p) = signed inverse of momentum [1/GeV]
lambda = pi/2 - polar angle at the given point
phi = azimuth angle at the given point
dxy = -vx*sin(phi) + vy*cos(phi) [cm]
dsz = vz*cos(lambda) - (vx*cos(phi)+vy*sin(phi))*sin(lambda) [cm]
Geometrically, dxy is the signed distance in the XY plane between the the straight line passing through (vx,vy) with azimuthal angle phi and the point (0,0).
The dsz parameter is the signed distance in the SZ plane between the the straight line passing through (vx,vy,vz) with angles (phi, lambda) and the point (s=0,z=0). The S axis is defined by the projection of the straight line onto the XY plane. The convention is to assign the S coordinate for (vx,vy) as the value vx*cos(phi)+vy*sin(phi). This value is zero when (vx,vy) is the point of minimum transverse distance to (0,0).
Note that dxy and dsz provide sensible estimates of the distance from the true particle trajectory to (0,0,0) ONLY in two cases:
When (vx,vy,vz) already correspond to the point of minimum transverse distance to (0,0,0) or is close to it (so that the differences between considering the exact trajectory or a straight line in this range are negligible). This is usually true for Tracker tracks.
When the track has infinite or extremely high momentum
More details about this parametrization are provided in the following document:
A. Strandlie, W. Wittek, "Propagation of Covariance Matrices...", CMS Note 2006/001
Definition at line 63 of file TrackBase.h.
typedef std::bitset<algoSize> reco::TrackBase::AlgoMask |
algo mask
Definition at line 146 of file TrackBase.h.
5 parameter covariance matrix
Definition at line 77 of file TrackBase.h.
typedef unsigned int reco::TrackBase::index |
index type
Definition at line 95 of file TrackBase.h.
parameter vector
Definition at line 74 of file TrackBase.h.
typedef math::XYZPoint reco::TrackBase::Point |
point in the space
Definition at line 83 of file TrackBase.h.
spatial vector
Definition at line 80 of file TrackBase.h.
anonymous enum |
anonymous enum |
anonymous enum |
enumerator provided indices to the five parameters
Enumerator | |
---|---|
i_qoverp | |
i_lambda | |
i_phi | |
i_dxy | |
i_dsz |
Definition at line 86 of file TrackBase.h.
track algorithm
Definition at line 99 of file TrackBase.h.
track quality
Enumerator | |
---|---|
undefQuality | |
loose | |
tight | |
highPurity | |
confirmed | |
goodIterative | |
looseSetWithPV | |
highPuritySetWithPV | |
discarded | |
qualitySize |
Definition at line 151 of file TrackBase.h.
TrackBase::TrackBase | ( | ) |
default constructor
Definition at line 69 of file TrackBase.cc.
References algoMask_, algorithm_, covariance_, dimension, i, customizeTrackingMonitorSeedNumber::idx, and j.
TrackBase::TrackBase | ( | double | chi2, |
double | ndof, | ||
const Point & | vertex, | ||
const Vector & | momentum, | ||
int | charge, | ||
const CovarianceMatrix & | cov, | ||
TrackAlgorithm | algorithm = undefAlgorithm , |
||
TrackQuality | quality = undefQuality , |
||
signed char | nloops = 0 , |
||
uint8_t | stopReason = 0 |
||
) |
constructor from fit parameters and error matrix
Definition at line 90 of file TrackBase.cc.
References algoMask_, algorithm_, covariance_, dimension, i, customizeTrackingMonitorSeedNumber::idx, j, and setQuality().
|
virtual |
|
inline |
Definition at line 492 of file TrackBase.h.
Referenced by RecoTrackSelectorBase::operator()(), and PrintRecoObjects::print().
|
static |
Definition at line 137 of file TrackBase.cc.
References algoNames, algoSize, spr::find(), findQualityFiles::size, and undefAlgorithm.
Referenced by RecoTrackSelectorBase::RecoTrackSelectorBase().
|
inline |
Definition at line 363 of file TrackBase.h.
Referenced by RecoTrackSelectorBase::operator()(), and BadGlobalMuonTagger::outInOnly().
|
inline |
Definition at line 364 of file TrackBase.h.
|
inline |
Definition at line 503 of file TrackBase.h.
|
inlinestatic |
Definition at line 535 of file TrackBase.h.
|
inline |
append a single hit to the HitPattern
Definition at line 455 of file TrackBase.h.
Referenced by PixelTrackProducer::store().
|
inline |
Definition at line 450 of file TrackBase.h.
bool reco::TrackBase::appendHits | ( | const C & | c, |
const TrackerTopology & | ttopo | ||
) |
append hit patterns from vector of hit references
Definition at line 480 of file TrackBase.h.
bool reco::TrackBase::appendHits | ( | const I & | begin, |
const I & | end, | ||
const TrackerTopology & | ttopo | ||
) |
Definition at line 474 of file TrackBase.h.
|
inline |
This is meant to be used only in cases where the an already-packed hit information is re-interpreted in terms of HitPattern (i.e. the IO rule for reading old versions of HitPattern)
Definition at line 464 of file TrackBase.h.
|
inline |
This is meant to be used only in cases where the an already-packed hit information is re-interpreted in terms of HitPattern (i.e. MiniAOD PackedCandidate, and the IO rule for reading old versions of HitPattern)
Definition at line 460 of file TrackBase.h.
|
inline |
track electric charge
Definition at line 562 of file TrackBase.h.
Referenced by FWSecVertexProxyBuilder::build(), reco::CandidatePtrTransientTrack::charge(), reco::TrackTransientTrack::charge(), reco::GsfTransientTrack::charge(), converter::TrackToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), VZeroFinder::getGlobalTrajectoryParameters(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), trajectoryStateTransform::innerFreeState(), trajectoryStateTransform::outerFreeState(), PrintRecoObjects::print(), PFDisplacedTrackerVertexProducer::produce(), and TrackExtrapolator::propagateTrackToVolume().
|
inline |
chi-squared of the fit
Definition at line 544 of file TrackBase.h.
Referenced by reco::TransientTrack::chi2(), reco::TransientTrack::normalizedChi2(), HIPixelTrackFilter::operator()(), and HIProtoTrackFilter::operator()().
|
inline |
return track covariance matrix
Definition at line 726 of file TrackBase.h.
Referenced by SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), and reco::print().
|
inline |
(i,j)-th element of covariance matrix (i, j = 0, ... 4)
Definition at line 740 of file TrackBase.h.
|
inlinestatic |
covariance matrix index in array
Definition at line 485 of file TrackBase.h.
Referenced by reco::GsfTrack::covarianceMode(), and reco::GsfTrack::errorMode().
|
inline |
dxy parameter in perigee convention (d0 = -dxy)
Definition at line 592 of file TrackBase.h.
Referenced by AlignmentMonitorGeneric::event(), and TrackWithVertexSelector::testTrack().
|
inline |
error on d0
Definition at line 797 of file TrackBase.h.
Referenced by HIPixelTrackFilter::operator()().
|
inline |
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)
Definition at line 598 of file TrackBase.h.
Referenced by RecoTrackSelectorBase::operator()(), and RecoTracktoTP::r_dsz().
|
inline |
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.
Definition at line 706 of file TrackBase.h.
|
inline |
error on dsz
Definition at line 803 of file TrackBase.h.
|
inline |
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).
Definition at line 586 of file TrackBase.h.
Referenced by PrimaryVertexAssignment::chargedHadronVertex(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), spr::goodTrack(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), RecoTrackSelectorBase::operator()(), PrintRecoObjects::print(), RecoTracktoTP::r_d02(), RecoTracktoTP::r_dxy(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), and TrackWithVertexSelector::testVertices().
|
inline |
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.
Definition at line 690 of file TrackBase.h.
|
inline |
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.
Definition at line 698 of file TrackBase.h.
|
inline |
error on dxy
Definition at line 791 of file TrackBase.h.
Referenced by PrimaryVertexAssignment::chargedHadronVertex(), reco::RecoChargedRefCandidate::dxyError(), reco::RecoCandidate::dxyError(), and pf2pat::IPCutPFCandidateSelectorDefinition::select().
|
inline |
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)
Definition at line 604 of file TrackBase.h.
Referenced by PrimaryVertexAssignment::chargedHadronVertex(), AlignmentMonitorGeneric::event(), spr::goodTrack(), HIPixelTrackFilter::operator()(), JetTracksAssociationDRVertexAssigned::produce(), RecoTracktoTP::r_dz(), RecoTracktoTP::r_dz2(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), TrackWithVertexSelector::testTrack(), and TrackWithVertexSelector::testVertices().
|
inline |
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.
Definition at line 714 of file TrackBase.h.
|
inline |
error on dz
Definition at line 809 of file TrackBase.h.
Referenced by reco::RecoChargedRefCandidate::dzError(), reco::RecoCandidate::dzError(), HIPixelTrackFilter::operator()(), and pf2pat::IPCutPFCandidateSelectorDefinition::select().
|
inline |
error on specified element
Definition at line 746 of file TrackBase.h.
|
inline |
pseudorapidity of momentum vector
Definition at line 646 of file TrackBase.h.
Referenced by Particle.Particle::__str__(), FWTrackProxyBuilder::build(), pat::CaloIsolationEnergy::calculate(), muonisolation::ExtractorFromDeposits::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), AlignmentMonitorGeneric::event(), MuonAlignmentPreFilter::filter(), TrackClassFilter::operator()(), RecoTrackSelectorBase::operator()(), examples::TrackAnalysisAlgorithm::process(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), L3MuonIsolationProducer::produce(), CutsIsolatorWithCorrection::result(), SimpleCutsIsolator::result(), TrackWithVertexSelector::testTrack(), muonisolation::PixelTrackExtractor::vetos(), and muonisolation::TrackExtractor::vetos().
|
inline |
error on eta
Definition at line 779 of file TrackBase.h.
TrackBase::CovarianceMatrix & TrackBase::fill | ( | CovarianceMatrix & | v | ) | const |
fill SMatrix
Definition at line 120 of file TrackBase.cc.
References covariance_, and reco::fillCovariance().
|
inline |
Access the hit pattern, indicating in which Tracker layers the track has hits.
Definition at line 445 of file TrackBase.h.
Referenced by spr::goodTrack(), reco::TransientTrack::hitPattern(), HLTTrackWithHits::hltFilter(), reco::TransientTrack::numberOfLostHits(), reco::TransientTrack::numberOfValidHits(), TrackClassFilter::operator()(), RecoTrackSelectorBase::operator()(), FastTrackerRecHitMaskProducer::produce(), reco::Track::residualX(), reco::Track::residualY(), TrackWithVertexSelector::testTrack(), and reco::TrackSelector::trackSelection().
|
inline |
Definition at line 365 of file TrackBase.h.
Referenced by BadGlobalMuonTagger::outInOnly().
|
inline |
Definition at line 872 of file TrackBase.h.
|
inline |
Lambda angle.
Definition at line 580 of file TrackBase.h.
|
inline |
error on lambda
Definition at line 773 of file TrackBase.h.
|
inline |
track momentum vector
Definition at line 670 of file TrackBase.h.
Referenced by converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), VZeroFinder::getGlobalTrajectoryParameters(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), reco::TrackSelector::operator()(), reco::print(), and PrintRecoObjects::print().
|
inline |
number of degrees of freedom of the fit
Definition at line 550 of file TrackBase.h.
Referenced by reco::TransientTrack::ndof(), and reco::TransientTrack::normalizedChi2().
|
inline |
Definition at line 877 of file TrackBase.h.
|
inline |
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)
Definition at line 556 of file TrackBase.h.
Referenced by helper::SimpleJetTrackAssociator::associate(), helper::SimpleJetTrackAssociator::associateTransient(), AlignmentMonitorGeneric::event(), spr::goodTrack(), TrackClassFilter::operator()(), RecoTrackSelectorBase::operator()(), TrackWithVertexSelector::testTrack(), and reco::TrackSelector::trackSelection().
|
inline |
number of cases where track crossed a layer without getting a hit.
Definition at line 821 of file TrackBase.h.
Referenced by TrackWithVertexSelector::testTrack().
|
inline |
number of valid hits found
Definition at line 815 of file TrackBase.h.
Referenced by helper::SimpleJetTrackAssociator::associate(), helper::SimpleJetTrackAssociator::associateTransient(), TrackClassFilter::operator()(), and TrackWithVertexSelector::testTrack().
|
inline |
Definition at line 496 of file TrackBase.h.
Referenced by RecoTrackSelectorBase::operator()().
|
inline |
momentum vector magnitude
Definition at line 610 of file TrackBase.h.
Referenced by pat::TrackerIsolationPt::calculate(), MuonAlignmentPreFilter::filter(), muonid::matchTracks(), TrackClassFilter::operator()(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), and reco::JetTracksAssociation::tracksP4().
|
inline |
i-th parameter ( i = 0, ... 4 )
Definition at line 734 of file TrackBase.h.
|
inline |
Track parameters with one-to-one correspondence to the covariance matrix.
Definition at line 720 of file TrackBase.h.
|
inline |
azimuthal angle of momentum vector
Definition at line 640 of file TrackBase.h.
Referenced by Particle.Particle::__str__(), pat::CaloIsolationEnergy::calculate(), muonisolation::ExtractorFromDeposits::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), AlignmentMonitorGeneric::event(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), muonisolation::PixelTrackExtractor::vetos(), and muonisolation::TrackExtractor::vetos().
|
inline |
error on phi
Definition at line 785 of file TrackBase.h.
|
inline |
track transverse momentum
Definition at line 616 of file TrackBase.h.
Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), FWTrackProxyBuilder::build(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), fw::estimate_field(), AlignmentMonitorGeneric::event(), MuonAlignmentPreFilter::filter(), spr::goodTrack(), HLTTrackWithHits::hltFilter(), muonid::matchTracks(), HIPixelTrackFilter::operator()(), HIProtoTrackFilter::operator()(), reco::TrackSelector::operator()(), CalibrationTrackSelector::ComparePt::operator()(), RecoTrackSelectorBase::operator()(), AlignmentTrackSelector::ComparePt::operator()(), examples::TrackAnalysisAlgorithm::process(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), CutsIsolatorWithCorrection::result(), and TrackWithVertexSelector::testTrack().
|
inline |
error on Pt (set to 1000 TeV if charge==0 for safety)
Definition at line 758 of file TrackBase.h.
Referenced by TrackWithVertexSelector::testTrack().
|
inline |
x coordinate of momentum vector
Definition at line 622 of file TrackBase.h.
Referenced by reco::TrackKinematics::add(), FWSecVertexProxyBuilder::build(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), fw::estimate_field(), muonid::matchTracks(), TrackExtrapolator::propagateTrackToVolume(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), and reco::JetTracksAssociation::tracksP4().
|
inline |
y coordinate of momentum vector
Definition at line 628 of file TrackBase.h.
Referenced by reco::TrackKinematics::add(), FWSecVertexProxyBuilder::build(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), fw::estimate_field(), muonid::matchTracks(), TrackExtrapolator::propagateTrackToVolume(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), and reco::JetTracksAssociation::tracksP4().
|
inline |
z coordinate of momentum vector
Definition at line 634 of file TrackBase.h.
Referenced by reco::TrackKinematics::add(), FWSecVertexProxyBuilder::build(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), muonid::matchTracks(), PixelTrackFilterByKinematics::operator()(), TrackExtrapolator::propagateTrackToVolume(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), and reco::JetTracksAssociation::tracksP4().
|
inline |
|
inline |
error on signed transverse curvature
Definition at line 752 of file TrackBase.h.
Referenced by spr::goodTrack().
|
inline |
Track quality.
Definition at line 505 of file TrackBase.h.
Referenced by TemplatedJetProbabilityComputer< Container, Base >::discriminator(), spr::goodTrack(), TrackFilterForPVFinding::operator()(), TrackClassFilter::operator()(), RecoTrackSelectorBase::operator()(), TemplatedTrackCountingComputer< Container, Base >::orderedSignificances(), FastTrackerRecHitMaskProducer::produce(), ExtraFromSeeds::produce(), TrackWithVertexSelector::testTrack(), and reco::TrackSelector::trackSelection().
|
static |
Definition at line 125 of file TrackBase.cc.
References spr::find(), qualityNames, qualitySize, findQualityFiles::size, and undefQuality.
Referenced by FilterOutScraping::filter(), TrackIsoCalculator::getBkgSubTrackIso(), TrackIsoCalculator::getTrackIso(), LightPFTrackProducer::LightPFTrackProducer(), MuonTrackCut::MuonTrackCut(), TrackClassFilter::operator()(), PromptTrackCountingComputer::PromptTrackCountingComputer(), RecoTrackSelectorBase::RecoTrackSelectorBase(), L1Analysis::L1AnalysisRecoTrack::SetTracks(), TemplatedJetProbabilityComputer< Container, Base >::TemplatedJetProbabilityComputer(), TemplatedTrackCountingComputer< Container, Base >::TemplatedTrackCountingComputer(), TrackWithVertexSelector::testTrack(), TrackExtrapolator::TrackExtrapolator(), TrackFilterForPVFinding::TrackFilterForPVFinding(), and reco::TrackSelector::TrackSelector().
|
inline |
Definition at line 857 of file TrackBase.h.
|
inlinestatic |
Definition at line 527 of file TrackBase.h.
|
inline |
Reference point on the track.
Definition at line 676 of file TrackBase.h.
Referenced by SeedFromProtoTrack::init(), and PrintRecoObjects::print().
|
inline |
Sets HitPattern as empty.
Definition at line 468 of file TrackBase.h.
|
inline |
Definition at line 361 of file TrackBase.h.
|
inline |
Track algorithm.
Definition at line 842 of file TrackBase.h.
|
inline |
Definition at line 867 of file TrackBase.h.
|
inline |
Definition at line 849 of file TrackBase.h.
|
inline |
Definition at line 518 of file TrackBase.h.
Referenced by TrackBase().
|
inline |
Definition at line 862 of file TrackBase.h.
|
inline |
Definition at line 397 of file TrackBase.h.
|
inline |
Definition at line 399 of file TrackBase.h.
|
inline |
|
inline |
error on theta
Definition at line 767 of file TrackBase.h.
|
inline |
fraction of valid hits on the track
Definition at line 827 of file TrackBase.h.
|
inline |
reference point on the track. This method is DEPRECATED, please use referencePoint() instead
Definition at line 682 of file TrackBase.h.
Referenced by converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), Tau.Tau::dxy(), VZeroFinder::getGlobalTrajectoryParameters(), ElectronTkIsolation::getIso(), trajectoryStateTransform::initialFreeState(), reco::print(), and TrackWithVertexSelector::testVertices().
|
inline |
x coordinate of the reference point on track
Definition at line 652 of file TrackBase.h.
Referenced by FWSecVertexProxyBuilder::build(), directionAlongMomentum(), fw::estimate_field(), and TrackExtrapolator::propagateTrackToVolume().
|
inline |
y coordinate of the reference point on track
Definition at line 658 of file TrackBase.h.
Referenced by FWSecVertexProxyBuilder::build(), directionAlongMomentum(), fw::estimate_field(), and TrackExtrapolator::propagateTrackToVolume().
|
inline |
z coordinate of the reference point on track
Definition at line 664 of file TrackBase.h.
Referenced by FWSecVertexProxyBuilder::build(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), ComparePairs::operator()(), and TrackExtrapolator::propagateTrackToVolume().
|
private |
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping by the listmerger
Definition at line 419 of file TrackBase.h.
Referenced by TrackBase().
|
static |
Definition at line 148 of file TrackBase.h.
Referenced by algoByName().
|
private |
|
private |
electric charge
Definition at line 425 of file TrackBase.h.
|
private |
chi-squared
Definition at line 410 of file TrackBase.h.
|
private |
perigee 5x5 covariance matrix
Definition at line 407 of file TrackBase.h.
Referenced by fill(), and TrackBase().
|
private |
hit pattern
Definition at line 404 of file TrackBase.h.
|
private |
momentum vector at innermost point
Definition at line 416 of file TrackBase.h.
|
private |
number of degrees of freedom
Definition at line 422 of file TrackBase.h.
|
private |
number of loops made during the building of the trajectory of a looper particle
Definition at line 438 of file TrackBase.h.
|
private |
track algorithm
Definition at line 431 of file TrackBase.h.
|
private |
track quality
Definition at line 435 of file TrackBase.h.
|
static |
Definition at line 164 of file TrackBase.h.
Referenced by qualityByName().
|
private |
Stop Reason.
Definition at line 441 of file TrackBase.h.
|
private |
innermost (reference) point on track
Definition at line 413 of file TrackBase.h.