CMS 3D CMS Logo

Public Member Functions | Private Attributes

reco::Track Class Reference

#include <DataFormats/TrackReco/interface/Track.h>

Inheritance diagram for reco::Track:
reco::TrackBase reco::GsfTrack reco::TrackTransientTrack reco::GsfTransientTrack

List of all members.

Public Member Functions

const TrackExtraRefextra () const
 reference to "extra" object
CovarianceMatrixfillInner (CovarianceMatrix &v) const
 fill outermost trajectory state curvilinear errors
CovarianceMatrixfillOuter (CovarianceMatrix &v) const
 fill outermost trajectory state curvilinear errors
unsigned short found () const
 Number of valid hits on track.
unsigned int innerDetId () const
 DetId of the detector on which surface the innermost state is located.
const math::XYZVectorinnerMomentum () const
 momentum vector at the innermost hit position
bool innerOk () const
 return true if the innermost hit is valid
const math::XYZPointinnerPosition () const
 position of the innermost hit
CovarianceMatrix innerStateCovariance () const
 innermost trajectory state curvilinear errors
unsigned short lost () const
 Number of lost (=invalid) hits on track.
unsigned int outerDetId () const
 DetId of the detector on which surface the outermost state is located.
double outerEta () const
 pseudorapidity of the momentum vector at the outermost hit position
const math::XYZVectorouterMomentum () const
 momentum vector at the outermost hit position
bool outerOk () const
 return true if the outermost hit is valid
double outerP () const
 magnitude of momentum vector at the outermost hit position
double outerPhi () const
 azimuthal angle of the momentum vector at the outermost hit position
const math::XYZPointouterPosition () const
 position of the outermost hit
double outerPt () const
 transverse momentum at the outermost hit position
double outerPx () const
 x coordinate of momentum vector at the outermost hit position
double outerPy () const
 y coordinate of momentum vector at the outermost hit position
double outerPz () const
 z coordinate of momentum vector at the outermost hit position
double outerRadius () const
 polar radius of the outermost hit position
CovarianceMatrix outerStateCovariance () const
 outermost trajectory state curvilinear errors
double outerTheta () const
 polar angle of the momentum vector at the outermost hit position
double outerX () const
 x coordinate of the outermost hit position
double outerY () const
 y coordinate of the outermost hit position
double outerZ () const
 z coordinate of the outermost hit position
TrackingRecHitRef recHit (size_t i) const
 Get i-th hit on the track.
trackingRecHit_iterator recHitsBegin () const
 Iterator to first hit on the track.
trackingRecHit_iterator recHitsEnd () const
 Iterator to last hit on the track.
size_t recHitsSize () const
 Get number of RecHits. (Warning, this includes invalid hits, which are not physical hits).
const TrackResidualsresiduals () const
double residualX (int position) const
double residualY (int position) const
PropagationDirection seedDirection () const
 direction of how the hits were sorted in the original seed
edm::RefToBase< TrajectorySeedseedRef () const
void setExtra (const TrackExtraRef &ref)
 set reference to "extra" object
 Track (double chi2, double ndof, const Point &referencePoint, const Vector &momentum, int charge, const CovarianceMatrix &, TrackAlgorithm=undefAlgorithm, TrackQuality quality=undefQuality)
 constructor from fit parameters and error matrix
 Track ()
 default constructor
virtual ~Track ()
 virtual destructor

Private Attributes

TrackExtraRef extra_
 Reference to additional information stored only on RECO.

Detailed Description

This class describes the reconstructed tracks that are stored in the AOD and RECO. It also contains a reference to more detailed information about each track, that is stoed in the TrackExtra object, available only in RECO.

Note that most of the functions provided in this Track class rely on the existance of the TrackExtra object, so will not work on AOD.

The most useful functions are those provided in the TrackBase class from which this inherits, all of which work on AOD.

Author:
Luca Lista, INFN
Version:
Id:
Track.h,v 1.47 2008/05/05 22:56:59 jmuelmen Exp

Definition at line 27 of file Track.h.


Constructor & Destructor Documentation

reco::Track::Track ( ) [inline]

default constructor

Definition at line 30 of file Track.h.

{ }
Track::~Track ( ) [virtual]

virtual destructor

Definition at line 11 of file Track.cc.

              {
}
Track::Track ( double  chi2,
double  ndof,
const Point referencePoint,
const Vector momentum,
int  charge,
const CovarianceMatrix cov,
TrackAlgorithm  algo = undefAlgorithm,
TrackQuality  quality = undefQuality 
)

constructor from fit parameters and error matrix

Definition at line 5 of file Track.cc.

                                                         :
  TrackBase( chi2, ndof, vertex, momentum, charge, cov, algo, quality ) {
}

Member Function Documentation

const TrackExtraRef& reco::Track::extra ( ) const [inline]
CovarianceMatrix& reco::Track::fillInner ( CovarianceMatrix v) const [inline]

fill outermost trajectory state curvilinear errors

Definition at line 57 of file Track.h.

References extra_.

{ return extra_->fillInner( v ); }
CovarianceMatrix& reco::Track::fillOuter ( CovarianceMatrix v) const [inline]

fill outermost trajectory state curvilinear errors

Definition at line 55 of file Track.h.

References extra_.

{ return extra_->fillOuter( v ); }
unsigned short reco::Track::found ( ) const [inline]
unsigned int reco::Track::innerDetId ( ) const [inline]
const math::XYZVector& reco::Track::innerMomentum ( ) const [inline]
bool reco::Track::innerOk ( ) const [inline]
const math::XYZPoint& reco::Track::innerPosition ( ) const [inline]

position of the innermost hit

Definition at line 42 of file Track.h.

References extra_.

Referenced by TrackDetectorAssociator::associate(), IdealHelixParameters::calculate(), TrackEfficiencyMonitor::checkSemiCylinder(), helper::GsfElectronCollectionStoreManager::cloneAndStore(), TrackDetectorAssociator::crossedIP(), directionAlongMomentum(), fw::estimate_field(), IdealHelixParameters::evalCircleCenter(), IdealHelixParameters::evalMomentumatTangentPoint(), IdealHelixParameters::evalTangentPoint(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), cms::HICFTSfromL1orL2::FTSfromStandAlone(), AlCaHOCalibProducer::getFreeTrajectoryState(), trajectoryStateTransform::innerFreeState(), reco::modules::CosmicTrackSplitter::makeCandidate(), reco::modules::TrackerTrackHitFilter::makeCandidate(), fireworks::prepareTrack(), PrintRecoObjects::print(), helper::MuonCollectionStoreManager::processMuon(), helper::TrackCollectionStoreManager::processTrack(), TrackListCombiner::produce(), cms::TrackListMerger::produce(), cms::SimpleTrackListMerger::produce(), reco::modules::CosmicTrackSelector::produce(), FastTrackMerger::produce(), reco::modules::TrackMultiSelector::produce(), reco::modules::AnalyticalTrackSelector::produce(), reco::modules::TrackFullCloneSelectorBase< Selector >::produce(), TrackCandidateProducer::produce(), MuonTrackProducer::produce(), QualityFilter::produce(), L3TkMuonProducer::produce(), reco::modules::HICaloCompatibleTrackSelector::produce(), PropagateToMuon::startingState(), and SiStripFineDelayTOF::trackParameters().

{ return extra_->innerPosition(); }
CovarianceMatrix reco::Track::innerStateCovariance ( ) const [inline]
unsigned short reco::Track::lost ( ) const [inline]

Number of lost (=invalid) hits on track.

Definition at line 102 of file Track.h.

References reco::TrackBase::numberOfLostHits().

Referenced by PrimaryVertexAnalyzer4PU::fillTrackHistos(), and GlobalMuonToMuonProducer::printTrackRecHits().

{return  numberOfLostHits();  }
unsigned int reco::Track::outerDetId ( ) const [inline]
double reco::Track::outerEta ( ) const [inline]

pseudorapidity of the momentum vector at the outermost hit position

Definition at line 89 of file Track.h.

References extra_.

Referenced by BetaCalculatorECAL::addInfoToCandidate(), and EwkMuLumiMonitorDQM::tkIso().

{ return extra_->outerEta(); }
const math::XYZVector& reco::Track::outerMomentum ( ) const [inline]
bool reco::Track::outerOk ( ) const [inline]
double reco::Track::outerP ( ) const [inline]

magnitude of momentum vector at the outermost hit position

Definition at line 83 of file Track.h.

References extra_.

{ return extra_->outerP(); }
double reco::Track::outerPhi ( ) const [inline]

azimuthal angle of the momentum vector at the outermost hit position

Definition at line 87 of file Track.h.

References extra_.

Referenced by BetaCalculatorECAL::addInfoToCandidate(), and EwkMuLumiMonitorDQM::tkIso().

{ return extra_->outerPhi(); }
const math::XYZPoint& reco::Track::outerPosition ( ) const [inline]
double reco::Track::outerPt ( ) const [inline]

transverse momentum at the outermost hit position

Definition at line 85 of file Track.h.

References extra_.

{ return extra_->outerPt(); }
double reco::Track::outerPx ( ) const [inline]

x coordinate of momentum vector at the outermost hit position

Definition at line 71 of file Track.h.

References extra_.

Referenced by AlCaHOCalibProducer::getFreeTrajectoryState(), EcalShowerProperties::getTrajectoryAtOuterPoint(), PlotRecTracks::getTrajectoryAtOuterPoint(), and TrackExtrapolator::propagateTrackToVolume().

{ return extra_->outerPx(); }
double reco::Track::outerPy ( ) const [inline]

y coordinate of momentum vector at the outermost hit position

Definition at line 73 of file Track.h.

References extra_.

Referenced by AlCaHOCalibProducer::getFreeTrajectoryState(), EcalShowerProperties::getTrajectoryAtOuterPoint(), PlotRecTracks::getTrajectoryAtOuterPoint(), and TrackExtrapolator::propagateTrackToVolume().

{ return extra_->outerPy(); }
double reco::Track::outerPz ( ) const [inline]

z coordinate of momentum vector at the outermost hit position

Definition at line 75 of file Track.h.

References extra_.

Referenced by AlCaHOCalibProducer::getFreeTrajectoryState(), EcalShowerProperties::getTrajectoryAtOuterPoint(), PlotRecTracks::getTrajectoryAtOuterPoint(), and TrackExtrapolator::propagateTrackToVolume().

{ return extra_->outerPz(); }
double reco::Track::outerRadius ( ) const [inline]

polar radius of the outermost hit position

Definition at line 93 of file Track.h.

References extra_.

{ return extra_->outerRadius(); }
CovarianceMatrix reco::Track::outerStateCovariance ( ) const [inline]
double reco::Track::outerTheta ( ) const [inline]

polar angle of the momentum vector at the outermost hit position

Definition at line 91 of file Track.h.

References extra_.

{ return extra_->outerTheta(); }    
double reco::Track::outerX ( ) const [inline]

x coordinate of the outermost hit position

Definition at line 77 of file Track.h.

References extra_.

Referenced by AlCaHOCalibProducer::getFreeTrajectoryState(), EcalShowerProperties::getTrajectoryAtOuterPoint(), PlotRecTracks::getTrajectoryAtOuterPoint(), and TrackExtrapolator::propagateTrackToVolume().

{ return extra_->outerX(); }
double reco::Track::outerY ( ) const [inline]

y coordinate of the outermost hit position

Definition at line 79 of file Track.h.

References extra_.

Referenced by AlCaHOCalibProducer::getFreeTrajectoryState(), EcalShowerProperties::getTrajectoryAtOuterPoint(), PlotRecTracks::getTrajectoryAtOuterPoint(), and TrackExtrapolator::propagateTrackToVolume().

{ return extra_->outerY(); }
double reco::Track::outerZ ( ) const [inline]

z coordinate of the outermost hit position

Definition at line 81 of file Track.h.

References extra_.

Referenced by AlCaHOCalibProducer::getFreeTrajectoryState(), EcalShowerProperties::getTrajectoryAtOuterPoint(), PlotRecTracks::getTrajectoryAtOuterPoint(), and TrackExtrapolator::propagateTrackToVolume().

{ return extra_->outerZ(); }
TrackingRecHitRef reco::Track::recHit ( size_t  i) const [inline]
trackingRecHit_iterator reco::Track::recHitsBegin ( ) const [inline]

Iterator to first hit on the track.

Definition at line 63 of file Track.h.

References extra_.

Referenced by FWConvTrackHitsDetailView::addModules(), FWTrackHitsDetailView::addModules(), fireworks::addSiStripClusters(), TrackSplittingMonitor::analyze(), RPCRecHitProbability::analyze(), SegmentTrackAnalyzer::analyze(), RPCMonitorDigi::analyze(), CosmicSplitterValidation::analyze(), SegmentsTrackAssociator::associate(), QuickTrackAssociatorByHits::associateRecoToSimImplementation(), MuonErrorMatrixAdjuster::attachRecHits(), FWTracksModulesProxyBuilder::build(), FWTrackTrackingRecHitProxyBuilder::build(), AlignmentTrackSelector::checkPrescaledHits(), helper::GsfElectronCollectionStoreManager::cloneAndStore(), SiStripFineDelayHit::closestCluster(), helper::MuonCollectionStoreManager::clusterRefsOK(), RecoMuonValidator::countMuonHits(), RecoMuonValidator::countTrackerHits(), AlignmentTrackSelector::detailedHitsCheck(), CalibrationTrackSelector::detailedHitsCheck(), PrimaryVertexAnalyzer4PU::dumpHitInfo(), TkAlCaRecoMonitor::fillHitmaps(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), MuonAlignmentPreFilter::filter(), FastTrackMerger::findId(), TrackCandidateProducer::findId(), QuickTrackAssociatorByHits::getAllSimTrackIdentifiers(), GlobalTrajectoryBuilderBase::getTransientRecHits(), GlobalCosmicMuonTrajectoryBuilder::getTransientRecHits(), GlobalCosmicMuonTrajectoryBuilder::isTraversing(), MuonSegmentMatcher::matchCSC(), MuonSegmentMatcher::matchDT(), spr::matchedSimTrack(), ConversionHitChecker::nSharedHits(), FWTrackResidualDetailView::prepareData(), GlobalMuonToMuonProducer::printTrackRecHits(), helper::MuonCollectionStoreManager::processMuon(), helper::TrackCollectionStoreManager::processTrack(), FastTrackMerger::produce(), reco::modules::CosmicTrackSelector::produce(), cms::TrackListMerger::produce(), reco::modules::TrackMultiSelector::produce(), reco::modules::AnalyticalTrackSelector::produce(), SiStripElectronAssociator::produce(), reco::modules::TrackFullCloneSelectorBase< Selector >::produce(), reco::modules::CosmicTrackSplitter::produce(), MuonTrackProducer::produce(), TrackClusterSplitter::produce(), L3TkMuonProducer::produce(), reco::modules::HICaloCompatibleTrackSelector::produce(), reco::modules::TrackerTrackHitFilter::produceFromTrack(), fireworks::pushNearbyPixelHits(), fireworks::pushPixelHits(), TSGForRoadSearch::pushTrajectorySeed(), SiStripFineDelayHit::rechit(), reco::TransientTrack::recHitsBegin(), reco::modules::CosmicTrackSelector::select(), ora::QueryableVector< Item >::select(), and CosmicMuonLinksProducer::sharedHits().

{ return extra_->recHitsBegin(); }
trackingRecHit_iterator reco::Track::recHitsEnd ( ) const [inline]

Iterator to last hit on the track.

Definition at line 65 of file Track.h.

References extra_.

Referenced by FWConvTrackHitsDetailView::addModules(), FWTrackHitsDetailView::addModules(), fireworks::addSiStripClusters(), TrackSplittingMonitor::analyze(), RPCRecHitProbability::analyze(), SegmentTrackAnalyzer::analyze(), RPCMonitorDigi::analyze(), CosmicSplitterValidation::analyze(), SegmentsTrackAssociator::associate(), QuickTrackAssociatorByHits::associateRecoToSimImplementation(), MuonErrorMatrixAdjuster::attachRecHits(), FWTracksModulesProxyBuilder::build(), FWTrackTrackingRecHitProxyBuilder::build(), AlignmentTrackSelector::checkPrescaledHits(), helper::GsfElectronCollectionStoreManager::cloneAndStore(), SiStripFineDelayHit::closestCluster(), helper::MuonCollectionStoreManager::clusterRefsOK(), RecoMuonValidator::countMuonHits(), RecoMuonValidator::countTrackerHits(), AlignmentTrackSelector::detailedHitsCheck(), CalibrationTrackSelector::detailedHitsCheck(), SiStripFineDelayHit::detId(), PrimaryVertexAnalyzer4PU::dumpHitInfo(), TkAlCaRecoMonitor::fillHitmaps(), MillePedeMonitor::fillTrack(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), MuonAlignmentPreFilter::filter(), FastTrackMerger::findId(), TrackCandidateProducer::findId(), QuickTrackAssociatorByHits::getAllSimTrackIdentifiers(), GlobalTrajectoryBuilderBase::getTransientRecHits(), GlobalCosmicMuonTrajectoryBuilder::getTransientRecHits(), GlobalCosmicMuonTrajectoryBuilder::isTraversing(), MuonSegmentMatcher::matchCSC(), MuonSegmentMatcher::matchDT(), spr::matchedSimTrack(), ConversionHitChecker::nSharedHits(), GlobalMuonToMuonProducer::printTrackRecHits(), helper::MuonCollectionStoreManager::processMuon(), helper::TrackCollectionStoreManager::processTrack(), FastTrackMerger::produce(), reco::modules::CosmicTrackSelector::produce(), cms::TrackListMerger::produce(), reco::modules::TrackMultiSelector::produce(), reco::modules::AnalyticalTrackSelector::produce(), SiStripElectronAssociator::produce(), reco::modules::TrackFullCloneSelectorBase< Selector >::produce(), reco::modules::CosmicTrackSplitter::produce(), MuonTrackProducer::produce(), TrackClusterSplitter::produce(), L3TkMuonProducer::produce(), reco::modules::HICaloCompatibleTrackSelector::produce(), reco::modules::TrackerTrackHitFilter::produceFromTrack(), fireworks::pushNearbyPixelHits(), fireworks::pushPixelHits(), TSGForRoadSearch::pushTrajectorySeed(), SiStripFineDelayHit::rechit(), reco::TransientTrack::recHitsEnd(), reco::modules::CosmicTrackSelector::select(), ora::QueryableVector< Item >::select(), and CosmicMuonLinksProducer::sharedHits().

{ return extra_->recHitsEnd(); }
size_t reco::Track::recHitsSize ( ) const [inline]
const TrackResiduals& reco::Track::residuals ( ) const [inline]
double Track::residualX ( int  position) const

return the residual (local x/y) for the hit in the ith position; this position is aligned with the position in the HitPattern

Definition at line 14 of file Track.cc.

References extra_, and reco::TrackBase::hitPattern().

Referenced by TrackVertexArbitration::trackVertexArbitrator().

{
     return extra_->residuals().residualX(position, hitPattern());
}
double Track::residualY ( int  position) const

Definition at line 19 of file Track.cc.

References extra_, and reco::TrackBase::hitPattern().

Referenced by TrackVertexArbitration::trackVertexArbitrator().

{
     return extra_->residuals().residualY(position, hitPattern());
}
PropagationDirection reco::Track::seedDirection ( ) const [inline]
edm::RefToBase<TrajectorySeed> reco::Track::seedRef ( ) const [inline]
void reco::Track::setExtra ( const TrackExtraRef ref) [inline]

Member Data Documentation