#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) |
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... | |
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... | |
float | beta_ |
char | charge_ |
electric charge More... | |
float | chi2_ |
chi-squared More... | |
float | covariance_ [covarianceSize] |
perigee 5x5 covariance matrix More... | |
float | covbetabeta_ |
float | covt0t0_ |
errors for time and velocity (separate from cov for now) 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... | |
float | t0_ |
time at the reference point on track 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 |
parameter dimension
Enumerator | |
---|---|
dimension |
Definition at line 68 of file TrackBase.h.
anonymous enum |
error matrix size
Enumerator | |
---|---|
covarianceSize |
Definition at line 71 of file TrackBase.h.
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, mps_fire::i, and training_settings::idx.
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 , |
||
float | t0 = 0.f , |
||
float | beta = 0.f , |
||
float | covt0t0 = -1.f , |
||
float | covbetabeta = -1.f |
||
) |
constructor from fit parameters and error matrix
Definition at line 94 of file TrackBase.cc.
References algoMask_, algorithm_, covariance_, dimension, mps_fire::i, training_settings::idx, and setQuality().
|
virtual |
|
inline |
Definition at line 536 of file TrackBase.h.
References algorithm_.
Referenced by algoName(), dqm::TrackAnalyzer::analyze(), ElectronConversionRejectionValidator::analyze(), TkConvValidator::analyze(), ConversionProducer::buildCollection(), TrackExtenderWithMTDT< TrackCollection >::buildTrack(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), PrimaryVertexValidation::fillTrackHistos(), isAlgoInMask(), AlignmentTrackSelector::isOkTrkQuality(), TrackMerger::merge(), RecoTrackSelectorBase::operator()(), EleTkIsolFromCands::passAlgo(), ElectronTkIsolation::passAlgo(), PrintRecoObjects::print(), TrackListMerger::produce(), and QcdUeDQM::trackSelection().
|
static |
Definition at line 146 of file TrackBase.cc.
References algoNames, algoSize, spr::find(), findQualityFiles::size, and undefAlgorithm.
Referenced by AlignmentTrackSelector::AlignmentTrackSelector(), BeamFitter::BeamFitter(), TCMETAlgo::configure(), TrackingNtuple::fillSeeds(), isAlgoInMask(), cms::MuonTCMETValueMapProducer::MuonTCMETValueMapProducer(), QcdUeDQM::QcdUeDQM(), RecoTrackSelectorBase::RecoTrackSelectorBase(), TrackAlgoPriorityOrderESProducer::TrackAlgoPriorityOrderESProducer(), and EleTkIsolFromCands::TrkCuts::TrkCuts().
|
inline |
Definition at line 393 of file TrackBase.h.
References algoMask_.
Referenced by algoMaskUL(), isAlgoInMask(), RecoTrackSelectorBase::operator()(), and BadGlobalMuonTagger::outInOnly().
|
inline |
|
inline |
Definition at line 547 of file TrackBase.h.
References algo().
Referenced by LhcTrackAnalyzer::analyze(), TrackingNtuple::fillTracks(), and isAlgoInMask().
|
inlinestatic |
Definition at line 579 of file TrackBase.h.
References algoNames, algoSize, and createfilelist::int.
|
inline |
append a single hit to the HitPattern
Definition at line 495 of file TrackBase.h.
References reco::HitPattern::appendHit(), and hitPattern_.
Referenced by MuonErrorMatrixAdjuster::attachRecHits(), isTimeOk(), MuonTrackLoader::loadTracks(), PixelTracksProducer::produce(), SeedToTrackProducer::produce(), KfTrackProducerBase::putInEvt(), GsfTrackProducerBase::putInEvt(), TrackProducerWithSCAssociation::putInEvt(), PixelTrackProducer::store(), and MuonTrackLoader::~MuonTrackLoader().
|
inline |
Definition at line 490 of file TrackBase.h.
References reco::HitPattern::appendHit(), and hitPattern_.
|
inline |
Definition at line 504 of file TrackBase.h.
References reco::HitPattern::appendHit(), and hitPattern_.
bool reco::TrackBase::appendHits | ( | const C & | c, |
const TrackerTopology & | ttopo | ||
) |
append hit patterns from vector of hit references
Definition at line 524 of file TrackBase.h.
References reco::HitPattern::appendHits(), and hitPattern_.
Referenced by isTimeOk().
bool reco::TrackBase::appendHits | ( | const I & | begin, |
const I & | end, | ||
const TrackerTopology & | ttopo | ||
) |
Definition at line 518 of file TrackBase.h.
References reco::HitPattern::appendHits(), and hitPattern_.
|
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 508 of file TrackBase.h.
References reco::HitPattern::appendMuonHit(), and hitPattern_.
Referenced by isTimeOk().
|
inline |
These are 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 500 of file TrackBase.h.
References reco::HitPattern::appendTrackerHit(), and hitPattern_.
Referenced by isTimeOk().
|
inline |
velocity at the reference point in natural units
Definition at line 732 of file TrackBase.h.
References beta_.
Referenced by isTimeOk(), and reco::Track::Track().
|
inline |
error on beta
Definition at line 889 of file TrackBase.h.
References covbetabeta_, and mathSSE::sqrt().
Referenced by isTimeOk().
|
inline |
track electric charge
Definition at line 606 of file TrackBase.h.
References charge_.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), ValidationMisalignedTracker::analyze(), EwkMuLumiMonitorDQM::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), ConversionProducer::buildCollection(), FWTrackProxyBuilderFullFramework::buildTrack(), reco::CandidatePtrTransientTrack::charge(), reco::TrackTransientTrack::charge(), reco::GsfTransientTrack::charge(), Tau3MuReco::check4MuonTrack(), AlignmentTwoBodyDecayTrackSelector::checkCharge(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), CandidateChargeBTagComputer::discriminator(), MultiTrackValidatorGenPs::dqmAnalyze(), TrackTimeValueMapProducer::extractTrackVertexTime(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), CSCEfficiency::filter(), egammaTools::getConversionInfo(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), AlCaHOCalibProducer::getFreeTrajectoryState(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), FWPFTrackUtils::getTrack(), ValidHitPairFilter::getTrajectory(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkFilter::initialFreeState(), trajectoryStateTransform::innerFreeState(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), isTimeOk(), MuonIdProducer::makeMuon(), MuonErrorMatrixAdjuster::makeTrack(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), trajectoryStateTransform::outerFreeState(), fireworks::prepareTrack(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), QuarkoniaTrackSelector::produce(), PFDisplacedTrackerVertexProducer::produce(), ConversionSeedFilter::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateCosmicCALO(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), ptError(), qoverp(), TrackClassifier::reconstructionInformation(), PFAlgo::reconstructTrack(), MuonDTLocalMillepedeAlgorithm::run(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), sqr(), reco::Track::Track(), ConversionProducer::trackD0Cut(), and trackFromSeedFitFailed().
|
inline |
chi-squared of the fit
Definition at line 588 of file TrackBase.h.
References chi2_.
Referenced by TrackTypeMonitor::analyze(), dqm::TrackAnalyzer::analyze(), TestTrackHits::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), MuonTrackLoader::buildTrackUpdatedAtPCA(), reco::TransientTrack::chi2(), AlignmentMonitorTracksFromTrajectories::event(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), JetVertexChecker::filter(), isTimeOk(), MuonErrorMatrixAdjuster::makeTrack(), reco::TransientTrack::normalizedChi2(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), TrackListMerger::produce(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), sqr(), reco::Track::Track(), and trackFromSeedFitFailed().
|
inline |
return track covariance matrix
Definition at line 782 of file TrackBase.h.
References fill(), and funct::m.
Referenced by PackedCandidateTrackValidator::analyze(), tauImpactParameter::ParticleBuilder::createTrackParticle(), dxyError(), MatcherByPullsAlgorithm::fillInvCov(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmmkFilter::initialFreeState(), isTimeOk(), MuonErrorMatrixAdjuster::makeTrack(), MuonErrorMatrixAdjuster::makeTrackExtra(), muonisolation::CaloExtractor::MuonAtCaloPosition(), ptError(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), pat::PackedCandidate::setTrackProperties(), sqr(), and track_associator::trackAssociationChi2().
|
inline |
(i,j)-th element of covariance matrix (i, j = 0, ... 4)
Definition at line 796 of file TrackBase.h.
References covariance_, and covIndex().
|
inline |
error on beta
Definition at line 877 of file TrackBase.h.
References covbetabeta_.
Referenced by isTimeOk().
|
inlinestatic |
covariance matrix index in array
Definition at line 529 of file TrackBase.h.
References a, b, and mps_fire::i.
Referenced by covariance(), reco::GsfTrack::covarianceMode(), error(), reco::GsfTrack::errorMode(), and isTimeOk().
|
inline |
error on t0
Definition at line 871 of file TrackBase.h.
References covt0t0_.
Referenced by isTimeOk(), and reco::Track::Track().
|
inline |
dxy parameter in perigee convention (d0 = -dxy)
Definition at line 636 of file TrackBase.h.
References dxy().
Referenced by TrackTypeMonitor::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), AlignmentTrackSelector::basicCuts(), PFEGammaProducer::createSingleLegConversions(), AlignmentMonitorGeneric::event(), MillePedeMonitor::fillTrack(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), egammaTools::getConversionInfo(), CosmicSplitterValidation::is_gold_muon(), isTimeOk(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), HIPAlignmentAlgorithm::run(), TrackWithVertexSelector::testTrack(), and ConversionProducer::trackD0Cut().
|
inline |
error on d0
Definition at line 853 of file TrackBase.h.
References error(), and i_dxy.
Referenced by dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), isTimeOk(), HIPixelTrackFilter::operator()(), PrimaryVertexValidation::passesTrackCuts(), PFTauTransverseImpactParameters::produce(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), sqr(), and ConversionProducer::trackD0Cut().
|
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 642 of file TrackBase.h.
References p(), pt(), px(), py(), pz(), vx(), vy(), and vz().
Referenced by TestOutliers::analyze(), CosmicSplitterValidation::is_gold_muon(), isTimeOk(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), RecoTrackSelectorBase::operator()(), parameters(), RecoTracktoTP::r_dsz(), TPtoRecoTrack::rA_dsz(), and TPtoRecoTrack::rB_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 762 of file TrackBase.h.
References p(), pt(), px(), py(), pz(), vx(), vy(), and vz().
|
inline |
error on dsz
Definition at line 859 of file TrackBase.h.
References error(), and i_dsz.
Referenced by PackedCandidateTrackValidator::analyze(), and isTimeOk().
|
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 630 of file TrackBase.h.
References pt(), px(), py(), vx(), and vy().
Referenced by TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), MonitorTrackResidualsBase< pixel_or_strip >::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), PrimaryVertexAssignment::chargedHadronVertex(), PileupJetIdAlgo::computeIdVariables(), Electron.Electron::cutBasedId(), d0(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFDisplacedVertexHelper::TracksSelector::dxy(), dxy(), ntupleDataFormat.Track::dxyPull(), AlignmentMonitorSegmentDifferences::event(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorMuonSystemMap1D::event(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForEfficiencyFromHitPatter(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), parameters(), PrimaryVertexValidation::passesTrackCuts(), PrintRecoObjects::print(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), pat::PATIsolatedTrackProducer::produce(), PFTauTransverseImpactParameters::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), RecoTracktoTP::r_d02(), RecoTracktoTP::r_dxy(), TPtoRecoTrack::rA_d02(), TPtoRecoTrack::rA_dxy(), TPtoRecoTrack::rB_d02(), TPtoRecoTrack::rB_dxy(), TrackClassifier::reconstructionInformation(), MuonAlignmentFromReference::run(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), HLTMuonMatchAndPlot::selectedMuons(), sqr(), TrackWithVertexSelector::testVertices(), ConversionProducer::trackD0Cut(), QcdUeDQM::trackSelection(), and reco::tau::qcuts::trkTransverseImpactParameter().
|
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 746 of file TrackBase.h.
References pt(), px(), py(), vx(), and vy().
Referenced by Electron.Electron::cutBasedId(), and ntupleDataFormat.Track::dxyPull().
|
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 754 of file TrackBase.h.
References dxy(), reco::BeamSpot::position(), and vz().
Referenced by Electron.Electron::cutBasedId(), and ntupleDataFormat.Track::dxyPull().
|
inline |
error on dxy
Definition at line 847 of file TrackBase.h.
References error(), and i_dxy.
Referenced by PatTrackAnalyzer::analyze(), dqm::TrackAnalyzer::analyze(), MonitorTrackResidualsBase< pixel_or_strip >::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), PrimaryVertexAssignment::chargedHadronVertex(), reco::RecoChargedRefCandidate::dxyError(), reco::RecoCandidate::dxyError(), reco::PFCandidate::dxyError(), dxyError(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), V0Fitter::fitAll(), isTimeOk(), HIMultiTrackSelector::processMVA(), pat::PATIsolatedTrackProducer::produce(), reco::CentralityProducer::produce(), TrackClassifier::reconstructionInformation(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), ConversionProducer::trackD0Cut(), and QcdUeDQM::trackSelection().
double TrackBase::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)
Definition at line 158 of file TrackBase.cc.
References covariance(), i_dxy, i_phi, pt(), px(), py(), and mathSSE::sqrt().
|
inline |
error on dxy with respect to a user-given beamspot
Definition at line 895 of file TrackBase.h.
References dxyError(), reco::BeamSpot::position(), reco::BeamSpot::rotatedCovariance3D(), and vz().
|
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 648 of file TrackBase.h.
References pt(), px(), py(), pz(), vx(), vy(), and vz().
Referenced by TrackTypeMonitor::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), PrimaryVertexAssignment::chargedHadronVertex(), PileupJetIdAlgo::computeIdVariables(), Electron.Electron::cutBasedId(), ntupleDataFormat.Track::dzPull(), AlignmentMonitorGeneric::event(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), getBestVertex(), MultiTrackSelector::getBestVertex(), getBestVertex_withError(), egammaTools::getConversionInfo(), reco::tau::RecoTauVertexAssociator::getLeadTrackRef(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), muonisolation::CaloExtractor::MuonAtCaloPosition(), HIPixelTrackFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), PrimaryVertexValidation::passesTrackCuts(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), JetTracksAssociationDRVertexAssigned::produce(), TOFPIDProducer::produce(), pat::PATPackedCandidateProducer::produce(), VertexFromTrackProducer::produce(), pat::PATIsolatedTrackProducer::produce(), PFTauTransverseImpactParameters::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::produce(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::produce(), IPProducer< Container, Base, Helper >::produce(), fireworks::pushPixelHits(), RecoTracktoTP::r_dz(), RecoTracktoTP::r_dz2(), TPtoRecoTrack::rA_dz(), TPtoRecoTrack::rA_dz2(), TPtoRecoTrack::rB_dz(), TPtoRecoTrack::rB_dz2(), TrackClassifier::reconstructionInformation(), HIPAlignmentAlgorithm::run(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), HLTMuonMatchAndPlot::selectedMuons(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), PFTauElementsOperators::setAreaMetricrecoElementsmaxabsEta(), sqr(), TrackWithVertexSelector::testTrack(), TrackWithVertexSelector::testVertices(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), and reco::tau::qcuts::trkLongitudinalImpactParameterWrtTrack().
|
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 770 of file TrackBase.h.
References pt(), px(), py(), pz(), vx(), vy(), and vz().
Referenced by Electron.Electron::cutBasedId(), and ntupleDataFormat.Track::dzPull().
|
inline |
error on dz
Definition at line 865 of file TrackBase.h.
References error(), i_dsz, p(), and pt().
Referenced by dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), PrimaryVertexAssignment::chargedHadronVertex(), reco::RecoChargedRefCandidate::dzError(), reco::RecoCandidate::dzError(), reco::PFCandidate::dzError(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), V0Fitter::fitAll(), isTimeOk(), HIPixelTrackFilter::operator()(), TrackFilterForPVFinding::operator()(), PrimaryVertexValidation::passesTrackCuts(), HIMultiTrackSelector::processMVA(), TOFPIDProducer::produce(), pat::PATIsolatedTrackProducer::produce(), PFTauTransverseImpactParameters::produce(), reco::CentralityProducer::produce(), TrackClassifier::reconstructionInformation(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), sqr(), and QcdUeDQM::trackSelection().
|
inline |
error on specified element
Definition at line 802 of file TrackBase.h.
References covariance_, covIndex(), and mathSSE::sqrt().
Referenced by Page1Parser.Page1Parser::check_for_whole_start_tag(), d0Error(), dszError(), dxyError(), dzError(), etaError(), isTimeOk(), lambdaError(), phiError(), TriggerMatcherToHLTDebug::produce(), qoverpError(), and thetaError().
|
inline |
pseudorapidity of momentum vector
Definition at line 690 of file TrackBase.h.
References momentum_.
Referenced by Particle.Particle::__str__(), DeDxDiscriminatorLearner::algoAnalyze(), SiStripGainFromData::algoAnalyze(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), TrackingRecoMaterialAnalyser::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), GlobalMuonMatchAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), IsoTrackCalib::analyze(), analyzer::SiPixelLorentzAngle::analyze(), IsolatedTracksCone::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), FWTrackProxyBuilder::build(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), pat::CaloIsolationEnergy::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), EleTkIsolFromCands::calIsol(), spr::chargeIsolationHcal(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFRecoTauDiscriminationAgainstElectronMVA6::discriminate(), PFRecoTauDiscriminationAgainstElectronMVA5::discriminate(), AntiElectronIDCut2::Discriminator(), MuonCaloCompatibility::evaluate(), AlignmentMonitorGeneric::event(), lowptgsfeleid::features_V1(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexValidation::fillTrackHistos(), reco::HcalNoiseInfoProducer::filltracks(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), MuonAlignmentPreFilter::filter(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), CSCEfficiency::filter(), PFElecTkProducer::FindPfRef(), MuonShowerInformationFiller::getCompatibleDets(), Tau3MuReco::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), HLTMuonTrimuonL3Filter::hltFilter(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), MuonIdProducer::isGoodTrack(), isTimeOk(), Jet.Jet::jetID(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), TrackMerger::merge(), reco::tau::qcuts::minTrackVertexWeight(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), PFTauMiniAODPrimaryVertexProducer::nonTauTracksInPVFromPackedCands(), TrackClassFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), EleTkIsolFromCands::passTrkSel(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), examples::TrackAnalysisAlgorithm::process(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), QuarkoniaTrackSelector::produce(), L3MuonIsolationProducer::produce(), HLTMuonL2SelectorForL3IO::produce(), TauJetSelectorForHLTTrackSeeding::produce(), DeDxHitInfoProducer::produce(), pat::PATPackedCandidateProducer::produce(), OutsideInMuonSeeder::produce(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), reco::CentralityProducer::produce(), PFRecoTauChargedHadronProducer::produce(), TriggerMatcherToHLTDebug::produce(), spr::propagateCALO(), Jet.Jet::puJetId(), fireworks::pushPixelHits(), PFAlgo::reconstructTrack(), SoftLepton::refineJetAxis(), GlobalMuonRefitter::refit(), CutsIsolatorWithCorrection::result(), SimpleCutsIsolator::result(), MuonMillepedeAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), AlCaIsoTracksProducer::select(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), IsoTrig::studyMipCut(), TrackWithVertexSelector::testTrack(), EwkMuLumiMonitorDQM::tkIso(), HcalIsoTrkAnalyzer::trackP(), StudyHLT::trackPID(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), muonisolation::PixelTrackExtractor::vetos(), muonisolation::TrackExtractor::vetos(), and egammaisolation::EgammaTrackExtractor::vetos().
|
inline |
error on eta
Definition at line 835 of file TrackBase.h.
References error(), i_lambda, p(), and pt().
Referenced by CosmicSplitterValidation::analyze(), PackedCandidateTrackValidator::analyze(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), isTimeOk(), HIMultiTrackSelector::processMVA(), and MuonTrackingRegionBuilder::region().
TrackBase::CovarianceMatrix & TrackBase::fill | ( | CovarianceMatrix & | v | ) | const |
fill SMatrix
Definition at line 129 of file TrackBase.cc.
References covariance_, and reco::fillCovariance().
Referenced by covariance(), and isTimeOk().
|
inline |
Access the hit pattern, indicating in which Tracker layers the track has hits.
Definition at line 485 of file TrackBase.h.
References hitPattern_.
Referenced by TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), PFCheckHitPattern::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TkConvValidator::analyze(), PrimaryVertexValidation::analyze(), IsolatedTracksCone::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), spr::coneChargeIsolation(), PFRecoTauDiscriminationByHPSSelection::discriminate(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForEfficiencyFromHitPatter(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), egammaTools::getConversionInfo(), spr::goodTrack(), reco::TransientTrack::hitPattern(), HLTTrackWithHits::hltFilter(), isTimeOk(), PFMuonAlgo::isTrackerTightMuon(), PFDisplacedVertexHelper::isTrackSelected(), reco::TransientTrack::numberOfLostHits(), reco::TransientTrack::numberOfValidHits(), GhostTrackComputer::operator()(), TrackClassFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), pat::PATLostTracks::passTrkCuts(), EleTkIsolFromCands::passTrkSel(), FWTrackResidualDetailView::prepareData(), CheckHitPattern::print(), PFCheckHitPattern::print(), PFMuonAlgo::printMuonProperties(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), FastTrackerRecHitMaskProducer::produce(), HLTMuonL2SelectorForL3IO::produce(), TrackListMerger::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATIsolatedTrackProducer::produce(), IPProducer< Container, Base, Helper >::produce(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), pat::PackedCandidate::setHits(), FWConvTrackHitsDetailView::setTextInfo(), reco::IPTagInfo< Container, Base >::taggingVariables(), TrackWithVertexSelector::testTrack(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::trackFilter(), SiStripMonitorTrack::trackFilter(), TrackVertexArbitration< VTX >::trackFilterArbitrator(), MuonBadTrackFilter::trackInfo(), reco::TrackSelector::trackSelection(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkPixelHits(), reco::tau::qcuts::trkTrackerHits(), and QuickTrackAssociatorByHitsImpl::weightedNumberOfTrackClusters().
|
inline |
Definition at line 395 of file TrackBase.h.
References a, algo(), algoByName(), algoMask(), algoName(), isLooper(), dataset::name, nLoops(), originalAlgo(), quality(), qualityByName(), qualityMask(), qualityName(), setNLoops(), setQuality(), setQualityMask(), and AlCaHLTBitMon_QueryRunRegistry::string.
Referenced by BadGlobalMuonTagger::outInOnly().
|
inline |
Definition at line 958 of file TrackBase.h.
References nLoops_.
Referenced by isAlgoInMask().
|
inline |
return true if timing measurement is usable
Definition at line 181 of file TrackBase.h.
References a, appendHitPattern(), appendHits(), appendMuonHitPattern(), appendTrackerHitPattern(), begin, beta(), betaError(), EnergyCorrector::c, patCaloMETCorrections_cff::C, charge(), chi2(), covariance(), covBetaBeta(), covIndex(), covt0t0(), covt0t0_, d0(), d0Error(), dsz(), dszError(), dxy(), dxyError(), dz(), dzError(), end, error(), eta(), etaError(), fill(), hitPattern(), Exhume::I, mps_fire::i, lambda(), lambdaError(), momentum(), ndof(), normalizedChi2(), numberOfLostHits(), numberOfValidHits(), p(), parameter(), parameters(), listBenchmarks::pattern, phi(), phiError(), pt(), ptError(), px(), py(), pz(), qoverp(), qoverpError(), referencePoint(), resetHitPattern(), setAlgorithm(), setOriginalAlgorithm(), t0(), t0Error(), theta(), thetaError(), findQualityFiles::v, validFraction(), vertex(), extraflags_cff::vtx, vx(), vy(), and vz().
|
inline |
Lambda angle.
Definition at line 624 of file TrackBase.h.
References M_PI_2, and momentum_.
Referenced by TestOutliers::analyze(), PrimaryVertexValidation::fillTrackHistos(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), isTimeOk(), and parameters().
|
inline |
error on lambda
Definition at line 829 of file TrackBase.h.
References error(), and i_lambda.
Referenced by MTVHistoProducerAlgoForTracker::getRecoMomentum(), isTimeOk(), and sqr().
|
inline |
track momentum vector
Definition at line 714 of file TrackBase.h.
References momentum_.
Referenced by ValidationMisalignedTracker::analyze(), PhotonValidator::analyze(), StudyHLT::analyze(), BPHMonitor::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), SiStripFineDelayHit::detId(), EgammaHLTTrackIsolation::electronIsolation(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MillePedeMonitor::fillTrack(), JetVertexChecker::filter(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), ValidHitPairFilter::getTrajectory(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkFilter::initialFreeState(), isTimeOk(), CalibrationTrackSelectorFromDetIdList::makeCandidate(), reco::modules::CosmicTrackSplitter::makeCandidate(), reco::modules::TrackerTrackHitFilter::makeCandidate(), MuonErrorMatrixAdjuster::makeTrack(), TrackMerger::merge(), reco::PFDisplacedVertex::momentum(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), CombinedSVComputer::operator()(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), SeedGeneratorFromProtoTracksEDProducer::produce(), SoftLepton::refineJetAxis(), HPSPFRecoTauAlgorithm::refitThreeProng(), MuonTrackingRegionBuilder::region(), reco::IPTagInfo< Container, Base >::taggingVariables(), reco::Track::Track(), ObjectValidator::validTrack(), and reco::IPTagInfo< Container, Base >::variableJTA().
|
inline |
number of degrees of freedom of the fit
Definition at line 594 of file TrackBase.h.
References ndof_.
Referenced by TrackTypeMonitor::analyze(), dqm::TrackAnalyzer::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), MuonTrackLoader::buildTrackUpdatedAtPCA(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), isTimeOk(), MuonErrorMatrixAdjuster::makeTrack(), reco::TransientTrack::ndof(), reco::TransientTrack::normalizedChi2(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), TrackExtenderWithMTDT< TrackCollection >::produce(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), reco::Track::Track(), trackFromSeedFitFailed(), and QcdUeDQM::trackSelection().
|
inline |
Definition at line 963 of file TrackBase.h.
References nLoops_.
Referenced by isAlgoInMask().
|
inline |
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)
Definition at line 600 of file TrackBase.h.
Referenced by ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), helper::SimpleJetTrackAssociator::associate(), helper::SimpleJetTrackAssociator::associateTransient(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), AlignmentMonitorGeneric::event(), AlignmentMonitorTracksFromTrajectories::event(), lowptgsfeleid::features_V1(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), CSCEfficiency::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), reco::tau::lead_track_chi2(), MuonResidualsFromTrack::normalizedChi2(), GhostTrackComputer::operator()(), TrackClassFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), HLTMuonL2SelectorForL3IO::produce(), pat::PATTauProducer::produce(), IPProducer< Container, Base, Helper >::produce(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), pat::PackedCandidate::setTrackProperties(), reco::IPTagInfo< Container, Base >::taggingVariables(), TrackWithVertexSelector::testTrack(), SiStripMonitorTrack::trackFilter(), MuonBadTrackFilter::trackInfo(), ConversionProducer::trackQualityFilter(), reco::TrackSelector::trackSelection(), QcdUeDQM::trackSelection(), and reco::tau::qcuts::trkChi2().
|
inline |
number of cases where track crossed a layer without getting a hit.
Definition at line 907 of file TrackBase.h.
References hitPattern_, reco::HitPattern::numberOfLostHits(), and reco::HitPattern::TRACK_HITS.
Referenced by dqm::TrackAnalyzer::analyze(), MuonTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), MillePedeMonitor::fillTrack(), isTimeOk(), reco::Track::lost(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), TrackListMerger::produce(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), and TrackWithVertexSelector::testTrack().
|
inline |
number of valid hits found
Definition at line 901 of file TrackBase.h.
References hitPattern_, and reco::HitPattern::numberOfValidHits().
Referenced by PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), helper::SimpleJetTrackAssociator::associate(), QuickTrackAssociatorByHitsImpl::associateRecoToSimImplementation(), helper::SimpleJetTrackAssociator::associateTransient(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), MuonAlignmentAnalyzer::doMatching(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), MillePedeMonitor::fillTrack(), V0Fitter::fitAll(), reco::Track::found(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), TrackClassFilter::operator()(), pat::PATLostTracks::passTrkCuts(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), HLTMuonL2SelectorForL3IO::produce(), TrackListMerger::produce(), DeDxHitInfoProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), TrackWithVertexSelector::testTrack(), and ObjectValidator::validTrack().
|
inline |
Definition at line 540 of file TrackBase.h.
References originalAlgorithm_.
Referenced by dqm::TrackAnalyzer::analyze(), MTVHistoProducerAlgoForTracker::fill_duplicate_histos(), isAlgoInMask(), and RecoTrackSelectorBase::operator()().
|
inline |
momentum vector magnitude
Definition at line 654 of file TrackBase.h.
References momentum_.
Referenced by PFTrackTransformer::addPoints(), SiStripGainFromData::algoAnalyze(), EwkMuLumiMonitorDQM::analyze(), TrackingRecoMaterialAnalyser::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalibration::analyze(), StudyHLT::analyze(), IsoTrackCalib::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), AlignmentTrackSelector::basicCuts(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), HBHEHitMap::calcTracksNeighborTowers_(), HBHEHitMap::calcTracksSameTowers_(), pat::TrackerIsolationPt::calculate(), spr::chargeIsolation(), spr::chargeIsolationCone(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), IsoTrig::chgIsolation(), spr::coneChargeIsolation(), dsz(), dzError(), etaError(), MuonCaloCompatibility::evaluate(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorSegmentDifferences::event(), AlignmentMonitorMuonVsCurvature::event(), TrackTimeValueMapProducer::extractTrackVertexTime(), lowptgsfeleid::features_V1(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), PrimaryVertexValidation::fillTrackHistos(), reco::HcalNoiseInfoProducer::filltracks(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), MuonAlignmentPreFilter::filter(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), MuonShowerInformationFiller::getCompatibleDets(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), MuonIdProducer::isGoodTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), MuonIdTruthInfo::matchChi2(), muonid::matchTracks(), muonisolation::CaloExtractor::MuonAtCaloPosition(), TrackClassFilter::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), JetTracksAssociationDRVertex::produce(), JetVetoedTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), QuarkoniaTrackSelector::produce(), DeDxHitInfoProducer::produce(), TrackTimeValueMapProducer::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateCALO(), Electron.Electron::ptErr(), ptError(), qoverp(), PFAlgo::reconstructTrack(), GlobalMuonRefitter::refit(), MuonTrackingRegionBuilder::region(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CSCOverlapsAlignmentAlgorithm::run(), MuonAlignmentFromReference::run(), AlCaIsoTracksProducer::select(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), SiStripMonitorTrack::trackFilter(), and reco::JetTracksAssociation::tracksP4().
|
inline |
i-th parameter ( i = 0, ... 4 )
Definition at line 790 of file TrackBase.h.
References mps_fire::i, and parameters().
Referenced by tauImpactParameter::ParticleBuilder::createTrackParticle(), isTimeOk(), and TriggerMatcherToHLTDebug::produce().
|
inline |
Track parameters with one-to-one correspondence to the covariance matrix.
Definition at line 776 of file TrackBase.h.
References dsz(), dxy(), lambda(), phi(), and qoverp().
Referenced by SiStripFineDelayHit::detId(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::inputTags(), isTimeOk(), parameter(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::properties(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::recursePSetProperties(), and track_associator::trackAssociationChi2().
|
inline |
azimuthal angle of momentum vector
Definition at line 684 of file TrackBase.h.
References momentum_.
Referenced by Particle.Particle::__str__(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), IsoTrackCalib::analyze(), analyzer::SiPixelLorentzAngle::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), pat::CaloIsolationEnergy::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), EleTkIsolFromCands::calIsol(), spr::chargeIsolationHcal(), AlignmentTwoBodyDecayTrackSelector::checkAcoplanarity(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), AlignmentMonitorGeneric::event(), TrackTimeValueMapProducer::extractTrackVertexTime(), lowptgsfeleid::features_V1(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), PFElecTkProducer::FindPfRef(), MuonShowerInformationFiller::getCompatibleDets(), Tau3MuReco::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), HLTMuonTrimuonL3Filter::hltFilter(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), CosmicSplitterValidation::is_gold_muon(), isTimeOk(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), MuonIdTruthInfo::matchChi2(), reco::tau::qcuts::minTrackVertexWeight(), muonisolation::CaloExtractor::MuonAtCaloPosition(), PFTauMiniAODPrimaryVertexProducer::nonTauTracksInPVFromPackedCands(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), parameters(), EleTkIsolFromCands::passTrkSel(), ntupleDataFormat.Track::phiPull(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), HLTMuonL2SelectorForL3IO::produce(), TauJetSelectorForHLTTrackSeeding::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), PFRecoTauChargedHadronProducer::produce(), spr::propagateCALO(), PFAlgo::reconstructTrack(), SoftLepton::refineJetAxis(), MuonMillepedeAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), AlCaIsoTracksProducer::select(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), sqr(), IsoTrig::studyMipCut(), EwkMuLumiMonitorDQM::tkIso(), HcalIsoTrkAnalyzer::trackP(), StudyHLT::trackPID(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), muonisolation::PixelTrackExtractor::vetos(), muonisolation::TrackExtractor::vetos(), and egammaisolation::EgammaTrackExtractor::vetos().
|
inline |
error on phi
Definition at line 841 of file TrackBase.h.
References error(), and i_phi.
Referenced by TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), PFMEtSignInterfaceBase::compResolution(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), isTimeOk(), SeedToTrackProducer::produce(), MuonTrackingRegionBuilder::region(), and sqr().
|
inline |
track transverse momentum
Definition at line 660 of file TrackBase.h.
References momentum_, and mathSSE::sqrt().
Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), DeDxDiscriminatorLearner::algoAnalyze(), SiStripGainFromData::algoAnalyze(), PFCandConnector::analyseNuclearWSec(), PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), MonitorTrackResidualsBase< pixel_or_strip >::analyze(), TrackSplittingMonitor::analyze(), ElectronConversionRejectionValidator::analyze(), GlobalMuonMatchAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TkConvValidator::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), DiDispStaMuonMonitor::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), StudyHLT::analyze(), IsoTrackCalib::analyze(), analyzer::SiPixelLorentzAngle::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWTrackProxyBuilder::build(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), EleTkIsolFromCands::calIsol(), Photon.Photon::calScaledIsoValueExp(), Photon.Photon::calScaledIsoValueLin(), Photon.Photon::calScaledIsoValueQuadr(), Tau3MuReco::check4MuonTrack(), pat::MuonMvaEstimator::computeMva(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFRecoTauDiscriminationAgainstElectronMVA6::discriminate(), PFRecoTauDiscriminationAgainstElectronMVA5::discriminate(), CandidateChargeBTagComputer::discriminator(), AntiElectronIDCut2::Discriminator(), MultiTrackValidatorGenPs::dqmAnalyze(), dsz(), dxy(), dxyError(), dz(), dzError(), fw::estimate_field(), etaError(), AlignmentMonitorGeneric::event(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorSegmentDifferences::event(), TrackTimeValueMapProducer::extractTrackVertexTime(), lowptgsfeleid::features_V1(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForEfficiencyFromHitPatter(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), reco::HcalNoiseInfoProducer::filltracks(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), MuonAlignmentPreFilter::filter(), JetVertexChecker::filter(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), CSCEfficiency::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), egammaTools::getConversionInfo(), reco::tau::RecoTauVertexAssociator::getLeadCand(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrimuonL3Filter::hltFilter(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), HLTTrackWithHits::hltFilter(), MuonIdProducer::isGoodTrack(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), PFDisplacedVertexCandidateFinder::link(), MuonTrackLoader::loadTracks(), LowPtConversion::match(), MatcherByPullsAlgorithm::match(), muonid::matchTracks(), reco::tau::qcuts::minTrackVertexWeight(), muonisolation::CaloExtractor::MuonAtCaloPosition(), Electron.Electron::mvaIDLoose(), Electron.Electron::mvaIDRun2(), Electron.Electron::mvaIDTight(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), PFTauMiniAODPrimaryVertexProducer::nonTauTracksInPVFromPackedCands(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), reco::TrackSelector::operator()(), reco::tau::RecoTauSoftTwoProngTausCleanerPlugin::operator()(), ClusterShapeTrackFilter::operator()(), CalibrationTrackSelector::ComparePt::operator()(), AlignmentTrackSelector::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), reco::Vertex::TrackEqual::operator()(), PrimaryVertexValidation::passesTrackCuts(), pat::PATLostTracks::passTrkCuts(), fireworks::prepareTrack(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), examples::TrackAnalysisAlgorithm::process(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), QuarkoniaTrackSelector::produce(), HLTMuonL2SelectorForL3IO::produce(), TauJetSelectorForHLTTrackSeeding::produce(), DeDxHitInfoProducer::produce(), Onia2MuMuPAT::produce(), pat::PATPackedCandidateProducer::produce(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), pat::PATTauProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), Electron.Electron::ptErr(), ptError(), reco::tau::qcuts::ptMin(), ntupleDataFormat.Track::ptPull(), PFAlgo::reconstructTrack(), SoftLepton::refineJetAxis(), GlobalMuonRefitter::refit(), MuonTrackingRegionBuilder::region(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), CutsIsolatorWithCorrection::result(), MuonMillepedeAlgorithm::run(), AnalyticalTrackSelector::run(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MultiTrackSelector::run(), HIMultiTrackSelector::run(), MuonAlignmentFromReference::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), AlCaIsoTracksProducer::select(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), Jet.Jet::setCorrP4(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), PrimaryVertexResolution::sortTracksByPt(), sqr(), IsoTrig::studyMipCut(), TrackWithVertexSelector::testTrack(), EwkMuLumiMonitorDQM::tkIso(), SiStripMonitorTrack::trackFilter(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::trackFilter(), TrackVertexArbitration< VTX >::trackFilterArbitrator(), MuonBadTrackFilter::trackInfo(), reco::PFDisplacedVertex::trackPosition(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), ObjectValidator::validTrack(), reco::IPTagInfo< Container, Base >::variableJTA(), and MuonTrackLoader::~MuonTrackLoader().
|
inline |
error on Pt (set to 1000 TeV if charge==0 for safety)
Definition at line 814 of file TrackBase.h.
References charge(), covariance(), i_lambda, i_qoverp, p(), pt(), pz(), and mathSSE::sqrt().
Referenced by PatTrackAnalyzer::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), PFMEtSignInterfaceBase::compResolution(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), CSCEfficiency::filter(), reco::tau::RecoTauVertexAssociator::getLeadCand(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::getTrackPtError(), PFDisplacedVertexCandidateFinder::goodPtResolution(), isTimeOk(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), PrimaryVertexValidation::passesTrackCuts(), EleTkIsolFromCands::passTrkSel(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), Onia2MuMuPAT::produce(), SeedToTrackProducer::produce(), reco::CentralityProducer::produce(), PrimaryVertexSorting::score(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), TrackWithVertexSelector::testTrack(), MuonBadTrackFilter::trackInfo(), and QcdUeDQM::trackSelection().
|
inline |
x coordinate of momentum vector
Definition at line 666 of file TrackBase.h.
References momentum_.
Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), BPHMonitor::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), dsz(), dummyPrediction(), dxy(), dxyError(), dz(), fw::estimate_field(), dqm::TrackAnalyzer::fillHistosForState(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), QuarkoniaTrackSelector::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
y coordinate of momentum vector
Definition at line 672 of file TrackBase.h.
References momentum_.
Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), BPHMonitor::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), dsz(), dummyPrediction(), dxy(), dxyError(), dz(), fw::estimate_field(), dqm::TrackAnalyzer::fillHistosForState(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), QuarkoniaTrackSelector::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
z coordinate of momentum vector
Definition at line 678 of file TrackBase.h.
References momentum_.
Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), BPHMonitor::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), dsz(), dummyPrediction(), dz(), dqm::TrackAnalyzer::fillHistosForState(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), QuarkoniaTrackSelector::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), ptError(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
q / p
Definition at line 612 of file TrackBase.h.
Referenced by PatTrackAnalyzer::analyze(), TestOutliers::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), TrackTypeMonitor::fillHistograms(), PrimaryVertexValidation::fillTrackHistos(), CSCEfficiency::filter(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), spr::goodTrack(), isTimeOk(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), parameters(), IsolatedTracksCone::printTrack(), and IsolatedTracksNxN::printTrack().
|
inline |
error on signed transverse curvature
Definition at line 808 of file TrackBase.h.
References error(), and i_qoverp.
Referenced by PatTrackAnalyzer::analyze(), TestOutliers::analyze(), MuonTrackValidator::analyze(), CSCEfficiency::filter(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), spr::goodTrack(), isTimeOk(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), and sqr().
|
inline |
Track quality.
Definition at line 549 of file TrackBase.h.
References goodIterative, highPurity, lumiQueryAPI::q, quality_, and undefQuality.
Referenced by PatTrackAnalyzer::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), StudyHLT::analyze(), BPHMonitor::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), TemplatedJetProbabilityComputer< Container, Base >::discriminator(), TemplatedJetBProbabilityComputer< Container, Base >::discriminator(), dqm::TrackAnalyzer::fillHistosForState(), CSCEfficiency::filter(), spr::goodTrack(), IPTagPlotter< Container, Base >::highestTrackQual(), isAlgoInMask(), AlignmentTrackSelector::isOkTrkQuality(), PFDisplacedVertexHelper::isTrackSelected(), TrackFilterForPVFinding::operator()(), TrackClassFilter::operator()(), RecoTrackSelectorBase::operator()(), TemplatedTrackCountingComputer< Container, Base >::orderedSignificances(), PrimaryVertexValidation::passesTrackCuts(), EleTkIsolFromCands::passQual(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), FastTrackerRecHitMaskProducer::produce(), Onia2MuMuPAT::produce(), ExtraFromSeeds::produce(), reco::CentralityProducer::produce(), spr::propagateCALO(), spr::propagateCosmicCALO(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), TrackWithVertexSelector::testTrack(), reco::Track::Track(), reco::TrackSelector::trackSelection(), and QcdUeDQM::trackSelection().
|
static |
Definition at line 134 of file TrackBase.cc.
References spr::find(), qualityNames, qualitySize, findQualityFiles::size, and undefQuality.
Referenced by AlCaIsoTracksFilter::AlCaIsoTracksFilter(), AlCaIsoTracksProducer::AlCaIsoTracksProducer(), AlignmentTrackSelector::AlignmentTrackSelector(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), StandaloneTrackMonitor::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), TrackCount::analyze(), FSQDQM::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), BeamFitter::BeamFitter(), QGTagger::calcVariables(), CaloRecoTauTagInfoAlgorithm::CaloRecoTauTagInfoAlgorithm(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), FilterOutLowPt::filter(), FilterOutScraping::filter(), TrackIsoCalculator::getBkgSubTrackIso(), TrackIsoCalculator::getTrackIso(), HcalIsoTrkAnalyzer::HcalIsoTrkAnalyzer(), HITrackClusterRemover::HITrackClusterRemover(), isAlgoInMask(), IsolatedTracksHcalScale::IsolatedTracksHcalScale(), IsoTrackCalib::IsoTrackCalib(), IsoTrackCalibration::IsoTrackCalibration(), IsoTrig::IsoTrig(), PFDisplacedVertexHelper::isTrackSelected(), JetPlusTrackProducerAA::JetPlusTrackProducerAA(), LightPFTrackProducer::LightPFTrackProducer(), LowPtGsfElectronSeedProducer::loop(), MuonTrackCut::MuonTrackCut(), TrackClassFilter::operator()(), PrimaryVertexValidation::passesTrackCuts(), pat::PATLostTracks::PATLostTracks(), PFTrackProducer::PFTrackProducer(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), reco::modules::HICaloCompatibleTrackSelector::produce(), PromptTrackCountingComputer::PromptTrackCountingComputer(), spr::propagateCALO(), spr::propagateCosmicCALO(), QcdUeDQM::QcdUeDQM(), QualityCutsAnalyzer::QualityCutsAnalyzer(), RecoTrackSelectorBase::RecoTrackSelectorBase(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), lowptgsfeleseed::Features::set(), L1Analysis::L1AnalysisRecoTrack::SetTracks(), StudyHLT::StudyHLT(), TemplatedJetBProbabilityComputer< Container, Base >::TemplatedJetBProbabilityComputer(), TemplatedJetProbabilityComputer< Container, Base >::TemplatedJetProbabilityComputer(), TemplatedTrackCountingComputer< Container, Base >::TemplatedTrackCountingComputer(), TrackWithVertexSelector::testTrack(), TrackExtrapolator::TrackExtrapolator(), TrackFilterForPVFinding::TrackFilterForPVFinding(), TrackListMerger::TrackListMerger(), reco::TrackSelector::TrackSelector(), and EleTkIsolFromCands::TrkCuts::TrkCuts().
|
inline |
Definition at line 943 of file TrackBase.h.
References quality_.
Referenced by PrimaryVertexValidation::fillTrackHistos(), isAlgoInMask(), pat::PATIsolatedTrackProducer::produce(), MultiTrackSelector::run(), and HIMultiTrackSelector::run().
|
inlinestatic |
Definition at line 571 of file TrackBase.h.
References createfilelist::int, qualityNames, and qualitySize.
Referenced by TkAlCaRecoMonitor::bookHistograms(), isAlgoInMask(), IsolatedTracksCone::printTrack(), and IsolatedTracksNxN::printTrack().
|
inline |
Reference point on the track.
Definition at line 720 of file TrackBase.h.
References vertex_.
Referenced by dqm::TrackAnalyzer::analyze(), CosmicSplitterValidation::analyze(), PackedCandidateTrackValidator::analyze(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::getTrackPos(), SeedFromProtoTrack::init(), isTimeOk(), MuonErrorMatrixAdjuster::makeTrack(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), pat::PATPackedCandidateProducer::produce(), and reco::Track::Track().
|
inline |
Sets HitPattern as empty.
Definition at line 512 of file TrackBase.h.
References reco::HitPattern::clear(), and hitPattern_.
Referenced by isTimeOk().
|
inline |
Definition at line 391 of file TrackBase.h.
|
inline |
Track algorithm.
Definition at line 928 of file TrackBase.h.
References a, algoMask_, algorithm_, and setOriginalAlgorithm().
Referenced by TrackProducerAlgorithm< reco::GsfTrack >::buildTrack(), isTimeOk(), and TrackListCombiner::produce().
|
inline |
Definition at line 953 of file TrackBase.h.
References nLoops_, and relativeConstraints::value.
Referenced by isAlgoInMask().
|
inline |
Definition at line 935 of file TrackBase.h.
References a, algoMask_, and originalAlgorithm_.
Referenced by TrackProducerAlgorithm< reco::Track >::buildTrack(), isTimeOk(), and setAlgorithm().
|
inline |
Definition at line 562 of file TrackBase.h.
References lumiQueryAPI::q, quality_, and undefQuality.
Referenced by isAlgoInMask(), and TrackBase().
|
inline |
|
inline |
|
inline |
Definition at line 429 of file TrackBase.h.
References stopReason_.
Referenced by dqm::TrackAnalyzer::analyze().
|
inline |
time at the reference point
Definition at line 726 of file TrackBase.h.
References t0_.
Referenced by isTimeOk(), and reco::Track::Track().
|
inline |
error on t0
Definition at line 883 of file TrackBase.h.
References covt0t0_, and mathSSE::sqrt().
Referenced by isTimeOk().
|
inline |
polar angle
Definition at line 618 of file TrackBase.h.
References momentum_.
Referenced by ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), MuonCaloCompatibility::evaluate(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), isTimeOk(), MatcherByPullsAlgorithm::match(), MuonIdTruthInfo::matchChi2(), muonisolation::CaloExtractor::MuonAtCaloPosition(), sqr(), and Tau.Tau::zImpact().
|
inline |
error on theta
Definition at line 823 of file TrackBase.h.
References error(), and i_lambda.
Referenced by TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), and isTimeOk().
|
inline |
fraction of valid hits on the track
Definition at line 913 of file TrackBase.h.
References hitPattern_, reco::HitPattern::MISSING_INNER_HITS, reco::HitPattern::MISSING_OUTER_HITS, reco::HitPattern::numberOfLostTrackerHits(), reco::HitPattern::numberOfValidTrackerHits(), and reco::HitPattern::TRACK_HITS.
Referenced by dqm::TrackAnalyzer::analyze(), and isTimeOk().
|
inline |
reference point on the track. This method is DEPRECATED, please use referencePoint() instead
Definition at line 738 of file TrackBase.h.
References vertex_.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), PrimaryVertexValidation::analyze(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), PFCandWithSuperClusterExtractor::depositFromObject(), Tau.Tau::dxy(), EgammaHLTTrackIsolation::electronIsolation(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), ElectronTkIsolation::getIso(), FWPFTrackUtils::getTrack(), ValidHitPairFilter::getTrajectory(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkFilter::initialFreeState(), isTimeOk(), MuonIdProducer::makeMuon(), SeedGeneratorFromProtoTracksEDProducer::produce(), and TrackWithVertexSelector::testVertices().
|
inline |
x coordinate of the reference point on track
Definition at line 696 of file TrackBase.h.
References vertex_.
Referenced by dqm::TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), PackedCandidateTrackValidator::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), directionAlongMomentum(), dsz(), dxy(), dz(), fw::estimate_field(), PrimaryVertexValidation::fillTrackHistos(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), isTimeOk(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), fireworks::prepareTrack(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), and EwkMuLumiMonitorDQM::tkIso().
|
inline |
y coordinate of the reference point on track
Definition at line 702 of file TrackBase.h.
References vertex_.
Referenced by dqm::TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), PackedCandidateTrackValidator::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), directionAlongMomentum(), dsz(), dxy(), dz(), fw::estimate_field(), PrimaryVertexValidation::fillTrackHistos(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), isTimeOk(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), fireworks::prepareTrack(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), and EwkMuLumiMonitorDQM::tkIso().
|
inline |
z coordinate of the reference point on track
Definition at line 708 of file TrackBase.h.
References vertex_.
Referenced by dqm::TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), PackedCandidateTrackValidator::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), EleTkIsolFromCands::calIsol(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), dsz(), dxy(), dxyError(), dz(), TrackTimeValueMapProducer::extractTrackVertexTime(), GsfTrackProducerBase::fillMode(), PrimaryVertexValidation::fillTrackHistos(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), isTimeOk(), MatcherByPullsAlgorithm::match(), ComparePairs::operator()(), EleTkIsolFromCands::passTrkSel(), fireworks::prepareTrack(), SiStripElectronAssociator::produce(), VertexFromTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), fireworks::pushPixelHits(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), and EwkMuLumiMonitorDQM::tkIso().
|
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 459 of file TrackBase.h.
Referenced by algoMask(), setAlgoMask(), setAlgorithm(), setOriginalAlgorithm(), and TrackBase().
|
static |
Definition at line 148 of file TrackBase.h.
Referenced by algoByName(), algoName(), dqm::TrackAnalyzer::bookHistosForHitProperties(), and MTVHistoProducerAlgoForTracker::bookRecoHistos().
|
private |
track algorithm
Definition at line 468 of file TrackBase.h.
Referenced by algo(), setAlgorithm(), and TrackBase().
|
private |
norm of the particle velocity at innermost point on track can multiply by momentum_.Unit() to get velocity vector
Definition at line 456 of file TrackBase.h.
Referenced by beta().
|
private |
|
private |
|
private |
perigee 5x5 covariance matrix
Definition at line 437 of file TrackBase.h.
Referenced by covariance(), error(), fill(), and TrackBase().
|
private |
Definition at line 440 of file TrackBase.h.
Referenced by betaError(), and covBetaBeta().
|
private |
errors for time and velocity (separate from cov for now)
Definition at line 440 of file TrackBase.h.
Referenced by covt0t0(), isTimeOk(), and t0Error().
|
private |
hit pattern
Definition at line 434 of file TrackBase.h.
Referenced by appendHitPattern(), appendHits(), appendMuonHitPattern(), appendTrackerHitPattern(), hitPattern(), numberOfLostHits(), numberOfValidHits(), resetHitPattern(), and validFraction().
|
private |
|
private |
number of degrees of freedom
Definition at line 462 of file TrackBase.h.
Referenced by ndof(), and normalizedChi2().
|
private |
number of loops made during the building of the trajectory of a looper particle
Definition at line 478 of file TrackBase.h.
Referenced by isLooper(), nLoops(), and setNLoops().
|
private |
track algorithm
Definition at line 471 of file TrackBase.h.
Referenced by originalAlgo(), and setOriginalAlgorithm().
|
private |
track quality
Definition at line 475 of file TrackBase.h.
Referenced by quality(), qualityMask(), setQuality(), and setQualityMask().
|
static |
Definition at line 164 of file TrackBase.h.
Referenced by dqm::TrackAnalyzer::bookHistosForState(), qualityByName(), and qualityName().
|
private |
Stop Reason.
Definition at line 481 of file TrackBase.h.
Referenced by setStopReason(), and stopReason().
|
private |
time at the reference point on track
Definition at line 449 of file TrackBase.h.
Referenced by t0().
|
private |
innermost (reference) point on track
Definition at line 446 of file TrackBase.h.
Referenced by referencePoint(), vertex(), vx(), vy(), and vz().