CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Static Public Member Functions | Static Public Attributes | Private Attributes
reco::TrackBase Class Reference

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

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

Public Types

enum  { dimension = 5 }
 parameter dimension More...
 
enum  { covarianceSize = dimension * (dimension + 1) / 2 }
 error matrix size More...
 
enum  {
  i_qoverp = 0, i_lambda, i_phi, i_dxy,
  i_dsz
}
 enumerator provided indices to the five parameters More...
 
typedef std::bitset< algoSizeAlgoMask
 algo mask More...
 
typedef math::Error< dimension >::type CovarianceMatrix
 5 parameter covariance matrix More...
 
typedef unsigned int index
 index type More...
 
typedef math::Vector< dimension >::type ParameterVector
 parameter vector More...
 
typedef math::XYZPoint Point
 point in the space More...
 
enum  TrackAlgorithm {
  undefAlgorithm = 0, ctf = 1, duplicateMerge = 2, cosmics = 3,
  initialStep = 4, lowPtTripletStep = 5, pixelPairStep = 6, detachedTripletStep = 7,
  mixedTripletStep = 8, pixelLessStep = 9, tobTecStep = 10, jetCoreRegionalStep = 11,
  conversionStep = 12, muonSeededStepInOut = 13, muonSeededStepOutIn = 14, outInEcalSeededConv = 15,
  inOutEcalSeededConv = 16, nuclInter = 17, standAloneMuon = 18, globalMuon = 19,
  cosmicStandAloneMuon = 20, cosmicGlobalMuon = 21, highPtTripletStep = 22, lowPtQuadStep = 23,
  detachedQuadStep = 24, reservedForUpgrades1 = 25, reservedForUpgrades2 = 26, bTagGhostTracks = 27,
  beamhalo = 28, gsf = 29, hltPixel = 30, hltIter0 = 31,
  hltIter1 = 32, hltIter2 = 33, hltIter3 = 34, hltIter4 = 35,
  hltIterX = 36, hiRegitMuInitialStep = 37, hiRegitMuLowPtTripletStep = 38, hiRegitMuPixelPairStep = 39,
  hiRegitMuDetachedTripletStep = 40, hiRegitMuMixedTripletStep = 41, hiRegitMuPixelLessStep = 42, hiRegitMuTobTecStep = 43,
  hiRegitMuMuonSeededStepInOut = 44, hiRegitMuMuonSeededStepOutIn = 45, algoSize = 46
}
 track algorithm More...
 
enum  TrackQuality {
  undefQuality = -1, loose = 0, tight = 1, highPurity = 2,
  confirmed = 3, goodIterative = 4, looseSetWithPV = 5, highPuritySetWithPV = 6,
  discarded = 7, qualitySize = 8
}
 track quality More...
 
typedef math::XYZVector Vector
 spatial vector More...
 

Public Member Functions

TrackAlgorithm algo () const
 
AlgoMask algoMask () const
 
unsigned long long algoMaskUL () const
 
std::string algoName () const
 
bool appendHitPattern (const TrackingRecHit &hit, const TrackerTopology &ttopo)
 append a single hit to the HitPattern More...
 
bool appendHitPattern (const DetId &id, TrackingRecHit::Type hitType, const TrackerTopology &ttopo)
 
bool appendHitPattern (const uint16_t pattern, TrackingRecHit::Type hitType)
 
template<typename C >
bool appendHits (const C &c, const TrackerTopology &ttopo)
 append hit patterns from vector of hit references More...
 
template<typename I >
bool appendHits (const I &begin, const I &end, const TrackerTopology &ttopo)
 
bool appendMuonHitPattern (const DetId &id, TrackingRecHit::Type hitType)
 
bool appendTrackerHitPattern (uint16_t subdet, uint16_t layer, uint16_t stereo, TrackingRecHit::Type hitType)
 
double beta () const
 velocity at the reference point in natural units More...
 
double betaError () const
 error on beta More...
 
int charge () const
 track electric charge More...
 
double chi2 () const
 chi-squared of the fit More...
 
CovarianceMatrix covariance () const
 return track covariance matrix More...
 
double covariance (int i, int j) const
 (i,j)-th element of covariance matrix (i, j = 0, ... 4) More...
 
double covBetaBeta () const
 error on beta More...
 
double covt0t0 () const
 error on t0 More...
 
double d0 () const
 dxy parameter in perigee convention (d0 = -dxy) More...
 
double d0Error () const
 error on d0 More...
 
double dsz () const
 dsz parameter (THIS IS NOT the SZ impact parameter to (0,0,0) if refPoint is far from (0,0,0): see parametrization definition above for details) More...
 
double dsz (const Point &myBeamSpot) const
 dsz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the distance in the S-Z plane to the beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More...
 
double dszError () const
 error on dsz More...
 
double dxy () const
 dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close to (0,0,0): see parametrization definition above for details). See also function dxy(myBeamSpot). More...
 
double dxy (const Point &myBeamSpot) const
 dxy parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More...
 
double dxy (const BeamSpot &theBeamSpot) const
 dxy parameter with respect to the beamSpot taking into account the beamspot slopes (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More...
 
double dxyError () const
 error on dxy More...
 
double dxyError (Point const &vtx, math::Error< 3 >::type const &vertexCov) const
 error on dxy with respect to a user-given reference point + uncertainty (i.e. reco::Vertex position) More...
 
double dxyError (const BeamSpot &theBeamSpot) const
 error on dxy with respect to a user-given beamspot More...
 
double dz () const
 dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to (0,0,0). See also function dz(myBeamSpot) More...
 
double dz (const Point &myBeamSpot) const
 dz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the track z0, if the beamSpot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks. More...
 
double dzError () const
 error on dz More...
 
double error (int i) const
 error on specified element More...
 
double eta () const
 pseudorapidity of momentum vector More...
 
double etaError () const
 error on eta More...
 
CovarianceMatrixfill (CovarianceMatrix &v) const
 fill SMatrix More...
 
const HitPatternhitPattern () const
 Access the hit pattern, indicating in which Tracker layers the track has hits. More...
 
bool isAlgoInMask (TrackAlgorithm a) const
 
bool isLooper () const
 
bool isTimeOk () const
 return true if timing measurement is usable More...
 
double lambda () const
 Lambda angle. More...
 
double lambdaError () const
 error on lambda More...
 
const Vectormomentum () const
 track momentum vector More...
 
double ndof () const
 number of degrees of freedom of the fit More...
 
signed char nLoops () const
 
double normalizedChi2 () const
 chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero) More...
 
unsigned short numberOfLostHits () const
 number of cases where track crossed a layer without getting a hit. More...
 
unsigned short numberOfValidHits () const
 number of valid hits found More...
 
TrackAlgorithm originalAlgo () const
 
double p () const
 momentum vector magnitude More...
 
double parameter (int i) const
 i-th parameter ( i = 0, ... 4 ) More...
 
ParameterVector parameters () const
 Track parameters with one-to-one correspondence to the covariance matrix. More...
 
double phi () const
 azimuthal angle of momentum vector More...
 
double phiError () const
 error on phi More...
 
double pt () const
 track transverse momentum More...
 
double ptError () const
 error on Pt (set to 1000 TeV if charge==0 for safety) More...
 
double px () const
 x coordinate of momentum vector More...
 
double py () const
 y coordinate of momentum vector More...
 
double pz () const
 z coordinate of momentum vector More...
 
double qoverp () const
 q / p More...
 
double qoverpError () const
 error on signed transverse curvature More...
 
bool quality (const TrackQuality) const
 Track quality. More...
 
int qualityMask () const
 
const PointreferencePoint () const
 Reference point on the track. More...
 
void resetHitPattern ()
 Sets HitPattern as empty. More...
 
void setAlgoMask (AlgoMask a)
 
void setAlgorithm (const TrackAlgorithm a)
 Track algorithm. More...
 
void setNLoops (signed char value)
 
void setOriginalAlgorithm (const TrackAlgorithm a)
 
void setQuality (const TrackQuality)
 
void setQualityMask (int qualMask)
 
void setStopReason (uint8_t value)
 
uint8_t stopReason () const
 
double t0 () const
 time at the reference point More...
 
double t0Error () const
 error on t0 More...
 
double theta () const
 polar angle More...
 
double thetaError () const
 error on theta More...
 
 TrackBase ()
 default constructor More...
 
 TrackBase (double chi2, double ndof, const Point &vertex, const Vector &momentum, int charge, const CovarianceMatrix &cov, TrackAlgorithm=undefAlgorithm, TrackQuality quality=undefQuality, signed char nloops=0, uint8_t stopReason=0, float t0=0.f, float beta=0.f, float covt0t0=-1.f, float covbetabeta=-1.f)
 constructor from fit parameters and error matrix More...
 
double validFraction () const
 fraction of valid hits on the track More...
 
const Pointvertex () const
 reference point on the track. This method is DEPRECATED, please use referencePoint() instead More...
 
double vx () const
 x coordinate of the reference point on track More...
 
double vy () const
 y coordinate of the reference point on track More...
 
double vz () const
 z coordinate of the reference point on track More...
 
virtual ~TrackBase ()
 virtual destructor More...
 

Static Public Member Functions

static TrackAlgorithm algoByName (const std::string &name)
 
static std::string algoName (TrackAlgorithm)
 
static index covIndex (index i, index j)
 covariance matrix index in array More...
 
static TrackQuality qualityByName (const std::string &name)
 
static std::string qualityName (TrackQuality)
 

Static Public Attributes

static const std::string algoNames []
 
static const std::string qualityNames []
 

Private Attributes

std::bitset< algoSizealgoMask_
 algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping by the listmerger More...
 
uint8_t algorithm_
 track algorithm More...
 
float beta_
 
char charge_
 electric charge More...
 
float chi2_
 chi-squared More...
 
float covariance_ [covarianceSize]
 perigee 5x5 covariance matrix More...
 
float covbetabeta_
 
float covt0t0_
 errors for time and velocity (separate from cov for now) More...
 
HitPattern hitPattern_
 hit pattern More...
 
Vector momentum_
 momentum vector at innermost point More...
 
float ndof_
 number of degrees of freedom More...
 
signed char nLoops_
 number of loops made during the building of the trajectory of a looper particle More...
 
uint8_t originalAlgorithm_
 track algorithm More...
 
uint8_t quality_
 track quality More...
 
uint8_t stopReason_
 Stop Reason. More...
 
float t0_
 time at the reference point on track More...
 
Point vertex_
 innermost (reference) point on track More...
 

Detailed Description

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

Author
Thomas Speer, Luca Lista, Pascal Vanlaer, Juan Alcaraz

Definition at line 63 of file TrackBase.h.

Member Typedef Documentation

typedef std::bitset<algoSize> reco::TrackBase::AlgoMask

algo mask

Definition at line 146 of file TrackBase.h.

5 parameter covariance matrix

Definition at line 77 of file TrackBase.h.

typedef unsigned int reco::TrackBase::index

index type

Definition at line 95 of file TrackBase.h.

parameter vector

Definition at line 74 of file TrackBase.h.

point in the space

Definition at line 83 of file TrackBase.h.

spatial vector

Definition at line 80 of file TrackBase.h.

Member Enumeration Documentation

anonymous enum

parameter dimension

Enumerator
dimension 

Definition at line 68 of file TrackBase.h.

anonymous enum

error matrix size

Enumerator
covarianceSize 

Definition at line 71 of file TrackBase.h.

anonymous enum

enumerator provided indices to the five parameters

Enumerator
i_qoverp 
i_lambda 
i_phi 
i_dxy 
i_dsz 

Definition at line 86 of file TrackBase.h.

track algorithm

Enumerator
undefAlgorithm 
ctf 
duplicateMerge 
cosmics 
initialStep 
lowPtTripletStep 
pixelPairStep 
detachedTripletStep 
mixedTripletStep 
pixelLessStep 
tobTecStep 
jetCoreRegionalStep 
conversionStep 
muonSeededStepInOut 
muonSeededStepOutIn 
outInEcalSeededConv 
inOutEcalSeededConv 
nuclInter 
standAloneMuon 
globalMuon 
cosmicStandAloneMuon 
cosmicGlobalMuon 
highPtTripletStep 
lowPtQuadStep 
detachedQuadStep 
reservedForUpgrades1 
reservedForUpgrades2 
bTagGhostTracks 
beamhalo 
gsf 
hltPixel 
hltIter0 
hltIter1 
hltIter2 
hltIter3 
hltIter4 
hltIterX 
hiRegitMuInitialStep 
hiRegitMuLowPtTripletStep 
hiRegitMuPixelPairStep 
hiRegitMuDetachedTripletStep 
hiRegitMuMixedTripletStep 
hiRegitMuPixelLessStep 
hiRegitMuTobTecStep 
hiRegitMuMuonSeededStepInOut 
hiRegitMuMuonSeededStepOutIn 
algoSize 

Definition at line 99 of file TrackBase.h.

99  {
100  undefAlgorithm = 0, ctf = 1,
101  duplicateMerge = 2, cosmics = 3,
102  initialStep = 4,
103  lowPtTripletStep = 5,
104  pixelPairStep = 6,
106  mixedTripletStep = 8,
107  pixelLessStep = 9,
108  tobTecStep = 10,
109  jetCoreRegionalStep = 11,
110  conversionStep = 12,
111  muonSeededStepInOut = 13,
112  muonSeededStepOutIn = 14,
114  nuclInter = 17,
116  // Phase1
119  bTagGhostTracks = 27,
120  beamhalo = 28,
121  gsf = 29,
122  // HLT algo name
123  hltPixel = 30,
124  // steps used by PF
125  hltIter0 = 31,
126  hltIter1 = 32,
127  hltIter2 = 33,
128  hltIter3 = 34,
129  hltIter4 = 35,
130  // steps used by all other objects @HLT
131  hltIterX = 36,
132  // steps used by HI muon regional iterative tracking
139  hiRegitMuTobTecStep = 43,
142  algoSize = 46
143  };

track quality

Enumerator
undefQuality 
loose 
tight 
highPurity 
confirmed 
goodIterative 
looseSetWithPV 
highPuritySetWithPV 
discarded 
qualitySize 

Definition at line 151 of file TrackBase.h.

151  {
152  undefQuality = -1,
153  loose = 0,
154  tight = 1,
155  highPurity = 2,
156  confirmed = 3, // means found by more than one iteration
157  goodIterative = 4, // meaningless
158  looseSetWithPV = 5,
160  discarded = 7, // because a better track found. kept in the collection for reference....
161  qualitySize = 8
162  };

Constructor & Destructor Documentation

TrackBase::TrackBase ( )

default constructor

Definition at line 69 of file TrackBase.cc.

References algoMask_, algorithm_, covariance_, dimension, mps_fire::i, and training_settings::idx.

69  :
70  covt0t0_(-1.f),
71  covbetabeta_(-1.f),
72  chi2_(0),
73  vertex_(0, 0, 0),
74  t0_(0),
75  momentum_(0, 0, 0),
76  beta_(0),
77  ndof_(0),
78  charge_(0),
81  quality_(0),
82  nLoops_(0),
83  stopReason_(0)
84 {
85  algoMask_.set(algorithm_);
86  index idx = 0;
87  for (index i = 0; i < dimension; ++i) {
88  for (index j = 0; j <= i; ++j) {
89  covariance_[idx++] = 0;
90  }
91  }
92 }
uint8_t stopReason_
Stop Reason.
Definition: TrackBase.h:481
float chi2_
chi-squared
Definition: TrackBase.h:443
unsigned int index
index type
Definition: TrackBase.h:95
uint8_t quality_
track quality
Definition: TrackBase.h:475
uint8_t originalAlgorithm_
track algorithm
Definition: TrackBase.h:471
char charge_
electric charge
Definition: TrackBase.h:465
Point vertex_
innermost (reference) point on track
Definition: TrackBase.h:446
float covbetabeta_
Definition: TrackBase.h:440
signed char nLoops_
number of loops made during the building of the trajectory of a looper particle
Definition: TrackBase.h:478
std::bitset< algoSize > algoMask_
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping ...
Definition: TrackBase.h:459
double f[11][100]
float covt0t0_
errors for time and velocity (separate from cov for now)
Definition: TrackBase.h:440
float ndof_
number of degrees of freedom
Definition: TrackBase.h:462
float t0_
time at the reference point on track
Definition: TrackBase.h:449
float covariance_[covarianceSize]
perigee 5x5 covariance matrix
Definition: TrackBase.h:437
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
uint8_t algorithm_
track algorithm
Definition: TrackBase.h:468
TrackBase::TrackBase ( double  chi2,
double  ndof,
const Point vertex,
const Vector momentum,
int  charge,
const CovarianceMatrix cov,
TrackAlgorithm  algorithm = undefAlgorithm,
TrackQuality  quality = undefQuality,
signed char  nloops = 0,
uint8_t  stopReason = 0,
float  t0 = 0.f,
float  beta = 0.f,
float  covt0t0 = -1.f,
float  covbetabeta = -1.f 
)

constructor from fit parameters and error matrix

Definition at line 94 of file TrackBase.cc.

References algoMask_, algorithm_, covariance_, dimension, mps_fire::i, training_settings::idx, and setQuality().

97  :
99  covbetabeta_(covbetabeta),
100  chi2_(chi2),
101  vertex_(vertex),
102  t0_(t0),
103  momentum_(momentum),
104  beta_(beta),
105  ndof_(ndof),
106  charge_(charge),
109  quality_(0),
110  nLoops_(nloops),
112 {
113  algoMask_.set(algorithm_);
114 
115  index idx = 0;
116  for (index i = 0; i < dimension; ++i) {
117  for (index j = 0; j <= i; ++j) {
118  covariance_[idx++] = cov(i, j);
119  }
120  }
121  setQuality(quality);
122 }
uint8_t stopReason_
Stop Reason.
Definition: TrackBase.h:481
float chi2_
chi-squared
Definition: TrackBase.h:443
double t0() const
time at the reference point
Definition: TrackBase.h:726
void setQuality(const TrackQuality)
Definition: TrackBase.h:562
unsigned int index
index type
Definition: TrackBase.h:95
uint8_t quality_
track quality
Definition: TrackBase.h:475
uint8_t originalAlgorithm_
track algorithm
Definition: TrackBase.h:471
char charge_
electric charge
Definition: TrackBase.h:465
Point vertex_
innermost (reference) point on track
Definition: TrackBase.h:446
uint8_t stopReason() const
Definition: TrackBase.h:429
float covbetabeta_
Definition: TrackBase.h:440
signed char nLoops_
number of loops made during the building of the trajectory of a looper particle
Definition: TrackBase.h:478
double beta() const
velocity at the reference point in natural units
Definition: TrackBase.h:732
double chi2() const
chi-squared of the fit
Definition: TrackBase.h:588
std::bitset< algoSize > algoMask_
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping ...
Definition: TrackBase.h:459
double ndof() const
number of degrees of freedom of the fit
Definition: TrackBase.h:594
float covt0t0_
errors for time and velocity (separate from cov for now)
Definition: TrackBase.h:440
float ndof_
number of degrees of freedom
Definition: TrackBase.h:462
double covt0t0() const
error on t0
Definition: TrackBase.h:871
float t0_
time at the reference point on track
Definition: TrackBase.h:449
float covariance_[covarianceSize]
perigee 5x5 covariance matrix
Definition: TrackBase.h:437
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
int charge() const
track electric charge
Definition: TrackBase.h:606
uint8_t algorithm_
track algorithm
Definition: TrackBase.h:468
TrackBase::~TrackBase ( )
virtual

virtual destructor

Definition at line 124 of file TrackBase.cc.

125 {
126  ;
127 }

Member Function Documentation

TrackBase::TrackAlgorithm reco::TrackBase::algo ( ) const
inline
TrackBase::TrackAlgorithm TrackBase::algoByName ( const std::string &  name)
static

Definition at line 146 of file TrackBase.cc.

References algoNames, algoSize, spr::find(), findQualityFiles::size, and undefAlgorithm.

Referenced by AlignmentTrackSelector::AlignmentTrackSelector(), BeamFitter::BeamFitter(), TCMETAlgo::configure(), TrackingNtuple::fillSeeds(), isAlgoInMask(), cms::MuonTCMETValueMapProducer::MuonTCMETValueMapProducer(), QcdUeDQM::QcdUeDQM(), RecoTrackSelectorBase::RecoTrackSelectorBase(), TrackAlgoPriorityOrderESProducer::TrackAlgoPriorityOrderESProducer(), and EleTkIsolFromCands::TrkCuts::TrkCuts().

147 {
149  int index = std::find(algoNames, algoNames + size, name) - algoNames;
150  if (index == size) {
151  return undefAlgorithm; // better this or throw() ?
152  }
153 
154  // cast
155  return TrackAlgorithm(index);
156 }
size
Write out results.
unsigned int index
index type
Definition: TrackBase.h:95
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
Definition: FindCaloHit.cc:20
TrackAlgorithm
track algorithm
Definition: TrackBase.h:99
static const std::string algoNames[]
Definition: TrackBase.h:148
AlgoMask reco::TrackBase::algoMask ( ) const
inline

Definition at line 393 of file TrackBase.h.

References algoMask_.

Referenced by algoMaskUL(), isAlgoInMask(), RecoTrackSelectorBase::operator()(), and BadGlobalMuonTagger::outInOnly().

393 { return algoMask_;}
std::bitset< algoSize > algoMask_
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping ...
Definition: TrackBase.h:459
unsigned long long reco::TrackBase::algoMaskUL ( ) const
inline

Definition at line 394 of file TrackBase.h.

References algoMask().

394 { return algoMask().to_ullong();}
AlgoMask algoMask() const
Definition: TrackBase.h:393
std::string reco::TrackBase::algoName ( ) const
inline

Definition at line 547 of file TrackBase.h.

References algo().

Referenced by LhcTrackAnalyzer::analyze(), TrackingNtuple::fillTracks(), and isAlgoInMask().

547 { return TrackBase::algoName(algo()); }
TrackAlgorithm algo() const
Definition: TrackBase.h:536
std::string algoName() const
Definition: TrackBase.h:547
std::string reco::TrackBase::algoName ( TrackAlgorithm  a)
inlinestatic

Definition at line 579 of file TrackBase.h.

References algoNames, algoSize, and createfilelist::int.

580 {
581  if (int(a) < int(algoSize) && int(a) > 0) {
582  return algoNames[int(a)];
583  }
584  return "undefAlgorithm";
585 }
static const std::string algoNames[]
Definition: TrackBase.h:148
double a
Definition: hdecay.h:121
bool reco::TrackBase::appendHitPattern ( const TrackingRecHit hit,
const TrackerTopology ttopo 
)
inline
bool reco::TrackBase::appendHitPattern ( const DetId id,
TrackingRecHit::Type  hitType,
const TrackerTopology ttopo 
)
inline

Definition at line 490 of file TrackBase.h.

References reco::HitPattern::appendHit(), and hitPattern_.

491 {
492  return hitPattern_.appendHit(id, hitType, ttopo);
493 }
bool appendHit(const TrackingRecHit &hit, const TrackerTopology &ttopo)
Definition: HitPattern.cc:226
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
bool reco::TrackBase::appendHitPattern ( const uint16_t  pattern,
TrackingRecHit::Type  hitType 
)
inline

Definition at line 504 of file TrackBase.h.

References reco::HitPattern::appendHit(), and hitPattern_.

504  {
505  return hitPattern_.appendHit(pattern, hitType);
506 }
bool appendHit(const TrackingRecHit &hit, const TrackerTopology &ttopo)
Definition: HitPattern.cc:226
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
template<typename C >
bool reco::TrackBase::appendHits ( const C &  c,
const TrackerTopology ttopo 
)

append hit patterns from vector of hit references

Definition at line 524 of file TrackBase.h.

References reco::HitPattern::appendHits(), and hitPattern_.

Referenced by isTimeOk().

525 {
526  return hitPattern_.appendHits(c.begin(), c.end(), ttopo);
527 }
bool appendHits(const I &begin, const I &end, const TrackerTopology &ttopo)
Definition: HitPattern.h:543
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
template<typename I >
bool reco::TrackBase::appendHits ( const I &  begin,
const I &  end,
const TrackerTopology ttopo 
)

Definition at line 518 of file TrackBase.h.

References reco::HitPattern::appendHits(), and hitPattern_.

519 {
520  return hitPattern_.appendHits(begin, end, ttopo);
521 }
bool appendHits(const I &begin, const I &end, const TrackerTopology &ttopo)
Definition: HitPattern.h:543
#define end
Definition: vmac.h:39
#define begin
Definition: vmac.h:32
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
bool reco::TrackBase::appendMuonHitPattern ( const DetId id,
TrackingRecHit::Type  hitType 
)
inline

This is meant to be used only in cases where the an already-packed hit information is re-interpreted in terms of HitPattern (i.e. the IO rule for reading old versions of HitPattern)

Definition at line 508 of file TrackBase.h.

References reco::HitPattern::appendMuonHit(), and hitPattern_.

Referenced by isTimeOk().

508  {
509  return hitPattern_.appendMuonHit(id, hitType);
510 }
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
bool appendMuonHit(const DetId &id, TrackingRecHit::Type hitType)
Definition: HitPattern.cc:308
bool reco::TrackBase::appendTrackerHitPattern ( uint16_t  subdet,
uint16_t  layer,
uint16_t  stereo,
TrackingRecHit::Type  hitType 
)
inline

These are meant to be used only in cases where the an already-packed hit information is re-interpreted in terms of HitPattern (i.e. MiniAOD PackedCandidate, and the IO rule for reading old versions of HitPattern)

Definition at line 500 of file TrackBase.h.

References reco::HitPattern::appendTrackerHit(), and hitPattern_.

Referenced by isTimeOk().

500  {
501  return hitPattern_.appendTrackerHit(subdet, layer, stereo, hitType);
502 }
bool appendTrackerHit(uint16_t subdet, uint16_t layer, uint16_t stereo, TrackingRecHit::Type hitType)
Definition: HitPattern.cc:304
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
double reco::TrackBase::beta ( ) const
inline

velocity at the reference point in natural units

Definition at line 732 of file TrackBase.h.

References beta_.

Referenced by isTimeOk(), and reco::Track::Track().

733 {
734  return beta_;
735 }
double reco::TrackBase::betaError ( ) const
inline

error on beta

Definition at line 889 of file TrackBase.h.

References covbetabeta_, and mathSSE::sqrt().

Referenced by isTimeOk().

890 {
891  return std::sqrt(covbetabeta_);
892 }
float covbetabeta_
Definition: TrackBase.h:440
T sqrt(T t)
Definition: SSEVec.h:18
int reco::TrackBase::charge ( ) const
inline

track electric charge

Definition at line 606 of file TrackBase.h.

References charge_.

Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), ValidationMisalignedTracker::analyze(), EwkMuLumiMonitorDQM::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), ConversionProducer::buildCollection(), FWTrackProxyBuilderFullFramework::buildTrack(), reco::CandidatePtrTransientTrack::charge(), reco::TrackTransientTrack::charge(), reco::GsfTransientTrack::charge(), Tau3MuReco::check4MuonTrack(), AlignmentTwoBodyDecayTrackSelector::checkCharge(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), CandidateChargeBTagComputer::discriminator(), MultiTrackValidatorGenPs::dqmAnalyze(), TrackTimeValueMapProducer::extractTrackVertexTime(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), CSCEfficiency::filter(), egammaTools::getConversionInfo(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), AlCaHOCalibProducer::getFreeTrajectoryState(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), FWPFTrackUtils::getTrack(), ValidHitPairFilter::getTrajectory(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkFilter::initialFreeState(), trajectoryStateTransform::innerFreeState(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), isTimeOk(), MuonIdProducer::makeMuon(), MuonErrorMatrixAdjuster::makeTrack(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), trajectoryStateTransform::outerFreeState(), fireworks::prepareTrack(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), QuarkoniaTrackSelector::produce(), PFDisplacedTrackerVertexProducer::produce(), ConversionSeedFilter::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateCosmicCALO(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), ptError(), qoverp(), TrackClassifier::reconstructionInformation(), PFAlgo::reconstructTrack(), MuonDTLocalMillepedeAlgorithm::run(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), sqr(), reco::Track::Track(), ConversionProducer::trackD0Cut(), and trackFromSeedFitFailed().

607 {
608  return charge_;
609 }
char charge_
electric charge
Definition: TrackBase.h:465
double reco::TrackBase::chi2 ( void  ) const
inline
TrackBase::CovarianceMatrix reco::TrackBase::covariance ( void  ) const
inline
double reco::TrackBase::covariance ( int  i,
int  j 
) const
inline

(i,j)-th element of covariance matrix (i, j = 0, ... 4)

Definition at line 796 of file TrackBase.h.

References covariance_, and covIndex().

797 {
798  return covariance_[covIndex(i, j)];
799 }
static index covIndex(index i, index j)
covariance matrix index in array
Definition: TrackBase.h:529
float covariance_[covarianceSize]
perigee 5x5 covariance matrix
Definition: TrackBase.h:437
double reco::TrackBase::covBetaBeta ( ) const
inline

error on beta

Definition at line 877 of file TrackBase.h.

References covbetabeta_.

Referenced by isTimeOk().

878 {
879  return covbetabeta_;
880 }
float covbetabeta_
Definition: TrackBase.h:440
TrackBase::index reco::TrackBase::covIndex ( index  i,
index  j 
)
inlinestatic

covariance matrix index in array

Definition at line 529 of file TrackBase.h.

References a, b, and mps_fire::i.

Referenced by covariance(), reco::GsfTrack::covarianceMode(), error(), reco::GsfTrack::errorMode(), and isTimeOk().

530 {
531  int a = (i <= j ? i : j);
532  int b = (i <= j ? j : i);
533  return b * (b + 1) / 2 + a;
534 }
double b
Definition: hdecay.h:120
double a
Definition: hdecay.h:121
double reco::TrackBase::covt0t0 ( ) const
inline

error on t0

Definition at line 871 of file TrackBase.h.

References covt0t0_.

Referenced by isTimeOk(), and reco::Track::Track().

872 {
873  return covt0t0_;
874 }
float covt0t0_
errors for time and velocity (separate from cov for now)
Definition: TrackBase.h:440
double reco::TrackBase::d0 ( ) const
inline
double reco::TrackBase::d0Error ( ) const
inline
double reco::TrackBase::dsz ( ) const
inline

dsz parameter (THIS IS NOT the SZ impact parameter to (0,0,0) if refPoint is far from (0,0,0): see parametrization definition above for details)

Definition at line 642 of file TrackBase.h.

References p(), pt(), px(), py(), pz(), vx(), vy(), and vz().

Referenced by TestOutliers::analyze(), CosmicSplitterValidation::is_gold_muon(), isTimeOk(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), RecoTrackSelectorBase::operator()(), parameters(), RecoTracktoTP::r_dsz(), TPtoRecoTrack::rA_dsz(), and TPtoRecoTrack::rB_dsz().

643 {
644  return vz() * pt() / p() - (vx() * px() + vy() * py()) / pt() * pz() / p();
645 }
double p() const
momentum vector magnitude
Definition: TrackBase.h:654
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:678
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:708
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:702
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:696
double reco::TrackBase::dsz ( const Point myBeamSpot) const
inline

dsz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the distance in the S-Z plane to the beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks.

Definition at line 762 of file TrackBase.h.

References p(), pt(), px(), py(), pz(), vx(), vy(), and vz().

763 {
764  return (vz() - myBeamSpot.z()) * pt() / p() - ((vx() - myBeamSpot.x()) * px() + (vy() - myBeamSpot.y()) * py()) / pt() * pz() / p();
765 }
double p() const
momentum vector magnitude
Definition: TrackBase.h:654
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:678
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:708
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:702
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:696
double reco::TrackBase::dszError ( ) const
inline

error on dsz

Definition at line 859 of file TrackBase.h.

References error(), and i_dsz.

Referenced by PackedCandidateTrackValidator::analyze(), and isTimeOk().

860 {
861  return error(i_dsz);
862 }
double error(int i) const
error on specified element
Definition: TrackBase.h:802
double reco::TrackBase::dxy ( ) const
inline

dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close to (0,0,0): see parametrization definition above for details). See also function dxy(myBeamSpot).

Definition at line 630 of file TrackBase.h.

References pt(), px(), py(), vx(), and vy().

Referenced by TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), MonitorTrackResidualsBase< pixel_or_strip >::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), PrimaryVertexAssignment::chargedHadronVertex(), PileupJetIdAlgo::computeIdVariables(), Electron.Electron::cutBasedId(), d0(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFDisplacedVertexHelper::TracksSelector::dxy(), dxy(), ntupleDataFormat.Track::dxyPull(), AlignmentMonitorSegmentDifferences::event(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorMuonSystemMap1D::event(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForEfficiencyFromHitPatter(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), MatcherByPullsAlgorithm::match(), muonisolation::CaloExtractor::MuonAtCaloPosition(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), parameters(), PrimaryVertexValidation::passesTrackCuts(), PrintRecoObjects::print(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), pat::PATIsolatedTrackProducer::produce(), PFTauTransverseImpactParameters::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), RecoTracktoTP::r_d02(), RecoTracktoTP::r_dxy(), TPtoRecoTrack::rA_d02(), TPtoRecoTrack::rA_dxy(), TPtoRecoTrack::rB_d02(), TPtoRecoTrack::rB_dxy(), TrackClassifier::reconstructionInformation(), MuonAlignmentFromReference::run(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), HLTMuonMatchAndPlot::selectedMuons(), sqr(), TrackWithVertexSelector::testVertices(), ConversionProducer::trackD0Cut(), QcdUeDQM::trackSelection(), and reco::tau::qcuts::trkTransverseImpactParameter().

631 {
632  return (-vx() * py() + vy() * px()) / pt();
633 }
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:702
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:696
double reco::TrackBase::dxy ( const Point myBeamSpot) const
inline

dxy parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks.

Definition at line 746 of file TrackBase.h.

References pt(), px(), py(), vx(), and vy().

Referenced by Electron.Electron::cutBasedId(), and ntupleDataFormat.Track::dxyPull().

747 {
748  return (-(vx() - myBeamSpot.x()) * py() + (vy() - myBeamSpot.y()) * px()) / pt();
749 }
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:702
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:696
double reco::TrackBase::dxy ( const BeamSpot theBeamSpot) const
inline

dxy parameter with respect to the beamSpot taking into account the beamspot slopes (WARNING: this quantity can only be interpreted as a minimum transverse distance if beamSpot, if the beam spot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks.

Definition at line 754 of file TrackBase.h.

References dxy(), reco::BeamSpot::position(), and vz().

Referenced by Electron.Electron::cutBasedId(), and ntupleDataFormat.Track::dxyPull().

755 {
756  return dxy(theBeamSpot.position(vz()));
757 }
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:708
double dxy() const
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close t...
Definition: TrackBase.h:630
double reco::TrackBase::dxyError ( ) const
inline
double TrackBase::dxyError ( Point const &  vtx,
math::Error< 3 >::type const &  vertexCov 
) const

error on dxy with respect to a user-given reference point + uncertainty (i.e. reco::Vertex position)

Definition at line 158 of file TrackBase.cc.

References covariance(), i_dxy, i_phi, pt(), px(), py(), and mathSSE::sqrt().

158  {
159  // Gradient of TrackBase::dxy(const Point &myBeamSpot) with respect to track parameters. Using unrolled expressions to avoid calling for higher dimension matrices
160  // ( 0, 0, x_vert * cos(phi) + y_vert * sin(phi), 1, 0 )
161  // Gradient with respect to point parameters
162  // ( sin(phi), -cos(phi))
163  // Propagate covariance assuming cross-terms of the covariance between track and vertex parameters are 0
164  return std::sqrt((vtx.x() * px() + vtx.y() * py()) * (vtx.x() * px() + vtx.y() * py()) / (pt() * pt()) *
166  2 * (vtx.x() * px() + vtx.y() * py()) / pt() * covariance(i_phi, i_dxy) + covariance(i_dxy, i_dxy) +
167  py() * py() / (pt() * pt()) * vertexCov(0, 0) - 2 * py() * px() / (pt() * pt()) * vertexCov(0, 1) +
168  px() * px() / (pt() * pt()) * vertexCov(1, 1));
169 }
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
CovarianceMatrix covariance() const
return track covariance matrix
Definition: TrackBase.h:782
T sqrt(T t)
Definition: SSEVec.h:18
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double reco::TrackBase::dxyError ( const BeamSpot theBeamSpot) const
inline

error on dxy with respect to a user-given beamspot

Definition at line 895 of file TrackBase.h.

References dxyError(), reco::BeamSpot::position(), reco::BeamSpot::rotatedCovariance3D(), and vz().

896 {
897  return dxyError(theBeamSpot.position(vz()), theBeamSpot.rotatedCovariance3D());
898 }
double dxyError() const
error on dxy
Definition: TrackBase.h:847
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:708
double reco::TrackBase::dz ( ) const
inline

dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to (0,0,0). See also function dz(myBeamSpot)

Definition at line 648 of file TrackBase.h.

References pt(), px(), py(), pz(), vx(), vy(), and vz().

Referenced by TrackTypeMonitor::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), PrimaryVertexAssignment::chargedHadronVertex(), PileupJetIdAlgo::computeIdVariables(), Electron.Electron::cutBasedId(), ntupleDataFormat.Track::dzPull(), AlignmentMonitorGeneric::event(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), getBestVertex(), MultiTrackSelector::getBestVertex(), getBestVertex_withError(), egammaTools::getConversionInfo(), reco::tau::RecoTauVertexAssociator::getLeadTrackRef(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), muonisolation::CaloExtractor::MuonAtCaloPosition(), HIPixelTrackFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), PrimaryVertexValidation::passesTrackCuts(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), JetTracksAssociationDRVertexAssigned::produce(), TOFPIDProducer::produce(), pat::PATPackedCandidateProducer::produce(), VertexFromTrackProducer::produce(), pat::PATIsolatedTrackProducer::produce(), PFTauTransverseImpactParameters::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::produce(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::produce(), IPProducer< Container, Base, Helper >::produce(), fireworks::pushPixelHits(), RecoTracktoTP::r_dz(), RecoTracktoTP::r_dz2(), TPtoRecoTrack::rA_dz(), TPtoRecoTrack::rA_dz2(), TPtoRecoTrack::rB_dz(), TPtoRecoTrack::rB_dz2(), TrackClassifier::reconstructionInformation(), HIPAlignmentAlgorithm::run(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), HLTMuonMatchAndPlot::selectedMuons(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), PFTauElementsOperators::setAreaMetricrecoElementsmaxabsEta(), sqr(), TrackWithVertexSelector::testTrack(), TrackWithVertexSelector::testVertices(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), and reco::tau::qcuts::trkLongitudinalImpactParameterWrtTrack().

649 {
650  return vz() - (vx() * px() + vy() * py()) / pt() * (pz() / pt());
651 }
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:678
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:708
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:702
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:696
double reco::TrackBase::dz ( const Point myBeamSpot) const
inline

dz parameter with respect to a user-given beamSpot (WARNING: this quantity can only be interpreted as the track z0, if the beamSpot is reasonably close to the refPoint, since linear approximations are involved). This is a good approximation for Tracker tracks.

Definition at line 770 of file TrackBase.h.

References pt(), px(), py(), pz(), vx(), vy(), and vz().

Referenced by Electron.Electron::cutBasedId(), and ntupleDataFormat.Track::dzPull().

771 {
772  return (vz() - myBeamSpot.z()) - ((vx() - myBeamSpot.x()) * px() + (vy() - myBeamSpot.y()) * py()) / pt() * pz() / pt();
773 }
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:666
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:678
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:708
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:702
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:672
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:696
double reco::TrackBase::dzError ( ) const
inline

error on dz

Definition at line 865 of file TrackBase.h.

References error(), i_dsz, p(), and pt().

Referenced by dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), PrimaryVertexAssignment::chargedHadronVertex(), reco::RecoChargedRefCandidate::dzError(), reco::RecoCandidate::dzError(), reco::PFCandidate::dzError(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), V0Fitter::fitAll(), isTimeOk(), HIPixelTrackFilter::operator()(), TrackFilterForPVFinding::operator()(), PrimaryVertexValidation::passesTrackCuts(), HIMultiTrackSelector::processMVA(), TOFPIDProducer::produce(), pat::PATIsolatedTrackProducer::produce(), PFTauTransverseImpactParameters::produce(), reco::CentralityProducer::produce(), TrackClassifier::reconstructionInformation(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), sqr(), and QcdUeDQM::trackSelection().

866 {
867  return error(i_dsz) * p() / pt();
868 }
double p() const
momentum vector magnitude
Definition: TrackBase.h:654
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double error(int i) const
error on specified element
Definition: TrackBase.h:802
double reco::TrackBase::error ( int  i) const
inline

error on specified element

Definition at line 802 of file TrackBase.h.

References covariance_, covIndex(), and mathSSE::sqrt().

Referenced by Page1Parser.Page1Parser::check_for_whole_start_tag(), d0Error(), dszError(), dxyError(), dzError(), etaError(), isTimeOk(), lambdaError(), phiError(), TriggerMatcherToHLTDebug::produce(), qoverpError(), and thetaError().

803 {
804  return sqrt(covariance_[covIndex(i, i)]);
805 }
static index covIndex(index i, index j)
covariance matrix index in array
Definition: TrackBase.h:529
T sqrt(T t)
Definition: SSEVec.h:18
float covariance_[covarianceSize]
perigee 5x5 covariance matrix
Definition: TrackBase.h:437
double reco::TrackBase::eta ( ) const
inline

pseudorapidity of momentum vector

Definition at line 690 of file TrackBase.h.

References momentum_.

Referenced by Particle.Particle::__str__(), DeDxDiscriminatorLearner::algoAnalyze(), SiStripGainFromData::algoAnalyze(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), TrackingRecoMaterialAnalyser::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), GlobalMuonMatchAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), IsoTrackCalib::analyze(), analyzer::SiPixelLorentzAngle::analyze(), IsolatedTracksCone::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), FWTrackProxyBuilder::build(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), pat::CaloIsolationEnergy::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), EleTkIsolFromCands::calIsol(), spr::chargeIsolationHcal(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFRecoTauDiscriminationAgainstElectronMVA6::discriminate(), PFRecoTauDiscriminationAgainstElectronMVA5::discriminate(), AntiElectronIDCut2::Discriminator(), MuonCaloCompatibility::evaluate(), AlignmentMonitorGeneric::event(), lowptgsfeleid::features_V1(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexValidation::fillTrackHistos(), reco::HcalNoiseInfoProducer::filltracks(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), MuonAlignmentPreFilter::filter(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), CSCEfficiency::filter(), PFElecTkProducer::FindPfRef(), MuonShowerInformationFiller::getCompatibleDets(), Tau3MuReco::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), HLTMuonTrimuonL3Filter::hltFilter(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), MuonIdProducer::isGoodTrack(), isTimeOk(), Jet.Jet::jetID(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), TrackMerger::merge(), reco::tau::qcuts::minTrackVertexWeight(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), PFTauMiniAODPrimaryVertexProducer::nonTauTracksInPVFromPackedCands(), TrackClassFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), EleTkIsolFromCands::passTrkSel(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), examples::TrackAnalysisAlgorithm::process(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), QuarkoniaTrackSelector::produce(), L3MuonIsolationProducer::produce(), HLTMuonL2SelectorForL3IO::produce(), TauJetSelectorForHLTTrackSeeding::produce(), DeDxHitInfoProducer::produce(), pat::PATPackedCandidateProducer::produce(), OutsideInMuonSeeder::produce(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), reco::CentralityProducer::produce(), PFRecoTauChargedHadronProducer::produce(), TriggerMatcherToHLTDebug::produce(), spr::propagateCALO(), Jet.Jet::puJetId(), fireworks::pushPixelHits(), PFAlgo::reconstructTrack(), SoftLepton::refineJetAxis(), GlobalMuonRefitter::refit(), CutsIsolatorWithCorrection::result(), SimpleCutsIsolator::result(), MuonMillepedeAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), AlCaIsoTracksProducer::select(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), IsoTrig::studyMipCut(), TrackWithVertexSelector::testTrack(), EwkMuLumiMonitorDQM::tkIso(), HcalIsoTrkAnalyzer::trackP(), StudyHLT::trackPID(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), muonisolation::PixelTrackExtractor::vetos(), muonisolation::TrackExtractor::vetos(), and egammaisolation::EgammaTrackExtractor::vetos().

691 {
692  return momentum_.Eta();
693 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::etaError ( ) const
inline

error on eta

Definition at line 835 of file TrackBase.h.

References error(), i_lambda, p(), and pt().

Referenced by CosmicSplitterValidation::analyze(), PackedCandidateTrackValidator::analyze(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), isTimeOk(), HIMultiTrackSelector::processMVA(), and MuonTrackingRegionBuilder::region().

836 {
837  return error(i_lambda) * p() / pt();
838 }
double p() const
momentum vector magnitude
Definition: TrackBase.h:654
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double error(int i) const
error on specified element
Definition: TrackBase.h:802
TrackBase::CovarianceMatrix & TrackBase::fill ( CovarianceMatrix v) const

fill SMatrix

Definition at line 129 of file TrackBase.cc.

References covariance_, and reco::fillCovariance().

Referenced by covariance(), and isTimeOk().

130 {
131  return fillCovariance(v, covariance_);
132 }
PerigeeCovarianceMatrix & fillCovariance(PerigeeCovarianceMatrix &v, const float *data)
float covariance_[covarianceSize]
perigee 5x5 covariance matrix
Definition: TrackBase.h:437
const HitPattern & reco::TrackBase::hitPattern ( ) const
inline

Access the hit pattern, indicating in which Tracker layers the track has hits.

Definition at line 485 of file TrackBase.h.

References hitPattern_.

Referenced by TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), PFCheckHitPattern::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TkConvValidator::analyze(), PrimaryVertexValidation::analyze(), IsolatedTracksCone::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), spr::coneChargeIsolation(), PFRecoTauDiscriminationByHPSSelection::discriminate(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForEfficiencyFromHitPatter(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), egammaTools::getConversionInfo(), spr::goodTrack(), reco::TransientTrack::hitPattern(), HLTTrackWithHits::hltFilter(), isTimeOk(), PFMuonAlgo::isTrackerTightMuon(), PFDisplacedVertexHelper::isTrackSelected(), reco::TransientTrack::numberOfLostHits(), reco::TransientTrack::numberOfValidHits(), GhostTrackComputer::operator()(), TrackClassFilter::operator()(), CheckHitPattern::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), pat::PATLostTracks::passTrkCuts(), EleTkIsolFromCands::passTrkSel(), FWTrackResidualDetailView::prepareData(), CheckHitPattern::print(), PFCheckHitPattern::print(), PFMuonAlgo::printMuonProperties(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), FastTrackerRecHitMaskProducer::produce(), HLTMuonL2SelectorForL3IO::produce(), TrackListMerger::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATIsolatedTrackProducer::produce(), IPProducer< Container, Base, Helper >::produce(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), pat::PackedCandidate::setHits(), FWConvTrackHitsDetailView::setTextInfo(), reco::IPTagInfo< Container, Base >::taggingVariables(), TrackWithVertexSelector::testTrack(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::trackFilter(), SiStripMonitorTrack::trackFilter(), TrackVertexArbitration< VTX >::trackFilterArbitrator(), MuonBadTrackFilter::trackInfo(), reco::TrackSelector::trackSelection(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkPixelHits(), reco::tau::qcuts::trkTrackerHits(), and QuickTrackAssociatorByHitsImpl::weightedNumberOfTrackClusters().

486 {
487  return hitPattern_;
488 }
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
bool reco::TrackBase::isAlgoInMask ( TrackAlgorithm  a) const
inline
bool reco::TrackBase::isLooper ( ) const
inline

Definition at line 958 of file TrackBase.h.

References nLoops_.

Referenced by isAlgoInMask().

959 {
960  return (nLoops_ > 0);
961 }
signed char nLoops_
number of loops made during the building of the trajectory of a looper particle
Definition: TrackBase.h:478
bool reco::TrackBase::isTimeOk ( ) const
inline
double reco::TrackBase::lambda ( ) const
inline

Lambda angle.

Definition at line 624 of file TrackBase.h.

References M_PI_2, and momentum_.

Referenced by TestOutliers::analyze(), PrimaryVertexValidation::fillTrackHistos(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), isTimeOk(), and parameters().

625 {
626  return M_PI_2 - momentum_.theta();
627 }
#define M_PI_2
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::lambdaError ( ) const
inline

error on lambda

Definition at line 829 of file TrackBase.h.

References error(), and i_lambda.

Referenced by MTVHistoProducerAlgoForTracker::getRecoMomentum(), isTimeOk(), and sqr().

830 {
831  return error(i_lambda);
832 }
double error(int i) const
error on specified element
Definition: TrackBase.h:802
const TrackBase::Vector & reco::TrackBase::momentum ( ) const
inline

track momentum vector

Definition at line 714 of file TrackBase.h.

References momentum_.

Referenced by ValidationMisalignedTracker::analyze(), PhotonValidator::analyze(), StudyHLT::analyze(), BPHMonitor::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), SiStripFineDelayHit::detId(), EgammaHLTTrackIsolation::electronIsolation(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MillePedeMonitor::fillTrack(), JetVertexChecker::filter(), TrackDetectorAssociator::getFreeTrajectoryState(), HTrackAssociator::getFreeTrajectoryState(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), ValidHitPairFilter::getTrajectory(), SeedFromProtoTrack::init(), trajectoryStateTransform::initialFreeState(), HLTmumutktkVtxProducer::initialFreeState(), HLTmmkkFilter::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkFilter::initialFreeState(), isTimeOk(), CalibrationTrackSelectorFromDetIdList::makeCandidate(), reco::modules::CosmicTrackSplitter::makeCandidate(), reco::modules::TrackerTrackHitFilter::makeCandidate(), MuonErrorMatrixAdjuster::makeTrack(), TrackMerger::merge(), reco::PFDisplacedVertex::momentum(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), CombinedSVComputer::operator()(), PrintRecoObjects::print(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), SeedGeneratorFromProtoTracksEDProducer::produce(), SoftLepton::refineJetAxis(), HPSPFRecoTauAlgorithm::refitThreeProng(), MuonTrackingRegionBuilder::region(), reco::IPTagInfo< Container, Base >::taggingVariables(), reco::Track::Track(), ObjectValidator::validTrack(), and reco::IPTagInfo< Container, Base >::variableJTA().

715 {
716  return momentum_;
717 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::ndof ( ) const
inline
signed char reco::TrackBase::nLoops ( ) const
inline

Definition at line 963 of file TrackBase.h.

References nLoops_.

Referenced by isAlgoInMask().

964 {
965  return nLoops_;
966 }
signed char nLoops_
number of loops made during the building of the trajectory of a looper particle
Definition: TrackBase.h:478
double reco::TrackBase::normalizedChi2 ( ) const
inline

chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)

Definition at line 600 of file TrackBase.h.

References chi2_, and ndof_.

Referenced by ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), helper::SimpleJetTrackAssociator::associate(), helper::SimpleJetTrackAssociator::associateTransient(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), AlignmentMonitorGeneric::event(), AlignmentMonitorTracksFromTrajectories::event(), lowptgsfeleid::features_V1(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), CSCEfficiency::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), reco::tau::lead_track_chi2(), MuonResidualsFromTrack::normalizedChi2(), GhostTrackComputer::operator()(), TrackClassFilter::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), HLTMuonL2SelectorForL3IO::produce(), pat::PATTauProducer::produce(), IPProducer< Container, Base, Helper >::produce(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), pat::PackedCandidate::setTrackProperties(), reco::IPTagInfo< Container, Base >::taggingVariables(), TrackWithVertexSelector::testTrack(), SiStripMonitorTrack::trackFilter(), MuonBadTrackFilter::trackInfo(), ConversionProducer::trackQualityFilter(), reco::TrackSelector::trackSelection(), QcdUeDQM::trackSelection(), and reco::tau::qcuts::trkChi2().

601 {
602  return ndof_ != 0 ? chi2_ / ndof_ : chi2_ * 1e6;
603 }
float chi2_
chi-squared
Definition: TrackBase.h:443
float ndof_
number of degrees of freedom
Definition: TrackBase.h:462
unsigned short reco::TrackBase::numberOfLostHits ( ) const
inline
unsigned short reco::TrackBase::numberOfValidHits ( ) const
inline

number of valid hits found

Definition at line 901 of file TrackBase.h.

References hitPattern_, and reco::HitPattern::numberOfValidHits().

Referenced by PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), helper::SimpleJetTrackAssociator::associate(), QuickTrackAssociatorByHitsImpl::associateRecoToSimImplementation(), helper::SimpleJetTrackAssociator::associateTransient(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), MuonAlignmentAnalyzer::doMatching(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), dqm::TrackAnalyzer::fillHistosForState(), MillePedeMonitor::fillTrack(), V0Fitter::fitAll(), reco::Track::found(), HLTMuonTrackMassFilter::hltFilter(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), TrackClassFilter::operator()(), pat::PATLostTracks::passTrkCuts(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), HLTMuonL2SelectorForL3IO::produce(), TrackListMerger::produce(), DeDxHitInfoProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), MuonMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), TrackWithVertexSelector::testTrack(), and ObjectValidator::validTrack().

902 {
904 }
int numberOfValidHits() const
Definition: HitPattern.h:896
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
TrackBase::TrackAlgorithm reco::TrackBase::originalAlgo ( ) const
inline

Definition at line 540 of file TrackBase.h.

References originalAlgorithm_.

Referenced by dqm::TrackAnalyzer::analyze(), MTVHistoProducerAlgoForTracker::fill_duplicate_histos(), isAlgoInMask(), and RecoTrackSelectorBase::operator()().

541 {
543 }
uint8_t originalAlgorithm_
track algorithm
Definition: TrackBase.h:471
TrackAlgorithm
track algorithm
Definition: TrackBase.h:99
double reco::TrackBase::p ( ) const
inline

momentum vector magnitude

Definition at line 654 of file TrackBase.h.

References momentum_.

Referenced by PFTrackTransformer::addPoints(), SiStripGainFromData::algoAnalyze(), EwkMuLumiMonitorDQM::analyze(), TrackingRecoMaterialAnalyser::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalibration::analyze(), StudyHLT::analyze(), IsoTrackCalib::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), AlignmentTrackSelector::basicCuts(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), HBHEHitMap::calcTracksNeighborTowers_(), HBHEHitMap::calcTracksSameTowers_(), pat::TrackerIsolationPt::calculate(), spr::chargeIsolation(), spr::chargeIsolationCone(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), IsoTrig::chgIsolation(), spr::coneChargeIsolation(), dsz(), dzError(), etaError(), MuonCaloCompatibility::evaluate(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorSegmentDifferences::event(), AlignmentMonitorMuonVsCurvature::event(), TrackTimeValueMapProducer::extractTrackVertexTime(), lowptgsfeleid::features_V1(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), PrimaryVertexValidation::fillTrackHistos(), reco::HcalNoiseInfoProducer::filltracks(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), MuonAlignmentPreFilter::filter(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), MuonShowerInformationFiller::getCompatibleDets(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), MuonIdProducer::isGoodTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), MuonIdTruthInfo::matchChi2(), muonid::matchTracks(), muonisolation::CaloExtractor::MuonAtCaloPosition(), TrackClassFilter::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), JetTracksAssociationDRVertex::produce(), JetVetoedTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), QuarkoniaTrackSelector::produce(), DeDxHitInfoProducer::produce(), TrackTimeValueMapProducer::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateCALO(), Electron.Electron::ptErr(), ptError(), qoverp(), PFAlgo::reconstructTrack(), GlobalMuonRefitter::refit(), MuonTrackingRegionBuilder::region(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), CSCOverlapsAlignmentAlgorithm::run(), MuonAlignmentFromReference::run(), AlCaIsoTracksProducer::select(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), SiStripMonitorTrack::trackFilter(), and reco::JetTracksAssociation::tracksP4().

655 {
656  return momentum_.R();
657 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::parameter ( int  i) const
inline

i-th parameter ( i = 0, ... 4 )

Definition at line 790 of file TrackBase.h.

References mps_fire::i, and parameters().

Referenced by tauImpactParameter::ParticleBuilder::createTrackParticle(), isTimeOk(), and TriggerMatcherToHLTDebug::produce().

791 {
792  return parameters()[i];
793 }
ParameterVector parameters() const
Track parameters with one-to-one correspondence to the covariance matrix.
Definition: TrackBase.h:776
TrackBase::ParameterVector reco::TrackBase::parameters ( void  ) const
inline

Track parameters with one-to-one correspondence to the covariance matrix.

Definition at line 776 of file TrackBase.h.

References dsz(), dxy(), lambda(), phi(), and qoverp().

Referenced by SiStripFineDelayHit::detId(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::inputTags(), isTimeOk(), parameter(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::properties(), Vispa.Plugins.ConfigEditor.ConfigDataAccessor.ConfigDataAccessor::recursePSetProperties(), and track_associator::trackAssociationChi2().

777 {
778  return TrackBase::ParameterVector(qoverp(), lambda(), phi(), dxy(), dsz());
779 }
double qoverp() const
q / p
Definition: TrackBase.h:612
double phi() const
azimuthal angle of momentum vector
Definition: TrackBase.h:684
math::Vector< dimension >::type ParameterVector
parameter vector
Definition: TrackBase.h:74
double dsz() const
dsz parameter (THIS IS NOT the SZ impact parameter to (0,0,0) if refPoint is far from (0...
Definition: TrackBase.h:642
double lambda() const
Lambda angle.
Definition: TrackBase.h:624
double dxy() const
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close t...
Definition: TrackBase.h:630
double reco::TrackBase::phi ( ) const
inline

azimuthal angle of momentum vector

Definition at line 684 of file TrackBase.h.

References momentum_.

Referenced by Particle.Particle::__str__(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), IsoTrackCalib::analyze(), analyzer::SiPixelLorentzAngle::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), pat::CaloIsolationEnergy::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), EleTkIsolFromCands::calIsol(), spr::chargeIsolationHcal(), AlignmentTwoBodyDecayTrackSelector::checkAcoplanarity(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::JetExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), AlignmentMonitorGeneric::event(), TrackTimeValueMapProducer::extractTrackVertexTime(), lowptgsfeleid::features_V1(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), PrimaryVertexValidation::fillTrackHistos(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), CSCEfficiency::filter(), PFElecTkProducer::FindPfRef(), MuonShowerInformationFiller::getCompatibleDets(), Tau3MuReco::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), HLTMuonTrimuonL3Filter::hltFilter(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), CosmicSplitterValidation::is_gold_muon(), isTimeOk(), PFDisplacedVertexCandidateFinder::link(), MatcherByPullsAlgorithm::match(), MuonIdTruthInfo::matchChi2(), reco::tau::qcuts::minTrackVertexWeight(), muonisolation::CaloExtractor::MuonAtCaloPosition(), PFTauMiniAODPrimaryVertexProducer::nonTauTracksInPVFromPackedCands(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), parameters(), EleTkIsolFromCands::passTrkSel(), ntupleDataFormat.Track::phiPull(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), HLTMuonL2SelectorForL3IO::produce(), TauJetSelectorForHLTTrackSeeding::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), PFRecoTauChargedHadronProducer::produce(), spr::propagateCALO(), PFAlgo::reconstructTrack(), SoftLepton::refineJetAxis(), MuonMillepedeAlgorithm::run(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), AlCaIsoTracksProducer::select(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), sqr(), IsoTrig::studyMipCut(), EwkMuLumiMonitorDQM::tkIso(), HcalIsoTrkAnalyzer::trackP(), StudyHLT::trackPID(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), muonisolation::PixelTrackExtractor::vetos(), muonisolation::TrackExtractor::vetos(), and egammaisolation::EgammaTrackExtractor::vetos().

685 {
686  return momentum_.Phi();
687 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::phiError ( ) const
inline
double reco::TrackBase::pt ( ) const
inline

track transverse momentum

Definition at line 660 of file TrackBase.h.

References momentum_, and mathSSE::sqrt().

Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), DeDxDiscriminatorLearner::algoAnalyze(), SiStripGainFromData::algoAnalyze(), PFCandConnector::analyseNuclearWSec(), PatTrackAnalyzer::analyze(), ValidationMisalignedTracker::analyze(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), MonitorTrackResidualsBase< pixel_or_strip >::analyze(), TrackSplittingMonitor::analyze(), ElectronConversionRejectionValidator::analyze(), GlobalMuonMatchAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TkConvValidator::analyze(), TestTrackHits::analyze(), TestOutliers::analyze(), DiDispStaMuonMonitor::analyze(), ObjMonitor::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), StudyHLT::analyze(), IsoTrackCalib::analyze(), analyzer::SiPixelLorentzAngle::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), MuonTrackValidator::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), IPTagPlotter< Container, Base >::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWTrackProxyBuilder::build(), btagbtvdeep::TrackPairInfoBuilder::buildTrackPairInfo(), EleTkIsolFromCands::calIsol(), Photon.Photon::calScaledIsoValueExp(), Photon.Photon::calScaledIsoValueLin(), Photon.Photon::calScaledIsoValueQuadr(), Tau3MuReco::check4MuonTrack(), pat::MuonMvaEstimator::computeMva(), muonisolation::CaloExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFRecoTauDiscriminationAgainstElectronMVA6::discriminate(), PFRecoTauDiscriminationAgainstElectronMVA5::discriminate(), CandidateChargeBTagComputer::discriminator(), AntiElectronIDCut2::Discriminator(), MultiTrackValidatorGenPs::dqmAnalyze(), dsz(), dxy(), dxyError(), dz(), dzError(), fw::estimate_field(), etaError(), AlignmentMonitorGeneric::event(), AlignmentMonitorMuonVsCurvature::event(), AlignmentMonitorMuonSystemMap1D::event(), AlignmentMonitorSegmentDifferences::event(), TrackTimeValueMapProducer::extractTrackVertexTime(), lowptgsfeleid::features_V1(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForEfficiencyFromHitPatter(), dqm::TrackAnalyzer::fillHistosForState(), dqm::TrackAnalyzer::fillHistosForTrackerSpecific(), MillePedeMonitor::fillTrack(), PrimaryVertexValidation::fillTrackHistos(), reco::HcalNoiseInfoProducer::filltracks(), ApeEstimator::fillTrackVariables(), HcalIsoTrkAnalyzer::fillTree(), MuonAlignmentPreFilter::filter(), JetVertexChecker::filter(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), CSCEfficiency::filter(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), egammaTools::getConversionInfo(), reco::tau::RecoTauVertexAssociator::getLeadCand(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonTrimuonL3Filter::hltFilter(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), HLTTrackWithHits::hltFilter(), MuonIdProducer::isGoodTrack(), isTimeOk(), PFDisplacedVertexHelper::isTrackSelected(), PFDisplacedVertexCandidateFinder::link(), MuonTrackLoader::loadTracks(), LowPtConversion::match(), MatcherByPullsAlgorithm::match(), muonid::matchTracks(), reco::tau::qcuts::minTrackVertexWeight(), muonisolation::CaloExtractor::MuonAtCaloPosition(), Electron.Electron::mvaIDLoose(), Electron.Electron::mvaIDRun2(), Electron.Electron::mvaIDTight(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), PFTauMiniAODPrimaryVertexProducer::nonTauTracksInPVFromPackedCands(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), reco::TrackSelector::operator()(), reco::tau::RecoTauSoftTwoProngTausCleanerPlugin::operator()(), ClusterShapeTrackFilter::operator()(), CalibrationTrackSelector::ComparePt::operator()(), AlignmentTrackSelector::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), RecoTrackSelectorBase::operator()(), reco::Vertex::TrackEqual::operator()(), PrimaryVertexValidation::passesTrackCuts(), pat::PATLostTracks::passTrkCuts(), fireworks::prepareTrack(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), examples::TrackAnalysisAlgorithm::process(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), QuarkoniaTrackSelector::produce(), HLTMuonL2SelectorForL3IO::produce(), TauJetSelectorForHLTTrackSeeding::produce(), DeDxHitInfoProducer::produce(), Onia2MuMuPAT::produce(), pat::PATPackedCandidateProducer::produce(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), pat::PATTauProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), reco::CentralityProducer::produce(), TriggerMatcherToHLTDebug::produce(), IPProducer< Container, Base, Helper >::produce(), Electron.Electron::ptErr(), ptError(), reco::tau::qcuts::ptMin(), ntupleDataFormat.Track::ptPull(), PFAlgo::reconstructTrack(), SoftLepton::refineJetAxis(), GlobalMuonRefitter::refit(), MuonTrackingRegionBuilder::region(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), CutsIsolatorWithCorrection::result(), MuonMillepedeAlgorithm::run(), AnalyticalTrackSelector::run(), MuonDTLocalMillepedeAlgorithm::run(), HIPAlignmentAlgorithm::run(), MultiTrackSelector::run(), HIMultiTrackSelector::run(), MuonAlignmentFromReference::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), AlCaIsoTracksProducer::select(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), Jet.Jet::setCorrP4(), FWTrackHitsDetailView::setTextInfo(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), PrimaryVertexResolution::sortTracksByPt(), sqr(), IsoTrig::studyMipCut(), TrackWithVertexSelector::testTrack(), EwkMuLumiMonitorDQM::tkIso(), SiStripMonitorTrack::trackFilter(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::trackFilter(), TrackVertexArbitration< VTX >::trackFilterArbitrator(), MuonBadTrackFilter::trackInfo(), reco::PFDisplacedVertex::trackPosition(), QcdUeDQM::trackSelection(), reco::tau::qcuts::trkLongitudinalImpactParameter(), reco::tau::qcuts::trkTransverseImpactParameter(), ObjectValidator::validTrack(), reco::IPTagInfo< Container, Base >::variableJTA(), and MuonTrackLoader::~MuonTrackLoader().

661 {
662  return sqrt(momentum_.Perp2());
663 }
T sqrt(T t)
Definition: SSEVec.h:18
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::ptError ( ) const
inline

error on Pt (set to 1000 TeV if charge==0 for safety)

Definition at line 814 of file TrackBase.h.

References charge(), covariance(), i_lambda, i_qoverp, p(), pt(), pz(), and mathSSE::sqrt().

Referenced by PatTrackAnalyzer::analyze(), dqm::TrackAnalyzer::analyze(), TrackSplittingMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), PFMEtSignInterfaceBase::compResolution(), TrackTypeMonitor::fillHistograms(), dqm::TrackAnalyzer::fillHistosForState(), ApeEstimator::fillTrackVariables(), CSCEfficiency::filter(), reco::tau::RecoTauVertexAssociator::getLeadCand(), MTVHistoProducerAlgoForTracker::getRecoMomentum(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::getTrackPtError(), PFDisplacedVertexCandidateFinder::goodPtResolution(), isTimeOk(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), PrimaryVertexValidation::passesTrackCuts(), EleTkIsolFromCands::passTrkSel(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), Onia2MuMuPAT::produce(), SeedToTrackProducer::produce(), reco::CentralityProducer::produce(), PrimaryVertexSorting::score(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), TrackWithVertexSelector::testTrack(), MuonBadTrackFilter::trackInfo(), and QcdUeDQM::trackSelection().

815 {
816  return (charge() != 0) ? sqrt(
817  pt() * pt() * p() * p() / charge() / charge() * covariance(i_qoverp, i_qoverp)
818  + 2 * pt() * p() / charge() * pz() * covariance(i_qoverp, i_lambda)
819  + pz() * pz() * covariance(i_lambda, i_lambda)) : 1.e6;
820 }
double p() const
momentum vector magnitude
Definition: TrackBase.h:654
CovarianceMatrix covariance() const
return track covariance matrix
Definition: TrackBase.h:782
T sqrt(T t)
Definition: SSEVec.h:18
double pt() const
track transverse momentum
Definition: TrackBase.h:660
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:678
int charge() const
track electric charge
Definition: TrackBase.h:606
double reco::TrackBase::px ( ) const
inline

x coordinate of momentum vector

Definition at line 666 of file TrackBase.h.

References momentum_.

Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), BPHMonitor::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), dsz(), dummyPrediction(), dxy(), dxyError(), dz(), fw::estimate_field(), dqm::TrackAnalyzer::fillHistosForState(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), QuarkoniaTrackSelector::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().

667 {
668  return momentum_.x();
669 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::py ( ) const
inline

y coordinate of momentum vector

Definition at line 672 of file TrackBase.h.

References momentum_.

Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), BPHMonitor::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), directionAlongMomentum(), dsz(), dummyPrediction(), dxy(), dxyError(), dz(), fw::estimate_field(), dqm::TrackAnalyzer::fillHistosForState(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), QuarkoniaTrackSelector::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().

673 {
674  return momentum_.y();
675 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::pz ( ) const
inline

z coordinate of momentum vector

Definition at line 678 of file TrackBase.h.

References momentum_.

Referenced by reco::TrackKinematics::add(), PFTrackTransformer::addPoints(), EwkMuLumiMonitorDQM::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), BPHMonitor::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), pat::TrackerIsolationPt::calculate(), FWInvMassDialog::Calculate(), IsoTrig::chgIsolation(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), dsz(), dummyPrediction(), dz(), dqm::TrackAnalyzer::fillHistosForState(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), egammaTools::getConversionInfo(), IsoTrig::getGoodTracks(), FWPFTrackUtils::getTrack(), isTimeOk(), PFDisplacedVertexHelper::lambdaCP(), MuonIdProducer::makeMuon(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), fireworks::prepareTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), QuarkoniaTrackSelector::produce(), SiStripElectronAssociator::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), ptError(), PFAlgo::reconstructTrack(), HPSPFRecoTauAlgorithm::refitThreeProng(), AlCaIsoTracksProducer::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), reco::tau::setChargedHadronP4(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), IsoTrig::StudyTrkEbyP(), and reco::JetTracksAssociation::tracksP4().

679 {
680  return momentum_.z();
681 }
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:452
double reco::TrackBase::qoverp ( ) const
inline
double reco::TrackBase::qoverpError ( ) const
inline
bool reco::TrackBase::quality ( const TrackQuality  ) const
inline

Track quality.

Definition at line 549 of file TrackBase.h.

References goodIterative, highPurity, lumiQueryAPI::q, quality_, and undefQuality.

Referenced by PatTrackAnalyzer::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), PrimaryVertexValidation::analyze(), StudyHLT::analyze(), BPHMonitor::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), TemplatedJetProbabilityComputer< Container, Base >::discriminator(), TemplatedJetBProbabilityComputer< Container, Base >::discriminator(), dqm::TrackAnalyzer::fillHistosForState(), CSCEfficiency::filter(), spr::goodTrack(), IPTagPlotter< Container, Base >::highestTrackQual(), isAlgoInMask(), AlignmentTrackSelector::isOkTrkQuality(), PFDisplacedVertexHelper::isTrackSelected(), TrackFilterForPVFinding::operator()(), TrackClassFilter::operator()(), RecoTrackSelectorBase::operator()(), TemplatedTrackCountingComputer< Container, Base >::orderedSignificances(), PrimaryVertexValidation::passesTrackCuts(), EleTkIsolFromCands::passQual(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), FastTrackerRecHitMaskProducer::produce(), Onia2MuMuPAT::produce(), ExtraFromSeeds::produce(), reco::CentralityProducer::produce(), spr::propagateCALO(), spr::propagateCosmicCALO(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), TrackWithVertexSelector::testTrack(), reco::Track::Track(), reco::TrackSelector::trackSelection(), and QcdUeDQM::trackSelection().

550 {
551  switch (q) {
552  case undefQuality:
553  return quality_ == 0;
554  case goodIterative:
556  default:
557  return (quality_ & (1 << q)) >> q;
558  }
559  return false;
560 }
uint8_t quality_
track quality
Definition: TrackBase.h:475
TrackBase::TrackQuality TrackBase::qualityByName ( const std::string &  name)
static

Definition at line 134 of file TrackBase.cc.

References spr::find(), qualityNames, qualitySize, findQualityFiles::size, and undefQuality.

Referenced by AlCaIsoTracksFilter::AlCaIsoTracksFilter(), AlCaIsoTracksProducer::AlCaIsoTracksProducer(), AlignmentTrackSelector::AlignmentTrackSelector(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), StandaloneTrackMonitor::analyze(), TrackingRecoMaterialAnalyser::analyze(), dqm::TrackAnalyzer::analyze(), TrackCount::analyze(), FSQDQM::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), BeamFitter::BeamFitter(), QGTagger::calcVariables(), CaloRecoTauTagInfoAlgorithm::CaloRecoTauTagInfoAlgorithm(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), FilterOutLowPt::filter(), FilterOutScraping::filter(), TrackIsoCalculator::getBkgSubTrackIso(), TrackIsoCalculator::getTrackIso(), HcalIsoTrkAnalyzer::HcalIsoTrkAnalyzer(), HITrackClusterRemover::HITrackClusterRemover(), isAlgoInMask(), IsolatedTracksHcalScale::IsolatedTracksHcalScale(), IsoTrackCalib::IsoTrackCalib(), IsoTrackCalibration::IsoTrackCalibration(), IsoTrig::IsoTrig(), PFDisplacedVertexHelper::isTrackSelected(), JetPlusTrackProducerAA::JetPlusTrackProducerAA(), LightPFTrackProducer::LightPFTrackProducer(), LowPtGsfElectronSeedProducer::loop(), MuonTrackCut::MuonTrackCut(), TrackClassFilter::operator()(), PrimaryVertexValidation::passesTrackCuts(), pat::PATLostTracks::PATLostTracks(), PFTrackProducer::PFTrackProducer(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), reco::modules::HICaloCompatibleTrackSelector::produce(), PromptTrackCountingComputer::PromptTrackCountingComputer(), spr::propagateCALO(), spr::propagateCosmicCALO(), QcdUeDQM::QcdUeDQM(), QualityCutsAnalyzer::QualityCutsAnalyzer(), RecoTrackSelectorBase::RecoTrackSelectorBase(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), lowptgsfeleseed::Features::set(), L1Analysis::L1AnalysisRecoTrack::SetTracks(), StudyHLT::StudyHLT(), TemplatedJetBProbabilityComputer< Container, Base >::TemplatedJetBProbabilityComputer(), TemplatedJetProbabilityComputer< Container, Base >::TemplatedJetProbabilityComputer(), TemplatedTrackCountingComputer< Container, Base >::TemplatedTrackCountingComputer(), TrackWithVertexSelector::testTrack(), TrackExtrapolator::TrackExtrapolator(), TrackFilterForPVFinding::TrackFilterForPVFinding(), TrackListMerger::TrackListMerger(), reco::TrackSelector::TrackSelector(), and EleTkIsolFromCands::TrkCuts::TrkCuts().

135 {
138  if (index == size) {
139  return undefQuality; // better this or throw() ?
140  }
141 
142  // cast
143  return TrackQuality(index);
144 }
size
Write out results.
unsigned int index
index type
Definition: TrackBase.h:95
TrackQuality
track quality
Definition: TrackBase.h:151
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
Definition: FindCaloHit.cc:20
static const std::string qualityNames[]
Definition: TrackBase.h:164
This class analyses the reconstruction quality for a given track.
Definition: TrackQuality.h:28
int reco::TrackBase::qualityMask ( ) const
inline
std::string reco::TrackBase::qualityName ( TrackQuality  q)
inlinestatic

Definition at line 571 of file TrackBase.h.

References createfilelist::int, qualityNames, and qualitySize.

Referenced by TkAlCaRecoMonitor::bookHistograms(), isAlgoInMask(), IsolatedTracksCone::printTrack(), and IsolatedTracksNxN::printTrack().

572 {
573  if (int(q) < int(qualitySize) && int(q) >= 0) {
574  return qualityNames[int(q)];
575  }
576  return "undefQuality";
577 }
static const std::string qualityNames[]
Definition: TrackBase.h:164
const TrackBase::Point & reco::TrackBase::referencePoint ( ) const
inline
void reco::TrackBase::resetHitPattern ( )
inline

Sets HitPattern as empty.

Definition at line 512 of file TrackBase.h.

References reco::HitPattern::clear(), and hitPattern_.

Referenced by isTimeOk().

513 {
514  hitPattern_.clear();
515 }
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
void reco::TrackBase::setAlgoMask ( AlgoMask  a)
inline

Definition at line 391 of file TrackBase.h.

References a, and algoMask_.

391 { algoMask_ = a;}
std::bitset< algoSize > algoMask_
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping ...
Definition: TrackBase.h:459
double a
Definition: hdecay.h:121
void reco::TrackBase::setAlgorithm ( const TrackAlgorithm  a)
inline

Track algorithm.

Definition at line 928 of file TrackBase.h.

References a, algoMask_, algorithm_, and setOriginalAlgorithm().

Referenced by TrackProducerAlgorithm< reco::GsfTrack >::buildTrack(), isTimeOk(), and TrackListCombiner::produce().

929 {
930  algorithm_ = a;
931  algoMask_.reset();
933 }
void setOriginalAlgorithm(const TrackAlgorithm a)
Definition: TrackBase.h:935
std::bitset< algoSize > algoMask_
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping ...
Definition: TrackBase.h:459
double a
Definition: hdecay.h:121
uint8_t algorithm_
track algorithm
Definition: TrackBase.h:468
void reco::TrackBase::setNLoops ( signed char  value)
inline

Definition at line 953 of file TrackBase.h.

References nLoops_, and relativeConstraints::value.

Referenced by isAlgoInMask().

954 {
955  nLoops_ = value;
956 }
signed char nLoops_
number of loops made during the building of the trajectory of a looper particle
Definition: TrackBase.h:478
void reco::TrackBase::setOriginalAlgorithm ( const TrackAlgorithm  a)
inline

Definition at line 935 of file TrackBase.h.

References a, algoMask_, and originalAlgorithm_.

Referenced by TrackProducerAlgorithm< reco::Track >::buildTrack(), isTimeOk(), and setAlgorithm().

936 {
938  algoMask_.set(a);
939 }
uint8_t originalAlgorithm_
track algorithm
Definition: TrackBase.h:471
std::bitset< algoSize > algoMask_
algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping ...
Definition: TrackBase.h:459
double a
Definition: hdecay.h:121
void reco::TrackBase::setQuality ( const TrackQuality  )
inline

Definition at line 562 of file TrackBase.h.

References lumiQueryAPI::q, quality_, and undefQuality.

Referenced by isAlgoInMask(), and TrackBase().

563 {
564  if (q == undefQuality) {
565  quality_ = 0;
566  } else {
567  quality_ |= (1 << q);
568  }
569 }
uint8_t quality_
track quality
Definition: TrackBase.h:475
void reco::TrackBase::setQualityMask ( int  qualMask)
inline

Definition at line 948 of file TrackBase.h.

References quality_.

Referenced by isAlgoInMask().

949 {
950  quality_ = qualMask;
951 }
uint8_t quality_
track quality
Definition: TrackBase.h:475
void reco::TrackBase::setStopReason ( uint8_t  value)
inline

Definition at line 427 of file TrackBase.h.

References stopReason_, and relativeConstraints::value.

427 { stopReason_ = value; }
uint8_t stopReason_
Stop Reason.
Definition: TrackBase.h:481
uint8_t reco::TrackBase::stopReason ( ) const
inline

Definition at line 429 of file TrackBase.h.

References stopReason_.

Referenced by dqm::TrackAnalyzer::analyze().

429 { return stopReason_; }
uint8_t stopReason_
Stop Reason.
Definition: TrackBase.h:481
double reco::TrackBase::t0 ( ) const
inline

time at the reference point

Definition at line 726 of file TrackBase.h.

References t0_.

Referenced by isTimeOk(), and reco::Track::Track().

727 {
728  return t0_;
729 }
float t0_
time at the reference point on track
Definition: TrackBase.h:449
double reco::TrackBase::t0Error ( ) const
inline

error on t0

Definition at line 883 of file TrackBase.h.

References covt0t0_, and mathSSE::sqrt().

Referenced by isTimeOk().

884 {
885  return std::sqrt(covt0t0_);
886 }
T sqrt(T t)
Definition: SSEVec.h:18
float covt0t0_
errors for time and velocity (separate from cov for now)
Definition: TrackBase.h:440
double reco::TrackBase::theta ( ) const
inline
double reco::TrackBase::thetaError ( ) const
inline
double reco::TrackBase::validFraction ( ) const
inline

fraction of valid hits on the track

Definition at line 913 of file TrackBase.h.

References hitPattern_, reco::HitPattern::MISSING_INNER_HITS, reco::HitPattern::MISSING_OUTER_HITS, reco::HitPattern::numberOfLostTrackerHits(), reco::HitPattern::numberOfValidTrackerHits(), and reco::HitPattern::TRACK_HITS.

Referenced by dqm::TrackAnalyzer::analyze(), and isTimeOk().

914 {
919 
920  if ((valid + lost + lostIn + lostOut) == 0) {
921  return -1;
922  }
923 
924  return valid / (double)(valid + lost + lostIn + lostOut);
925 }
int numberOfLostTrackerHits(HitCategory category) const
Definition: HitPattern.h:995
int numberOfValidTrackerHits() const
Definition: HitPattern.h:901
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:434
const TrackBase::Point & reco::TrackBase::vertex ( ) const
inline
double reco::TrackBase::vx ( ) const
inline
double reco::TrackBase::vy ( ) const
inline
double reco::TrackBase::vz ( ) const
inline

z coordinate of the reference point on track

Definition at line 708 of file TrackBase.h.

References vertex_.

Referenced by dqm::TrackAnalyzer::analyze(), GenPurposeSkimmerData::analyze(), PackedCandidateTrackValidator::analyze(), FWSecVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::build(), FWVertexProxyBuilder::build(), FWTrackProxyBuilderFullFramework::buildTrack(), EleTkIsolFromCands::calIsol(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), PFCandWithSuperClusterExtractor::depositFromObject(), dsz(), dxy(), dxyError(), dz(), TrackTimeValueMapProducer::extractTrackVertexTime(), GsfTrackProducerBase::fillMode(), PrimaryVertexValidation::fillTrackHistos(), PFDisplacedVertexCandidateFinder::getGlobalTrajectoryParameters(), isTimeOk(), MatcherByPullsAlgorithm::match(), ComparePairs::operator()(), EleTkIsolFromCands::passTrkSel(), fireworks::prepareTrack(), SiStripElectronAssociator::produce(), VertexFromTrackProducer::produce(), spr::propagateECAL(), spr::propagateHCAL(), spr::propagateHCALBack(), spr::propagateTracker(), spr::propagateTrackerEnd(), spr::propagateTrackToECAL(), spr::propagateTrackToHCAL(), TrackExtrapolator::propagateTrackToVolume(), fireworks::pushPixelHits(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), and EwkMuLumiMonitorDQM::tkIso().

709 {
710  return vertex_.z();
711 }
Point vertex_
innermost (reference) point on track
Definition: TrackBase.h:446

Member Data Documentation

std::bitset<algoSize> reco::TrackBase::algoMask_
private

algo mask, bit set for the algo where it was reconstructed + each algo a track was found overlapping by the listmerger

Definition at line 459 of file TrackBase.h.

Referenced by algoMask(), setAlgoMask(), setAlgorithm(), setOriginalAlgorithm(), and TrackBase().

std::string const TrackBase::algoNames
static
uint8_t reco::TrackBase::algorithm_
private

track algorithm

Definition at line 468 of file TrackBase.h.

Referenced by algo(), setAlgorithm(), and TrackBase().

float reco::TrackBase::beta_
private

norm of the particle velocity at innermost point on track can multiply by momentum_.Unit() to get velocity vector

Definition at line 456 of file TrackBase.h.

Referenced by beta().

char reco::TrackBase::charge_
private

electric charge

Definition at line 465 of file TrackBase.h.

Referenced by charge().

float reco::TrackBase::chi2_
private

chi-squared

Definition at line 443 of file TrackBase.h.

Referenced by chi2(), and normalizedChi2().

float reco::TrackBase::covariance_[covarianceSize]
private

perigee 5x5 covariance matrix

Definition at line 437 of file TrackBase.h.

Referenced by covariance(), error(), fill(), and TrackBase().

float reco::TrackBase::covbetabeta_
private

Definition at line 440 of file TrackBase.h.

Referenced by betaError(), and covBetaBeta().

float reco::TrackBase::covt0t0_
private

errors for time and velocity (separate from cov for now)

Definition at line 440 of file TrackBase.h.

Referenced by covt0t0(), isTimeOk(), and t0Error().

HitPattern reco::TrackBase::hitPattern_
private
Vector reco::TrackBase::momentum_
private

momentum vector at innermost point

Definition at line 452 of file TrackBase.h.

Referenced by eta(), lambda(), momentum(), p(), phi(), pt(), px(), py(), pz(), and theta().

float reco::TrackBase::ndof_
private

number of degrees of freedom

Definition at line 462 of file TrackBase.h.

Referenced by ndof(), and normalizedChi2().

signed char reco::TrackBase::nLoops_
private

number of loops made during the building of the trajectory of a looper particle

Definition at line 478 of file TrackBase.h.

Referenced by isLooper(), nLoops(), and setNLoops().

uint8_t reco::TrackBase::originalAlgorithm_
private

track algorithm

Definition at line 471 of file TrackBase.h.

Referenced by originalAlgo(), and setOriginalAlgorithm().

uint8_t reco::TrackBase::quality_
private

track quality

Definition at line 475 of file TrackBase.h.

Referenced by quality(), qualityMask(), setQuality(), and setQualityMask().

std::string const TrackBase::qualityNames
static
Initial value:
= {
"loose",
"tight",
"highPurity",
"confirmed",
"goodIterative",
"looseSetWithPV",
"highPuritySetWithPV",
"discarded"
}

Definition at line 164 of file TrackBase.h.

Referenced by dqm::TrackAnalyzer::bookHistosForState(), qualityByName(), and qualityName().

uint8_t reco::TrackBase::stopReason_
private

Stop Reason.

Definition at line 481 of file TrackBase.h.

Referenced by setStopReason(), and stopReason().

float reco::TrackBase::t0_
private

time at the reference point on track

Definition at line 449 of file TrackBase.h.

Referenced by t0().

Point reco::TrackBase::vertex_
private

innermost (reference) point on track

Definition at line 446 of file TrackBase.h.

Referenced by referencePoint(), vertex(), vx(), vy(), and vz().