#include <DataFormats/TrackReco/interface/TrackBase.h>
Public Member Functions | |
TrackAlgorithm | algo () const |
std::string | algoName () const |
bool | appendHitPattern (const TrackingRecHit &hit) |
append a single hit to the HitPattern More... | |
bool | appendHitPattern (const DetId &id, TrackingRecHit::Type hitType) |
template<typename C > | |
bool | appendHits (const C &c) |
append hit patterns from vector of hit references More... | |
template<typename I > | |
bool | appendHits (const I &begin, const I &end) |
int | charge () const |
track electric charge More... | |
double | chi2 () const |
chi-squared of the fit More... | |
CovarianceMatrix | covariance () const |
return track covariance matrix More... | |
double | covariance (int i, int j) const |
(i,j)-th element of covariance matrix (i, j = 0, ... 4) More... | |
double | d0 () const |
dxy parameter in perigee convention (d0 = -dxy) More... | |
double | d0Error () const |
error on d0 More... | |
double | dsz () const |
dsz parameter (THIS IS NOT the SZ impact parameter to (0,0,0) if refPoint is far from (0,0,0): see parametrization definition above for details) More... | |
double | dsz (const Point &myBeamSpot) const |
dsz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the distance in the S-Z plane to the beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dszError () const |
error on dsz More... | |
double | dxy () const |
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close to (0,0,0): see parametrization definition above for details). See also function dxy(myBeamSpot). More... | |
double | dxy (const Point &myBeamSpot) const |
dxy parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dxy (const BeamSpot &theBeamSpot) const |
dxy parameter with respect to the beamSpot taking into account the beamspot slopes (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dxyError () const |
error on dxy More... | |
double | dz () const |
dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to (0,0,0). See also function dz(myBeamSpot) More... | |
double | dz (const Point &myBeamSpot) const |
dz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the track z0, if the beamSpot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More... | |
double | dzError () const |
error on dz More... | |
double | error (int i) const |
error on specified element More... | |
double | eta () const |
pseudorapidity of momentum vector More... | |
double | etaError () const |
error on eta More... | |
CovarianceMatrix & | fill (CovarianceMatrix &v) const |
fill SMatrix More... | |
const HitPattern & | hitPattern () const |
Access the hit pattern, indicating in which Tracker layers the track has hits. More... | |
bool | isLooper () const |
double | lambda () const |
Lambda angle. More... | |
double | lambdaError () const |
error on lambda More... | |
const Vector & | momentum () const |
track momentum vector More... | |
double | ndof () const |
number of degrees of freedom of the fit More... | |
signed char | nLoops () const |
double | normalizedChi2 () const |
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero) More... | |
unsigned short | numberOfLostHits () const |
number of cases where track crossed a layer without getting a hit. More... | |
unsigned short | numberOfValidHits () const |
number of valid hits found More... | |
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 | setAlgorithm (const TrackAlgorithm a, bool set=true) |
Track algorithm. More... | |
void | setNLoops (signed char value) |
void | setQuality (const TrackQuality, bool set=true) |
void | setQualityMask (int qualMask) |
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) | |
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 | |
uint8_t | algorithm_ |
track algorithm More... | |
char | charge_ |
electric charge More... | |
float | chi2_ |
chi-squared More... | |
float | covariance_ [covarianceSize] |
perigee 5x5 covariance matrix More... | |
HitPattern | hitPattern_ |
hit pattern More... | |
Vector | momentum_ |
momentum vector at innermost point More... | |
float | ndof_ |
number of degrees of freedom More... | |
signed char | nLoops_ |
number of loops made during the building of the trajectory of a looper particle More... | |
uint8_t | quality_ |
track quality 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 62 of file TrackBase.h.
5 parameter covariance matrix
Definition at line 76 of file TrackBase.h.
typedef unsigned int reco::TrackBase::index |
index type
Definition at line 94 of file TrackBase.h.
parameter vector
Definition at line 73 of file TrackBase.h.
typedef math::XYZPoint reco::TrackBase::Point |
point in the space
Definition at line 82 of file TrackBase.h.
spatial vector
Definition at line 79 of file TrackBase.h.
anonymous enum |
parameter dimension
Enumerator | |
---|---|
dimension |
Definition at line 67 of file TrackBase.h.
anonymous enum |
error matrix size
Enumerator | |
---|---|
covarianceSize |
Definition at line 70 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 85 of file TrackBase.h.
track algorithm
Definition at line 97 of file TrackBase.h.
track quality
Enumerator | |
---|---|
undefQuality | |
loose | |
tight | |
highPurity | |
confirmed | |
goodIterative | |
looseSetWithPV | |
highPuritySetWithPV | |
qualitySize |
Definition at line 133 of file TrackBase.h.
TrackBase::TrackBase | ( | ) |
default constructor
Definition at line 59 of file TrackBase.cc.
References covariance_, dimension, i, customizeTrackingMonitorSeedNumber::idx, and j.
TrackBase::TrackBase | ( | double | chi2, |
double | ndof, | ||
const Point & | vertex, | ||
const Vector & | momentum, | ||
int | charge, | ||
const CovarianceMatrix & | cov, | ||
TrackAlgorithm | algorithm = undefAlgorithm , |
||
TrackQuality | quality = undefQuality , |
||
signed char | nloops = 0 |
||
) |
constructor from fit parameters and error matrix
Definition at line 77 of file TrackBase.cc.
References covariance_, dimension, i, customizeTrackingMonitorSeedNumber::idx, j, and setQuality().
|
virtual |
|
inline |
Definition at line 423 of file TrackBase.h.
References algorithm_.
Referenced by TrackAnalyzer::analyze(), ElectronConversionRejectionValidator::analyze(), TkConvValidator::analyze(), ConversionProducer::buildCollection(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), AlignmentTrackSelector::isOkTrkQuality(), RecoTrackSelector::operator()(), PrintRecoObjects::print(), ShallowTracksProducer::produce(), TrackListMerger::produce(), DuplicateListMerger::produce(), and QcdUeDQM::trackSelection().
|
static |
Definition at line 120 of file TrackBase.cc.
References algoNames, algoSize, spr::find(), findQualityFiles::size, and undefAlgorithm.
Referenced by AlignmentTrackSelector::AlignmentTrackSelector(), BeamFitter::BeamFitter(), QcdUeDQM::QcdUeDQM(), and RecoTrackSelector::RecoTrackSelector().
|
inline |
Definition at line 428 of file TrackBase.h.
References algorithm_, beamhalo, bTagGhostTracks, conversionStep, cosmicGlobalMuon, cosmics, cosmicStandAloneMuon, ctf, detachedTripletStep, globalMuon, gsf, hltIter0, hltIter1, hltIter2, hltIter3, hltIter4, hltIterX, hltPixel, initialStep, inOutEcalSeededConv, iter1LargeD0, iter2LargeD0, iter3LargeD0, iter4LargeD0, iter5LargeD0, jetCoreRegionalStep, lowPtTripletStep, mixedTripletStep, muonSeededStepInOut, muonSeededStepOutIn, nuclInter, outInEcalSeededConv, pixelLessStep, pixelPairStep, rs, standAloneMuon, tobTecStep, and undefAlgorithm.
|
inlinestatic |
Definition at line 588 of file TrackBase.h.
References algoNames, and algoSize.
|
inline |
append a single hit to the HitPattern
Definition at line 394 of file TrackBase.h.
References reco::HitPattern::appendHit(), and hitPattern_.
Referenced by MuonErrorMatrixAdjuster::attachRecHits(), MuonTrackProducer::produce(), PixelTracksProducer::produce(), SeedToTrackProducer::produce(), KfTrackProducerBase::putInEvt(), GsfTrackProducerBase::putInEvt(), TrackProducerWithSCAssociation::putInEvt(), PixelTrackProducer::store(), and pat::PackedCandidate::unpackTrk().
|
inline |
Definition at line 389 of file TrackBase.h.
References reco::HitPattern::appendHit(), and hitPattern_.
bool reco::TrackBase::appendHits | ( | const C & | c | ) |
append hit patterns from vector of hit references
Definition at line 411 of file TrackBase.h.
Referenced by TrackerSeedValidator::analyze().
bool reco::TrackBase::appendHits | ( | const I & | begin, |
const I & | end | ||
) |
Definition at line 405 of file TrackBase.h.
References reco::HitPattern::appendHits(), and hitPattern_.
|
inline |
track electric charge
Definition at line 615 of file TrackBase.h.
References charge_.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), MultiTrackValidatorGenPs::analyze(), MultiTrackValidator::analyze(), ValidationMisalignedTracker::analyze(), EwkMuLumiMonitorDQM::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), 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(), AlignmentMonitorGeneric::event(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), CSCEfficiency::filter(), ConversionFinder::getConversionInfo(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), AlCaHOCalibProducer::getFreeTrajectoryState(), VZeroFinder::getGlobalTrajectoryParameters(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), FWPFTrackUtils::getTrack(), ValidHitPairFilter::getTrajectory(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmmkFilter::initialFreeState(), trajectoryStateTransform::innerFreeState(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), MuonIdProducer::makeMuon(), MuonErrorMatrixAdjuster::makeTrack(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), trajectoryStateTransform::outerFreeState(), fireworks::prepareTrack(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), ShallowTracksProducer::produce(), QuarkoniaTrackSelector::produce(), PFDisplacedTrackerVertexProducer::produce(), pat::PATLostTracks::produce(), DuplicateTrackMerger::produce(), ConversionSeedFilter::produce(), SiStripElectronAssociator::produce(), DuplicateListMerger::produce(), spr::propagateCosmicCALO(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), ptError(), qoverp(), TrackClassifier::reconstructionInformation(), PFAlgo::reconstructTrack(), MuonDTLocalMillepedeAlgorithm::run(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), ElectronMaker::SetVars(), and ConversionProducer::trackD0Cut().
|
inline |
chi-squared of the fit
Definition at line 597 of file TrackBase.h.
References chi2_.
Referenced by SiStripGainFromCalibTree::algoAnalyze(), TrackTypeMonitor::analyze(), TrackAnalyzer::analyze(), TestTrackHits::analyze(), MuonTrackValidator::analyze(), MuonTrackLoader::buildTrackUpdatedAtPCA(), reco::TransientTrack::chi2(), KalmanAlignmentTrackRefitter::debugTrackData(), AlignmentMonitorTracksFromTrajectories::event(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), WtoLNuSelector::filter(), JetVertexChecker::filter(), MuonErrorMatrixAdjuster::makeTrack(), reco::TransientTrack::normalizedChi2(), PixelTrackFilterByKinematics::operator()(), HIPixelTrackFilter::operator()(), HIProtoTrackFilter::operator()(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), TrackListMerger::produce(), DuplicateListMerger::produce(), KalmanAlignmentTrackRefitter::rejectTrack(), MultiTrackSelector::select(), and ElectronMaker::SetVars().
|
inline |
return track covariance matrix
Definition at line 779 of file TrackBase.h.
References fill(), and contentValuesFiles::m.
Referenced by tauImpactParameter::ParticleBuilder::createTrackParticle(), MatcherByPullsAlgorithm::fillInvCov(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmmkFilter::initialFreeState(), MuonErrorMatrixAdjuster::makeTrack(), MuonErrorMatrixAdjuster::makeTrackExtra(), muonisolation::CaloExtractor::MuonAtCaloPosition(), PixelTrackFilterByKinematics::operator()(), reco::print(), ptError(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), and pat::PackedCandidate::setTrackProperties().
|
inline |
(i,j)-th element of covariance matrix (i, j = 0, ... 4)
Definition at line 793 of file TrackBase.h.
References covariance_, and covIndex().
|
inlinestatic |
covariance matrix index in array
Definition at line 416 of file TrackBase.h.
Referenced by covariance(), reco::GsfTrack::covarianceMode(), error(), and reco::GsfTrack::errorMode().
|
inline |
dxy parameter in perigee convention (d0 = -dxy)
Definition at line 645 of file TrackBase.h.
References dxy().
Referenced by TrackTypeMonitor::analyze(), TrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), AlignmentTrackSelector::basicCuts(), PFEGammaProducer::createSingleLegConversions(), AlignmentMonitorGeneric::event(), MillePedeMonitor::fillTrack(), TrackerValidationVariables::fillTrackQuantities(), WtoLNuSelector::filter(), ConversionFinder::getConversionInfo(), CosmicSplitterValidation::is_gold_muon(), PixelTrackFilterByKinematics::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), HIPAlignmentAlgorithm::run(), ElectronMaker::SetVars(), TrackWithVertexSelector::testTrack(), and ConversionProducer::trackD0Cut().
|
inline |
error on d0
Definition at line 850 of file TrackBase.h.
References error(), and i_dxy.
Referenced by TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), PixelTrackFilterByKinematics::operator()(), HIPixelTrackFilter::operator()(), MultiTrackSelector::select(), TrackMultiSelector::testVtx(), 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 651 of file TrackBase.h.
References p(), pt(), px(), py(), pz(), vx(), vy(), and vz().
Referenced by TestOutliers::analyze(), CosmicSplitterValidation::is_gold_muon(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), RecoTrackSelector::operator()(), parameters(), ShallowTracksProducer::produce(), 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 759 of file TrackBase.h.
References p(), pt(), px(), py(), pz(), vx(), vy(), and vz().
|
inline |
error on dsz
Definition at line 856 of file TrackBase.h.
References error(), and i_dsz.
Referenced by ShallowTracksProducer::produce().
|
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 639 of file TrackBase.h.
References pt(), px(), py(), vx(), and vy().
Referenced by TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), CheckHitPattern::analyze(), TkConvValidator::analyze(), TestOutliers::analyze(), HLTMuonMatchAndPlot::analyze(), GenPurposeSkimmerData::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), PrimaryVertexAssignment::chargedHadronVertex(), d0(), KalmanAlignmentTrackRefitter::debugTrackData(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFDisplacedVertexHelper::TracksSelector::dxy(), dxy(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorSegmentDifferences::event(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), PrimaryVertexAnalyzer4PU::getSimEvents(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), PFDisplacedVertexHelper::isTrackSelected(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), HIPixelTrackFilter::operator()(), HIProtoTrackFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), RecoTrackSelector::operator()(), parameters(), PrintRecoObjects::print(), ShallowTracksProducer::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(), HLTMuonMatchAndPlot::selectedMuons(), ElectronMaker::SetVars(), TrackWithVertexSelector::testVertices(), TrackMultiSelector::testVtx(), 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 743 of file TrackBase.h.
References pt(), px(), py(), vx(), and vy().
|
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 751 of file TrackBase.h.
References dxy(), reco::BeamSpot::position(), and vz().
|
inline |
error on dxy
Definition at line 844 of file TrackBase.h.
References error(), and i_dxy.
Referenced by PatTrackAnalyzer::analyze(), MuonTrackValidator::analyze(), PrimaryVertexAssignment::chargedHadronVertex(), reco::RecoChargedRefCandidate::dxyError(), reco::RecoCandidate::dxyError(), reco::PFCandidate::dxyError(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), V0Fitter::fitAll(), PrimaryVertexAnalyzer4PU::getSimEvents(), ShallowTracksProducer::produce(), reco::CentralityProducer::produce(), TrackClassifier::reconstructionInformation(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), ConversionProducer::trackD0Cut(), and QcdUeDQM::trackSelection().
|
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 657 of file TrackBase.h.
References pt(), px(), py(), pz(), vx(), vy(), and vz().
Referenced by TrackTypeMonitor::analyze(), TrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), CheckHitPattern::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), HLTMuonMatchAndPlot::analyze(), CosmicSplitterValidation::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), PrimaryVertexAssignment::chargedHadronVertex(), KalmanAlignmentTrackRefitter::debugTrackData(), AlignmentMonitorGeneric::event(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), MillePedeMonitor::fillTrack(), TrackerValidationVariables::fillTrackQuantities(), WtoLNuSelector::filter(), PFTauVertexSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), ConversionFinder::getConversionInfo(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), muon::isHighPtMuon(), muonisolation::CaloExtractor::MuonAtCaloPosition(), HIPixelTrackFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), JetTracksAssociationDRVertexAssigned::produce(), pat::PATPackedCandidateProducer::produce(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::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(), HLTMuonMatchAndPlot::selectedMuons(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), ElectronMaker::SetVars(), TrackWithVertexSelector::testTrack(), TrackWithVertexSelector::testVertices(), TrackMultiSelector::testVtx(), 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 767 of file TrackBase.h.
References pt(), px(), py(), pz(), vx(), vy(), and vz().
|
inline |
error on dz
Definition at line 862 of file TrackBase.h.
References error(), i_dsz, p(), and pt().
Referenced by TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), reco::RecoChargedRefCandidate::dzError(), reco::RecoCandidate::dzError(), reco::PFCandidate::dzError(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), HIPixelTrackFilter::operator()(), PrimaryVertexAnalyzer4PU::printEventSummary(), reco::CentralityProducer::produce(), TrackClassifier::reconstructionInformation(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), MultiTrackSelector::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), TrackMultiSelector::testVtx(), and QcdUeDQM::trackSelection().
|
inline |
error on specified element
Definition at line 799 of file TrackBase.h.
References covariance_, covIndex(), and mathSSE::sqrt().
Referenced by argparse.ArgumentParser::_get_option_tuples(), python.rootplot.argparse.ArgumentParser::_get_option_tuples(), argparse.ArgumentParser::_parse_known_args(), python.rootplot.argparse.ArgumentParser::_parse_known_args(), argparse.ArgumentParser::_parse_optional(), python.rootplot.argparse.ArgumentParser::_parse_optional(), argparse.ArgumentParser::_read_args_from_files(), python.rootplot.argparse.ArgumentParser::_read_args_from_files(), argparse.ArgumentParser::add_subparsers(), python.rootplot.argparse.ArgumentParser::add_subparsers(), d0Error(), dszError(), dxyError(), dzError(), etaError(), lambdaError(), argparse.ArgumentParser::parse_args(), python.rootplot.argparse.ArgumentParser::parse_args(), argparse.ArgumentParser::parse_known_args(), python.rootplot.argparse.ArgumentParser::parse_known_args(), phiError(), TriggerMatcherToHLTDebug::produce(), qoverpError(), and thetaError().
|
inline |
pseudorapidity of momentum vector
Definition at line 699 of file TrackBase.h.
References momentum_.
Referenced by Particle.Particle::__str__(), Muon.Muon::absEffAreaIso(), DeDxDiscriminatorLearner::algoAnalyze(), SiStripGainFromData::algoAnalyze(), SiStripGainFromCalibTree::algoAnalyze(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), ValidationMisalignedTracker::analyze(), CheckHitPattern::analyze(), GlobalMuonMatchAnalyzer::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), GetTrackTrajInfo::analyze(), HcalIsoTrkAnalyzer::analyze(), CosmicSplitterValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), analyzer::SiPixelLorentzAngle::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), FWTrackProxyBuilder::build(), pat::CaloIsolationEnergy::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), spr::chargeIsolationHcal(), KalmanAlignmentTrackRefitter::debugTrackData(), muonisolation::ExtractorFromDeposits::deposit(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFRecoTauDiscriminationAgainstElectronMVA5::discriminate(), AntiElectronIDCut2::Discriminator(), PrimaryVertexAnalyzer4PU::dumpHitInfo(), MuonCaloCompatibility::evaluate(), AlignmentMonitorGeneric::event(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), TrackerValidationVariables::fillTrackQuantities(), reco::HcalNoiseInfoProducer::filltracks(), MuonAlignmentPreFilter::filter(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), PFElecTkProducer::FindPfRef(), MuonShowerInformationFiller::getCompatibleDets(), Tau3MuReco::getDeltaR(), MuonIdProducer::isGoodTrack(), Jet.Jet::jetID(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), reco::tau::qcuts::minTrackVertexWeight(), AntiElectronIDMVA5::MVAValue(), TrackClassFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), RecoTrackSelector::operator()(), PrimaryVertexAnalyzer4PU::printEventSummary(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), examples::TrackAnalysisAlgorithm::process(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), QuarkoniaTrackSelector::produce(), L3MuonIsolationProducer::produce(), pat::PATLostTracks::produce(), DeDxHitInfoProducer::produce(), OutsideInMuonSeeder::produce(), PFRecoTauChargedHadronProducer::produce(), reco::CentralityProducer::produce(), SeedToTrackProducer::produce(), TriggerMatcherToHLTDebug::produce(), spr::propagateCALO(), Jet.Jet::puJetId(), fireworks::pushPixelHits(), SoftLepton::refineJetAxis(), CutsIsolatorWithCorrection::result(), SimpleCutsIsolator::result(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), AlCaIsoTracksProducer::select(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), TrackWithVertexSelector::testTrack(), EwkMuLumiMonitorDQM::tkIso(), 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 832 of file TrackBase.h.
References error(), i_lambda, p(), and pt().
Referenced by CosmicSplitterValidation::analyze(), TrackAnalyzer::fillHistosForState(), and ShallowTracksProducer::produce().
TrackBase::CovarianceMatrix & TrackBase::fill | ( | CovarianceMatrix & | v | ) | const |
fill SMatrix
Definition at line 103 of file TrackBase.cc.
References covariance_, and reco::fillCovariance().
Referenced by covariance().
|
inline |
Access the hit pattern, indicating in which Tracker layers the track has hits.
Definition at line 384 of file TrackBase.h.
References hitPattern_.
Referenced by TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackAnalyzer::analyze(), PFCheckHitPattern::analyze(), CheckHitPattern::analyze(), TkConvValidator::analyze(), GetTrackTrajInfo::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), spr::coneChargeIsolation(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackAnalyzer::fillHistosForState(), TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), spr::goodTrack(), reco::TransientTrack::hitPattern(), HLTTrackWithHits::hltFilter(), PFMuonAlgo::isTrackerTightMuon(), PFDisplacedVertexHelper::isTrackSelected(), reco::TransientTrack::numberOfLostHits(), reco::TransientTrack::numberOfValidHits(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), TrackClassFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), RecoTrackSelector::operator()(), FWTrackResidualDetailView::prepareData(), PFCheckHitPattern::print(), CheckHitPattern::print(), PFMuonAlgo::printMuonProperties(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), pat::PATLostTracks::produce(), TrackListMerger::produce(), pat::PATPackedCandidateProducer::produce(), DuplicateTrackMerger::produce(), HITrackClusterRemover::produce(), IPProducer< Container, Base, Helper >::produce(), reco::Track::residualX(), reco::Track::residualY(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), TrackMultiSelector::select(), MultiTrackSelector::select(), FWConvTrackHitsDetailView::setTextInfo(), pat::PackedCandidate::setTrackProperties(), ElectronMaker::SetVars(), TrackWithVertexSelector::testTrack(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::trackFilter(), TrackVertexArbitration< VTX >::trackFilterArbitrator(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkPixelHits(), and reco::tau::qcuts::trkTrackerHits().
|
inline |
Definition at line 919 of file TrackBase.h.
References nLoops_.
|
inline |
Lambda angle.
Definition at line 633 of file TrackBase.h.
References M_PI_2, and momentum_.
Referenced by TestOutliers::analyze(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), and parameters().
|
inline |
error on lambda
Definition at line 826 of file TrackBase.h.
References error(), and i_lambda.
Referenced by MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), and PixelTrackFilterByKinematics::operator()().
|
inline |
track momentum vector
Definition at line 723 of file TrackBase.h.
References momentum_.
Referenced by ValidationMisalignedTracker::analyze(), StudyHLT::analyze(), PhotonValidator::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), SiStripFineDelayHit::detId(), EgammaHLTTrackIsolation::electronIsolation(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), CombinedSVComputer::fillCommonVariables(), MillePedeMonitor::fillTrack(), JetVertexChecker::filter(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), VZeroFinder::getGlobalTrajectoryParameters(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), ValidHitPairFilter::getTrajectory(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmmkFilter::initialFreeState(), reco::modules::CosmicTrackSplitter::makeCandidate(), reco::modules::TrackerTrackHitFilter::makeCandidate(), MuonErrorMatrixAdjuster::makeTrack(), TrackMerger::merge(), reco::PFDisplacedVertex::momentum(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), CombinedSVComputer::operator()(), reco::print(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), SeedGeneratorFromProtoTracksEDProducer::produce(), DuplicateListMerger::produce(), SoftLepton::refineJetAxis(), HPSPFRecoTauAlgorithm::refitThreeProng(), ObjectValidator::validTrack(), and reco::IPTagInfo< Container, Base >::variableJTA().
|
inline |
number of degrees of freedom of the fit
Definition at line 603 of file TrackBase.h.
References ndof_.
Referenced by SiStripGainFromCalibTree::algoAnalyze(), TrackTypeMonitor::analyze(), TrackAnalyzer::analyze(), MuonTrackValidator::analyze(), MuonTrackLoader::buildTrackUpdatedAtPCA(), KalmanAlignmentTrackRefitter::debugTrackData(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), WtoLNuSelector::filter(), MuonErrorMatrixAdjuster::makeTrack(), reco::TransientTrack::ndof(), reco::TransientTrack::normalizedChi2(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), DuplicateListMerger::produce(), KalmanAlignmentTrackRefitter::rejectTrack(), MultiTrackSelector::select(), ElectronMaker::SetVars(), and QcdUeDQM::trackSelection().
|
inline |
Definition at line 924 of file TrackBase.h.
References nLoops_.
|
inline |
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)
Definition at line 609 of file TrackBase.h.
Referenced by TrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), helper::SimpleJetTrackAssociator::associate(), helper::SimpleJetTrackAssociator::associateTransient(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), KalmanAlignmentTrackRefitter::debugTrackData(), AlignmentMonitorGeneric::event(), AlignmentMonitorTracksFromTrajectories::event(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackAnalyzer::fillHistosForState(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), TrackerValidationVariables::fillTrackQuantities(), CSCEfficiency::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), PFDisplacedVertexHelper::isTrackSelected(), MuonResidualsFromTrack::normalizedChi2(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), TrackClassFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), RecoTrackSelector::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), DuplicateListMerger::produce(), IPProducer< Container, Base, Helper >::produce(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), TrackMultiSelector::select(), MultiTrackSelector::select(), pat::PackedCandidate::setTrackProperties(), TrackWithVertexSelector::testTrack(), ConversionProducer::trackQualityFilter(), QcdUeDQM::trackSelection(), and reco::tau::qcuts::trkChi2().
|
inline |
number of cases where track crossed a layer without getting a hit.
Definition at line 874 of file TrackBase.h.
References hitPattern_, reco::HitPattern::numberOfLostHits(), and reco::HitPattern::TRACK_HITS.
Referenced by TrackAnalyzer::analyze(), MuonTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), MillePedeMonitor::fillTrack(), TrackerValidationVariables::fillTrackQuantities(), reco::Track::lost(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), TrackListMerger::produce(), TrackMultiSelector::select(), MultiTrackSelector::select(), and TrackWithVertexSelector::testTrack().
|
inline |
number of valid hits found
Definition at line 868 of file TrackBase.h.
References hitPattern_, and reco::HitPattern::numberOfValidHits().
Referenced by SiStripGainFromCalibTree::algoAnalyze(), PatTrackAnalyzer::analyze(), TrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), MuonTrackValidator::analyze(), helper::SimpleJetTrackAssociator::associate(), 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(), TrackAnalyzer::fillHistosForState(), MillePedeMonitor::fillTrack(), TrackerValidationVariables::fillTrackQuantities(), V0Fitter::fitAll(), reco::Track::found(), HLTMuonTrackMassFilter::hltFilter(), PFDisplacedVertexHelper::isTrackSelected(), TrackClassFilter::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), pat::PATLostTracks::produce(), TrackListMerger::produce(), DeDxHitInfoProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MultiTrackSelector::select(), TrackWithVertexSelector::testTrack(), and ObjectValidator::validTrack().
|
inline |
momentum vector magnitude
Definition at line 663 of file TrackBase.h.
References momentum_.
Referenced by PFTrackTransformer::addPoints(), SiStripGainFromData::algoAnalyze(), SiStripGainFromCalibTree::algoAnalyze(), EwkMuLumiMonitorDQM::analyze(), StudyHLT::analyze(), HcalIsoTrkAnalyzer::analyze(), CosmicSplitterValidation::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksNxN::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), AlignmentTrackSelector::basicCuts(), HBHEHitMap::calcTracksNeighborTowers_(), HBHEHitMap::calcTracksSameTowers_(), pat::TrackerIsolationPt::calculate(), spr::chargeIsolation(), spr::chargeIsolationCone(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), IsoTrig::chgIsolation(), spr::coneChargeIsolation(), dsz(), dzError(), etaError(), MuonCaloCompatibility::evaluate(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorSegmentDifferences::event(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), reco::HcalNoiseInfoProducer::filltracks(), MuonAlignmentPreFilter::filter(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), MuonShowerInformationFiller::getCompatibleDets(), ConversionFinder::getConversionInfo(), IsoTrig::getGoodTracks(), MuonIdProducer::isGoodTrack(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), MuonIdTruthInfo::matchChi2(), muonid::matchTracks(), muonisolation::CaloExtractor::MuonAtCaloPosition(), TrackClassFilter::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), ShallowTracksProducer::produce(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), QuarkoniaTrackSelector::produce(), DeDxHitInfoProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateCALO(), ptError(), qoverp(), PFAlgo::reconstructTrack(), MuonTrackingRegionBuilder::region(), HIPAlignmentAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), CSCOverlapsAlignmentAlgorithm::run(), MuonAlignmentFromReference::run(), AlCaIsoTracksProducer::select(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), ElectronMaker::SetVars(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
i-th parameter ( i = 0, ... 4 )
Definition at line 787 of file TrackBase.h.
References i, and parameters().
Referenced by tauImpactParameter::ParticleBuilder::createTrackParticle(), and TriggerMatcherToHLTDebug::produce().
|
inline |
Track parameters with one-to-one correspondence to the covariance matrix.
Definition at line 773 of file TrackBase.h.
References dsz(), dxy(), lambda(), phi(), and qoverp().
Referenced by MuonTrackValidator::analyze(), SiStripFineDelayHit::detId(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::inputTags(), parameter(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::properties(), and Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::recursePSetProperties().
|
inline |
azimuthal angle of momentum vector
Definition at line 693 of file TrackBase.h.
References momentum_.
Referenced by Particle.Particle::__str__(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), HcalIsoTrkAnalyzer::analyze(), CosmicSplitterValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), analyzer::SiPixelLorentzAngle::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), pat::CaloIsolationEnergy::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), spr::chargeIsolationHcal(), AlignmentTwoBodyDecayTrackSelector::checkAcoplanarity(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), KalmanAlignmentTrackRefitter::debugTrackData(), muonisolation::ExtractorFromDeposits::deposit(), 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(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), TrackerValidationVariables::fillTrackQuantities(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), PFElecTkProducer::FindPfRef(), MuonShowerInformationFiller::getCompatibleDets(), Tau3MuReco::getDeltaR(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), CosmicSplitterValidation::is_gold_muon(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), MuonIdTruthInfo::matchChi2(), reco::tau::qcuts::minTrackVertexWeight(), muonisolation::CaloExtractor::MuonAtCaloPosition(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), parameters(), PrimaryVertexAnalyzer4PU::printEventSummary(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), JetTracksAssociationDRVertex::produce(), ShallowTracksProducer::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), pat::PATLostTracks::produce(), pat::PATPackedCandidateProducer::produce(), PFRecoTauChargedHadronProducer::produce(), SeedToTrackProducer::produce(), spr::propagateCALO(), SoftLepton::refineJetAxis(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), AlCaIsoTracksProducer::select(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), EwkMuLumiMonitorDQM::tkIso(), 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 838 of file TrackBase.h.
References error(), and i_phi.
Referenced by TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PFMEtSignInterfaceBase::compResolution(), TrackAnalyzer::fillHistosForState(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), ShallowTracksProducer::produce(), and SeedToTrackProducer::produce().
|
inline |
track transverse momentum
Definition at line 669 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(), MultiTrackValidatorGenPs::analyze(), MultiTrackValidator::analyze(), PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), EwkMuLumiMonitorDQM::analyze(), StudyHLT::analyze(), ElectronConversionRejectionValidator::analyze(), TrackSplittingMonitor::analyze(), GlobalMuonMatchAnalyzer::analyze(), TkConvValidator::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), HcalIsoTrkAnalyzer::analyze(), CosmicSplitterValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), analyzer::SiPixelLorentzAngle::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksNxN::analyze(), MuonTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), FWTrackProxyBuilder::build(), Photon.Photon::calScaledIsoValue(), Tau3MuReco::check4MuonTrack(), KalmanAlignmentTrackRefitter::debugTrackData(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFRecoTauDiscriminationAgainstElectronMVA5::discriminate(), AntiElectronIDCut2::Discriminator(), dsz(), PrimaryVertexAnalyzer4PU::dumpHitInfo(), dxy(), dz(), dzError(), fw::estimate_field(), etaError(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorSegmentDifferences::event(), AlignmentMonitorGeneric::event(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), TrackerValidationVariables::fillTrackQuantities(), reco::HcalNoiseInfoProducer::filltracks(), MuonAlignmentPreFilter::filter(), JetVertexChecker::filter(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), ConversionFinder::getConversionInfo(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTTrackWithHits::hltFilter(), MuonIdProducer::isGoodTrack(), PFDisplacedVertexHelper::isTrackSelected(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), muonid::matchTracks(), reco::tau::qcuts::minTrackVertexWeight(), muonisolation::CaloExtractor::MuonAtCaloPosition(), Electron.Electron::mvaIDLoose(), Electron.Electron::mvaIDTight(), AntiElectronIDMVA5::MVAValue(), PixelTrackFilterByKinematics::operator()(), HIPixelTrackFilter::operator()(), HIProtoTrackFilter::operator()(), reco::TrackSelector::operator()(), CalibrationTrackSelector::ComparePt::operator()(), AlignmentTrackSelector::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), RecoTrackSelector::operator()(), reco::Vertex::TrackEqual::operator()(), fireworks::prepareTrack(), PrimaryVertexAnalyzer4PU::printEventSummary(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), examples::TrackAnalysisAlgorithm::process(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), QuarkoniaTrackSelector::produce(), pat::PATLostTracks::produce(), DeDxHitInfoProducer::produce(), reco::CentralityProducer::produce(), SeedToTrackProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), ptError(), reco::tau::qcuts::ptMin(), SoftLepton::refineJetAxis(), GlobalMuonRefitter::refit(), Lepton.Lepton::relEffAreaIso(), Lepton.Lepton::relIso(), CutsIsolatorWithCorrection::result(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), AnalyticalTrackSelector::run(), MuonDTLocalMillepedeAlgorithm::run(), MultiTrackSelector::run(), MuonAlignmentFromReference::run(), CosmicTrackSelector::select(), TrackMultiSelector::select(), MultiTrackSelector::select(), AlCaIsoTracksProducer::select(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), TrackClusterSplitter::splitCluster(), TrackWithVertexSelector::testTrack(), EwkMuLumiMonitorDQM::tkIso(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::trackFilter(), TrackVertexArbitration< VTX >::trackFilterArbitrator(), reco::PFDisplacedVertex::trackPosition(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), ObjectValidator::validTrack(), and reco::IPTagInfo< Container, Base >::variableJTA().
|
inline |
error on Pt (set to 1000 TeV if charge==0 for safety)
Definition at line 811 of file TrackBase.h.
References charge(), covariance(), i_lambda, i_qoverp, p(), pt(), pz(), and mathSSE::sqrt().
Referenced by PatTrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PFMEtSignInterfaceBase::compResolution(), TrackTypeMonitor::fillHistograms(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), CSCEfficiency::filter(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), PFDisplacedVertexCandidateFinder::goodPtResolution(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), MultiTrackSelector::processMVA(), ShallowTracksProducer::produce(), reco::CentralityProducer::produce(), SeedToTrackProducer::produce(), MultiTrackSelector::select(), TrackWithVertexSelector::testTrack(), and QcdUeDQM::trackSelection().
|
inline |
x coordinate of momentum vector
Definition at line 675 of file TrackBase.h.
References momentum_.
Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), HcalIsoTrkAnalyzer::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), DiJetAnalyzer::analyze(), GammaJetAnalysis::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), dsz(), dummyPrediction(), dxy(), dz(), fw::estimate_field(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), AlCaIsoTracksFilter::filter(), ConversionFinder::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), QuarkoniaTrackSelector::produce(), DeDxHitInfoProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), ElectronMaker::SetVars(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
y coordinate of momentum vector
Definition at line 681 of file TrackBase.h.
References momentum_.
Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), HcalIsoTrkAnalyzer::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), DiJetAnalyzer::analyze(), GammaJetAnalysis::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), dsz(), dummyPrediction(), dxy(), dz(), fw::estimate_field(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), AlCaIsoTracksFilter::filter(), ConversionFinder::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), QuarkoniaTrackSelector::produce(), DeDxHitInfoProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), ElectronMaker::SetVars(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
z coordinate of momentum vector
Definition at line 687 of file TrackBase.h.
References momentum_.
Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), HcalIsoTrkAnalyzer::analyze(), IsoTrackCalib::analyze(), IsoTrackCalibration::analyze(), DiJetAnalyzer::analyze(), GammaJetAnalysis::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollection(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), dsz(), dummyPrediction(), dz(), TrackAnalyzer::fillHistosForState(), TrackerValidationVariables::fillTrackQuantities(), AlCaIsoTracksFilter::filter(), ConversionFinder::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), QuarkoniaTrackSelector::produce(), DeDxHitInfoProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), ptError(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), ElectronMaker::SetVars(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().
|
inline |
q / p
Definition at line 621 of file TrackBase.h.
Referenced by PatTrackAnalyzer::analyze(), TestOutliers::analyze(), TrackTypeMonitor::fillHistograms(), CSCEfficiency::filter(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), spr::goodTrack(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), parameters(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), and ShallowTracksProducer::produce().
|
inline |
error on signed transverse curvature
Definition at line 805 of file TrackBase.h.
References error(), and i_qoverp.
Referenced by PatTrackAnalyzer::analyze(), TestOutliers::analyze(), CSCEfficiency::filter(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), MuonTrackValidator::getRecoMomentum(), spr::goodTrack(), PixelTrackFilterByKinematics::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), and ShallowTracksProducer::produce().
|
inline |
Track quality.
Definition at line 551 of file TrackBase.h.
References confirmed, goodIterative, highPurity, lumiQueryAPI::q, quality_, and undefQuality.
Referenced by PatTrackAnalyzer::analyze(), StudyHLT::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), TemplatedJetProbabilityComputer< Container, Base >::discriminator(), TemplatedJetBProbabilityComputer< Container, Base >::discriminator(), CSCEfficiency::filter(), spr::goodTrack(), IPTagPlotter< Container, Base >::highestTrackQual(), AlignmentTrackSelector::isOkTrkQuality(), PFDisplacedVertexHelper::isTrackSelected(), reco::TrackSelector::operator()(), TrackFilterForPVFinding::operator()(), TrackClassFilter::operator()(), RecoTrackSelector::operator()(), TemplatedTrackCountingComputer< Container, Base >::orderedSignificances(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), HITrackClusterRemover::produce(), ExtraFromSeeds::produce(), reco::CentralityProducer::produce(), spr::propagateCALO(), spr::propagateCosmicCALO(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), TrackWithVertexSelector::testTrack(), and QcdUeDQM::trackSelection().
|
static |
Definition at line 108 of file TrackBase.cc.
References spr::find(), qualityNames, qualitySize, findQualityFiles::size, and undefQuality.
Referenced by AlCaIsoTracksFilter::AlCaIsoTracksFilter(), AlCaIsoTracksProducer::AlCaIsoTracksProducer(), AlignmentTrackSelector::AlignmentTrackSelector(), TrackTypeMonitor::analyze(), StandaloneTrackMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackCount::analyze(), PrimaryVertexValidation::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), BeamFitter::BeamFitter(), QGTagger::calcVariables(), CaloRecoTauTagInfoAlgorithm::CaloRecoTauTagInfoAlgorithm(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), DuplicateListMerger::DuplicateListMerger(), FilterOutScraping::filter(), HcalIsoTrkAnalyzer::HcalIsoTrkAnalyzer(), HITrackClusterRemover::HITrackClusterRemover(), IsolatedTracksHcalScale::IsolatedTracksHcalScale(), IsoTrackCalib::IsoTrackCalib(), IsoTrackCalibration::IsoTrackCalibration(), IsoTrig::IsoTrig(), PFDisplacedVertexHelper::isTrackSelected(), JetPlusTrackProducerAA::JetPlusTrackProducerAA(), LightPFTrackProducer::LightPFTrackProducer(), TrackClassFilter::operator()(), PFTrackProducer::PFTrackProducer(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), SimpleTrackListMerger::produce(), reco::modules::HICaloCompatibleTrackSelector::produce(), PromptTrackCountingComputer::PromptTrackCountingComputer(), spr::propagateCALO(), spr::propagateCosmicCALO(), QcdUeDQM::QcdUeDQM(), QualityCutsAnalyzer::QualityCutsAnalyzer(), RecoTrackSelector::RecoTrackSelector(), SeedClusterRemover::SeedClusterRemover(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), PFMuonAlgo::setParameters(), 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 VertexAssociatorByTracks::VertexAssociatorByTracks().
|
inline |
Definition at line 904 of file TrackBase.h.
References quality_.
Referenced by PrimaryVertexAnalyzer4PU::fillTrackHistos(), DuplicateListMerger::produce(), and MultiTrackSelector::run().
|
inlinestatic |
Definition at line 580 of file TrackBase.h.
References qualityNames, and qualitySize.
Referenced by TkAlCaRecoMonitor::bookHistograms(), IsolatedTracksCone::printTrack(), and IsolatedTracksNxN::printTrack().
|
inline |
Reference point on the track.
Definition at line 729 of file TrackBase.h.
References vertex_.
Referenced by TrackAnalyzer::analyze(), CosmicSplitterValidation::analyze(), SeedFromProtoTrack::init(), MuonErrorMatrixAdjuster::makeTrack(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), pat::PATPackedCandidateProducer::produce(), and DuplicateListMerger::produce().
|
inline |
Sets HitPattern as empty.
Definition at line 399 of file TrackBase.h.
References reco::HitPattern::clear(), and hitPattern_.
|
inline |
Track algorithm.
Definition at line 895 of file TrackBase.h.
References a, algorithm_, and undefAlgorithm.
Referenced by TrackProducerAlgorithm< reco::GsfTrack >::buildTrack(), and TrackListCombiner::produce().
|
inline |
Definition at line 914 of file TrackBase.h.
References nLoops_, and relativeConstraints::value.
|
inline |
Definition at line 565 of file TrackBase.h.
References lumiQueryAPI::q, quality_, and undefQuality.
Referenced by TrackBase().
|
inline |
Definition at line 909 of file TrackBase.h.
References quality_.
Referenced by TrackProducerAlgorithm< reco::Track >::buildTrack().
|
inline |
polar angle
Definition at line 627 of file TrackBase.h.
References momentum_.
Referenced by TrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), TrackSplittingMonitor::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), MuonCaloCompatibility::evaluate(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), TrackAnalyzer::fillHistosForState(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), MatcherByPullsAlgorithm::match(), MuonIdTruthInfo::matchChi2(), muonisolation::CaloExtractor::MuonAtCaloPosition(), PixelTrackFilterByKinematics::operator()(), ShallowTracksProducer::produce(), and Tau.Tau::zImpact().
|
inline |
error on theta
Definition at line 820 of file TrackBase.h.
References error(), and i_lambda.
Referenced by TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), and ShallowTracksProducer::produce().
|
inline |
fraction of valid hits on the track
Definition at line 880 of file TrackBase.h.
References hitPattern_, reco::HitPattern::MISSING_INNER_HITS, reco::HitPattern::MISSING_OUTER_HITS, reco::HitPattern::numberOfLostTrackerHits(), reco::HitPattern::numberOfValidTrackerHits(), reco::HitPattern::TRACK_HITS, and TrackValidation_HighPurity_cff::valid.
|
inline |
reference point on the track. This method is DEPRECATED, please use referencePoint() instead
Definition at line 735 of file TrackBase.h.
References vertex_.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), PFCandWithSuperClusterExtractor::depositFromObject(), Tau.Tau::dxy(), EgammaHLTTrackIsolation::electronIsolation(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), VZeroFinder::getGlobalTrajectoryParameters(), ElectronTkIsolation::getIso(), FWPFTrackUtils::getTrack(), ValidHitPairFilter::getTrajectory(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmmkFilter::initialFreeState(), MuonIdProducer::makeMuon(), reco::print(), SeedGeneratorFromProtoTracksEDProducer::produce(), pat::PATLostTracks::produce(), and TrackWithVertexSelector::testVertices().
|
inline |
x coordinate of the reference point on track
Definition at line 705 of file TrackBase.h.
References vertex_.
Referenced by TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), directionAlongMomentum(), dsz(), dxy(), dz(), fw::estimate_field(), TrackerValidationVariables::fillTrackQuantities(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), fireworks::prepareTrack(), ShallowTracksProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), 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 711 of file TrackBase.h.
References vertex_.
Referenced by TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), directionAlongMomentum(), dsz(), dxy(), dz(), fw::estimate_field(), TrackerValidationVariables::fillTrackQuantities(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), fireworks::prepareTrack(), ShallowTracksProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), 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 717 of file TrackBase.h.
References vertex_.
Referenced by TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollectionTP(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), dsz(), dxy(), dz(), GsfTrackProducerBase::fillMode(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), TrackerValidationVariables::fillTrackQuantities(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), PrimaryVertexAnalyzer4PU::getSimEvents(), MatcherByPullsAlgorithm::match(), ComparePairs::operator()(), fireworks::prepareTrack(), PrimaryVertexAnalyzer4PU::printEventSummary(), PrimaryVertexAnalyzer4PU::printPVTrks(), ShallowTracksProducer::produce(), SiStripElectronAssociator::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), fireworks::pushPixelHits(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), ElectronMaker::SetVars(), and EwkMuLumiMonitorDQM::tkIso().
|
static |
Definition at line 130 of file TrackBase.h.
Referenced by algoByName(), algoName(), TrackAnalyzer::bookHistosForHitProperties(), and MTVHistoProducerAlgoForTracker::bookRecoHistos().
|
private |
track algorithm
Definition at line 374 of file TrackBase.h.
Referenced by algo(), algoName(), and setAlgorithm().
|
private |
|
private |
|
private |
perigee 5x5 covariance matrix
Definition at line 356 of file TrackBase.h.
Referenced by covariance(), error(), fill(), and TrackBase().
|
private |
hit pattern
Definition at line 353 of file TrackBase.h.
Referenced by appendHitPattern(), appendHits(), hitPattern(), numberOfLostHits(), numberOfValidHits(), resetHitPattern(), and validFraction().
|
private |
|
private |
number of degrees of freedom
Definition at line 368 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 380 of file TrackBase.h.
Referenced by isLooper(), nLoops(), and setNLoops().
|
private |
track quality
Definition at line 377 of file TrackBase.h.
Referenced by quality(), qualityMask(), setQuality(), and setQualityMask().
|
static |
Definition at line 145 of file TrackBase.h.
Referenced by qualityByName(), and qualityName().
|
private |
innermost (reference) point on track
Definition at line 362 of file TrackBase.h.
Referenced by referencePoint(), vertex(), vx(), vy(), and vz().