CMS 3D CMS Logo

List of all members | Classes | Public Types | Public Member Functions | Private Member Functions | Private Attributes
reco::Vertex Class Reference

#include <Vertex.h>

Inheritance diagram for reco::Vertex:
reco::PFDisplacedVertex

Classes

class  TrackEqual
 

Public Types

enum  { dimension = 3, dimension4D = 4 }
 error matrix dimension More...
 
enum  { size = dimension * (dimension + 1) / 2, size4D = (dimension4D) * (dimension4D + 1) / 2 }
 matix size More...
 
typedef math::Error< dimension >::type CovarianceMatrix
 covariance error matrix (3x3) More...
 
typedef math::Error< dimension4D >::type CovarianceMatrix4D
 covariance error matrix (4x4) More...
 
typedef math::Error< dimension >::type Error
 covariance error matrix (3x3) More...
 
typedef math::Error< dimension4D >::type Error4D
 covariance error matrix (4x4) More...
 
typedef unsigned int index
 index type More...
 
typedef math::XYZPoint Point
 point in the space More...
 
typedef std::vector< TrackBaseRef >::const_iterator trackRef_iterator
 The iteratator for the vector<TrackRef> More...
 

Public Member Functions

void add (const TrackBaseRef &r, const Track &refTrack, float w=1.0)
 add the original a Track(reference) and the smoothed Track More...
 
void add (const TrackBaseRef &r, float w=1.0)
 add a reference to a Track More...
 
double chi2 () const
 chi-squares More...
 
CovarianceMatrix covariance () const
 return SMatrix More...
 
double covariance (int i, int j) const
 (i, j)-th element of error matrix, i, j = 0, ... 2 More...
 
CovarianceMatrix4D covariance4D () const
 return SMatrix 4D More...
 
Error error () const
 return SMatrix More...
 
Error4D error4D () const
 return SMatrix More...
 
void fill (CovarianceMatrix &v) const
 fill SMatrix More...
 
void fill (CovarianceMatrix4D &v) const
 4D version More...
 
bool hasRefittedTracks () const
 Checks whether refitted tracks are stored. More...
 
bool isFake () const
 
bool isValid () const
 Tells whether the vertex is valid. More...
 
double ndof () const
 
double normalizedChi2 () const
 chi-squared divided by n.d.o.f. More...
 
unsigned int nTracks (float minWeight=0.5) const
 Returns the number of tracks in the vertex with weight above minWeight. More...
 
TrackBaseRef originalTrack (const Track &refTrack) const
 
math::XYZTLorentzVectorD p4 (float mass=0.13957018, float minWeight=0.5) const
 Returns the four momentum of the sum of the tracks, assuming the given mass for the decay products. More...
 
const Pointposition () const
 position More...
 
Track refittedTrack (const TrackBaseRef &track) const
 
Track refittedTrack (const TrackRef &track) const
 
const std::vector< Track > & refittedTracks () const
 Returns the container of refitted tracks. More...
 
void removeTracks ()
 
double t () const
 t coordinate More...
 
double tError () const
 error on t More...
 
const TrackBaseReftrackRefAt (size_t idx) const
 python friendly track getting More...
 
trackRef_iterator tracks_begin () const
 first iterator over tracks More...
 
trackRef_iterator tracks_end () const
 last iterator over tracks More...
 
size_t tracksSize () const
 number of tracks More...
 
template<typename TREF >
float trackWeight (const TREF &r) const
 returns the weight with which a Track has contributed to the vertex-fit. More...
 
 Vertex ()
 
 Vertex (const Point &, const Error &)
 Constructor for a fake vertex. More...
 
 Vertex (const Point &, const Error &, double chi2, double ndof, size_t size)
 constructor for a valid vertex, with all data More...
 
 Vertex (const Point &, const Error4D &, double time, double chi2, double ndof, size_t size)
 constructor for a valid vertex, with all data 4D More...
 
 Vertex (const Point &, const Error4D &, double)
 Constructor for a fake vertex. 4D. More...
 
double x () const
 x coordinate More...
 
double xError () const
 error on x More...
 
double y () const
 y coordinate More...
 
double yError () const
 error on y More...
 
double z () const
 z coordinate More...
 
double zError () const
 error on z More...
 

Private Member Functions

index idx (index i, index j) const
 position index More...
 

Private Attributes

float chi2_
 chi-sqared More...
 
float covariance_ [size4D]
 covariance matrix (4x4) as vector More...
 
float ndof_
 number of degrees of freedom More...
 
Point position_
 position More...
 
std::vector< TrackrefittedTracks_
 The vector of refitted tracks. More...
 
double time_
 
std::vector< TrackBaseReftracks_
 reference to tracks More...
 
bool validity_
 tells wether the vertex is really valid. More...
 
std::vector< uint8_t > weights_
 

Detailed Description

A reconstructed Vertex providing position, error, chi2, ndof and reconstrudted tracks. The vertex can be valid, fake, or invalid. A valid vertex is one which has been obtained from a vertex fit of tracks, and all data is meaningful A fake vertex is a vertex which was not made out of a proper fit with tracks, but still has a position and error (chi2 and ndof are null). For a primary vertex, it could simply be the beam line. A fake vertex is considered valid. An invalid vertex has no meaningful data.

Author
Luca Lista, INFN

Definition at line 35 of file Vertex.h.

Member Typedef Documentation

◆ CovarianceMatrix

covariance error matrix (3x3)

Definition at line 46 of file Vertex.h.

◆ CovarianceMatrix4D

covariance error matrix (4x4)

Definition at line 50 of file Vertex.h.

◆ Error

covariance error matrix (3x3)

Definition at line 44 of file Vertex.h.

◆ Error4D

covariance error matrix (4x4)

Definition at line 48 of file Vertex.h.

◆ index

typedef unsigned int reco::Vertex::index

index type

Definition at line 54 of file Vertex.h.

◆ Point

point in the space

Definition at line 40 of file Vertex.h.

◆ trackRef_iterator

typedef std::vector<TrackBaseRef>::const_iterator reco::Vertex::trackRef_iterator

The iteratator for the vector<TrackRef>

Definition at line 38 of file Vertex.h.

Member Enumeration Documentation

◆ anonymous enum

anonymous enum

error matrix dimension

Enumerator
dimension 
dimension4D 

Definition at line 42 of file Vertex.h.

42 { dimension = 3, dimension4D = 4 };

◆ anonymous enum

anonymous enum

matix size

Enumerator
size 
size4D 

Definition at line 52 of file Vertex.h.

52 { size = dimension * (dimension + 1) / 2, size4D = (dimension4D) * (dimension4D + 1) / 2 };

Constructor & Destructor Documentation

◆ Vertex() [1/5]

reco::Vertex::Vertex ( )
inline

default constructor - The vertex will not be valid. Position, error, chi2, ndof will have random entries, and the vectors of tracks will be empty Use the isValid method to check that your vertex is valid.

Definition at line 58 of file Vertex.h.

58  : chi2_(0.0), ndof_(0), position_(0., 0., 0.), time_(0.) {
59  validity_ = false;
60  for (int i = 0; i < size4D; ++i)
61  covariance_[i] = 0.;
62  }

References covariance_, mps_fire::i, size4D, and validity_.

◆ Vertex() [2/5]

Vertex::Vertex ( const Point p,
const Error err 
)

Constructor for a fake vertex.

Definition at line 34 of file Vertex.cc.

34  : chi2_(0.0), ndof_(0), position_(p), time_(0.) {
35  index idx = 0;
36  for (index i = 0; i < dimension4D; ++i) {
37  for (index j = 0; j <= i; ++j) {
38  if (i == dimension || j == dimension) {
39  covariance_[idx++] = 0.0;
40  } else {
41  covariance_[idx++] = err(i, j);
42  }
43  }
44  }
45  validity_ = true;
46 }

References covariance_, dimension, dimension4D, runTheMatrix::err, mps_fire::i, idx(), dqmiolumiharvest::j, and validity_.

◆ Vertex() [3/5]

Vertex::Vertex ( const Point p,
const Error4D err,
double  time 
)

Constructor for a fake vertex. 4D.

Definition at line 48 of file Vertex.cc.

48  : chi2_(0.0), ndof_(0), position_(p), time_(time) {
49  index idx = 0;
50  for (index i = 0; i < dimension + 1; ++i)
51  for (index j = 0; j <= i; ++j)
52  covariance_[idx++] = err(i, j);
53  validity_ = true;
54 }

References covariance_, dimension, runTheMatrix::err, mps_fire::i, idx(), dqmiolumiharvest::j, and validity_.

◆ Vertex() [4/5]

Vertex::Vertex ( const Point p,
const Error err,
double  chi2,
double  ndof,
size_t  size 
)

constructor for a valid vertex, with all data

Definition at line 8 of file Vertex.cc.

9  : chi2_(chi2), ndof_(ndof), position_(p), time_(0.) {
10  tracks_.reserve(size);
11  index idx = 0;
12  for (index i = 0; i < dimension4D; ++i) {
13  for (index j = 0; j <= i; ++j) {
14  if (i == dimension || j == dimension) {
15  covariance_[idx++] = 0.0;
16  } else {
17  covariance_[idx++] = err(i, j);
18  }
19  }
20  }
21  validity_ = true;
22 }

References covariance_, dimension, dimension4D, runTheMatrix::err, mps_fire::i, idx(), dqmiolumiharvest::j, size, tracks_, and validity_.

◆ Vertex() [5/5]

Vertex::Vertex ( const Point p,
const Error4D err,
double  time,
double  chi2,
double  ndof,
size_t  size 
)

constructor for a valid vertex, with all data 4D

Definition at line 24 of file Vertex.cc.

26  tracks_.reserve(size4D);
27  index idx = 0;
28  for (index i = 0; i < dimension4D; ++i)
29  for (index j = 0; j <= i; ++j)
30  covariance_[idx++] = err(i, j);
31  validity_ = true;
32 }

References covariance_, dimension4D, runTheMatrix::err, mps_fire::i, idx(), dqmiolumiharvest::j, size4D, tracks_, and validity_.

Member Function Documentation

◆ add() [1/2]

void Vertex::add ( const TrackBaseRef r,
const Track refTrack,
float  w = 1.0 
)

add the original a Track(reference) and the smoothed Track

Definition at line 84 of file Vertex.cc.

84  {
85  tracks_.push_back(r);
86  refittedTracks_.push_back(refTrack);
87  weights_.push_back(w * 255);
88 }

References alignCSCRings::r, refittedTracks_, tracks_, w, and weights_.

Referenced by counter.Counter::register(), SequenceTypes.Task::remove(), and SequenceTypes.Task::replace().

◆ add() [2/2]

void Vertex::add ( const TrackBaseRef r,
float  w = 1.0 
)

add a reference to a Track

Definition at line 79 of file Vertex.cc.

79  {
80  tracks_.push_back(r);
81  weights_.push_back(w * 255);
82 }

References alignCSCRings::r, tracks_, w, and weights_.

Referenced by reco::PFDisplacedVertex::addElement(), counter.Counter::register(), SequenceTypes.Task::remove(), and SequenceTypes.Task::replace().

◆ chi2()

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

◆ covariance() [1/2]

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

return SMatrix

Definition at line 137 of file Vertex.h.

137  {
138  Error m;
139  fill(m);
140  return m;
141  }

References fill(), and visualization-live-secondInstance_cfg::m.

Referenced by tError(), xError(), yError(), and zError().

◆ covariance() [2/2]

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

(i, j)-th element of error matrix, i, j = 0, ... 2

Definition at line 135 of file Vertex.h.

135 { return covariance_[idx(i, j)]; }

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

Referenced by VertexDistance::compatibility(), VertexDistance::distance(), V0Fitter::fitAll(), and reco::V0Candidate::vtxCovariance().

◆ covariance4D()

CovarianceMatrix4D reco::Vertex::covariance4D ( ) const
inline

return SMatrix 4D

Definition at line 143 of file Vertex.h.

143  {
144  Error4D m;
145  fill(m);
146  return m;
147  }

References fill(), and visualization-live-secondInstance_cfg::m.

◆ error()

Error reco::Vertex::error ( ) const
inline

◆ error4D()

Error4D reco::Vertex::error4D ( ) const
inline

return SMatrix

Definition at line 156 of file Vertex.h.

156  {
157  Error4D m;
158  fill(m);
159  return m;
160  }

References fill(), and visualization-live-secondInstance_cfg::m.

◆ fill() [1/2]

void reco::Vertex::fill ( CovarianceMatrix v) const

fill SMatrix

Referenced by covariance(), covariance4D(), error(), error4D(), and fill().

◆ fill() [2/2]

void Vertex::fill ( CovarianceMatrix4D v) const

4D version

Definition at line 56 of file Vertex.cc.

56  {
57  Error4D temp;
58  fill(temp);
59  err = temp.Sub<Error>(0, 0);
60 }

References runTheMatrix::err, fill(), and groupFilesInBlocks::temp.

◆ hasRefittedTracks()

bool reco::Vertex::hasRefittedTracks ( ) const
inline

Checks whether refitted tracks are stored.

Definition at line 168 of file Vertex.h.

168 { return !refittedTracks_.empty(); }

References refittedTracks_.

Referenced by nTracks(), p4(), and Onia2MuMuPAT::produce().

◆ idx()

index reco::Vertex::idx ( index  i,
index  j 
) const
inlineprivate

position index

Definition at line 219 of file Vertex.h.

219  {
220  int a = (i <= j ? i : j), b = (i <= j ? j : i);
221  return b * (b + 1) / 2 + a;
222  }

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

Referenced by covariance(), ntupleDataFormat.TrackMatchInfo::track(), ntupleDataFormat.TrackingParticleMatchInfo::trackingParticle(), trackRefAt(), and Vertex().

◆ isFake()

bool reco::Vertex::isFake ( ) const
inline

Tells whether a Vertex is fake, i.e. not a vertex made out of a proper fit with tracks. For a primary vertex, it could simply be the beam line.

Definition at line 76 of file Vertex.h.

76 { return (chi2_ == 0 && ndof_ == 0 && tracks_.empty()); }

References chi2_, ndof_, and tracks_.

Referenced by TrackingMonitor::analyze(), FSQDQM::analyze(), SplitVertexResolution::analyze(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), and BVertexFilterT< VTX >::filter().

◆ isValid()

bool reco::Vertex::isValid ( void  ) const
inline

◆ ndof()

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

◆ normalizedChi2()

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

chi-squared divided by n.d.o.f.

Definition at line 112 of file Vertex.h.

112 { return ndof_ != 0 ? chi2_ / ndof_ : chi2_ * 1e6; }

References chi2_, and ndof_.

Referenced by FSQDQM::analyze(), reco::PFDisplacedVertex::Dump(), V0Fitter::fitAll(), HLTmumutkFilter::hltFilter(), and HLTmumutktkFilter::hltFilter().

◆ nTracks()

unsigned int Vertex::nTracks ( float  minWeight = 0.5) const

Returns the number of tracks in the vertex with weight above minWeight.

Definition at line 146 of file Vertex.cc.

146  {
147  int n = 0;
148  if (hasRefittedTracks()) {
149  for (std::vector<Track>::const_iterator iter = refittedTracks_.begin(); iter != refittedTracks_.end(); ++iter)
150  if (trackWeight(originalTrack(*iter)) >= minWeight)
151  n++;
152  } else {
153  for (std::vector<reco::TrackBaseRef>::const_iterator iter = tracks_begin(); iter != tracks_end(); iter++)
154  if (trackWeight(*iter) >= minWeight)
155  n++;
156  }
157  return n;
158 }

References hasRefittedTracks(), fftjetcommon_cfi::minWeight, dqmiodumpmetadata::n, originalTrack(), refittedTracks_, tracks_begin(), tracks_end(), and trackWeight().

Referenced by SplitVertexResolution::analyze().

◆ originalTrack()

TrackBaseRef Vertex::originalTrack ( const Track refTrack) const

Returns the original track which corresponds to a particular refitted Track Throws an exception if now refitted tracks are stored ot the track is not found in the list

Definition at line 96 of file Vertex.cc.

96  {
97  if (refittedTracks_.empty())
98  throw cms::Exception("Vertex") << "No refitted tracks stored in vertex\n";
99  std::vector<Track>::const_iterator it = find_if(refittedTracks_.begin(), refittedTracks_.end(), TrackEqual(refTrack));
100  if (it == refittedTracks_.end())
101  throw cms::Exception("Vertex") << "Refitted track not found in list\n";
102  size_t pos = it - refittedTracks_.begin();
103  return tracks_[pos];
104 }

References refittedTracks_, and tracks_.

Referenced by PFDisplacedVertexFinder::commonTracks(), PF_PU_AssoMapAlgos::FindNIVertex(), reco::PFDisplacedVertex::isIncomingTrack(), reco::PFDisplacedVertex::isMergedTrack(), reco::PFDisplacedVertex::isOutgoingTrack(), reco::PFDisplacedVertex::isPrimaryTrack(), reco::PFDisplacedVertex::isSecondaryTrack(), reco::PFDisplacedVertex::momentum(), nTracks(), p4(), Onia2MuMuPAT::produce(), reco::PFDisplacedVertex::trackHitFullInfo(), and reco::PFDisplacedVertex::trackPosition().

◆ p4()

math::XYZTLorentzVectorD Vertex::p4 ( float  mass = 0.13957018,
float  minWeight = 0.5 
) const

Returns the four momentum of the sum of the tracks, assuming the given mass for the decay products.

Definition at line 118 of file Vertex.cc.

118  {
120  ROOT::Math::LorentzVector<ROOT::Math::PxPyPzM4D<double> > vec;
121 
122  if (hasRefittedTracks()) {
123  for (std::vector<Track>::const_iterator iter = refittedTracks_.begin(); iter != refittedTracks_.end(); ++iter) {
124  if (trackWeight(originalTrack(*iter)) >= minWeight) {
125  vec.SetPx(iter->px());
126  vec.SetPy(iter->py());
127  vec.SetPz(iter->pz());
128  vec.SetM(mass);
129  sum += vec;
130  }
131  }
132  } else {
133  for (std::vector<reco::TrackBaseRef>::const_iterator iter = tracks_begin(); iter != tracks_end(); iter++) {
134  if (trackWeight(*iter) >= minWeight) {
135  vec.SetPx((*iter)->px());
136  vec.SetPy((*iter)->py());
137  vec.SetPz((*iter)->pz());
138  vec.SetM(mass);
139  sum += vec;
140  }
141  }
142  }
143  return sum;
144 }

References hasRefittedTracks(), EgHLTOffHistBins_cfi::mass, fftjetcommon_cfi::minWeight, originalTrack(), refittedTracks_, tracks_begin(), tracks_end(), and trackWeight().

Referenced by Tau.Tau::dxy_approx(), Tau.Tau::dz(), Lepton.Lepton::p4WithFSR(), and reco::Conversion::refittedPair4Momentum().

◆ position()

const Point& reco::Vertex::position ( ) const
inline

position

Definition at line 114 of file Vertex.h.

114 { return position_; }

References position_.

Referenced by CMSDAS11DijetAnalyzer::analyze(), CMSDAS11DijetTestAnalyzer::analyze(), TrackTypeMonitor::analyze(), ElectronConversionRejectionValidator::analyze(), TkConvValidator::analyze(), TrackingMonitor::analyze(), FSQDQM::analyze(), PackedCandidateTrackValidator::analyze(), pat::LeptonVertexSignificance::calculate(), reco::PFMETProducerMVA::chargedFracInCone(), PFAlgo::checkGoodTrackDeadHcal(), VertexDistance::compatibility(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), reco::PFMETProducerMVA::computePFCandidateInfo(), VertexDistance::distance(), reco::PFDisplacedVertex::Dump(), BPHWriteSpecificDecay::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton::MonitorEnsemble::fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), PFEGammaAlgo::fillPFCandidates(), TrackingFailureFilter::filter(), PF_PU_AssoMapAlgos::FindNIVertex(), L1TTauOffline::getPrimaryVertex(), HLTmumutkFilter::hltFilter(), HLTmumutktkFilter::hltFilter(), isTightMuonCustom(), PhotonConversionTrajectorySeedProducerFromQuadrupletsAlgo::loop(), L3MuonTrajectoryBuilder::makeTkCandCollection(), NuclearTrackCorrector::newTrajNeeded(), TOFPIDProducer::produce(), Onia2MuMuPAT::produce(), PFAlgo::recoTracksNotHCAL(), reco::PFDisplacedVertex::setPrimaryDirection(), reco::V0Candidate::setRecoVertex(), VertexDistanceXY::signedDistance(), VertexDistance3D::signedDistance(), and ConversionProducer::trackD0Cut().

◆ refittedTrack() [1/2]

Track Vertex::refittedTrack ( const TrackBaseRef track) const

Returns the refitted track which corresponds to a particular original Track Throws an exception if now refitted tracks are stored ot the track is not found in the list

Definition at line 106 of file Vertex.cc.

106  {
107  if (refittedTracks_.empty())
108  throw cms::Exception("Vertex") << "No refitted tracks stored in vertex\n";
110  if (it == tracks_end())
111  throw cms::Exception("Vertex") << "Track not found in list\n";
112  size_t pos = it - tracks_begin();
113  return refittedTracks_[pos];
114 }

References Exception, spr::find(), refittedTracks_, HLT_2018_cff::track, tracks_begin(), and tracks_end().

Referenced by refittedTrack(), and reco::PFDisplacedVertex::trackPosition().

◆ refittedTrack() [2/2]

Track Vertex::refittedTrack ( const TrackRef track) const

Returns the refitted track which corresponds to a particular original Track Throws an exception if now refitted tracks are stored ot the track is not found in the list

Definition at line 116 of file Vertex.cc.

116 { return refittedTrack(TrackBaseRef(track)); }

References refittedTrack(), and HLT_2018_cff::track.

◆ refittedTracks()

const std::vector<Track>& reco::Vertex::refittedTracks ( ) const
inline

◆ removeTracks()

void Vertex::removeTracks ( )

Definition at line 90 of file Vertex.cc.

90  {
91  weights_.clear();
92  tracks_.clear();
93  refittedTracks_.clear();
94 }

References refittedTracks_, tracks_, and weights_.

Referenced by reco::PFDisplacedVertex::cleanTracks(), and PFDisplacedVertexFinder::fitVertexFromSeed().

◆ t()

double reco::Vertex::t ( ) const
inline

t coordinate

Definition at line 122 of file Vertex.h.

122 { return time_; }

References time_.

Referenced by reco::Vertex::TrackEqual::operator()(), TOFPIDProducer::produce(), and trackWeight().

◆ tError()

double reco::Vertex::tError ( ) const
inline

error on t

Definition at line 130 of file Vertex.h.

130 { return sqrt(covariance(3, 3)); }

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

◆ trackRefAt()

const TrackBaseRef& reco::Vertex::trackRefAt ( size_t  idx) const
inline

python friendly track getting

Definition at line 101 of file Vertex.h.

101 { return tracks_[idx]; }

References idx(), and tracks_.

◆ tracks_begin()

Vertex::trackRef_iterator Vertex::tracks_begin ( ) const

◆ tracks_end()

Vertex::trackRef_iterator Vertex::tracks_end ( ) const

◆ tracksSize()

size_t Vertex::tracksSize ( ) const

◆ trackWeight()

template<typename TREF >
float reco::Vertex::trackWeight ( const TREF &  r) const
inline

returns the weight with which a Track has contributed to the vertex-fit.

Definition at line 85 of file Vertex.h.

85  {
86  int i = 0;
87  for (auto const &t : tracks_) {
88  if ((r.id() == t.id()) & (t.key() == r.key()))
89  return weights_[i] / 255.f;
90  ++i;
91  }
92  return 0;
93  }

References mps_fire::i, alignCSCRings::r, t(), tracks_, and weights_.

Referenced by pat::PATLostTracks::addPackedCandidate(), nTracks(), p4(), and Onia2MuMuPAT::produce().

◆ x()

double reco::Vertex::x ( ) const
inline

◆ xError()

double reco::Vertex::xError ( ) const
inline

◆ y()

double reco::Vertex::y ( ) const
inline

◆ yError()

double reco::Vertex::yError ( ) const
inline

error on y

Definition at line 126 of file Vertex.h.

126 { return sqrt(covariance(1, 1)); }

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

Referenced by FSQDQM::analyze(), SplitVertexResolution::analyze(), and PrimaryVertexResolution::Resolution::Resolution().

◆ z()

double reco::Vertex::z ( ) const
inline

◆ zError()

double reco::Vertex::zError ( ) const
inline

Member Data Documentation

◆ chi2_

float reco::Vertex::chi2_
private

chi-sqared

Definition at line 202 of file Vertex.h.

Referenced by chi2(), isFake(), and normalizedChi2().

◆ covariance_

float reco::Vertex::covariance_[size4D]
private

covariance matrix (4x4) as vector

Definition at line 208 of file Vertex.h.

Referenced by covariance(), and Vertex().

◆ ndof_

float reco::Vertex::ndof_
private

number of degrees of freedom

Definition at line 204 of file Vertex.h.

Referenced by isFake(), ndof(), and normalizedChi2().

◆ position_

Point reco::Vertex::position_
private

position

Definition at line 206 of file Vertex.h.

Referenced by position(), x(), y(), and z().

◆ refittedTracks_

std::vector<Track> reco::Vertex::refittedTracks_
private

The vector of refitted tracks.

Definition at line 212 of file Vertex.h.

Referenced by add(), hasRefittedTracks(), nTracks(), originalTrack(), p4(), refittedTrack(), refittedTracks(), and removeTracks().

◆ time_

double reco::Vertex::time_
private

Definition at line 216 of file Vertex.h.

Referenced by t().

◆ tracks_

std::vector<TrackBaseRef> reco::Vertex::tracks_
private

reference to tracks

Definition at line 210 of file Vertex.h.

Referenced by add(), isFake(), originalTrack(), removeTracks(), trackRefAt(), tracks_begin(), tracks_end(), trackWeight(), and Vertex().

◆ validity_

bool reco::Vertex::validity_
private

tells wether the vertex is really valid.

Definition at line 215 of file Vertex.h.

Referenced by isValid(), and Vertex().

◆ weights_

std::vector<uint8_t> reco::Vertex::weights_
private

Definition at line 213 of file Vertex.h.

Referenced by add(), removeTracks(), tracksSize(), and trackWeight().

reco::Vertex::trackRef_iterator
std::vector< TrackBaseRef >::const_iterator trackRef_iterator
The iteratator for the vector<TrackRef>
Definition: Vertex.h:38
reco::Vertex::time_
double time_
Definition: Vertex.h:216
reco::Vertex::originalTrack
TrackBaseRef originalTrack(const Track &refTrack) const
Definition: Vertex.cc:96
mps_fire.i
i
Definition: mps_fire.py:355
reco::Vertex::chi2_
float chi2_
chi-sqared
Definition: Vertex.h:202
dqmiodumpmetadata.n
n
Definition: dqmiodumpmetadata.py:28
reco::Vertex::Error
math::Error< dimension >::type Error
covariance error matrix (3x3)
Definition: Vertex.h:44
AlCaHLTBitMon_ParallelJobs.p
p
Definition: AlCaHLTBitMon_ParallelJobs.py:153
math::XYZTLorentzVectorD
ROOT::Math::LorentzVector< ROOT::Math::PxPyPzE4D< double > > XYZTLorentzVectorD
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:14
reco::Vertex::refittedTrack
Track refittedTrack(const TrackBaseRef &track) const
Definition: Vertex.cc:106
pos
Definition: PixelAliasList.h:18
reco::TrackBaseRef
edm::RefToBase< reco::Track > TrackBaseRef
persistent reference to a Track, using views
Definition: TrackFwd.h:35
reco::Vertex::idx
index idx(index i, index j) const
position index
Definition: Vertex.h:219
reco::Vertex::validity_
bool validity_
tells wether the vertex is really valid.
Definition: Vertex.h:215
fftjetcommon_cfi.minWeight
minWeight
Definition: fftjetcommon_cfi.py:213
spr::find
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
Definition: FindCaloHit.cc:19
groupFilesInBlocks.temp
list temp
Definition: groupFilesInBlocks.py:142
reco::Vertex::dimension4D
Definition: Vertex.h:42
reco::Vertex::tracks_
std::vector< TrackBaseRef > tracks_
reference to tracks
Definition: Vertex.h:210
w
const double w
Definition: UKUtility.cc:23
visualization-live-secondInstance_cfg.m
m
Definition: visualization-live-secondInstance_cfg.py:72
mathSSE::sqrt
T sqrt(T t)
Definition: SSEVec.h:19
reco::Vertex::tracks_end
trackRef_iterator tracks_end() const
last iterator over tracks
Definition: Vertex.cc:73
b
double b
Definition: hdecay.h:118
reco::Vertex::hasRefittedTracks
bool hasRefittedTracks() const
Checks whether refitted tracks are stored.
Definition: Vertex.h:168
reco::Vertex::covariance
CovarianceMatrix covariance() const
return SMatrix
Definition: Vertex.h:137
reco::Vertex::refittedTracks_
std::vector< Track > refittedTracks_
The vector of refitted tracks.
Definition: Vertex.h:212
a
double a
Definition: hdecay.h:119
reco::Vertex::dimension
Definition: Vertex.h:42
reco::Vertex::tracks_begin
trackRef_iterator tracks_begin() const
first iterator over tracks
Definition: Vertex.cc:71
runTheMatrix.err
err
Definition: runTheMatrix.py:288
reco::Vertex::position_
Point position_
position
Definition: Vertex.h:206
reco::Vertex::chi2
double chi2() const
chi-squares
Definition: Vertex.h:103
alignCSCRings.r
r
Definition: alignCSCRings.py:93
reco::Vertex::trackWeight
float trackWeight(const TREF &r) const
returns the weight with which a Track has contributed to the vertex-fit.
Definition: Vertex.h:85
reco::Vertex::size
Definition: Vertex.h:52
reco::Vertex::fill
void fill(CovarianceMatrix &v) const
fill SMatrix
reco::Vertex::t
double t() const
t coordinate
Definition: Vertex.h:122
Exception
Definition: hltDiff.cc:246
reco::Vertex::covariance_
float covariance_[size4D]
covariance matrix (4x4) as vector
Definition: Vertex.h:208
EgHLTOffHistBins_cfi.mass
mass
Definition: EgHLTOffHistBins_cfi.py:34
reco::Vertex::ndof_
float ndof_
number of degrees of freedom
Definition: Vertex.h:204
HLT_2018_cff.track
track
Definition: HLT_2018_cff.py:10352
cms::Exception
Definition: Exception.h:70
reco::Vertex::index
unsigned int index
index type
Definition: Vertex.h:54
dqmiolumiharvest.j
j
Definition: dqmiolumiharvest.py:66
ntuplemaker.time
time
Definition: ntuplemaker.py:310
reco::Vertex::ndof
double ndof() const
Definition: Vertex.h:110
reco::Vertex::Error4D
math::Error< dimension4D >::type Error4D
covariance error matrix (4x4)
Definition: Vertex.h:48
reco::Vertex::weights_
std::vector< uint8_t > weights_
Definition: Vertex.h:213
math::Error
fixed size error matrix
Definition: Error.h:31
reco::Vertex::size4D
Definition: Vertex.h:52