CMS 3D CMS Logo

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 reco::SecondaryVertex

List of all members.

Classes

class  TrackEqual

Public Types

enum  { dimension = 3 }
 

error matrix dimension

More...
enum  { size = dimension * ( dimension + 1 ) / 2 }
 

matix size

More...
typedef math::Error< dimension >
::type 
CovarianceMatrix
 covariance error matrix (3x3)
typedef math::Error< dimension >
::type 
Error
 covariance error matrix (3x3)
typedef unsigned int index
 index type
typedef math::XYZPoint Point
 point in the space
typedef std::vector
< TrackBaseRef >
::const_iterator 
trackRef_iterator
 The iteratator for the vector<TrackRef>

Public Member Functions

void add (const TrackBaseRef &r, float w=1.0)
 add a reference to a Track
void add (const TrackBaseRef &r, const Track &refTrack, float w=1.0)
 add the original a Track(reference) and the smoothed Track
double chi2 () const
 chi-squares
double covariance (int i, int j) const
 (i, j)-th element of error matrix, i, j = 0, ... 2
CovarianceMatrix covariance () const
 return SMatrix
Error error () const
 return SMatrix
void fill (CovarianceMatrix &v) const
 fill SMatrix
bool hasRefittedTracks () const
 Checks whether refitted tracks are stored.
bool isFake () const
bool isValid () const
 Tells whether the vertex is valid.
double ndof () const
double normalizedChi2 () const
 chi-squared divided by n.d.o.f.
unsigned int nTracks (float minWeight=0.5) const
 Returns the number of tracks in the vertex with weight above minWeight.
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.
const Pointposition () const
 position
Track refittedTrack (const TrackBaseRef &track) const
Track refittedTrack (const TrackRef &track) const
const std::vector< Track > & refittedTracks () const
 Returns the container of refitted tracks.
void removeTracks ()
trackRef_iterator tracks_begin () const
 first iterator over tracks
trackRef_iterator tracks_end () const
 last iterator over tracks
size_t tracksSize () const
 number of tracks
float trackWeight (const TrackBaseRef &r) const
 returns the weight with which a Track has contributed to the vertex-fit.
float trackWeight (const TrackRef &r) const
 returns the weight with which a Track has contributed to the vertex-fit.
 Vertex (const Point &, const Error &, double chi2, double ndof, size_t size)
 constructor for a valid vertex, with all data
 Vertex ()
 Vertex (const Point &, const Error &)
 Constructor for a fake vertex.
double x () const
 x coordinate
double xError () const
 error on x
double y () const
 y coordinate
double yError () const
 error on y
double z () const
 y coordinate
double zError () const
 error on z

Private Member Functions

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

Private Attributes

float chi2_
 chi-sqared
float covariance_ [size]
 covariance matrix (3x3) as vector
float ndof_
 number of degrees of freedom
Point position_
 position
std::vector< TrackrefittedTracks_
 The vector of refitted tracks.
std::vector< TrackBaseReftracks_
 reference to tracks
bool validity_
 tells wether the vertex is really valid.
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
Version:
Id:
Vertex.h,v 1.39 2011/02/25 22:05:02 dlange Exp

Definition at line 35 of file Vertex.h.


Member Typedef Documentation

covariance error matrix (3x3)

Definition at line 46 of file Vertex.h.

typedef math::Error<dimension>::type reco::Vertex::Error

covariance error matrix (3x3)

Definition at line 44 of file Vertex.h.

typedef unsigned int reco::Vertex::index

index type

Definition at line 50 of file Vertex.h.

point in the space

Definition at line 40 of file Vertex.h.

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

error matrix dimension

Enumerator:
dimension 

Definition at line 42 of file Vertex.h.

{ dimension = 3 };
anonymous enum

matix size

Enumerator:
size 

Definition at line 48 of file Vertex.h.

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

Constructor & Destructor Documentation

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 54 of file Vertex.h.

References covariance_, i, size, and validity_.

            :  chi2_( 0.0 ), ndof_( 0 ), position_(0.,0.,0. ) { validity_ = false; for(int i = 0; i < size; ++ i ) covariance_[i]=0.;
}
Vertex::Vertex ( const Point p,
const Error err 
)

Constructor for a fake vertex.

Definition at line 19 of file Vertex.cc.

References covariance_, dimension, i, idx(), j, and validity_.

                                                   :
  chi2_( 0.0 ), ndof_( 0 ), position_( p ) {
  index idx = 0;
  for( index i = 0; i < dimension; ++ i ) 
    for( index j = 0; j <= i; ++ j )
      covariance_[ idx ++ ] = err( i, j );
  validity_ = true;
}
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 9 of file Vertex.cc.

References covariance_, dimension, i, idx(), j, tracks_, and validity_.

                                                                                           :
  chi2_( chi2 ), ndof_( ndof ), position_( p ) {
  tracks_.reserve( size );
  index idx = 0;
  for( index i = 0; i < dimension; ++ i ) 
    for( index j = 0; j <= i; ++ j )
      covariance_[ idx ++ ] = err( i, j );
  validity_ = true;
}

Member Function Documentation

void Vertex::add ( const TrackBaseRef r,
float  w = 1.0 
)
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 58 of file Vertex.cc.

References refittedTracks_, tracks_, and weights_.

{
  tracks_.push_back ( r );
  refittedTracks_.push_back ( refTrack );
  weights_.push_back(w*255);
}
double reco::Vertex::chi2 ( void  ) const [inline]
double reco::Vertex::covariance ( int  i,
int  j 
) const [inline]
CovarianceMatrix reco::Vertex::covariance ( void  ) const [inline]

return SMatrix

Definition at line 114 of file Vertex.h.

References fill(), and m.

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

{ Error m; fill( m ); return m; }
Error reco::Vertex::error ( ) const [inline]
void Vertex::fill ( CovarianceMatrix v) const

fill SMatrix

Definition at line 28 of file Vertex.cc.

References covariance_, dimension, i, idx(), and j.

Referenced by covariance(), error(), CandCommonVertexFitterBase::set(), and PFCandCommonVertexFitterBase::set().

                                     {
  index idx = 0;
  for( index i = 0; i < dimension; ++ i ) 
    for( index j = 0; j <= i; ++ j )
      err( i, j ) = covariance_[ idx ++ ];
}
bool reco::Vertex::hasRefittedTracks ( ) const [inline]

Checks whether refitted tracks are stored.

Definition at line 121 of file Vertex.h.

References refittedTracks_.

Referenced by nTracks(), reco::VertexFilter::operator()(), CombinedSVComputer::operator()(), GhostTrackComputer::operator()(), p4(), and reco::TrackKinematics::TrackKinematics().

{return !refittedTracks_.empty();}
index reco::Vertex::idx ( index  i,
index  j 
) const [inline, private]

position index

Definition at line 170 of file Vertex.h.

References a, b, and j.

Referenced by covariance(), fill(), and Vertex().

                                        {
      int a = ( i <= j ? i : j ), b = ( i <= j ? j : i );
      return b * ( b + 1 ) / 2 + a;
    }
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.

Reimplemented in reco::PFDisplacedVertex.

Definition at line 65 of file Vertex.h.

References chi2_, ndof_, and tracks_.

Referenced by TopDiLeptonDQM::analyze(), TopHLTDiMuonDQM::analyze(), TauTagTools::filteredPFChargedHadrCands(), TauTagTools::filteredTracks(), HLTVertexFilter::hltFilter(), PVObjectSelector::operator()(), EventVtxInfoNtupleDumper::produce(), PFchsMETcorrInputProducer::produce(), and PrimaryVertexMonitor::vertexPlots().

{return (chi2_==0 && ndof_==0 && tracks_.empty());}
bool reco::Vertex::isValid ( void  ) const [inline]
double reco::Vertex::ndof ( ) const [inline]
double reco::Vertex::normalizedChi2 ( ) const [inline]
unsigned int Vertex::nTracks ( float  minWeight = 0.5) const

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

Definition at line 147 of file Vertex.cc.

References hasRefittedTracks(), n, originalTrack(), refittedTracks_, tracks_begin(), tracks_end(), and trackWeight().

{
 int n=0;
 if(hasRefittedTracks()) {
 for(std::vector<Track>::const_iterator iter = refittedTracks_.begin(); iter != refittedTracks_.end(); ++iter) 
   if (trackWeight(originalTrack(*iter)) >=minWeight) 
     n++;
 }
 else
 {
  for(std::vector<reco::TrackBaseRef>::const_iterator iter = tracks_begin(); iter != tracks_end(); iter++) 
   if (trackWeight(*iter) >=minWeight) 
    n++;  
 } 
 return n;
}
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 86 of file Vertex.cc.

References pos, refittedTracks_, and tracks_.

Referenced by PFDisplacedVertexFinder::commonTracks(), PFDisplacedVertexHelper::identifyVertex(), PFDisplacedVertexHelper::lambdaCP(), reco::PFDisplacedVertex::momentum(), nTracks(), and p4().

{
  if (refittedTracks_.empty())
        throw cms::Exception("Vertex") << "No refitted tracks stored in vertex\n";
  std::vector<Track>::const_iterator it =
        find_if(refittedTracks_.begin(), refittedTracks_.end(), TrackEqual(refTrack));
  if (it==refittedTracks_.end())
        throw cms::Exception("Vertex") << "Refitted track not found in list\n";
  size_t pos = it - refittedTracks_.begin();
  return tracks_[pos];
}
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 113 of file Vertex.cc.

References hasRefittedTracks(), originalTrack(), refittedTracks_, tracks_begin(), tracks_end(), and trackWeight().

Referenced by FWVertexProxyBuilder::build(), and reco::Conversion::refittedPair4Momentum().

{

 math::XYZTLorentzVectorD sum;
 ROOT::Math::LorentzVector<ROOT::Math::PxPyPzM4D<double> > vec;

 if(hasRefittedTracks()) {
 for(std::vector<Track>::const_iterator iter = refittedTracks_.begin();
     iter != refittedTracks_.end(); ++iter) {
   if (trackWeight(originalTrack(*iter)) >=minWeight) {
   vec.SetPx(iter->px());
   vec.SetPy(iter->py());
   vec.SetPz(iter->pz());
   vec.SetM(mass);
   sum += vec;
   }
  }
 }
 else
 {
 for(std::vector<reco::TrackBaseRef>::const_iterator iter = tracks_begin();
            iter != tracks_end(); iter++) {
  if (trackWeight(*iter) >=minWeight) {
   vec.SetPx((*iter)->px());
   vec.SetPy((*iter)->py());
   vec.SetPz((*iter)->pz());
   vec.SetM(mass);
   sum += vec;
   }
  }
 }
 return sum;
}
const Point& reco::Vertex::position ( ) const [inline]

position

Definition at line 93 of file Vertex.h.

References position_.

Referenced by IPTools::absoluteImpactParameter(), IPTools::absoluteImpactParameter3D(), IPTools::absoluteTransverseImpactParameter(), CMSDAS11DijetTestAnalyzer::analyze(), TopElectronHLTOfflineSource::analyze(), CMSDAS11DijetAnalyzer::analyze(), TkConvValidator::analyze(), SignedImpactParameter3D::apply(), CaloRecoTauAlgorithm::buildCaloTau(), PFRecoTauAlgorithm::buildPFTau(), pat::LeptonVertexSignificance::calculate(), ConversionProducer::checkPhi(), VertexDistance::compatibility(), reco::SecondaryVertex::computeDist2d(), reco::SecondaryVertex::computeDist3d(), GsfConstraintAtVertex::constrainAtVertex(), reco::VZero::crossingPoint(), VertexDistance::distance(), VertexCompatibleWithBeam::distanceToBeam(), dummyPrediction(), KalmanVertexTrackCompatibilityEstimator< N >::estimate(), GsfVertexTrackCompatibilityEstimator::estimate(), PrimaryVertexAnalyzer4PU::fillTrackHistos(), TauTagTools::filteredPFChargedHadrCands(), TauTagTools::filteredTracks(), PFDisplacedVertexFinder::fitVertexFromSeed(), HLTDisplacedmumuFilter::hltFilter(), HLTDisplacedmumumuFilter::hltFilter(), PFDisplacedVertexHelper::identifyVertex(), NuclearVertexBuilder::isCompatible(), PFTauQualityCutWrapper::isolationChargedObjects(), PFTauQualityCutWrapper::isolationPUObjects(), muon::isTightMuon(), PhotonConversionTrajectorySeedProducerFromQuadrupletsAlgo::loop(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::loopOnPriVtx(), ConversionTools::matchesConversion(), InclusiveVertexFinder::nearTracks(), NuclearTrackCorrector::newTrajNeeded(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), reco::VertexFilter::operator()(), VertexCompatibleWithBeam::operator()(), PVObjectSelector::operator()(), pat::VertexAssociationSelector::operator()(), print(), VertexFromTrackProducer::produce(), EventVtxInfoNtupleDumper::produce(), MuonFromPVSelector::produce(), GsfElectronFromPVSelector::produce(), TrackIPProducer::produce(), TrackFromPVSelector::produce(), SecondaryVertexProducer::produce(), TkConvValidator::recalculateMomentumAtFittedVertex(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), reco::PFDisplacedVertex::setPrimaryDirection(), FWConvTrackHitsDetailView::setTextInfo(), reco::V0Candidate::setVertex(), PFTauQualityCutWrapper::signalChargedObjects(), VertexDistanceXY::signedDistance(), VertexDistance3D::signedDistance(), IPTools::signedImpactParameter3D(), IPTools::signedTransverseImpactParameter(), ConeIsolationAlgorithm::tag(), ConversionProducer::trackD0Cut(), QcdUeDQM::trackSelection(), reco::JetSignalVertexCompatibilityAlgo::trackVertexCompat(), PrimaryVertexMonitor::vertexPlots(), and reco::GhostTrackVertexFinder::vertices().

{ return position_; }
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 98 of file Vertex.cc.

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

Referenced by CombinedSVComputer::operator()(), GhostTrackComputer::operator()(), refittedTrack(), reco::TrackKinematics::TrackKinematics(), and reco::PFDisplacedVertex::trackPosition().

{
  if (refittedTracks_.empty())
         throw cms::Exception("Vertex") << "No refitted tracks stored in vertex\n";
  trackRef_iterator it = find(tracks_begin(), tracks_end(), track);
  if (it==tracks_end()) throw cms::Exception("Vertex") << "Track not found in list\n";
  size_t pos = it - tracks_begin();
  return refittedTracks_[pos];
}
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 108 of file Vertex.cc.

References refittedTrack().

{
  return refittedTrack(TrackBaseRef(track));
}
const std::vector<Track>& reco::Vertex::refittedTracks ( ) const [inline]
void Vertex::removeTracks ( )

Definition at line 65 of file Vertex.cc.

References refittedTracks_, tracks_, and weights_.

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

{
  weights_.clear();
  tracks_.clear();
  refittedTracks_.clear();
}
Vertex::trackRef_iterator Vertex::tracks_begin ( ) const

first iterator over tracks

Definition at line 40 of file Vertex.cc.

References tracks_.

Referenced by NuclearVertexBuilder::addSecondaryTrack(), VertexMonitor::analyze(), PatBJetVertexAnalyzer::analyze(), PrimaryVertexAnalyzer4PU::analyzeVertexCollectionTP(), FWVertexProxyBuilder::build(), FWSecVertexProxyBuilder::build(), NuclearLikelihood::calculate(), PFPileUpAlgo::chargedHadronVertex(), computeSharedTracks(), PFRecoTauDiscriminationByFlight::discriminate(), KalmanVertexTrackCompatibilityEstimator< N >::estimate(), GsfVertexTrackCompatibilityEstimator::estimate(), recoBSVTagInfoValidationAnalyzer::fillRecoToSim(), SVTagInfoValidationAnalyzer::fillRecoToSim(), FFTJetPFPileupCleaner::findSomeVertex(), PrimaryVertexAnalyzer4PU::getTruthMatchedVertexTracks(), PATPrimaryVertexSelector::getVertexVariables(), HLTDisplacedmumuFilter::hltFilter(), HLTDisplacedmumumuFilter::hltFilter(), NuclearVertexBuilder::isCompatible(), reco::VZero::negativeDaughter(), nTracks(), reco::VertexFilter::operator()(), p4(), reco::VZero::positiveDaughter(), reco::NuclearInteraction::primaryTrack(), PrimaryVertexAnalyzer4PU::printEventSummary(), PFchsMETcorrInputProducer::produce(), SecondaryVertexProducer::produce(), PVClusterComparer::pTSquaredSum(), refittedTrack(), NuclearLikelihood::secondaryTrackMaxHits(), reco::NuclearInteraction::secondaryTracks_begin(), PFElectronAlgo::SetIDOutputs(), PFElectronAlgo::SetLinks(), reco::NbSharedTracks::sharedTracks(), VertexHigherPtSquared::sumPtSquared(), TrackerDpgAnalysis::sumPtSquared(), reco::TrackKinematics::TrackKinematics(), trackWeight(), and PrimaryVertexMonitor::vertexPlots().

{
  return tracks_.begin();
}
Vertex::trackRef_iterator Vertex::tracks_end ( ) const
size_t Vertex::tracksSize ( ) const
float Vertex::trackWeight ( const TrackRef r) const

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

Definition at line 80 of file Vertex.cc.

References trackWeight().

{
  return trackWeight(TrackBaseRef(track));
}
float Vertex::trackWeight ( const TrackBaseRef r) const
double reco::Vertex::x ( ) const [inline]

x coordinate

Definition at line 95 of file Vertex.h.

References position_.

Referenced by TopDiLeptonDQM::analyze(), TopHLTDiMuonDQM::analyze(), PatVertexAnalyzer::analyze(), TkConvValidator::analyze(), SignedImpactParameter3D::apply(), SignedTransverseImpactParameter::apply(), SignedDecayLength3D::apply(), TauDiscriminationAgainstCaloMuon< TauType, TauDiscriminator >::beginEvent(), FWVertexProxyBuilder::build(), FWSecVertexProxyBuilder::build(), PFRecoTauAlgorithm::buildPFTau(), IPTools::closestApproachToJet(), SignedDecayLength3D::closestApproachToJet(), SignedImpactParameter3D::closestApproachToJet(), SignedImpactParameter3D::distance(), SignedImpactParameter3D::distanceWithJetAxis(), reco::Conversion::dxy(), reco::Conversion::dz(), PFPhotonAlgo::EvaluateSingleLegMVA(), recoBSVTagInfoValidationAnalyzer::fillRecoToSim(), SVTagInfoValidationAnalyzer::fillRecoToSim(), V0Fitter::fitAll(), getVertexD0(), HLTVertexFilter::hltFilter(), ConversionTools::isGoodConversion(), IPTools::jetTrackDistance(), IPTools::linearizedSignedImpactParameter3D(), reco::Conversion::lxy(), reco::PFDisplacedVertex::momentum(), ConversionHitChecker::nHitsBeforeVtx(), pat::VertexAssociationSelector::operator()(), PFAlgo::postMuonCleaning(), reco::print(), ParticleReplacerParticleGun::produce(), pat::PATConversionProducer::produce(), SecondaryVertexProducer::produce(), PFAlgo::reconstructCluster(), PFPhotonAlgo::RunPFPhoton(), reco::PFDisplacedVertex::setPrimaryDirection(), FWConvTrackHitsDetailView::setTextInfo(), IPTools::signedDecayLength3D(), IPTools::signedImpactParameter3D(), IPTools::signedTransverseImpactParameter(), TrackClusterSplitter::splitClusters(), and SignedTransverseImpactParameter::zImpactParameter().

{ return position_.X(); }
double reco::Vertex::xError ( ) const [inline]
double reco::Vertex::y ( ) const [inline]

y coordinate

Definition at line 97 of file Vertex.h.

References position_.

Referenced by TopDiLeptonDQM::analyze(), TopHLTDiMuonDQM::analyze(), PatVertexAnalyzer::analyze(), TkConvValidator::analyze(), SignedImpactParameter3D::apply(), SignedTransverseImpactParameter::apply(), SignedDecayLength3D::apply(), TauDiscriminationAgainstCaloMuon< TauType, TauDiscriminator >::beginEvent(), FWVertexProxyBuilder::build(), FWSecVertexProxyBuilder::build(), PFRecoTauAlgorithm::buildPFTau(), IPTools::closestApproachToJet(), SignedDecayLength3D::closestApproachToJet(), SignedImpactParameter3D::closestApproachToJet(), SignedImpactParameter3D::distance(), SignedImpactParameter3D::distanceWithJetAxis(), reco::Conversion::dxy(), reco::Conversion::dz(), PFPhotonAlgo::EvaluateSingleLegMVA(), recoBSVTagInfoValidationAnalyzer::fillRecoToSim(), SVTagInfoValidationAnalyzer::fillRecoToSim(), V0Fitter::fitAll(), getVertexD0(), HLTVertexFilter::hltFilter(), ConversionTools::isGoodConversion(), IPTools::jetTrackDistance(), IPTools::linearizedSignedImpactParameter3D(), reco::Conversion::lxy(), reco::PFDisplacedVertex::momentum(), ConversionHitChecker::nHitsBeforeVtx(), pat::VertexAssociationSelector::operator()(), PFAlgo::postMuonCleaning(), reco::print(), ParticleReplacerParticleGun::produce(), pat::PATConversionProducer::produce(), SecondaryVertexProducer::produce(), PFAlgo::reconstructCluster(), PFPhotonAlgo::RunPFPhoton(), reco::PFDisplacedVertex::setPrimaryDirection(), FWConvTrackHitsDetailView::setTextInfo(), IPTools::signedDecayLength3D(), IPTools::signedImpactParameter3D(), IPTools::signedTransverseImpactParameter(), TrackClusterSplitter::splitClusters(), and SignedTransverseImpactParameter::zImpactParameter().

{ return position_.Y(); }
double reco::Vertex::yError ( ) const [inline]
double reco::Vertex::z ( ) const [inline]

y coordinate

Definition at line 99 of file Vertex.h.

References position_.

Referenced by CMSDAS11DijetTestAnalyzer::analyze(), TopDiLeptonDQM::analyze(), CMSDAS11DijetAnalyzer::analyze(), TopHLTDiMuonDQM::analyze(), PatVertexAnalyzer::analyze(), SignedImpactParameter3D::apply(), SignedTransverseImpactParameter::apply(), SignedDecayLength3D::apply(), TauDiscriminationAgainstCaloMuon< TauType, TauDiscriminator >::beginEvent(), FWVertexProxyBuilder::build(), FWSecVertexProxyBuilder::build(), CaloRecoTauTagInfoAlgorithm::buildCaloTauTagInfo(), PFRecoTauAlgorithm::buildPFTau(), PFRecoTauTagInfoAlgorithm::buildPFTauTagInfo(), IPTools::closestApproachToJet(), SignedDecayLength3D::closestApproachToJet(), SignedImpactParameter3D::closestApproachToJet(), SignedImpactParameter3D::distance(), SignedImpactParameter3D::distanceWithJetAxis(), reco::Conversion::dz(), PFPhotonAlgo::EvaluateLCorrMVA(), PFPhotonAlgo::EvaluateSingleLegMVA(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), recoBSVTagInfoValidationAnalyzer::fillRecoToSim(), SVTagInfoValidationAnalyzer::fillRecoToSim(), V0Fitter::fitAll(), HLTVertexFilter::hltFilter(), IPTools::jetTrackDistance(), IPTools::linearizedSignedImpactParameter3D(), QualityCutsAnalyzer::LoopOverJetTracksAssociation(), reco::Conversion::lz(), PrimaryVertexAnalyzer4PU::matchVertex(), PrimaryVertexAnalyzer::matchVertex(), reco::PFDisplacedVertex::momentum(), ConversionHitChecker::nHitsBeforeVtx(), pat::VertexAssociationSelector::operator()(), PVObjectSelector::operator()(), reco::print(), EventVtxInfoNtupleDumper::produce(), ParticleReplacerParticleGun::produce(), PFchsMETcorrInputProducer::produce(), ConeIsolation::produce(), SecondaryVertexProducer::produce(), PFAlgo::reconstructCluster(), PFPhotonAlgo::RunPFPhoton(), reco::PFDisplacedVertex::setPrimaryDirection(), FWConvTrackHitsDetailView::setTextInfo(), IPTools::signedDecayLength3D(), IPTools::signedImpactParameter3D(), TrackClusterSplitter::splitClusters(), ConeIsolationAlgorithm::tag(), and SignedTransverseImpactParameter::zImpactParameter().

{ return position_.Z(); }
double reco::Vertex::zError ( ) const [inline]

Member Data Documentation

float reco::Vertex::chi2_ [private]

chi-sqared

Definition at line 153 of file Vertex.h.

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

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

covariance matrix (3x3) as vector

Definition at line 159 of file Vertex.h.

Referenced by covariance(), fill(), and Vertex().

float reco::Vertex::ndof_ [private]

number of degrees of freedom

Definition at line 155 of file Vertex.h.

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

position

Definition at line 157 of file Vertex.h.

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

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

The vector of refitted tracks.

Definition at line 163 of file Vertex.h.

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

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

reference to tracks

Definition at line 161 of file Vertex.h.

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

bool reco::Vertex::validity_ [private]

tells wether the vertex is really valid.

Definition at line 166 of file Vertex.h.

Referenced by isValid(), and Vertex().

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

Definition at line 164 of file Vertex.h.

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