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 DetId &id, TrackingRecHit::Type hitType, const TrackerTopology &ttopo)
 
bool appendHitPattern (const TrackingRecHit &hit, const TrackerTopology &ttopo)
 append a single hit to the HitPattern More...
 
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 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 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 dxyError () const
 error on dxy More...
 
double dxyError (const BeamSpot &theBeamSpot) const
 error on dxy with respect to a user-given beamspot 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 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...
 
int missingInnerHits () const
 number of hits expected from inner track extrapolation but missing More...
 
int missingOuterHits () const
 number of hits expected from outer track extrapolation but missing 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 p2 () const
 momentum vector magnitude square 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 pt2 () const
 track transverse momentum square More...
 
double ptError () const
 error on Pt (set to 1000 TeV if charge==0 for safety) More...
 
double ptError2 () const
 error on Pt (set to 1000**2 TeV**2 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 62 of file TrackBase.h.

Member Typedef Documentation

◆ AlgoMask

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

algo mask

Definition at line 145 of file TrackBase.h.

◆ CovarianceMatrix

5 parameter covariance matrix

Definition at line 74 of file TrackBase.h.

◆ index

typedef unsigned int reco::TrackBase::index

index type

Definition at line 86 of file TrackBase.h.

◆ ParameterVector

parameter vector

Definition at line 71 of file TrackBase.h.

◆ Point

point in the space

Definition at line 80 of file TrackBase.h.

◆ Vector

spatial vector

Definition at line 77 of file TrackBase.h.

Member Enumeration Documentation

◆ anonymous enum

anonymous enum

parameter dimension

Enumerator
dimension 

Definition at line 65 of file TrackBase.h.

65 { dimension = 5 };

◆ anonymous enum

anonymous enum

error matrix size

Enumerator
covarianceSize 

Definition at line 68 of file TrackBase.h.

68 { covarianceSize = dimension * (dimension + 1) / 2 };

◆ anonymous enum

anonymous enum

enumerator provided indices to the five parameters

Enumerator
i_qoverp 
i_lambda 
i_phi 
i_dxy 
i_dsz 

Definition at line 83 of file TrackBase.h.

83 { i_qoverp = 0, i_lambda, i_phi, i_dxy, i_dsz };

◆ TrackAlgorithm

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 89 of file TrackBase.h.

89  {
90  undefAlgorithm = 0,
91  ctf = 1,
92  duplicateMerge = 2,
93  cosmics = 3,
94  initialStep = 4,
95  lowPtTripletStep = 5,
96  pixelPairStep = 6,
98  mixedTripletStep = 8,
99  pixelLessStep = 9,
100  tobTecStep = 10,
101  jetCoreRegionalStep = 11,
102  conversionStep = 12,
103  muonSeededStepInOut = 13,
104  muonSeededStepOutIn = 14,
105  outInEcalSeededConv = 15,
106  inOutEcalSeededConv = 16,
107  nuclInter = 17,
108  standAloneMuon = 18,
109  globalMuon = 19,
111  cosmicGlobalMuon = 21,
112  // Phase1
113  highPtTripletStep = 22,
114  lowPtQuadStep = 23,
115  detachedQuadStep = 24,
118  bTagGhostTracks = 27,
119  beamhalo = 28,
120  gsf = 29,
121  // HLT algo name
122  hltPixel = 30,
123  // steps used by PF
124  hltIter0 = 31,
125  hltIter1 = 32,
126  hltIter2 = 33,
127  hltIter3 = 34,
128  hltIter4 = 35,
129  // steps used by all other objects @HLT
130  hltIterX = 36,
131  // steps used by HI muon regional iterative tracking
138  hiRegitMuTobTecStep = 43,
141  algoSize = 46
142  };

◆ TrackQuality

track quality

Enumerator
undefQuality 
loose 
tight 
highPurity 
confirmed 
goodIterative 
looseSetWithPV 
highPuritySetWithPV 
discarded 
qualitySize 

Definition at line 150 of file TrackBase.h.

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

Constructor & Destructor Documentation

◆ TrackBase() [1/2]

TrackBase::TrackBase ( )

default constructor

Definition at line 59 of file TrackBase.cc.

60  : covt0t0_(-1.f),
61  covbetabeta_(-1.f),
62  chi2_(0),
63  vertex_(0, 0, 0),
64  t0_(0),
65  momentum_(0, 0, 0),
66  beta_(0),
67  ndof_(0),
68  charge_(0),
71  quality_(0),
72  nLoops_(0),
73  stopReason_(0) {
74  algoMask_.set(algorithm_);
75  index idx = 0;
76  for (index i = 0; i < dimension; ++i) {
77  for (index j = 0; j <= i; ++j) {
78  covariance_[idx++] = 0;
79  }
80  }
81 }

References algoMask_, algorithm_, covariance_, dimension, mps_fire::i, heavyIonCSV_trainingSettings::idx, and dqmiolumiharvest::j.

◆ TrackBase() [2/2]

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 83 of file TrackBase.cc.

97  : covt0t0_(covt0t0),
98  covbetabeta_(covbetabeta),
99  chi2_(chi2),
100  vertex_(vertex),
101  t0_(t0),
103  beta_(beta),
104  ndof_(ndof),
105  charge_(charge),
108  quality_(0),
109  nLoops_(nloops),
111  algoMask_.set(algorithm_);
112 
113  index idx = 0;
114  for (index i = 0; i < dimension; ++i) {
115  for (index j = 0; j <= i; ++j) {
116  covariance_[idx++] = cov(i, j);
117  }
118  }
120 }

References algoMask_, algorithm_, covariance_, dimension, mps_fire::i, heavyIonCSV_trainingSettings::idx, dqmiolumiharvest::j, quality(), and setQuality().

◆ ~TrackBase()

TrackBase::~TrackBase ( )
virtual

virtual destructor

Definition at line 122 of file TrackBase.cc.

122 { ; }

Member Function Documentation

◆ algo()

TrackBase::TrackAlgorithm reco::TrackBase::algo ( ) const
inline

◆ algoByName()

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

◆ algoMask()

AlgoMask reco::TrackBase::algoMask ( ) const
inline

Definition at line 415 of file TrackBase.h.

415 { return algoMask_; }

References algoMask_.

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

◆ algoMaskUL()

unsigned long long reco::TrackBase::algoMaskUL ( ) const
inline

Definition at line 416 of file TrackBase.h.

416 { return algoMask().to_ullong(); }

References algoMask().

◆ algoName() [1/2]

std::string reco::TrackBase::algoName ( ) const
inline

Definition at line 550 of file TrackBase.h.

550 { return TrackBase::algoName(algo()); }

References algo().

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

◆ algoName() [2/2]

std::string reco::TrackBase::algoName ( TrackAlgorithm  a)
inlinestatic

Definition at line 579 of file TrackBase.h.

579  {
580  if (int(a) < int(algoSize) && int(a) > 0) {
581  return algoNames[int(a)];
582  }
583  return "undefAlgorithm";
584  }

References a, algoNames, algoSize, and createfilelist::int.

◆ appendHitPattern() [1/3]

bool reco::TrackBase::appendHitPattern ( const DetId id,
TrackingRecHit::Type  hitType,
const TrackerTopology ttopo 
)
inline

Definition at line 506 of file TrackBase.h.

506  {
507  return hitPattern_.appendHit(id, hitType, ttopo);
508  }

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

◆ appendHitPattern() [2/3]

bool reco::TrackBase::appendHitPattern ( const TrackingRecHit hit,
const TrackerTopology ttopo 
)
inline

append a single hit to the HitPattern

Definition at line 510 of file TrackBase.h.

510  {
511  return hitPattern_.appendHit(hit, ttopo);
512  }

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

Referenced by MuonErrorMatrixAdjuster::attachRecHits(), and SeedToTrackProducer::produce().

◆ appendHitPattern() [3/3]

bool reco::TrackBase::appendHitPattern ( const uint16_t  pattern,
TrackingRecHit::Type  hitType 
)
inline

Definition at line 521 of file TrackBase.h.

521  {
522  return hitPattern_.appendHit(pattern, hitType);
523  }

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

◆ appendHits() [1/2]

template<typename C >
bool reco::TrackBase::appendHits ( const C &  c,
const TrackerTopology ttopo 
)

append hit patterns from vector of hit references

Definition at line 537 of file TrackBase.h.

537  {
538  return hitPattern_.appendHits(c.begin(), c.end(), ttopo);
539  }

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

◆ appendHits() [2/2]

template<typename I >
bool reco::TrackBase::appendHits ( const I &  begin,
const I &  end,
const TrackerTopology ttopo 
)

Definition at line 532 of file TrackBase.h.

532  {
533  return hitPattern_.appendHits(begin, end, ttopo);
534  }

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

◆ appendMuonHitPattern()

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 525 of file TrackBase.h.

525  {
526  return hitPattern_.appendMuonHit(id, hitType);
527  }

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

◆ appendTrackerHitPattern()

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 514 of file TrackBase.h.

517  {
518  return hitPattern_.appendTrackerHit(subdet, layer, stereo, hitType);
519  }

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

◆ beta()

double reco::TrackBase::beta ( ) const
inline

velocity at the reference point in natural units

Definition at line 673 of file TrackBase.h.

673 { return beta_; }

References beta_.

◆ betaError()

double reco::TrackBase::betaError ( ) const
inline

error on beta

Definition at line 790 of file TrackBase.h.

790 { return std::sqrt(covbetabeta_); }

References covbetabeta_, and mathSSE::sqrt().

◆ charge()

int reco::TrackBase::charge ( ) const
inline

track electric charge

Definition at line 596 of file TrackBase.h.

596 { return charge_; }

References charge_.

Referenced by PATTracksToPackedCandidates::addPackedCandidate(), EwkMuLumiMonitorDQM::analyze(), ObjMonitor::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), PrimaryVertexValidation::analyze(), MuonTrackValidator::analyze(), PackedCandidateTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), ConversionProducer::buildCollection(), reco::CandidatePtrTransientTrack::charge(), reco::TrackTransientTrack::charge(), reco::GsfTransientTrack::charge(), AlignmentTwoBodyDecayTrackSelector::checkCharge(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), CandidateChargeBTagComputer::discriminator(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), egamma::conv::getConversionInfo(), AlCaHOCalibProducer::getFreeTrajectoryState(), FWPFTrackUtils::getTrack(), SeedFromProtoTrack::init(), HLTmumutktkVtxProducer::initialFreeState(), HLTmumutkVtxProducer::initialFreeState(), HLTmmkFilter::initialFreeState(), HLTmmkkFilter::initialFreeState(), trajectoryStateTransform::initialFreeState(), trajectoryStateTransform::innerFreeState(), MuonErrorMatrixAdjuster::makeTrack(), MatcherByPullsAlgorithm::match(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), trajectoryStateTransform::outerFreeState(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), PFDisplacedTrackerVertexProducer::produce(), pat::PATIsolatedTrackProducer::produce(), EvtPlaneProducer::produce(), spr::propagateCosmicCALO(), TrackExtrapolator::propagateTrackToVolume(), ptError2(), qoverp(), FWConvTrackHitsDetailView::setTextInfo(), and ConversionProducer::trackD0Cut().

◆ chi2()

double reco::TrackBase::chi2 ( void  ) const
inline

◆ covariance() [1/2]

TrackBase::CovarianceMatrix reco::TrackBase::covariance ( void  ) const
inline

◆ covariance() [2/2]

double reco::TrackBase::covariance ( int  i,
int  j 
) const
inline

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

Definition at line 726 of file TrackBase.h.

726 { return covariance_[covIndex(i, j)]; }

References covariance_, covIndex(), mps_fire::i, and dqmiolumiharvest::j.

◆ covBetaBeta()

double reco::TrackBase::covBetaBeta ( ) const
inline

error on beta

Definition at line 784 of file TrackBase.h.

784 { return covbetabeta_; }

References covbetabeta_.

◆ covIndex()

TrackBase::index reco::TrackBase::covIndex ( index  i,
index  j 
)
inlinestatic

covariance matrix index in array

Definition at line 541 of file TrackBase.h.

541  {
542  int a = (i <= j ? i : j);
543  int b = (i <= j ? j : i);
544  return b * (b + 1) / 2 + a;
545  }

References a, b, mps_fire::i, and dqmiolumiharvest::j.

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

◆ covt0t0()

double reco::TrackBase::covt0t0 ( ) const
inline

error on t0

Definition at line 781 of file TrackBase.h.

781 { return covt0t0_; }

References covt0t0_.

◆ d0()

double reco::TrackBase::d0 ( ) const
inline

◆ d0Error()

double reco::TrackBase::d0Error ( ) const
inline

◆ dsz() [1/2]

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 614 of file TrackBase.h.

614  {
615  const auto thept = pt();
616  const auto thepinv = 1 / p();
617  const auto theptoverp = thept * thepinv;
618  return vz() * theptoverp - (vx() * px() + vy() * py()) / thept * pz() * thepinv;
619  }

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

Referenced by TestOutliers::analyze(), CosmicSplitterValidation::is_gold_muon(), MatcherByPullsAlgorithm::match(), parameters(), RecoTracktoTP::r_dsz(), TPtoRecoTrack::rA_dsz(), and TPtoRecoTrack::rB_dsz().

◆ dsz() [2/2]

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 693 of file TrackBase.h.

693  {
694  const auto thept = pt();
695  const auto thepinv = 1 / p();
696  const auto theptoverp = thept * thepinv;
697  return (vz() - myBeamSpot.z()) * theptoverp -
698  ((vx() - myBeamSpot.x()) * px() + (vy() - myBeamSpot.y()) * py()) / thept * pz() * thepinv;
699  }

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

◆ dszError()

double reco::TrackBase::dszError ( ) const
inline

error on dsz

Definition at line 775 of file TrackBase.h.

775 { return error(i_dsz); }

References error(), and i_dsz.

◆ dxy() [1/3]

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 608 of file TrackBase.h.

608 { return (-vx() * py() + vy() * px()) / pt(); }

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

Referenced by TrackTypeMonitor::analyze(), RecoMuonValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), GenPurposeSkimmerData::analyze(), PrimaryVertexValidation::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), PileupJetIdAlgo::computeIdVariables(), Electron.Electron::cutBasedId(), d0(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), PFDisplacedVertexHelper::TracksSelector::dxy(), dxy(), ntupleDataFormat.Track::dxyPull(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), WtoLNuSelector::filter(), V0Fitter::fitAll(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), PFDisplacedVertexHelper::isTrackSelected(), MatcherByPullsAlgorithm::match(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), parameters(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), pat::PATIsolatedTrackProducer::produce(), TriggerMatcherToHLTDebug::produce(), EvtPlaneProducer::produce(), RecoTracktoTP::r_d02(), RecoTracktoTP::r_dxy(), TPtoRecoTrack::rA_d02(), TPtoRecoTrack::rA_dxy(), TPtoRecoTrack::rB_d02(), TPtoRecoTrack::rB_dxy(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), ConversionProducer::trackD0Cut(), and QcdUeDQM::trackSelection().

◆ dxy() [2/3]

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 688 of file TrackBase.h.

688 { return dxy(theBeamSpot.position(vz())); }

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

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

◆ dxy() [3/3]

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 681 of file TrackBase.h.

681  {
682  return (-(vx() - myBeamSpot.x()) * py() + (vy() - myBeamSpot.y()) * px()) / pt();
683  }

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

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

◆ dxyError() [1/3]

double reco::TrackBase::dxyError ( ) const
inline

◆ dxyError() [2/3]

double reco::TrackBase::dxyError ( const BeamSpot theBeamSpot) const
inline

error on dxy with respect to a user-given beamspot

Definition at line 793 of file TrackBase.h.

793  {
794  return dxyError(theBeamSpot.position(vz()), theBeamSpot.rotatedCovariance3D());
795  }

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

◆ dxyError() [3/3]

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 148 of file TrackBase.cc.

148  {
149  // Gradient of TrackBase::dxy(const Point &myBeamSpot) with respect to track parameters. Using unrolled expressions to avoid calling for higher dimension matrices
150  // ( 0, 0, x_vert * cos(phi) + y_vert * sin(phi), 1, 0 )
151  // Gradient with respect to point parameters
152  // ( sin(phi), -cos(phi))
153  // Propagate covariance assuming cross-terms of the covariance between track and vertex parameters are 0
154  return std::sqrt((vtx.x() * px() + vtx.y() * py()) * (vtx.x() * px() + vtx.y() * py()) / (pt() * pt()) *
156  2 * (vtx.x() * px() + vtx.y() * py()) / pt() * covariance(i_phi, i_dxy) + covariance(i_dxy, i_dxy) +
157  py() * py() / (pt() * pt()) * vertexCov(0, 0) - 2 * py() * px() / (pt() * pt()) * vertexCov(0, 1) +
158  px() * px() / (pt() * pt()) * vertexCov(1, 1));
159 }

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

◆ dz() [1/2]

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 622 of file TrackBase.h.

622  {
623  const auto thept2inv = 1 / pt2();
624  return vz() - (vx() * px() + vy() * py()) * pz() * thept2inv;
625  }

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

Referenced by TrackTypeMonitor::analyze(), RecoMuonValidator::analyze(), ObjMonitor::analyze(), TrackSplittingMonitor::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), AlignmentTrackSelector::basicCuts(), PileupJetIdAlgo::computeIdVariables(), Electron.Electron::cutBasedId(), ntupleDataFormat.Track::dzPull(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), HcalHBHEMuonHighEtaAnalyzer::fillTrackParameters(), WtoLNuSelector::filter(), reco::tau::RecoTauQualityCuts::filterChargedCand(), reco::tau::RecoTauQualityCuts::filterTrack_(), V0Fitter::fitAll(), getBestVertex(), getBestVertex_withError(), spr::goodTrack(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), pat::PATPackedCandidateProducer::produce(), pat::PATIsolatedTrackProducer::produce(), TriggerMatcherToHLTDebug::produce(), EvtPlaneProducer::produce(), RecoTracktoTP::r_dz(), RecoTracktoTP::r_dz2(), TPtoRecoTrack::rA_dz(), TPtoRecoTrack::rA_dz2(), TPtoRecoTrack::rB_dz(), TPtoRecoTrack::rB_dz2(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), and QcdUeDQM::trackSelection().

◆ dz() [2/2]

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 704 of file TrackBase.h.

704  {
705  const auto theptinv2 = 1 / pt2();
706  return (vz() - myBeamSpot.z()) -
707  ((vx() - myBeamSpot.x()) * px() + (vy() - myBeamSpot.y()) * py()) * pz() * theptinv2;
708  }

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

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

◆ dzError()

double reco::TrackBase::dzError ( ) const
inline

◆ error()

double reco::TrackBase::error ( int  i) const
inline

◆ eta()

double reco::TrackBase::eta ( ) const
inline

pseudorapidity of momentum vector

Definition at line 652 of file TrackBase.h.

652 { return momentum_.Eta(); }

References momentum_.

Referenced by Particle.Particle::__str__(), PATTracksToPackedCandidates::addPackedCandidate(), RecoMuonValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), ObjMonitor::analyze(), GlobalMuonMatchAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), BTVHLTOfflineSource::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), GenPurposeSkimmerData::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalibration::analyze(), IsoTrackCalib::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), BeamHaloAnalyzer::analyze(), PackedCandidateTrackValidator::analyze(), HcalHBHEMuonHighEtaAnalyzer::analyzeHadron(), HcalHBHEMuonHighEtaAnalyzer::analyzeMuon(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), FWTrackProxyBuilder::build(), pat::CaloIsolationEnergy::calculate(), spr::chargeIsolationHcal(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), reco::HcalNoiseInfoProducer::filltracks(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), PFElecTkProducer::findPfRef(), Tau3MuReco::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), Jet.Jet::jetID(), ticl::SeedingRegionByTracks::makeRegions(), MatcherByPullsAlgorithm::match(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), EleTkIsolFromCands::operator()(), EleTkIsolFromCands::preselectTracksFromCands(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), TrackFromPackedCandidateProducer::produce(), OutsideInMuonSeeder::produce(), pat::PATPackedCandidateProducer::produce(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), TriggerMatcherToHLTDebug::produce(), EvtPlaneProducer::produce(), spr::propagateCALO(), Jet.Jet::puJetId(), CutsIsolatorWithCorrection::result(), SimpleCutsIsolator::result(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), AlCaIsoTracksProducer::select(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), IsoTrig::studyMipCut(), EwkMuLumiMonitorDQM::tkIso(), HcalIsoTrkAnalyzer::trackP(), StudyCaloResponse::trackPID(), and QcdUeDQM::trackSelection().

◆ etaError()

double reco::TrackBase::etaError ( ) const
inline

◆ fill()

TrackBase::CovarianceMatrix & TrackBase::fill ( CovarianceMatrix v) const

fill SMatrix

Definition at line 124 of file TrackBase.cc.

124 { return fillCovariance(v, covariance_); }

References covariance_, reco::fillCovariance(), and findQualityFiles::v.

Referenced by covariance().

◆ hitPattern()

const HitPattern & reco::TrackBase::hitPattern ( ) const
inline

◆ isAlgoInMask()

bool reco::TrackBase::isAlgoInMask ( TrackAlgorithm  a) const
inline

Definition at line 417 of file TrackBase.h.

417 { return algoMask()[a]; }

References a, and algoMask().

Referenced by BadGlobalMuonTagger::outInOnly().

◆ isLooper()

bool reco::TrackBase::isLooper ( ) const
inline

Definition at line 849 of file TrackBase.h.

849 { return (nLoops_ > 0); }

References nLoops_.

◆ isTimeOk()

bool reco::TrackBase::isTimeOk ( ) const
inline

return true if timing measurement is usable

Definition at line 188 of file TrackBase.h.

188 { return covt0t0_ > 0.f; }

References covt0t0_.

◆ lambda()

double reco::TrackBase::lambda ( ) const
inline

Lambda angle.

Definition at line 605 of file TrackBase.h.

605 { return M_PI_2 - momentum_.theta(); }

References M_PI_2, and momentum_.

Referenced by TestOutliers::analyze(), and parameters().

◆ lambdaError()

double reco::TrackBase::lambdaError ( ) const
inline

error on lambda

Definition at line 760 of file TrackBase.h.

760 { return error(i_lambda); }

References error(), and i_lambda.

◆ missingInnerHits()

int reco::TrackBase::missingInnerHits ( ) const
inline

number of hits expected from inner track extrapolation but missing

Definition at line 806 of file TrackBase.h.

References hitPattern_, reco::HitPattern::MISSING_INNER_HITS, and reco::HitPattern::numberOfLostHits().

◆ missingOuterHits()

int reco::TrackBase::missingOuterHits ( ) const
inline

number of hits expected from outer track extrapolation but missing

Definition at line 811 of file TrackBase.h.

References hitPattern_, reco::HitPattern::MISSING_OUTER_HITS, and reco::HitPattern::numberOfLostHits().

◆ momentum()

const TrackBase::Vector & reco::TrackBase::momentum ( ) const
inline

◆ ndof()

double reco::TrackBase::ndof ( ) const
inline

◆ nLoops()

signed char reco::TrackBase::nLoops ( ) const
inline

Definition at line 851 of file TrackBase.h.

851 { return nLoops_; }

References nLoops_.

◆ normalizedChi2()

double reco::TrackBase::normalizedChi2 ( ) const
inline

◆ numberOfLostHits()

unsigned short reco::TrackBase::numberOfLostHits ( ) const
inline

◆ numberOfValidHits()

unsigned short reco::TrackBase::numberOfValidHits ( ) const
inline

◆ originalAlgo()

TrackBase::TrackAlgorithm reco::TrackBase::originalAlgo ( ) const
inline

Definition at line 548 of file TrackBase.h.

548 { return (TrackAlgorithm)(originalAlgorithm_); }

References originalAlgorithm_.

Referenced by MTVHistoProducerAlgoForTracker::fill_duplicate_histos().

◆ p()

double reco::TrackBase::p ( ) const
inline

momentum vector magnitude

Definition at line 631 of file TrackBase.h.

631 { return sqrt(p2()); }

References p2(), and mathSSE::sqrt().

Referenced by RecoMuonValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), CosmicSplitterValidation::analyze(), IsoTrackCalibration::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), StudyCaloResponse::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), AlignmentTrackSelector::basicCuts(), HBHEHitMap::calcTracksNeighborTowers_(), HBHEHitMap::calcTracksSameTowers_(), pat::TrackerIsolationPt::calculate(), spr::chargeIsolation(), spr::chargeIsolationCone(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), IsoTrig::chgIsolation(), spr::coneChargeIsolation(), dsz(), PFRecoTauDiscriminationAgainstMuon2Helper::eval(), reco::HcalNoiseInfoProducer::filltracks(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), IsoTrig::getGoodTracks(), PFDisplacedVertexHelper::lambdaCP(), MuonIdTruthInfo::matchChi2(), muonid::matchTracks(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), spr::propagateCALO(), Electron.Electron::ptErr(), qoverp(), PFAlgo::reconstructTrack(), MuonTrackingRegionBuilder::region(), AlCaIsoTracksProducer::select(), IsoTrig::studyIsolation(), IsoTrig::studyMipCut(), and IsoTrig::StudyTrkEbyP().

◆ p2()

double reco::TrackBase::p2 ( ) const
inline

momentum vector magnitude square

Definition at line 628 of file TrackBase.h.

628 { return momentum_.Mag2(); }

References momentum_.

Referenced by dzError(), etaError(), p(), and ptError2().

◆ parameter()

double reco::TrackBase::parameter ( int  i) const
inline

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

Definition at line 723 of file TrackBase.h.

723 { return parameters()[i]; }

References mps_fire::i, and parameters().

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

◆ parameters()

TrackBase::ParameterVector reco::TrackBase::parameters ( void  ) const
inline

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

Definition at line 711 of file TrackBase.h.

711  {
712  return TrackBase::ParameterVector(qoverp(), lambda(), phi(), dxy(), dsz());
713  }

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

Referenced by SiStripFineDelayHit::detId(), and parameter().

◆ phi()

double reco::TrackBase::phi ( ) const
inline

azimuthal angle of momentum vector

Definition at line 649 of file TrackBase.h.

649 { return momentum_.Phi(); }

References momentum_.

Referenced by Particle.Particle::__str__(), PATTracksToPackedCandidates::addPackedCandidate(), RecoMuonValidator::analyze(), ObjMonitor::analyze(), TrackSplittingMonitor::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), BTVHLTOfflineSource::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), GenPurposeSkimmerData::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalibration::analyze(), IsoTrackCalib::analyze(), PackedCandidateTrackValidator::analyze(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), pat::CaloIsolationEnergy::calculate(), spr::chargeIsolationHcal(), AlignmentTwoBodyDecayTrackSelector::checkAcoplanarity(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), HcalIsoTrkAnalyzer::fillTree(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), PFElecTkProducer::findPfRef(), egamma::conv::getConversionInfo(), Tau3MuReco::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), CosmicSplitterValidation::is_gold_muon(), MatcherByPullsAlgorithm::match(), MuonIdTruthInfo::matchChi2(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), EleTkIsolFromCands::operator()(), parameters(), ntupleDataFormat.Track::phiPull(), EleTkIsolFromCands::preselectTracksFromCands(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), TrackFromPackedCandidateProducer::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), EvtPlaneProducer::produce(), spr::propagateCALO(), AlCaIsoTracksProducer::select(), FWConvTrackHitsDetailView::setTextInfo(), IsoTrig::studyMipCut(), EwkMuLumiMonitorDQM::tkIso(), HcalIsoTrkAnalyzer::trackP(), StudyCaloResponse::trackPID(), and QcdUeDQM::trackSelection().

◆ phiError()

double reco::TrackBase::phiError ( ) const
inline

◆ pt()

double reco::TrackBase::pt ( ) const
inline

track transverse momentum

Definition at line 637 of file TrackBase.h.

637 { return sqrt(pt2()); }

References pt2(), and mathSSE::sqrt().

Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), PATTracksToPackedCandidates::addPackedCandidate(), PFCandConnector::analyseNuclearWSec(), DiDispStaMuonMonitor::analyze(), RecoMuonValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), ObjMonitor::analyze(), TrackSplittingMonitor::analyze(), GlobalMuonMatchAnalyzer::analyze(), ElectronConversionRejectionValidator::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), BTVHLTOfflineSource::analyze(), TkConvValidator::analyze(), TestOutliers::analyze(), CosmicSplitterValidation::analyze(), GenPurposeSkimmerData::analyze(), IsoTrackCalibration::analyze(), PrimaryVertexValidation::analyze(), IsoTrackCalib::analyze(), StudyCaloResponse::analyze(), IsolatedTracksHcalScale::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), PackedCandidateTrackValidator::analyze(), CalibrationTrackSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), FWTrackProxyBuilder::build(), Photon.Photon::calScaledIsoValueExp(), Photon.Photon::calScaledIsoValueLin(), Photon.Photon::calScaledIsoValueQuadr(), muonisolation::PixelTrackExtractor::deposit(), muonisolation::TrackExtractor::deposit(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), CandidateChargeBTagComputer::discriminator(), dsz(), dxy(), dxyError(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), reco::HcalNoiseInfoProducer::filltracks(), HcalIsoTrkAnalyzer::fillTree(), JetVertexChecker::filter(), AlCaIsoTracksFilter::filter(), LeptonSkimming::filter(), V0Fitter::fitAll(), egamma::conv::getConversionInfo(), PFDisplacedVertexCandidateFinder::goodPtResolution(), spr::goodTrack(), HLTMuonL3PreFilter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), PFDisplacedVertexHelper::isTrackSelected(), MatcherByPullsAlgorithm::match(), muonid::matchTracks(), Electron.Electron::mvaIDLoose(), Electron.Electron::mvaIDRun2(), Electron.Electron::mvaIDTight(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), reco::Vertex::TrackEqual::operator()(), pat::PATLostTracks::passTrkCuts(), EleTkIsolFromCands::preselectTracksFromCands(), IsolatedTracksCone::printTrack(), IsolatedTracksNxN::printTrack(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), AlignmentMonitorMuonVsCurvature::processMuonResidualsFromTrack(), AlignmentMonitorSegmentDifferences::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), TrackFromPackedCandidateProducer::produce(), pat::PATPackedCandidateProducer::produce(), TrackTimeValueMapProducer::produce(), pat::PATIsolatedTrackProducer::produce(), SeedToTrackProducer::produce(), HLTScoutingMuonProducer::produce(), TriggerMatcherToHLTDebug::produce(), EvtPlaneProducer::produce(), Electron.Electron::ptErr(), ntupleDataFormat.Track::ptPull(), MuonTrackingRegionBuilder::region(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), CutsIsolatorWithCorrection::result(), AnalyticalTrackSelector::run(), MultiTrackSelector::run(), HIMultiTrackSelector::run(), CosmicTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), AlCaIsoTracksProducer::select(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), Jet.Jet::setCorrP4(), FWConvTrackHitsDetailView::setTextInfo(), FWPFTrackUtils::setupLegoTrack(), FWPFTrackUtils::setupTrack(), IsoTrig::studyMipCut(), EwkMuLumiMonitorDQM::tkIso(), reco::PFDisplacedVertex::trackPosition(), QcdUeDQM::trackSelection(), and ObjectValidator::validTrack().

◆ pt2()

double reco::TrackBase::pt2 ( ) const
inline

track transverse momentum square

Definition at line 634 of file TrackBase.h.

634 { return momentum_.Perp2(); }

References momentum_.

Referenced by dz(), dzError(), etaError(), pt(), and ptError2().

◆ ptError()

double reco::TrackBase::ptError ( ) const
inline

◆ ptError2()

double reco::TrackBase::ptError2 ( ) const
inline

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

Definition at line 735 of file TrackBase.h.

735  {
736  const auto thecharge = charge();
737 
738  if (thecharge != 0) {
739  const auto thept2 = pt2();
740  const auto thep2 = p2();
741  const auto thepz = pz();
742  const auto ptimespt = sqrt(thep2 * thept2);
743  const auto oneovercharge = 1 / thecharge;
744 
745  return thept2 * thep2 * oneovercharge * oneovercharge * covariance(i_qoverp, i_qoverp) +
746  2 * ptimespt * oneovercharge * thepz * covariance(i_qoverp, i_lambda) +
747  thepz * thepz * covariance(i_lambda, i_lambda);
748  }
749 
750  return 1.e12;
751  }

References charge(), covariance(), i_lambda, i_qoverp, p2(), pt2(), pz(), and mathSSE::sqrt().

Referenced by ptError().

◆ px()

double reco::TrackBase::px ( ) const
inline

◆ py()

double reco::TrackBase::py ( ) const
inline

◆ pz()

double reco::TrackBase::pz ( ) const
inline

◆ qoverp()

double reco::TrackBase::qoverp ( ) const
inline

◆ qoverpError()

double reco::TrackBase::qoverpError ( ) const
inline

error on signed transverse curvature

Definition at line 732 of file TrackBase.h.

732 { return error(i_qoverp); }

References error(), and i_qoverp.

Referenced by TestOutliers::analyze(), spr::goodTrack(), IsolatedTracksCone::printTrack(), and IsolatedTracksNxN::printTrack().

◆ quality()

bool reco::TrackBase::quality ( const  TrackQuality) const
inline

◆ qualityByName()

TrackBase::TrackQuality TrackBase::qualityByName ( const std::string &  name)
static

Definition at line 126 of file TrackBase.cc.

126  {
129  if (index == size) {
130  return undefQuality; // better this or throw() ?
131  }
132 
133  // cast
134  return TrackQuality(index);
135 }

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

Referenced by AlCaIsoTracksFilter::AlCaIsoTracksFilter(), AlCaIsoTracksProducer::AlCaIsoTracksProducer(), AlignmentTrackSelector::AlignmentTrackSelector(), TrackTypeMonitor::analyze(), PatTrackAnalyzer::analyze(), tadqm::TrackAnalyzer::analyze(), StandaloneTrackMonitor::analyze(), TrackCount::analyze(), FSQDQM::analyze(), IsolatedTracksCone::analyze(), IsolatedTracksNxN::analyze(), BeamFitter::BeamFitter(), QGTagger::calcVariables(), spr::chargeIsolation(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), spr::coneChargeIsolation(), lowptgsfeleseed::features(), FilterOutLowPt::filter(), FilterOutScraping::filter(), TrackIsoCalculator::getBkgSubTrackIso(), TrackIsoCalculator::getTrackIso(), HcalHBHEMuonHighEtaAnalyzer::HcalHBHEMuonHighEtaAnalyzer(), HcalIsoTrkAnalyzer::HcalIsoTrkAnalyzer(), HITrackClusterRemover::HITrackClusterRemover(), 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(), pat::PackedCandidateMuonSelectorProducer::produce(), pat::PATIsolatedTrackProducer::produce(), reco::modules::HICaloCompatibleTrackSelector::produce(), PromptTrackCountingComputer::PromptTrackCountingComputer(), spr::propagateCALO(), spr::propagateCosmicCALO(), QcdUeDQM::QcdUeDQM(), QualityCutsAnalyzer::QualityCutsAnalyzer(), RecoTrackSelectorBase::RecoTrackSelectorBase(), reco::modules::HICaloCompatibleTrackSelector::selectByPFCands(), reco::modules::HICaloCompatibleTrackSelector::selectByTowers(), L1Analysis::L1AnalysisRecoTrack::SetTracks(), StudyCaloResponse::StudyCaloResponse(), StudyTriggerHLT::StudyTriggerHLT(), TemplatedJetBProbabilityComputer< Container, Base >::TemplatedJetBProbabilityComputer(), TemplatedJetProbabilityComputer< Container, Base >::TemplatedJetProbabilityComputer(), TemplatedTrackCountingComputer< Container, Base >::TemplatedTrackCountingComputer(), TrackExtrapolator::TrackExtrapolator(), TrackFilterForPVFinding::TrackFilterForPVFinding(), TrackListMerger::TrackListMerger(), reco::TrackSelector::TrackSelector(), and EleTkIsolFromCands::TrkCuts::TrkCuts().

◆ qualityMask()

int reco::TrackBase::qualityMask ( ) const
inline

Definition at line 843 of file TrackBase.h.

843 { return quality_; }

References quality_.

Referenced by pat::PATIsolatedTrackProducer::produce(), MultiTrackSelector::run(), and HIMultiTrackSelector::run().

◆ qualityName()

std::string reco::TrackBase::qualityName ( TrackQuality  q)
inlinestatic

Definition at line 572 of file TrackBase.h.

572  {
573  if (int(q) < int(qualitySize) && int(q) >= 0) {
574  return qualityNames[int(q)];
575  }
576  return "undefQuality";
577  }

References createfilelist::int, submitPVResolutionJobs::q, qualityNames, and qualitySize.

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

◆ referencePoint()

const TrackBase::Point & reco::TrackBase::referencePoint ( ) const
inline

◆ resetHitPattern()

void reco::TrackBase::resetHitPattern ( )
inline

Sets HitPattern as empty.

Definition at line 529 of file TrackBase.h.

529 { hitPattern_.clear(); }

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

◆ setAlgoMask()

void reco::TrackBase::setAlgoMask ( AlgoMask  a)
inline

Definition at line 413 of file TrackBase.h.

413 { algoMask_ = a; }

References a, and algoMask_.

◆ setAlgorithm()

void reco::TrackBase::setAlgorithm ( const TrackAlgorithm  a)
inline

Track algorithm.

Definition at line 832 of file TrackBase.h.

832  {
833  algorithm_ = a;
834  algoMask_.reset();
836  }

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

Referenced by TrackListCombiner::produce().

◆ setNLoops()

void reco::TrackBase::setNLoops ( signed char  value)
inline

Definition at line 847 of file TrackBase.h.

847 { nLoops_ = value; }

References nLoops_, and relativeConstraints::value.

◆ setOriginalAlgorithm()

void reco::TrackBase::setOriginalAlgorithm ( const TrackAlgorithm  a)
inline

Definition at line 838 of file TrackBase.h.

838  {
840  algoMask_.set(a);
841  }

References a, algoMask_, and originalAlgorithm_.

Referenced by setAlgorithm().

◆ setQuality()

void reco::TrackBase::setQuality ( const  TrackQuality)
inline

Definition at line 564 of file TrackBase.h.

564  {
565  if (q == undefQuality) {
566  quality_ = 0;
567  } else {
568  quality_ |= (1 << q);
569  }
570  }

References submitPVResolutionJobs::q, quality_, and undefQuality.

Referenced by TrackBase().

◆ setQualityMask()

void reco::TrackBase::setQualityMask ( int  qualMask)
inline

Definition at line 845 of file TrackBase.h.

845 { quality_ = qualMask; }

References quality_.

◆ setStopReason()

void reco::TrackBase::setStopReason ( uint8_t  value)
inline

Definition at line 447 of file TrackBase.h.

447 { stopReason_ = value; }

References stopReason_, and relativeConstraints::value.

◆ stopReason()

uint8_t reco::TrackBase::stopReason ( ) const
inline

Definition at line 449 of file TrackBase.h.

449 { return stopReason_; }

References stopReason_.

◆ t0()

double reco::TrackBase::t0 ( ) const
inline

time at the reference point

Definition at line 670 of file TrackBase.h.

670 { return t0_; }

References t0_.

◆ t0Error()

double reco::TrackBase::t0Error ( ) const
inline

error on t0

Definition at line 787 of file TrackBase.h.

787 { return std::sqrt(covt0t0_); }

References covt0t0_, and mathSSE::sqrt().

◆ theta()

double reco::TrackBase::theta ( ) const
inline

◆ thetaError()

double reco::TrackBase::thetaError ( ) const
inline

error on theta

Definition at line 757 of file TrackBase.h.

757 { return error(i_lambda); }

References error(), and i_lambda.

Referenced by TrackSplittingMonitor::analyze(), TestOutliers::analyze(), and CosmicSplitterValidation::analyze().

◆ validFraction()

double reco::TrackBase::validFraction ( ) const
inline

fraction of valid hits on the track

Definition at line 816 of file TrackBase.h.

816  {
821 
822  const auto tot = valid + lost + lostIn + lostOut;
823 
824  if (tot == 0) {
825  return -1;
826  }
827 
828  return valid / (double)(tot);
829  }

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

◆ vertex()

const TrackBase::Point & reco::TrackBase::vertex ( ) const
inline

◆ vx()

double reco::TrackBase::vx ( ) const
inline

◆ vy()

double reco::TrackBase::vy ( ) const
inline

◆ vz()

double reco::TrackBase::vz ( ) const
inline

Member Data Documentation

◆ algoMask_

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 478 of file TrackBase.h.

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

◆ algoNames

const std::string TrackBase::algoNames
static

◆ algorithm_

uint8_t reco::TrackBase::algorithm_
private

track algorithm

Definition at line 487 of file TrackBase.h.

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

◆ beta_

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 475 of file TrackBase.h.

Referenced by beta().

◆ charge_

char reco::TrackBase::charge_
private

electric charge

Definition at line 484 of file TrackBase.h.

Referenced by charge().

◆ chi2_

float reco::TrackBase::chi2_
private

chi-squared

Definition at line 462 of file TrackBase.h.

Referenced by chi2(), and normalizedChi2().

◆ covariance_

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

perigee 5x5 covariance matrix

Definition at line 456 of file TrackBase.h.

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

◆ covbetabeta_

float reco::TrackBase::covbetabeta_
private

Definition at line 459 of file TrackBase.h.

Referenced by betaError(), and covBetaBeta().

◆ covt0t0_

float reco::TrackBase::covt0t0_
private

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

Definition at line 459 of file TrackBase.h.

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

◆ hitPattern_

HitPattern reco::TrackBase::hitPattern_
private

◆ momentum_

Vector reco::TrackBase::momentum_
private

momentum vector at innermost point

Definition at line 471 of file TrackBase.h.

Referenced by eta(), lambda(), momentum(), p2(), phi(), pt2(), px(), py(), pz(), and theta().

◆ ndof_

float reco::TrackBase::ndof_
private

number of degrees of freedom

Definition at line 481 of file TrackBase.h.

Referenced by ndof(), and normalizedChi2().

◆ nLoops_

signed char reco::TrackBase::nLoops_
private

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

Definition at line 497 of file TrackBase.h.

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

◆ originalAlgorithm_

uint8_t reco::TrackBase::originalAlgorithm_
private

track algorithm

Definition at line 490 of file TrackBase.h.

Referenced by originalAlgo(), and setOriginalAlgorithm().

◆ quality_

uint8_t reco::TrackBase::quality_
private

track quality

Definition at line 493 of file TrackBase.h.

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

◆ qualityNames

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

Definition at line 163 of file TrackBase.h.

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

◆ stopReason_

uint8_t reco::TrackBase::stopReason_
private

Stop Reason.

Definition at line 500 of file TrackBase.h.

Referenced by setStopReason(), and stopReason().

◆ t0_

float reco::TrackBase::t0_
private

time at the reference point on track

Definition at line 468 of file TrackBase.h.

Referenced by t0().

◆ vertex_

Point reco::TrackBase::vertex_
private

innermost (reference) point on track

Definition at line 465 of file TrackBase.h.

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

reco::TrackBase::setQuality
void setQuality(const TrackQuality)
Definition: TrackBase.h:564
reco::TrackBase::fill
CovarianceMatrix & fill(CovarianceMatrix &v) const
fill SMatrix
Definition: TrackBase.cc:124
reco::HitPattern::appendHit
bool appendHit(const TrackingRecHit &hit, const TrackerTopology &ttopo)
Definition: HitPattern.cc:201
reco::TrackBase::charge_
char charge_
electric charge
Definition: TrackBase.h:484
reco::TrackBase::index
unsigned int index
index type
Definition: TrackBase.h:86
reco::HitPattern::MISSING_OUTER_HITS
Definition: HitPattern.h:155
reco::TrackBase::vertex_
Point vertex_
innermost (reference) point on track
Definition: TrackBase.h:465
reco::TrackBase::covIndex
static index covIndex(index i, index j)
covariance matrix index in array
Definition: TrackBase.h:541
reco::TrackBase::highPuritySetWithPV
Definition: TrackBase.h:158
reco::TrackBase::hltIter2
Definition: TrackBase.h:126
reco::TrackBase::reservedForUpgrades2
Definition: TrackBase.h:117
reco::TrackBase::algorithm_
uint8_t algorithm_
track algorithm
Definition: TrackBase.h:487
mps_fire.i
i
Definition: mps_fire.py:428
reco::TrackBase::tight
Definition: TrackBase.h:153
reco::TrackBase::loose
Definition: TrackBase.h:152
reco::TrackBase::goodIterative
Definition: TrackBase.h:156
reco::TrackBase::cosmicStandAloneMuon
Definition: TrackBase.h:110
reco::TrackBase::inOutEcalSeededConv
Definition: TrackBase.h:106
f
double f[11][100]
Definition: MuScleFitUtils.cc:78
reco::TrackBase::detachedQuadStep
Definition: TrackBase.h:115
reco::TrackBase::lowPtQuadStep
Definition: TrackBase.h:114
reco::TrackBase::p
double p() const
momentum vector magnitude
Definition: TrackBase.h:631
reco::TrackBase::hiRegitMuMuonSeededStepOutIn
Definition: TrackBase.h:140
reco::TrackBase::beamhalo
Definition: TrackBase.h:119
reco::TrackBase::confirmed
Definition: TrackBase.h:155
reco::TrackBase::i_phi
Definition: TrackBase.h:83
reco::TrackBase::t0
double t0() const
time at the reference point
Definition: TrackBase.h:670
reco::TrackBase::undefQuality
Definition: TrackBase.h:151
reco::HitPattern::clear
void clear()
Definition: HitPattern.cc:58
reco::TrackBase::hltIter3
Definition: TrackBase.h:127
reco::TrackBase::chi2_
float chi2_
chi-squared
Definition: TrackBase.h:462
reco::TrackBase::TrackAlgorithm
TrackAlgorithm
track algorithm
Definition: TrackBase.h:89
reco::TrackBase::vx
double vx() const
x coordinate of the reference point on track
Definition: TrackBase.h:655
reco::TrackBase::i_dxy
Definition: TrackBase.h:83
reco::TrackBase::dsz
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:614
reco::TrackBase::TrackQuality
TrackQuality
track quality
Definition: TrackBase.h:150
reco::TrackBase::lowPtTripletStep
Definition: TrackBase.h:95
reco::TrackBase::px
double px() const
x coordinate of momentum vector
Definition: TrackBase.h:640
CovarianceMatrix
Definition: CovarianceMatrix.h:27
reco::TrackBase::gsf
Definition: TrackBase.h:120
reco::TrackBase::ndof
double ndof() const
number of degrees of freedom of the fit
Definition: TrackBase.h:590
findQualityFiles.v
v
Definition: findQualityFiles.py:179
reco::TrackBase::reservedForUpgrades1
Definition: TrackBase.h:116
reco::TrackBase::nLoops_
signed char nLoops_
number of loops made during the building of the trajectory of a looper particle
Definition: TrackBase.h:497
spr::find
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
Definition: FindCaloHit.cc:19
reco::HitPattern::numberOfLostHits
int numberOfLostHits(HitCategory category) const
Definition: HitPattern.h:860
reco::TrackBase::hltIter1
Definition: TrackBase.h:125
reco::TrackBase::algoMask
AlgoMask algoMask() const
Definition: TrackBase.h:415
reco::TrackBase::dxyError
double dxyError() const
error on dxy
Definition: TrackBase.h:769
reco::TrackBase::i_dsz
Definition: TrackBase.h:83
reco::TrackBase::mixedTripletStep
Definition: TrackBase.h:98
reco::TrackBase::hiRegitMuInitialStep
Definition: TrackBase.h:132
reco::TrackBase::covarianceSize
Definition: TrackBase.h:68
reco::TrackBase::covt0t0
double covt0t0() const
error on t0
Definition: TrackBase.h:781
heavyIonCSV_trainingSettings.idx
idx
Definition: heavyIonCSV_trainingSettings.py:5
reco::TrackBase::hiRegitMuPixelPairStep
Definition: TrackBase.h:134
reco::TrackBase::pt
double pt() const
track transverse momentum
Definition: TrackBase.h:637
reco::TrackBase::setOriginalAlgorithm
void setOriginalAlgorithm(const TrackAlgorithm a)
Definition: TrackBase.h:838
reco::TrackBase::dimension
Definition: TrackBase.h:65
reco::TrackBase::hiRegitMuMixedTripletStep
Definition: TrackBase.h:136
reco::TrackBase::standAloneMuon
Definition: TrackBase.h:108
reco::TrackBase::muonSeededStepOutIn
Definition: TrackBase.h:104
reco::TrackBase::i_qoverp
Definition: TrackBase.h:83
reco::TrackBase::covbetabeta_
float covbetabeta_
Definition: TrackBase.h:459
reco::TrackBase::hiRegitMuTobTecStep
Definition: TrackBase.h:138
reco::TrackBase::jetCoreRegionalStep
Definition: TrackBase.h:101
reco::TrackBase::py
double py() const
y coordinate of momentum vector
Definition: TrackBase.h:643
reco::TrackBase::outInEcalSeededConv
Definition: TrackBase.h:105
reco::TrackBase::vz
double vz() const
z coordinate of the reference point on track
Definition: TrackBase.h:661
visualization-live-secondInstance_cfg.m
m
Definition: visualization-live-secondInstance_cfg.py:72
mathSSE::sqrt
T sqrt(T t)
Definition: SSEVec.h:19
mps_fire.end
end
Definition: mps_fire.py:242
reco::TrackBase::ParameterVector
math::Vector< dimension >::type ParameterVector
parameter vector
Definition: TrackBase.h:71
reco::TrackBase::algoName
std::string algoName() const
Definition: TrackBase.h:550
reco::TrackBase::charge
int charge() const
track electric charge
Definition: TrackBase.h:596
reco::fillCovariance
PerigeeCovarianceMatrix & fillCovariance(PerigeeCovarianceMatrix &v, const float *data)
Definition: fillCovariance.cc:5
reco::TrackBase::covariance
CovarianceMatrix covariance() const
return track covariance matrix
Definition: TrackBase.h:716
reco::TrackBase::hltPixel
Definition: TrackBase.h:122
TrackQuality
This class analyses the reconstruction quality for a given track.
Definition: TrackQuality.h:28
b
double b
Definition: hdecay.h:118
reco::TrackBase::cosmics
Definition: TrackBase.h:93
reco::TrackBase::phi
double phi() const
azimuthal angle of momentum vector
Definition: TrackBase.h:649
reco::TrackBase::qualitySize
Definition: TrackBase.h:160
reco::TrackBase::i_lambda
Definition: TrackBase.h:83
reco::TrackBase::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:478
a
double a
Definition: hdecay.h:119
reco::TrackBase::discarded
Definition: TrackBase.h:159
reco::HitPattern::appendHits
bool appendHits(const I &begin, const I &end, const TrackerTopology &ttopo)
Definition: HitPattern.h:522
reco::TrackBase::detachedTripletStep
Definition: TrackBase.h:97
qcdUeDQM_cfi.algorithm
algorithm
Definition: qcdUeDQM_cfi.py:32
reco::TrackBase::undefAlgorithm
Definition: TrackBase.h:90
createfilelist.int
int
Definition: createfilelist.py:10
reco::TrackBase::beta_
float beta_
Definition: TrackBase.h:475
reco::TrackBase::covt0t0_
float covt0t0_
errors for time and velocity (separate from cov for now)
Definition: TrackBase.h:459
reco::TrackBase::stopReason
uint8_t stopReason() const
Definition: TrackBase.h:449
topSingleLeptonDQM_PU_cfi.pattern
pattern
Definition: topSingleLeptonDQM_PU_cfi.py:39
reco::TrackBase::covariance_
float covariance_[covarianceSize]
perigee 5x5 covariance matrix
Definition: TrackBase.h:456
reco::TrackBase::cosmicGlobalMuon
Definition: TrackBase.h:111
submitPVResolutionJobs.q
q
Definition: submitPVResolutionJobs.py:84
reco::TrackBase::initialStep
Definition: TrackBase.h:94
reco::TrackBase::beta
double beta() const
velocity at the reference point in natural units
Definition: TrackBase.h:673
reco::TrackBase::chi2
double chi2() const
chi-squared of the fit
Definition: TrackBase.h:587
HltBtagPostValidation_cff.c
c
Definition: HltBtagPostValidation_cff.py:31
reco::TrackBase::nuclInter
Definition: TrackBase.h:107
reco::TrackBase::hiRegitMuDetachedTripletStep
Definition: TrackBase.h:135
reco::TrackBase::tobTecStep
Definition: TrackBase.h:100
reco::TrackBase::conversionStep
Definition: TrackBase.h:102
reco::TrackBase::error
double error(int i) const
error on specified element
Definition: TrackBase.h:729
reco::TrackBase::momentum_
Vector momentum_
momentum vector at innermost point
Definition: TrackBase.h:471
reco::TrackBase::parameters
ParameterVector parameters() const
Track parameters with one-to-one correspondence to the covariance matrix.
Definition: TrackBase.h:711
reco::TrackBase::vertex
const Point & vertex() const
reference point on the track. This method is DEPRECATED, please use referencePoint() instead
Definition: TrackBase.h:676
reco::HitPattern::TRACK_HITS
Definition: HitPattern.h:155
reco::TrackBase::pixelPairStep
Definition: TrackBase.h:96
reco::TrackBase::algo
TrackAlgorithm algo() const
Definition: TrackBase.h:547
reco::TrackBase::muonSeededStepInOut
Definition: TrackBase.h:103
reco::TrackBase::qualityNames
static const std::string qualityNames[]
Definition: TrackBase.h:163
reco::TrackBase::ctf
Definition: TrackBase.h:91
reco::TrackBase::p2
double p2() const
momentum vector magnitude square
Definition: TrackBase.h:628
reco::TrackBase::highPtTripletStep
Definition: TrackBase.h:113
reco::TrackBase::looseSetWithPV
Definition: TrackBase.h:157
reco::TrackBase::vy
double vy() const
y coordinate of the reference point on track
Definition: TrackBase.h:658
extraflags_cff.vtx
vtx
Definition: extraflags_cff.py:18
reco::TrackBase::algoSize
Definition: TrackBase.h:141
reco::HitPattern::numberOfValidTrackerHits
int numberOfValidTrackerHits() const
Definition: HitPattern.h:788
reco::HitPattern::appendMuonHit
bool appendMuonHit(const DetId &id, TrackingRecHit::Type hitType)
Definition: HitPattern.cc:281
relativeConstraints.value
value
Definition: relativeConstraints.py:53
reco::HitPattern::appendTrackerHit
bool appendTrackerHit(uint16_t subdet, uint16_t layer, uint16_t stereo, TrackingRecHit::Type hitType)
Definition: HitPattern.cc:277
reco::TrackBase::pt2
double pt2() const
track transverse momentum square
Definition: TrackBase.h:634
reco::HitPattern::MISSING_INNER_HITS
Definition: HitPattern.h:155
Skims_PA_cff.name
name
Definition: Skims_PA_cff.py:17
reco::TrackBase::hiRegitMuMuonSeededStepInOut
Definition: TrackBase.h:139
reco::HitPattern::numberOfLostTrackerHits
int numberOfLostTrackerHits(HitCategory category) const
Definition: HitPattern.h:862
reco::TrackBase::stopReason_
uint8_t stopReason_
Stop Reason.
Definition: TrackBase.h:500
reco::TrackBase::pz
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:646
M_PI_2
#define M_PI_2
Definition: CSCGattiFunction.cc:6
reco::TrackBase::bTagGhostTracks
Definition: TrackBase.h:118
RunInfoPI::valid
Definition: RunInfoPayloadInspectoHelper.h:16
reco::TrackBase::hltIterX
Definition: TrackBase.h:130
reco::TrackBase::ndof_
float ndof_
number of degrees of freedom
Definition: TrackBase.h:481
reco::TrackBase::hiRegitMuLowPtTripletStep
Definition: TrackBase.h:133
reco::TrackBase::ptError2
double ptError2() const
error on Pt (set to 1000**2 TeV**2 if charge==0 for safety)
Definition: TrackBase.h:735
dqmiolumiharvest.j
j
Definition: dqmiolumiharvest.py:66
reco::TrackBase::momentum
const Vector & momentum() const
track momentum vector
Definition: TrackBase.h:664
reco::HitPattern::numberOfValidHits
int numberOfValidHits() const
Definition: HitPattern.h:786
reco::TrackBase::hiRegitMuPixelLessStep
Definition: TrackBase.h:137
reco::TrackBase::lambda
double lambda() const
Lambda angle.
Definition: TrackBase.h:605
reco::TrackBase::algoNames
static const std::string algoNames[]
Definition: TrackBase.h:147
reco::TrackBase::t0_
float t0_
time at the reference point on track
Definition: TrackBase.h:468
reco::TrackBase::dxy
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:608
reco::TrackBase::quality_
uint8_t quality_
track quality
Definition: TrackBase.h:493
reco::TrackBase::quality
bool quality(const TrackQuality) const
Track quality.
Definition: TrackBase.h:552
reco::TrackBase::pixelLessStep
Definition: TrackBase.h:99
reco::TrackBase::originalAlgorithm_
uint8_t originalAlgorithm_
track algorithm
Definition: TrackBase.h:490
reco::TrackBase::hltIter4
Definition: TrackBase.h:128
reco::TrackBase::hitPattern_
HitPattern hitPattern_
hit pattern
Definition: TrackBase.h:453
hit
Definition: SiStripHitEffFromCalibTree.cc:88
reco::TrackBase::duplicateMerge
Definition: TrackBase.h:92
reco::TrackBase::hltIter0
Definition: TrackBase.h:124
reco::TrackBase::qoverp
double qoverp() const
q / p
Definition: TrackBase.h:599
reco::TrackBase::globalMuon
Definition: TrackBase.h:109
findQualityFiles.size
size
Write out results.
Definition: findQualityFiles.py:443
reco::TrackBase::highPurity
Definition: TrackBase.h:154