#include <LeafCandidate.h>
Public Types | |
typedef int | Charge |
electric charge type More... | |
typedef CandidateCollection | daughters |
collection of daughter candidates More... | |
typedef unsigned int | index |
typedef math::XYZTLorentzVector | LorentzVector |
Lorentz vector. More... | |
typedef math::XYZPoint | Point |
point in the space More... | |
typedef math::PtEtaPhiMLorentzVector | PolarLorentzVector |
Lorentz vector. More... | |
typedef math::XYZVector | Vector |
point in the space More... | |
Public Types inherited from reco::Candidate | |
enum | { dimension = 3 } |
enum | { size = dimension * (dimension + 1) / 2 } |
matix size More... | |
typedef int | Charge |
electric charge type More... | |
typedef candidate::const_iterator | const_iterator |
typedef math::Error< dimension > ::type | CovarianceMatrix |
covariance error matrix (3x3) More... | |
typedef unsigned int | index |
index type More... | |
typedef candidate::iterator | iterator |
typedef math::XYZTLorentzVector | LorentzVector |
Lorentz vector. More... | |
typedef math::XYZPoint | Point |
point in the space More... | |
typedef math::PtEtaPhiMLorentzVector | PolarLorentzVector |
Lorentz vector. More... | |
typedef size_t | size_type |
typedef math::XYZVector | Vector |
point in the space More... | |
Public Member Functions | |
Vector | boostToCM () const final |
int | charge () const final |
electric charge More... | |
LeafCandidate * | clone () const override |
returns a clone of the Candidate object More... | |
void | construct (int qx3, float pt, float eta, float phi, float mass, const Point &vtx, int pdgId, int status) |
const Candidate * | daughter (size_type) const override |
return daughter at a given position (throws an exception) More... | |
Candidate * | daughter (size_type) override |
return daughter at a given position (throws an exception) More... | |
Candidate * | daughter (const std::string &s) override |
return daughter with a specified role name More... | |
const Candidate * | daughter (const std::string &s) const override |
return daughter with a specified role name More... | |
double | energy () const final |
energy More... | |
double | et () const final |
transverse energy More... | |
double | et2 () const final |
transverse energy squared (use this for cut!) More... | |
double | eta () const final |
momentum pseudorapidity More... | |
void | fillVertexCovariance (CovarianceMatrix &v) const override |
fill SMatrix More... | |
template<typename T > | |
T | get () const |
get a component More... | |
template<typename T , typename Tag > | |
T | get () const |
get a component More... | |
template<typename T > | |
T | get (size_type i) const |
get a component More... | |
template<typename T , typename Tag > | |
T | get (size_type i) const |
get a component More... | |
bool | hasMasterClone () const override |
bool | hasMasterClonePtr () const override |
bool | isCaloMuon () const override |
bool | isConvertedPhoton () const override |
bool | isElectron () const override |
bool | isGlobalMuon () const override |
bool | isJet () const override |
bool | isMuon () const override |
bool | isPhoton () const override |
bool | isStandAloneMuon () const override |
bool | isTrackerMuon () const override |
LeafCandidate () | |
LeafCandidate (const Candidate &c) | |
template<typename... Args> | |
LeafCandidate (Args &&...args) | |
LeafCandidate (LeafCandidate &rh) | |
LeafCandidate (LeafCandidate &&)=default | |
LeafCandidate (LeafCandidate const &)=default | |
bool | longLived () const final |
is long lived? More... | |
double | mass () const final |
mass More... | |
bool | massConstraint () const final |
do mass constraint? More... | |
double | massSqr () const final |
mass squared More... | |
const CandidateBaseRef & | masterClone () const override |
const CandidatePtr & | masterClonePtr () const override |
template<typename Ref > | |
Ref | masterRef () const |
cast master clone reference to a concrete type More... | |
Vector | momentum () const final |
spatial momentum vector More... | |
const Candidate * | mother (size_type) const override |
return mother at a given position (throws an exception) More... | |
double | mt () const final |
transverse mass More... | |
double | mtSqr () const final |
transverse mass squared More... | |
template<typename T > | |
size_type | numberOf () const |
number of components More... | |
template<typename T , typename Tag > | |
size_type | numberOf () const |
number of components More... | |
size_t | numberOfDaughters () const override |
number of daughters More... | |
size_t | numberOfMothers () const override |
number of mothers More... | |
size_t | numberOfSourceCandidatePtrs () const override |
LeafCandidate & | operator= (LeafCandidate &&)=default |
LeafCandidate & | operator= (LeafCandidate const &)=default |
double | p () const final |
magnitude of momentum vector More... | |
const LorentzVector & | p4 () const final |
four-momentum Lorentz vector More... | |
int | pdgId () const final |
PDG identifier. More... | |
double | phi () const final |
momentum azimuthal angle More... | |
const PolarLorentzVector & | polarP4 () const final |
four-momentum Lorentz vector More... | |
double | pt () const final |
transverse momentum More... | |
double | px () const final |
x coordinate of momentum vector More... | |
double | py () const final |
y coordinate of momentum vector More... | |
double | pz () const final |
z coordinate of momentum vector More... | |
double | rapidity () const final |
rapidity More... | |
void | setCharge (Charge q) final |
set electric charge More... | |
void | setLongLived () final |
void | setMass (double m) final |
set particle mass More... | |
void | setMassConstraint () final |
void | setP4 (const LorentzVector &p4) final |
set 4-momentum More... | |
void | setP4 (const PolarLorentzVector &p4) final |
set 4-momentum More... | |
void | setPdgId (int pdgId) final |
void | setPz (double pz) final |
void | setStatus (int status) final |
set status word More... | |
void | setThreeCharge (Charge qx3) final |
set electric charge More... | |
void | setVertex (const Point &vertex) override |
set vertex More... | |
CandidatePtr | sourceCandidatePtr (size_type i) const override |
int | status () const final |
status word More... | |
double | theta () const final |
momentum polar angle More... | |
int | threeCharge () const final |
electric charge More... | |
const Point & | vertex () const override |
vertex position (overwritten by PF...) More... | |
double | vertexChi2 () const override |
chi-squares More... | |
double | vertexCovariance (int i, int j) const override |
(i, j)-th element of error matrix, i, j = 0, ... 2 More... | |
CovarianceMatrix | vertexCovariance () const final |
return SMatrix More... | |
double | vertexNdof () const override |
double | vertexNormalizedChi2 () const override |
chi-squared divided by n.d.o.f. More... | |
double | vx () const override |
x coordinate of vertex position More... | |
double | vy () const override |
y coordinate of vertex position More... | |
double | vz () const override |
z coordinate of vertex position More... | |
double | y () const final |
rapidity More... | |
~LeafCandidate () override | |
destructor More... | |
Public Member Functions inherited from reco::Candidate | |
const_iterator | begin () const |
first daughter const_iterator More... | |
iterator | begin () |
first daughter iterator More... | |
virtual const Track * | bestTrack () const |
Candidate () | |
default constructor More... | |
virtual float | dxyError () const |
uncertainty on dxy More... | |
virtual float | dzError () const |
uncertainty on dz More... | |
const_iterator | end () const |
last daughter const_iterator More... | |
iterator | end () |
last daughter iterator More... | |
template<typename T > | |
T | get () const |
get a component More... | |
template<typename T , typename Tag > | |
T | get () const |
get a component More... | |
template<typename T > | |
T | get (size_type i) const |
get a component More... | |
template<typename T , typename Tag > | |
T | get (size_type i) const |
get a component More... | |
template<typename Ref > | |
Ref | masterRef () const |
cast master clone reference to a concrete type More... | |
template<typename T > | |
size_type | numberOf () const |
number of components More... | |
template<typename T , typename Tag > | |
size_type | numberOf () const |
number of components More... | |
virtual void | setSourceCandidatePtr (const CandidatePtr &ptr) |
Set the ptr to the source Candidate. More... | |
virtual | ~Candidate () |
destructor More... | |
Private Member Functions | |
bool | overlap (const Candidate &) const override |
check overlap with another Candidate More... | |
Private Attributes | |
ParticleState | m_state |
Friends | |
class | ::OverlapChecker |
template<typename , typename , typename > | |
struct | component |
class | ShallowCloneCandidate |
class | ShallowClonePtrCandidate |
Additional Inherited Members |
particle candidate with no constituent nor daughters
Definition at line 16 of file LeafCandidate.h.
typedef int reco::LeafCandidate::Charge |
electric charge type
Definition at line 21 of file LeafCandidate.h.
collection of daughter candidates
Definition at line 19 of file LeafCandidate.h.
typedef unsigned int reco::LeafCandidate::index |
Definition at line 31 of file LeafCandidate.h.
Lorentz vector.
Definition at line 23 of file LeafCandidate.h.
point in the space
Definition at line 27 of file LeafCandidate.h.
Lorentz vector.
Definition at line 25 of file LeafCandidate.h.
point in the space
Definition at line 29 of file LeafCandidate.h.
|
inline |
|
inlineexplicit |
Definition at line 36 of file LeafCandidate.h.
|
inlineexplicit |
Definition at line 40 of file LeafCandidate.h.
|
inline |
Definition at line 42 of file LeafCandidate.h.
|
default |
|
default |
|
override |
|
inlinefinalvirtual |
boost vector to boost a Lorentz vector to the particle center of mass system
Implements reco::Candidate.
Definition at line 121 of file LeafCandidate.h.
References reco::ParticleState::boostToCM(), and m_state.
|
inlinefinalvirtual |
electric charge
Implements reco::Candidate.
Definition at line 106 of file LeafCandidate.h.
References reco::ParticleState::charge(), and m_state.
Referenced by l1tpf_impl::RegionMapper::addMuon(), l1tpf_impl::RegionMapper::addTrack(), ElectronTagProbeAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), PFTester::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), L1GenTreeProducer::analyze(), HLTMuonMatchAndPlot::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), egHLT::OffEle::charge(), MuonGmtPair::charge(), pat::MuonMvaEstimator::computeMva(), reco::PFTau::dump(), PFAlgo::egammaFilters(), RecoMuonValidator::MuonME::fill(), EwkElecTauHistManager::fillHistograms(), WZInterestingEventSelector::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), pat::PATObject< ObjectType >::genParticleById(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), MuonMETAlgo::GetMuDepDeltas(), MuonGmtPair::gmtCharge(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), HcalIsoTrkSimAnalyzer::notaMuon(), L1HPSPFTauQualityCut::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), GenParticleCustomSelector::operator()(), reco::operator<<(), reco::LeafRefCandidateT::overlap(), overlap(), PFEGammaFilters::passElectronSelection(), reco::PFTauDecayMode::PFTauDecayMode(), reco::PFRecoTauChargedHadron::print(), printPFCand(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), HLTTriMuonIsolation::produce(), LowPtGSFToPackedCandidateLinker::produce(), pat::PATLostTracks::produce(), pat::L1MuonMatcher::produce(), pat::PATPackedCandidateProducer::produce(), L1TMuonLegacyConverter::produce(), SoftPFElectronTagInfoProducer::produce(), SoftPFMuonTagInfoProducer::produce(), ClassBasedElectronID::result(), MuScleFitMuonSelector::selectMuons(), reco::mlpf::setCandidateRefs(), l1t::Muon::setHwCharge(), GsfElectronAlgo::setPixelMatchInfomation(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), FWMuonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), reco::PFCandidate::setTrackRef(), and reco::PFCandidate::translateTypeToPdgId().
|
inlineoverridevirtual |
returns a clone of the Candidate object
Implements reco::Candidate.
Reimplemented in reco::PFJet, reco::CaloJet, reco::JPTJet, reco::GenJet, reco::IsolatedPixelTrackCandidate, reco::PFCandidate, pat::Jet, l1extra::L1EtMissParticle, reco::GsfElectron, reco::SiStripElectron, pat::Tau, l1extra::L1MuonParticle, reco::PFTauDecayMode, pat::Electron, reco::VertexCompositePtrCandidate, pat::Muon, pat::Photon, reco::PFTau, pat::MET, reco::HcalIsolatedTrackCandidate, l1extra::L1EmParticle, l1extra::L1JetParticle, reco::MET, pat::GenericParticle, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::NamedCompositeCandidate, reco::EcalIsolatedParticleCandidate, reco::Photon, pat::PFParticle, pat::CompositeCandidate, reco::ShallowCloneCandidate, reco::VertexCompositeCandidate, pat::Particle, reco::ShallowClonePtrCandidate, pat::Lepton< reco::BaseTau >, pat::Lepton< reco::GsfElectron >, pat::Lepton< reco::Muon >, reco::TrackJet, reco::GenParticle, reco::PFClusterJet, reco::Muon, reco::RecoCandidate, reco::BasicJet, reco::CaloRecHitCandidate, reco::RecoChargedCandidate, reco::RecoEcalCandidate, reco::RecoStandAloneMuonCandidate, reco::PileUpPFCandidate, reco::RecoCaloTowerCandidate, reco::IsolatedPFCandidate, reco::Electron, reco::BaseTau, reco::RecoPFClusterRefCandidate, and reco::RecoChargedRefCandidate.
Definition at line 195 of file LeafCandidate.h.
References LeafCandidate().
|
inline |
Definition at line 78 of file LeafCandidate.h.
References m_state.
return daughter at a given position (throws an exception)
Implements reco::Candidate.
Reimplemented in pat::Jet, reco::NamedCompositeCandidate, reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, and l1t::PFJet.
Definition at line 29 of file LeafCandidate.cc.
return daughter at a given position (throws an exception)
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::NamedCompositeCandidate, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 45 of file LeafCandidate.cc.
|
overridevirtual |
return daughter with a specified role name
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, and reco::NamedCompositeCandidate.
Definition at line 39 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
|
overridevirtual |
return daughter with a specified role name
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, and reco::NamedCompositeCandidate.
Definition at line 33 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
|
inlinefinalvirtual |
energy
Implements reco::Candidate.
Definition at line 125 of file LeafCandidate.h.
References reco::ParticleState::energy(), and m_state.
Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), JetValidation::analyze(), PatTauAnalyzer::analyze(), QcdHighPtDQM::analyze(), PFCandidateChecker::analyze(), TreeWriterForEcalCorrection::analyze(), EwkElecDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), ResolutionCreator::analyze(), SimplePhotonAnalyzer::analyze(), IsolatedParticlesGeneratedJets::analyze(), L1GenTreeProducer::analyze(), ZdcSimHitStudy::analyze(), PhotonValidator::analyze(), PhotonAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWHGCalTriggerCellProxyBuilder::build(), FWHGCalTriggerClusterProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), reco::FlavorHistoryEvent::cache(), reco::helper::CastorJetIDHelper::calculate(), pat::LeptonJetIsolationAngle::calculate(), pat::CaloIsolationEnergy::calculate(), reco::helper::JetIDHelper::calculate(), MEzCalculator::Calculate(), HiPuRhoProducer::calculateOrphanInput(), ElectronEnergyCalibrator::calibrate(), reco::CastorTower::CastorTower(), reco::JPTJet::chargedEmEnergyFraction(), reco::PFJet::chargedEmEnergyFraction(), pat::Jet::chargedEmEnergyFraction(), reco::JPTJet::chargedHadronEnergyFraction(), reco::PFJet::chargedHadronEnergyFraction(), pat::Jet::chargedHadronEnergyFraction(), reco::PFJet::chargedMuEnergyFraction(), pat::Jet::chargedMuEnergyFraction(), reco::helper::JetIDHelper::classifyJetComponents(), btagbtvdeep::commonCandidateToFeatures(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), JetPlusTrackCorrector::correctAA(), L1FastjetCorrector::correction(), L1JPTOffsetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), L1FastjetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L1JPTOffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), PFAlgo::createCandidatesHCAL(), reco::PFJet::electronEnergyFraction(), pat::Jet::electronEnergyFraction(), metsig::SignAlgoResolutions::ElectronPtResolution(), egHLT::OffPho::energy(), egHLT::OffEle::energy(), CaloTower::energyInHF(), CaloTower::energyInHO(), metsig::SignAlgoResolutions::evalPF(), pat::JetCorrFactorsProducer::evaluate(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), DeepBoostedJetTagInfoProducer::fillSVFeatures(), EMEnrichingFilterAlgo::filterIsoGenPar(), PFJetIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), PFJetBenchmark::gettrue(), CaloTower::hadP4(), reco::PFJet::HFEMEnergyFraction(), pat::Jet::HFEMEnergyFraction(), reco::PFJet::HFHadronEnergyFraction(), pat::Jet::HFHadronEnergyFraction(), reco::PFJet::hoEnergyFraction(), pat::Jet::hoEnergyFraction(), l1t::HGCalMulticluster::iEnergy(), btagbtvdeep::JetConverter::jetToFeatures(), TauValidation::leadingPionP4(), main(), MatchJet::matchCollections(), EGEtScaleSysModifier::modifyObject(), TauValidation::motherP4(), reco::PFJet::muonEnergyFraction(), pat::Jet::muonEnergyFraction(), reco::JPTJet::neutralEmEnergyFraction(), reco::PFJet::neutralEmEnergyFraction(), pat::Jet::neutralEmEnergyFraction(), reco::JPTJet::neutralHadronEnergyFraction(), reco::PFJet::neutralHadronEnergyFraction(), pat::Jet::neutralHadronEnergyFraction(), L1TkElectron::EtComparator::operator()(), AcceptJet::operator()(), EleEnergyRetriever::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), TtSemiLRSignalSelObservables::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), EgammaHLTFilteredObjProducer< OutCollType >::SelectionCut::CutValues::operator()(), reco::operator<<(), CaloTower::p4(), reco::PFMETProducerMVA::passPFLooseId(), reco::PFJet::photonEnergyFraction(), pat::Jet::photonEnergyFraction(), CaloTowerCandidateCreator::produce(), EgammaHLTCaloTowerProducer::produce(), pf2pat::PFMETAlgo::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), pat::PATPackedCandidateProducer::produce(), JetPlusTrackProducer::produce(), NoPileUpPFMEtDataProducer::produce(), CastorClusterProducer::produce(), JetPlusTrackProducerAA::produce(), reco::CentralityProducer::produce(), pat::PATTauProducer::produce(), JetIdSelector< T >::produce(), SmearedJetProducerT< T >::produce(), Jet.Jet::rawEnergy(), pf2pat::PFIsoDepositAlgo::sameParticle(), l1t::HGCalMulticluster::saveEnergyInterpretation(), FWTauProxyBuilderBase::scaleProduct(), FWMETProxyBuilder::scaleProduct(), FWJetProxyBuilder::scaleProduct(), ElectronEnergyCalibrator::setEnergyAndSystVarations(), TauValidation::spinEffectsZH(), btagbtvdeep::svToFeatures(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), TauValidation::visibleTauEnergy(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
transverse energy
Implements reco::Candidate.
Definition at line 127 of file LeafCandidate.h.
References reco::ParticleState::et(), and m_state.
Referenced by l1t::HGCalTower::addEtEm(), l1t::HGCalTower::addEtHad(), StKinFitter::addKinFitInfo(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), PatPhotonSimpleAnalyzer::analyze(), PFTester::analyze(), EwkDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), SimplePhotonAnalyzer::analyze(), SimplePi0DiscAnalyzer::analyze(), HigPhotonJetHLTOfflineSource::analyze(), PhotonValidator::analyze(), PhotonAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoJets(), ExoticaDQM::analyzeMonoMuons(), ExoticaDQM::analyzeMonoPhotons(), EgammaObjects::analyzePhotons(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWMETGlimpseProxyBuilder::build(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), razor::CalcMTR(), reco::helper::JetIDHelper::calculate(), EmDQM::checkGeneratedParticlesRequirement(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doCaloMet(), L1JetRecoTreeProducer::doCaloMetBE(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), egHLT::OffPho::et(), egHLT::OffEle::et(), l1t::TkHTMiss::EtMiss(), l1t::TkEtMiss::etMiss(), l1extra::L1EtMissParticle::etMiss(), TopDiLeptonOffline::MonitorEnsemble::fill(), L1TEGammaOffline::fillElectrons(), L1TStage2CaloLayer2Offline::fillJets(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), METAnalyzer::fillMonitorElement(), L1TEGammaOffline::fillPhotons(), BCToEFilterAlgo::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), ElectronVPlusJetsIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), HLTRechitInRegionsProducer< T1 >::getEtaPhiRegions(), WtoLNuSelector::getMt(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), JetVertexMain::Main(), reco::MET::mEtSig(), EGEtScaleSysModifier::modifyObject(), EG9X105XObjectUpdateModifier::modifyObject(), TtDilepLRSignalSelObservables::operator()(), TtSemiLRSignalSelObservables::operator()(), TtHadLRSignalSelObservables::CompareET::operator()(), TtSemiLRSignalSelObservables::CompareET::operator()(), EgammaHLTFilteredObjProducer< OutCollType >::SelectionCut::CutValues::operator()(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), JetEnergyShift::produce(), HiL1Subtractor::produce(), EvtPlaneProducer::produce(), JetPlusTrackCorrector::rebuildJta(), FWTauProxyBuilderBase::scaleProduct(), FWMETProxyBuilder::scaleProduct(), FWJetProxyBuilder::scaleProduct(), l1tp2::CaloTower::setEcalTowerEt(), L1GObject::setEt(), l1t::EGamma::setFootprintEt(), l1tp2::CaloTower::setHcalTowerEt(), l1t::HGCalTower::setHwEtEm(), l1t::HGCalTower::setHwEtHad(), l1t::EGamma::setIsoEt(), l1tp2::CaloTower::setL1egTowerEt(), L1Analysis::L1AnalysisRecoMet::SetMet(), l1t::EGamma::setRawEt(), FWPhotonDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), and reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables().
|
inlinefinalvirtual |
transverse energy squared (use this for cut!)
Implements reco::Candidate.
Definition at line 129 of file LeafCandidate.h.
References reco::ParticleState::et2(), and m_state.
|
inlinefinalvirtual |
momentum pseudorapidity
Implements reco::Candidate.
Definition at line 152 of file LeafCandidate.h.
References reco::ParticleState::eta(), and m_state.
Referenced by Particle.Particle::__str__(), BPHCompositeBasicSelect::accept(), l1tpf_impl::RegionMapper::addCalo(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), l1tpf_impl::RegionMapper::addEmCalo(), l1t::HGCalTower::addEt(), ZIterativeAlgorithmWithFit::addEvent(), StKinFitter::addKinFitInfo(), l1tpf_impl::RegionMapper::addMuon(), reco::tau::RecoTauConstructor::addPiZero(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), reco::tau::RecoTauConstructor::addTauChargedHadron(), l1tpf_impl::RegionMapper::addTrack(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), PatZjetsJetAnalyzer::analyze(), RPCRecHitProbability::analyze(), CMSDAS11DijetAnalyzer::analyze(), JetValidation::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), PatTauAnalyzer::analyze(), RPCMonitorDigi::analyze(), PFCandidateChecker::analyze(), ElectronTagProbeAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), TagAndProbeBtagTriggerMonitor::analyze(), EwkMuDQM::analyze(), TreeWriterForEcalCorrection::analyze(), EwkElecDQM::analyze(), ElectronMcFakeValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), PatPhotonSimpleAnalyzer::analyze(), QcdPhotonsDQM::analyze(), PFTester::analyze(), EwkDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), JetTester::analyze(), SimplePhotonAnalyzer::analyze(), SimplePi0DiscAnalyzer::analyze(), DQMExample_Step1::analyze(), IsolatedParticlesGeneratedJets::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), DQMPFCandidateAnalyzer::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), JetAnalyzer_HeavyIons::analyze(), IsoTrackCalib::analyze(), JetAnalyzer::analyze(), PhotonAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), EgammaObjects::analyzeElectrons(), EgammaObjects::analyzePhotons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), EMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::RecoTauVertexAssociator::associatedVertex(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), FWJetLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWMuonDetailView::build(), FWMuonLegoProxyBuilder::build(), FWGenParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), L1TkMuonProducer::build_tkMuons_from_idxs(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWMETProxyBuilder::buildViewType(), reco::helper::JetMuonHitsIDHelper::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), FWMuonBuilder::calculateField(), HiFJGridEmptyAreaCalculator::calculateGridRho(), HiPuRhoProducer::calculateOrphanInput(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), QGTagger::calcVariables(), HGCalTriggerCellCalibration::calibrateInMipT(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), l1t::PFJet::calibratePt(), l1t::PFCluster::calibratePt(), HGCalClusteringImpl::calibratePt(), JetPlusTrackCorrector::canCorrect(), hitfit::LeptonTranslatorBase< ALepton >::CheckEta(), hitfit::JetTranslatorBase< AJet >::CheckEta(), PFMuonAlgo::cleanPunchThroughAndFakes(), btagbtvdeep::commonCandidateToFeatures(), compare_l1candidate(), TauNNId::compute(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), pat::SoftMuonMvaEstimator::computeMva(), pat::MuonMvaEstimator::computeMva(), JetPlusTrackCorrector::correctAA(), LXXXCorrector::correction(), L1FastjetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), LXXXCorrectorImpl::correction(), L1FastjetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), l1tpf::corrector::correctPt(), HGCalTriggerClusterIdentificationBDT::decision(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), reco::GenJet::detectorEta(), L1TStage2CaloLayer2Offline::doesNotOverlapWithHLTObjects(), HLTObjectsMonitor::dzFinder(), PFAlgo::egammaFilters(), metsig::SignAlgoResolutions::ElectronPtResolution(), FWPFCandidateDetailView::eta(), TauL1TPair::eta(), egHLT::OffPho::eta(), egHLT::OffEle::eta(), MuonGmtPair::eta(), etaBin(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), pat::JetCorrFactorsProducer::evaluate(), lowptgsfeleid::features_V0(), lowptgsfeleid::features_V1(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), TopSingleLepton::MonitorEnsemble::fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), ZeePlots::fillEleClassesPlots(), L1TEGammaOffline::fillElectrons(), ZeeCalibration::fillEleInfo(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), L1TStage2CaloLayer2Offline::fillJets(), METAnalyzer::fillMonitorElement(), l1t::MuonRawDigiTranslator::fillMuonStableQuantities(), tmtt::TP::fillNearestJetInfo(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), L1TEGammaOffline::fillPhotons(), DeepBoostedJetTagInfoProducer::fillSVFeatures(), HcalIsoTrkSimAnalyzer::fillTree(), BCToEFilterAlgo::filter(), BadParticleFilter::filter(), GenHTFilter::filter(), ModelpMSSMFilter::filter(), WZInterestingEventSelector::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), L1Validator::FindBest(), TtFullLepHypGenMatch::findMatchingLepton(), PFJetIDSelectionFunctor::firstDataCuts(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), TrackIsoCalculator::getBkgSubTrackIso(), calib::CalibElectron::getCalibModulesWeights(), ElectronDNNEstimator::getInputsVars(), PhotonDNNEstimator::getInputsVars(), reco::tau::RecoTauVertexAssociator::getLeadCand(), DPFIsolation::getPredictions(), AntiElectronIDMVA6< TauType, ElectronType >::getTauVarsTypeSpecific(), getTheTauJet(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), EtaPtBin::inBin(), HGCalTriggerClusterInterpretationEM::interpret(), l1t::HGCalMulticluster::iPolarP4(), CosmicSplitterValidation::is_gold_muon(), PFIsolationEstimator::isChargedParticleVetoed(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), PFEGammaFilters::isElectronSafeForJetMET(), cms::MuonTCMETValueMapProducer::isGoodMuon(), muon::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), BPhysicsOniaDQM::isMuonInAccept(), PFIsolationEstimator::isNeutralParticleVetoed(), EGammaMvaEleEstimator::isoMvaValue(), PFIsolationEstimator::isPhotonParticleVetoed(), FWPFCandidateDetailView::isPntInRng(), L1HPSPFTauBuilder::isWithinIsolationCone(), L1HPSPFTauBuilder::isWithinSignalCone(), L1HPSPFTauBuilder::isWithinStrip(), Jet.Jet::jetID(), btagbtvdeep::JetConverter::jetToFeatures(), JetVertexMain::Main(), main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), hltriggeroffline::L1MuonMatcherAlgo::match(), L1MuonMatcherAlgo::match(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), PFIsolationEstimator::matchPFObject(), reco::RecoTauPiZero::maxDeltaEta(), DQMExample_Step1::MediumEle(), EG9X105XObjectUpdateModifier::modifyObject(), MuonGmtPair::MuonGmtPair(), ZToMuMuGammaAnalyzer::muonSelection(), ElectronMVAEstimator::mva(), SoftElectronMVAEstimator::mva(), muonisolation::CaloExtractor::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseHcal(), L1TkElectron::EtComparator::operator()(), GhostTrackComputer::operator()(), AcceptJet::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), deep_tau::TauWPThreshold::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WPlusJetsEventSelector::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::operator()(), hitfit::JetTranslatorBase< AJet >::operator()(), reco::operator<<(), operator<<(), pat::TriggerObjectStandAlone::packP4(), PFEGammaFilters::passElectronSelection(), passesElectronId(), passesElectronPreId(), reco::PFMETProducerMVA::passPFLooseId(), PFEGammaFilters::passPhotonSelection(), L1JetRecoTreeProducer::pfJetID(), PhotonAnalyzer::photonSelection(), PhotonAnalyzer::photonSelectionSlimmed(), reco::GenericJet::print(), reco::PFRecoTauChargedHadron::print(), reco::RecoTauPiZero::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), printPFCand(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), JetTracksAssociationDRVertex::produce(), JetVetoedTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetTracksAssociationDRCalo::produce(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), PileupJPTJetIdProducer::produce(), CaloMuonMerger::produce(), HLTTriMuonIsolation::produce(), HPSPFTauProducer::produce(), MVAJetPuIdProducer::produce(), CaloTowerCandidateCreator::produce(), PFLinker::produce(), MuonReSeeder::produce(), EgammaHLTCaloTowerProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), pat::PATPackedCandidateProducer::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), LeptonInJetProducer< T >::produce(), GenericBoostedTauSeedsProducer< JetType, CandType >::produce(), HiL1Subtractor::produce(), CastorClusterProducer::produce(), reco::CentralityProducer::produce(), JetIdSelector< T >::produce(), L1TPFProducer::produce(), PileupJetIdProducer::produce(), JetPartonMatcher::produce(), EvtPlaneProducer::produce(), SmearedJetProducerT< T >::produce(), Jet.Jet::puJetId(), pat::PATMuonProducer::puppiCombinedIsolation(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), L1TkMuonProducer::runOnMTFCollection_v1(), L1TkMuonProducer::runOnMTFCollection_v2(), pf2pat::PFIsoDepositAlgo::sameParticle(), l1t::PFTrack::setCaloEtaPhi(), L1MuKBMTrack::setCoarseEta(), L1GObject::setEta(), reco::HcalIsolatedTrackCandidate::SetEtaPhiEcal(), reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), reco::HcalIsolatedTrackCandidate::SetEtaPhiHcal(), L1MuKBMTrack::setFineEta(), l1t::L1Candidate::setHwEta(), reco::HcalIsolatedTrackCandidate::setL1(), l1t::HGCalTriggerCell::setPt(), l1t::HGCalClusterT< l1t::HGCalCluster >::setPt(), pat::Muon::setSimEta(), FWCaloTowerDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), l1tp2::CaloTower::setTowerEta(), HiFJGridEmptyAreaCalculator::setupGridJet(), cms::MuonMETValueMapProducer::should_type_MuonCandidateValuesUsed(), HGCalShowerShape::sigmaEtaEtaTot(), Phase1L1TJetProducer::subtract9x9Pileup(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), PFEGammaFilters::thisEleIsNotAllowedInPF(), HiFJGridEmptyAreaCalculator::tileIndexEta(), HiFJGridEmptyAreaCalculator::tileIndexEtaJet(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), and HGCalTriggerClusterIdentificationBDT::value().
|
overridevirtual |
fill SMatrix
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 58 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
Referenced by vertexCovariance().
|
inline |
get a component
Definition at line 239 of file LeafCandidate.h.
References reco::Candidate::get(), hasMasterClone(), and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.BetterConfigParser::__updateDict(), submitPVValidationJobs.BetterConfigParser::__updateDict(), util.rrapi.RRApi::columns(), rrapi.RRApi::columns(), rrapi.RRApi::count(), util.rrapi.RRApi::count(), rrapi.RRApi::data(), util.rrapi.RRApi::data(), betterConfigParser.BetterConfigParser::getCompares(), betterConfigParser.BetterConfigParser::getGeneral(), betterConfigParser.BetterConfigParser::getResultingSection(), submitPVValidationJobs.BetterConfigParser::getResultingSection(), HLTDiMuonGlbTrkFilter::hltFilter(), JetCleanerForType1METT< T, Textractor >::produce(), PFJetMETcorrInputProducerT< T, Textractor >::produce(), util.rrapi.RRApi::report(), rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), util.rrapi.RRApi::tags(), rrapi.RRApi::tags(), rrapi.RRApi::templates(), util.rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
|
inline |
get a component
Definition at line 247 of file LeafCandidate.h.
References reco::Candidate::get(), hasMasterClone(), and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.BetterConfigParser::__updateDict(), submitPVValidationJobs.BetterConfigParser::__updateDict(), util.rrapi.RRApi::columns(), rrapi.RRApi::columns(), rrapi.RRApi::count(), util.rrapi.RRApi::count(), rrapi.RRApi::data(), util.rrapi.RRApi::data(), betterConfigParser.BetterConfigParser::getCompares(), betterConfigParser.BetterConfigParser::getGeneral(), betterConfigParser.BetterConfigParser::getResultingSection(), submitPVValidationJobs.BetterConfigParser::getResultingSection(), util.rrapi.RRApi::report(), rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), util.rrapi.RRApi::tags(), rrapi.RRApi::tags(), rrapi.RRApi::templates(), util.rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
get a component
Definition at line 255 of file LeafCandidate.h.
References reco::Candidate::get(), hasMasterClone(), mps_fire::i, and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.BetterConfigParser::__updateDict(), submitPVValidationJobs.BetterConfigParser::__updateDict(), util.rrapi.RRApi::columns(), rrapi.RRApi::columns(), rrapi.RRApi::count(), util.rrapi.RRApi::count(), rrapi.RRApi::data(), util.rrapi.RRApi::data(), betterConfigParser.BetterConfigParser::getCompares(), betterConfigParser.BetterConfigParser::getGeneral(), betterConfigParser.BetterConfigParser::getResultingSection(), submitPVValidationJobs.BetterConfigParser::getResultingSection(), util.rrapi.RRApi::report(), rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), util.rrapi.RRApi::tags(), rrapi.RRApi::tags(), rrapi.RRApi::templates(), util.rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
get a component
Definition at line 263 of file LeafCandidate.h.
References reco::Candidate::get(), hasMasterClone(), mps_fire::i, and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.BetterConfigParser::__updateDict(), submitPVValidationJobs.BetterConfigParser::__updateDict(), util.rrapi.RRApi::columns(), rrapi.RRApi::columns(), rrapi.RRApi::count(), util.rrapi.RRApi::count(), rrapi.RRApi::data(), util.rrapi.RRApi::data(), betterConfigParser.BetterConfigParser::getCompares(), betterConfigParser.BetterConfigParser::getGeneral(), betterConfigParser.BetterConfigParser::getResultingSection(), submitPVValidationJobs.BetterConfigParser::getResultingSection(), util.rrapi.RRApi::report(), rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), util.rrapi.RRApi::tags(), rrapi.RRApi::tags(), rrapi.RRApi::templates(), util.rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
|
overridevirtual |
returns true if this candidate has a reference to a master clone. This only happens if the concrete Candidate type is ShallowCloneCandidate
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, and reco::ShallowCloneCandidate.
Definition at line 12 of file LeafCandidate.cc.
Referenced by get(), and numberOf().
|
overridevirtual |
returns true if this candidate has a ptr to a master clone. This only happens if the concrete Candidate type is ShallowClonePtrCandidate
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, and reco::ShallowClonePtrCandidate.
Definition at line 14 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 73 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 77 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::GsfElectron, reco::SiStripElectron, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, and reco::Electron.
Definition at line 63 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 67 of file LeafCandidate.cc.
Referenced by Muon.Muon::muonID().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::Jet, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 79 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, l1t::PFTrack, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 65 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::Photon, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 75 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 69 of file LeafCandidate.cc.
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 71 of file LeafCandidate.cc.
|
inlinefinalvirtual |
is long lived?
Implements reco::Candidate.
Definition at line 187 of file LeafCandidate.h.
References reco::ParticleState::longLived(), and m_state.
|
inlinefinalvirtual |
mass
Implements reco::Candidate.
Definition at line 131 of file LeafCandidate.h.
References m_state, and reco::ParticleState::mass().
Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), BPHCompositeBasicSelect::accept(), BPHHistoSpecificDecay::analyze(), JetTester::analyze(), l1t::PFJet::calibratePt(), l1t::PFCluster::calibratePt(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), JetPlusTrackCorrector::correction(), l1t::TkPhiCandidate::dmass(), BPhysicsValidation::ParticleMonitor::Fill(), V0Fitter::fitAll(), pat::Jet::groomedMass(), btagbtvdeep::JetConverter::jetToFeatures(), massSqr(), CATopJetHelper::operator()(), CAWZJetHelperUser::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), CATopJetHelperUser::operator()(), reco::operator<<(), pat::TriggerObjectStandAlone::packP4(), reco::PFRecoTauChargedHadron::print(), printPFCand(), HLTTriMuonIsolation::produce(), Onia2MuMuPAT::produce(), GenericBoostedTauSeedsProducer< JetType, CandType >::produce(), PatJPsiProducer::produce(), l1t::HGCalTriggerCell::setPt(), l1t::HGCalClusterT< l1t::HGCalCluster >::setPt(), btagbtvdeep::svToFeatures(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
do mass constraint?
Implements reco::Candidate.
Definition at line 192 of file LeafCandidate.h.
References m_state, and reco::ParticleState::massConstraint().
Referenced by CandKinematicVertexFitter::fill().
|
inlinefinalvirtual |
mass squared
Implements reco::Candidate.
Definition at line 133 of file LeafCandidate.h.
References mass().
Referenced by EwkElecDQM::analyze().
|
overridevirtual |
returns ptr to master clone, if existing. Throws an exception unless the concrete Candidate type is ShallowCloneCandidate
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, and reco::ShallowCloneCandidate.
Definition at line 7 of file LeafCandidate.cc.
References Exception.
Referenced by get(), masterRef(), and numberOf().
|
overridevirtual |
returns ptr to master clone, if existing. Throws an exception unless the concrete Candidate type is ShallowClonePtrCandidate
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, and reco::ShallowClonePtrCandidate.
Definition at line 16 of file LeafCandidate.cc.
References Exception.
|
inline |
cast master clone reference to a concrete type
Definition at line 233 of file LeafCandidate.h.
References masterClone().
|
inlinefinalvirtual |
spatial momentum vector
Implements reco::Candidate.
Definition at line 118 of file LeafCandidate.h.
References m_state, and reco::ParticleState::momentum().
Referenced by PFTauExtractor::depositFromObject(), MultiTrackValidatorGenPs::dqmAnalyze(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), PF_PU_AssoMapAlgos::FindV0Vertex(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), CombinedSVComputer::operator()(), SoftPFElectronTagInfoProducer::produce(), SoftPFMuonTagInfoProducer::produce(), PixelClusterTagInfoProducer::produce(), SoftLepton::refineJetAxis(), reco::GsfElectron::setCorrectedEcalEnergy(), btagbtvdeep::svToFeatures(), and btagbtvdeep::vertexDdotP().
return mother at a given position (throws an exception)
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 31 of file LeafCandidate.cc.
|
inlinefinalvirtual |
transverse mass
Implements reco::Candidate.
Definition at line 136 of file LeafCandidate.h.
References m_state, and reco::ParticleState::mt().
Referenced by reco::WMuNuCandidate::massT(), and reco::WMuNuCandidatePtr::massT().
|
inlinefinalvirtual |
transverse mass squared
Implements reco::Candidate.
Definition at line 138 of file LeafCandidate.h.
References m_state, and reco::ParticleState::mtSqr().
|
inline |
number of components
Definition at line 271 of file LeafCandidate.h.
References hasMasterClone(), masterClone(), and reco::Candidate::numberOf().
|
inline |
number of components
Definition at line 279 of file LeafCandidate.h.
References hasMasterClone(), masterClone(), and reco::Candidate::numberOf().
|
overridevirtual |
number of daughters
Implements reco::Candidate.
Reimplemented in pat::Jet, reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, and l1t::PFJet.
Definition at line 21 of file LeafCandidate.cc.
|
overridevirtual |
number of mothers
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 23 of file LeafCandidate.cc.
|
inlineoverridevirtual |
return the number of source Candidates ( the candidates used to construct this Candidate)
Implements reco::Candidate.
Reimplemented in pat::Photon, pat::Tau, reco::PFTau, pat::Electron, pat::Muon, reco::PFCandidate, and reco::LeafRefCandidateT.
Definition at line 100 of file LeafCandidate.h.
|
default |
Referenced by reco::PFCandidate::operator=().
|
default |
|
overrideprivatevirtual |
check overlap with another Candidate
Implements reco::Candidate.
Reimplemented in reco::Photon, reco::PFCandidate, reco::Muon, reco::PFTau, reco::PFJet, reco::IsolatedPixelTrackCandidate, reco::LeafRefCandidateT, reco::CaloJet, reco::JPTJet, reco::GsfElectron, reco::GenJet, reco::HcalIsolatedTrackCandidate, reco::GenParticle, reco::SiStripElectron, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::MET, reco::CaloMET, reco::GenMET, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, reco::TrackJet, reco::Electron, reco::PFClusterJet, reco::BaseTau, reco::CaloRecHitCandidate, reco::BasicJet, reco::RecoChargedCandidate, reco::RecoEcalCandidate, reco::RecoStandAloneMuonCandidate, reco::RecoCaloTowerCandidate, and reco::RecoCandidate.
Definition at line 25 of file LeafCandidate.cc.
References reco::Candidate::charge(), charge(), reco::Candidate::p4(), p4(), reco::Candidate::vertex(), and vertex().
|
inlinefinalvirtual |
magnitude of momentum vector
Implements reco::Candidate.
Definition at line 123 of file LeafCandidate.h.
References m_state, and reco::ParticleState::p().
Referenced by ElectronMcSignalValidatorMiniAOD::analyze(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), ElectronMcFakeValidator::analyze(), HiggsDQM::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), JetTagPlotter::analyzeTag(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), spr::chargeIsolationGenCone(), spr::chargeIsolationGenEcal(), PFMuonAlgo::cleanPunchThroughAndFakes(), CaloTower::emP4(), lowptgsfeleid::features_V0(), lowptgsfeleid::features_V1(), RecoMuonValidator::MuonME::fill(), reco::tau::fillIsoMVARun2Inputs(), HcalIsoTrkSimAnalyzer::fillTree(), GreedyMuonPFCandidateFilter::filter(), AntiElectronIDMVA6< TauType, ElectronType >::getTauVarsTypeSpecific(), CaloTower::hadP4(), HLTMuonTrackMassFilter::hltFilter(), BPhysicsOniaDQM::isMuonInAccept(), TauValidation::leadingPionP4(), SoftElectronMVAEstimator::mva(), EGammaMvaEleEstimatorCSA14::mvaValue(), EGammaMvaEleEstimator::mvaValue(), GsfEleMinEcalEtCut::operator()(), AcceptJet::operator()(), CaloTower::p4(), CaloTower::p4_HO(), reco::GenericJet::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), Electron.Electron::ptErr(), l1t::TkMuon::setPattern(), l1t::TkGlbMuon::setTrkPtr(), l1t::TkMuon::setTrkPtr(), and GsfEleMinEcalEtCut::value().
|
inlinefinalvirtual |
four-momentum Lorentz vector
Implements reco::Candidate.
Definition at line 114 of file LeafCandidate.h.
References m_state, and reco::ParticleState::p4().
Referenced by reco::tau::RecoTauConstructor::addPiZero(), BeamDivergenceVtxGenerator::addSmearedGenParticle(), reco::tau::RecoTauConstructor::addTauChargedHadron(), PFCandConnector::analyseNuclearWPrim(), PFCandConnector::analyseNuclearWSec(), CMSDAS11DijetAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), QcdHighPtDQM::analyze(), MuonPFAnalyzer::analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), EmbeddingLHEProducer::assign_4vector(), TtSemiLepJetComb::bOverLightQPt(), TtSemiLepJetComb::bQuarkVar(), FWVertexCandidateProxyBuilder::build(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), PFMEtSignInterfaceBase::compResolution(), TtFullHadKinFitter::KinFit::corJet(), pat::Jet::correctedP4(), TauJetCorrector::correction(), ZSPJPTJetCorrector::correction(), LXXXCorrector::correction(), LXXXCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), PFElectronTranslator::createGsfElectrons(), TtSemiLepJetComb::deduceMothers(), PFRecoTauDiscriminationByIsolation::discriminate(), PFRecoTauDiscriminationByIsolationContainer::discriminate(), l1t::TkBsCandidate::dRPhiPair(), Tau.Tau::dxy_approx(), Tau.Tau::dz(), CaloTower::emEt(), CaloTower::et(), BJetEnergyRegressionMVA::fillAdditionalVariables(), JetPartonMatcher::fillAlgoritDefinition(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), VBFGenJetFilter::filter(), pat::CaloJetSelector::filter(), VBFGenJetFilter::filterGenJets(), TauSpinnerCMS::GetRecoDaughters(), CaloTower::hadEt(), l1t::HGCalMulticluster::iP4(), TtSemiLepJetComb::lightQVar(), pat::RawJetExtractorT< pat::Jet >::operator()(), CorrectJet::operator()(), TtDilepLRSignalSelObservables::operator()(), JetCleanerForType1MET_namespace::RawJetExtractorT< pat::Jet >::operator()(), PFJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), CaloJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), TtHadLRJetCombObservables::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), TtSemiLRJetCombObservables::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), JetIDSelectionFunctor::operator()(), CaloTower::outerEt(), reco::LeafRefCandidateT::overlap(), overlap(), CaloTower::p(), CaloTower::p4(), Lepton.Lepton::p4WithFSR(), reco::PFTauDecayMode::PFTauDecayMode(), DeltaBetaWeights::produce(), pat::PATSecondaryVertexSlimmer::produce(), HLTTriMuonIsolation::produce(), PFJetsTauOverlapRemoval::produce(), JetTracksAssociationToTrackRefs::produce(), Type0PFMETcorrInputProducer::produce(), L1CaloJetProducer::produce(), SoftPFElectronTagInfoProducer::produce(), SoftPFMuonTagInfoProducer::produce(), BoostedDoubleSVProducer::produce(), TauSpinnerCMS::readParticlesfromReco(), TtSemiLepJetComb::relativePtHadronicTop(), reco::PFCandidate::rescaleMomentum(), reco::GsfElectron::setCorrectedEcalEnergy(), reco::GsfElectron::setP4(), pat::TriggerObjectStandAlone::triggerObject(), l1t::HGCalClusterT< l1t::HGCalCluster >::updateP4AndPosition(), and l1tpf_impl::COEFile::writeTracksToFile().
|
inlinefinalvirtual |
PDG identifier.
Implements reco::Candidate.
Definition at line 176 of file LeafCandidate.h.
References m_state, and reco::ParticleState::pdgId().
Referenced by Particle.Particle::__str__(), MCTruthHelper< P >::absPdgId(), TopDecaySubset::addRadiation(), TauDecay_GenParticle::AddRadInfo(), BeamDivergenceVtxGenerator::addSmearedGenParticle(), JetAnaPythia< Jet >::analyze(), TauDecay_GenParticle::Analyze(), PFTester::analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), ZdcSimHitStudy::analyze(), L1Validator::analyze(), L1TrackObjectNtupleMaker::analyze(), ExoticaDQM::analyzeDisplacedJets(), ExoticaDQM::analyzeDisplacedLeptons(), TauDecay_GenParticle::AnalyzeTau(), reco::PFCandidate::bestTrack(), TopDecaySubset::checkShowerModel(), TauValidation::countParticles(), TopGenEvent::daughterQuarkOfTop(), PFIsolationEstimator::fGetIsolationInRings(), CandKinematicVertexFitter::fill(), BPhysicsValidation::ParticleMonitor::Fill(), JetPartonMatcher::fillAlgoritDefinition(), BPhysicsValidation::FillDaughters(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), DYToMuMuGenFilter::filter(), BCToEFilterAlgo::filter(), ChargedHadronTrackResolutionFilter::filter(), MuonBadTrackFilter::filter(), ModelpMSSMFilter::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), TauValidation::findFSRandBrem(), GenHFHadronMatcher::findHadronJets(), TopDecaySubset::findLastParticleInChain(), TauValidation::findMother(), TauValidation::FindPhotosFSR(), TauValidation::findTauList(), pat::PATObject< ObjectType >::genParticleById(), TauSpinnerCMS::GetLastSelf(), TauValidation::GetMother(), TauValidation::GetMothers(), TauSpinnerCMS::GetRecoDaughters(), ttHFGenFilter::GetTops(), PFJetBenchmark::gettrue(), TrackClassifier::hadronFlavor(), GenParticlesHelper::hasAncestor(), BCToEFilterAlgo::isBCBaryon(), BCToEFilterAlgo::isBCMeson(), HGCalTriggerNtupleGenTau::isChargedHadron(), HGCalTriggerNtupleGenTau::isChargedHadronFromResonance(), HGCalTriggerNtupleGenTau::isElectron(), TauSpinnerCMS::isFirst(), HGCalTriggerNtupleGenTau::isGamma(), HGCalTriggerNtupleGenTau::isGoodTau(), HGCalTriggerNtupleGenTau::isIntermediateResonance(), HiGammaJetSignalDef::IsIsolated(), TauValidation::isLastTauinChain(), HGCalTriggerNtupleGenTau::isMuon(), HGCalTriggerNtupleGenTau::isNeutralPion(), HGCalTriggerNtupleGenTau::isNeutralPionFromResonance(), HiPhotonType::IsPrompt(), HGCalTriggerNtupleGenTau::isStableLepton(), HGCalTriggerNtupleGenTau::isStableNeutralHadron(), TauValidation::leadingPionP4(), BasicGenParticleValidation::matchParticles(), PFIsolationEstimator::matchPFObject(), HcalIsoTrkSimAnalyzer::notaMuon(), reco::RecoTauPiZero::numberOfElectrons(), reco::RecoTauPiZero::numberOfGammas(), TtDilepLRSignalSelObservables::operator()(), GenParticleCustomSelector::operator()(), l1tVertexFinder::operator<<(), reco::PFCandidate::particleId(), MCTruthHelper< P >::pdgId(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), PFTauElecRejectionBenchmark::process(), GenVisTauProducer::produce(), pat::PATLostTracks::produce(), HLTTauMCProducer::produce(), PartonSelector::produce(), pat::PATPackedCandidateProducer::produce(), JetPartonMatcher::produce(), EvtPlaneProducer::produce(), TauSpinnerCMS::readParticlesfromReco(), btagbtvdeep::recoCandidateToFeatures(), setPdgId(), TauValidation::spinEffectsZH(), TauValidation::tauMother(), toTrackRef(), HistoryBase::traceRecoGenHistory(), pat::TriggerObjectStandAlone::triggerObject(), TauValidation::visibleTauEnergy(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
momentum azimuthal angle
Implements reco::Candidate.
Definition at line 148 of file LeafCandidate.h.
References m_state, and reco::ParticleState::phi().
Referenced by Particle.Particle::__str__(), reco::WMuNuCandidate::acop(), l1tpf_impl::RegionMapper::addCalo(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), l1tpf_impl::RegionMapper::addEmCalo(), l1t::HGCalTower::addEt(), ZIterativeAlgorithmWithFit::addEvent(), l1tpf_impl::RegionMapper::addMuon(), reco::tau::RecoTauConstructor::addPiZero(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), reco::tau::RecoTauConstructor::addTauChargedHadron(), l1tpf_impl::RegionMapper::addTrack(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), PatZjetsJetAnalyzer::analyze(), RPCRecHitProbability::analyze(), CMSDAS11DijetAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), PatTauAnalyzer::analyze(), CaloTowerAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), PFCandidateChecker::analyze(), TagAndProbeBtagTriggerMonitor::analyze(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), METplusTrackMonitor::analyze(), EwkElecDQM::analyze(), METMonitor::analyze(), ElectronMcFakeValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), PatPhotonSimpleAnalyzer::analyze(), QcdPhotonsDQM::analyze(), ObjMonitor::analyze(), PFTester::analyze(), EwkDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), JetTester::analyze(), TopMonitor::analyze(), SimplePhotonAnalyzer::analyze(), HTMonitor::analyze(), SimplePi0DiscAnalyzer::analyze(), HigPhotonJetHLTOfflineSource::analyze(), METTester::analyze(), DQMExample_Step1::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), IsolatedParticlesGeneratedJets::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), DQMPFCandidateAnalyzer::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), JetAnalyzer_HeavyIons::analyze(), JetAnalyzer::analyze(), PhotonAnalyzer::analyze(), L1TrackObjectNtupleMaker::analyze(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoJets(), ExoticaDQM::analyzeMonoMuons(), ExoticaDQM::analyzeMonoPhotons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), JetTracksAssociationXtrpCalo::associateInputTracksToJet(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), FWJetLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWMETGlimpseProxyBuilder::build(), FWMETLegoProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWL1EtMissParticleLegoProxyBuilder::build(), FWMuonDetailView::build(), FWMuonLegoProxyBuilder::build(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWGenParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWPhotonProxyBuilder::buildViewType(), FWElectronProxyBuilder::buildViewType(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), reco::helper::CastorJetIDHelper::calculate(), reco::helper::JetMuonHitsIDHelper::calculate(), GlobalHaloAlgo::Calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), HiPuRhoProducer::calculateOrphanInput(), PFMETBenchmark::calculateQuantities(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), QGTagger::calcVariables(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), l1t::PFJet::calibratePt(), l1t::PFCluster::calibratePt(), HGCalClusteringImpl::calibratePt(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), compare_l1candidate(), TauNNId::compute(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), L1JetRecoTreeProducer::doCaloMet(), L1JetRecoTreeProducer::doCaloMetBE(), L1TStage2CaloLayer2Offline::doesNotOverlapWithHLTObjects(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), EcalDeadCellDeltaRFilter::dPhiToMETfunc(), HLTObjectsMonitor::dzFinder(), PFAlgo::egammaFilters(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), pat::JetCorrFactorsProducer::evaluate(), lowptgsfeleid::features_V0(), lowptgsfeleid::features_V1(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), L1TEGammaOffline::fillElectrons(), ZeeCalibration::fillEleInfo(), JetDQM::fillHistograms(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), L1TStage2CaloLayer2Offline::fillJets(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), METAnalyzer::fillMonitorElement(), l1t::MuonRawDigiTranslator::fillMuonStableQuantities(), tmtt::TP::fillNearestJetInfo(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), L1TEGammaOffline::fillPhotons(), HcalIsoTrkSimAnalyzer::fillTree(), BadParticleFilter::filter(), WZInterestingEventSelector::filter(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), L1Validator::FindBest(), TtFullLepHypGenMatch::findMatchingLepton(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), get_phi_bin(), reco::tau::RecoTauVertexAssociator::getLeadCand(), WtoLNuSelector::getMt(), DPFIsolation::getPredictions(), AntiElectronIDMVA6< TauType, ElectronType >::getTauVarsTypeSpecific(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), tnp::BaseTreeFiller::init(), l1t::HGCalMulticluster::iPolarP4(), PFIsolationEstimator::isChargedParticleVetoed(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), PFIsolationEstimator::isNeutralParticleVetoed(), EGammaMvaEleEstimator::isoMvaValue(), PFIsolationEstimator::isPhotonParticleVetoed(), FWPFCandidateDetailView::isPntInRng(), L1HPSPFTauBuilder::isWithinIsolationCone(), L1HPSPFTauBuilder::isWithinSignalCone(), L1HPSPFTauBuilder::isWithinStrip(), btagbtvdeep::JetConverter::jetToFeatures(), TauL1TPair::l1tPhi(), JetVertexMain::Main(), main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), hltriggeroffline::L1MuonMatcherAlgo::match(), L1MuonMatcherAlgo::match(), PFIsolationEstimator::matchPFObject(), MuonGmtPair::MuonGmtPair(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WPlusJetsEventSelector::operator()(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::operator()(), JetIDStudiesSelector::operator()(), reco::operator<<(), operator<<(), pat::TriggerObjectStandAlone::packP4(), PFEGammaFilters::passElectronSelection(), PFEGammaFilters::passPhotonSelection(), FWPFCandidateDetailView::phi(), TauL1TPair::phi(), egHLT::OffPho::phi(), egHLT::OffEle::phi(), MuonGmtPair::phi(), MuonIdProducer::phiOfMuonInteractionRegion(), ntupleDataFormat.Track::phiPull(), reco::GenericJet::print(), reco::PFRecoTauChargedHadron::print(), reco::RecoTauPiZero::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), printPFCand(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetVetoedTracksAssociationDRVertex::produce(), JetTracksAssociationDRCalo::produce(), RegressionEnergyPatElectronProducer::produce(), PileupJPTJetIdProducer::produce(), MVAJetPuIdProducer::produce(), HPSPFTauProducer::produce(), CaloTowerCandidateCreator::produce(), MuonReSeeder::produce(), pf2pat::PFMETAlgo::produce(), EgammaHLTCaloTowerProducer::produce(), NoPileUpPFMEtProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), pat::PATPackedCandidateProducer::produce(), LeptonInJetProducer< T >::produce(), reco::PFMETProducerMVA::produce(), GenericBoostedTauSeedsProducer< JetType, CandType >::produce(), CastorClusterProducer::produce(), L1TPFProducer::produce(), PileupJetIdProducer::produce(), JetPartonMatcher::produce(), EvtPlaneProducer::produce(), SmearedJetProducerT< T >::produce(), pat::PATMuonProducer::puppiCombinedIsolation(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), l1t::PFTrack::setCaloEtaPhi(), L1MuKBMTrack::setCoordinates(), L1MuKBMTrack::setCoordinatesAtMuon(), L1MuKBMTrack::setCoordinatesAtVertex(), reco::HcalIsolatedTrackCandidate::SetEtaPhiEcal(), reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), reco::HcalIsolatedTrackCandidate::SetEtaPhiHcal(), l1t::L1Candidate::setHwPhi(), reco::HcalIsolatedTrackCandidate::setL1(), L1Analysis::L1AnalysisRecoMet::SetMet(), L1GObject::setPhi(), l1t::HGCalTriggerCell::setPt(), l1t::HGCalClusterT< l1t::HGCalCluster >::setPt(), pat::Muon::setSimPhi(), FWCaloTowerDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), l1tp2::CaloTower::setTowerPhi(), HGCalShowerShape::sigmaPhiPhiTot(), pat::LeptonJetIsolationAngle::spaceAngle(), Phase1L1TJetProducer::subtract9x9Pileup(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), HiFJGridEmptyAreaCalculator::tileIndexPhi(), reco::IsolatedPixelTrackCandidate::towerIndex(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
four-momentum Lorentz vector
Implements reco::Candidate.
Definition at line 116 of file LeafCandidate.h.
References m_state, and reco::ParticleState::polarP4().
Referenced by pat::PATMuonProducer::getRelMiniIsoPUCorrected(), pat::L1MuonMatcher::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATElectronProducer::setElectronMiniIso(), and pat::PATMuonProducer::setMuonMiniIso().
|
inlinefinalvirtual |
transverse momentum
Implements reco::Candidate.
Definition at line 146 of file LeafCandidate.h.
References m_state, and reco::ParticleState::pt().
Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), BPHCompositeBasicSelect::accept(), HGCalConcentratorSuperTriggerCellImpl::SuperTriggerCell::add(), l1tpf_impl::RegionMapper::addCalo(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), l1tpf_impl::RegionMapper::addEmCalo(), l1t::HGCalTower::addEt(), StKinFitter::addKinFitInfo(), l1tpf_impl::RegionMapper::addMuon(), reco::tau::RecoTauConstructor::addPiZero(), L1NNTauProducer::addTau(), reco::tau::RecoTauConstructor::addTauChargedHadron(), l1tpf_impl::RegionMapper::addTrack(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), RPCRecHitProbability::analyze(), PatZjetsJetAnalyzer::analyze(), CMSDAS11DijetAnalyzer::analyze(), JetValidation::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), PatTauAnalyzer::analyze(), RPCMonitorDigi::analyze(), ElectronTagProbeAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), TagAndProbeBtagTriggerMonitor::analyze(), EwkMuDQM::analyze(), SUSYDQMAnalyzer::analyze(), METplusTrackMonitor::analyze(), EwkElecDQM::analyze(), METMonitor::analyze(), ElectronMcFakeValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), QcdPhotonsDQM::analyze(), MuonPFAnalyzer::analyze(), ObjMonitor::analyze(), EwkDQM::analyze(), JetTester::analyze(), TopMonitor::analyze(), HiggsDQM::analyze(), METTester::analyze(), DQMExample_Step1::analyze(), IsolatedParticlesGeneratedJets::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), L1GenTreeProducer::analyze(), HLTMuonMatchAndPlot::analyze(), DQMPFCandidateAnalyzer::analyze(), DiMuonVertexValidation::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), JetAnalyzer_HeavyIons::analyze(), ZToMuMuGammaAnalyzer::analyze(), IsoTrackCalib::analyze(), JetAnalyzer::analyze(), L1TrackObjectNtupleMaker::analyze(), BeamHaloAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), HGCalConcentratorSuperTriggerCellImpl::assignSuperTriggerCellEnergyAndPosition(), reco::tau::RecoTauVertexAssociator::associatedVertex(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), Phase1L1TJetProducer::buildJetsFromSeedsWithPUSubtraction(), reco::helper::JetIDHelper::calculate(), pat::LeptonJetIsolationAngle::calculate(), GlobalHaloAlgo::Calculate(), FWMuonBuilder::calculateField(), HiFJGridEmptyAreaCalculator::calculateGridRho(), HiPuRhoProducer::calculateOrphanInput(), PFMETBenchmark::calculateQuantities(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), HGCalClusteringDummyImpl::calibratePt(), l1t::PFCluster::calibratePt(), HGCalClusteringImpl::calibratePt(), Photon.Photon::calScaledIsoValueExp(), Photon.Photon::calScaledIsoValueLin(), Photon.Photon::calScaledIsoValueQuadr(), PFMuonAlgo::cleanMismeasured(), PFMuonAlgo::cleanPunchThroughAndFakes(), HGCalConcentratorCoarsenerImpl::coarsen(), MuonPFAnalyzer::combRelIso(), btagbtvdeep::commonCandidateToFeatures(), l1tp2::compare_cluster_pt(), CMSDAS11DijetAnalyzer::compare_JetPt(), CMSDAS11DijetTestAnalyzer::compare_JetPt(), compare_l1candidate(), TauNNId::compute(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), pat::SoftMuonMvaEstimator::computeMva(), pat::MuonMvaEstimator::computeMva(), LXXXCorrector::correction(), L1FastjetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), LXXXCorrectorImpl::correction(), L1FastjetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), l1tpf::corrector::correctPt(), CutBasedPhotonIDAlgo::decideEB(), CutBasedPhotonIDAlgo::decideEE(), HGCalTriggerClusterIdentificationBDT::decision(), PFCandWithSuperClusterExtractor::depositFromObject(), reco::PFTau::dump(), HLTObjectsMonitor::dzFinder(), PFAlgo::egammaFilters(), WZInterestingEventSelector::electronSelection(), l1t::PFCluster::emEt(), metsig::SignAlgoResolutions::evalPFJet(), pat::JetCorrFactorsProducer::evaluate(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), lowptgsfeleid::features_V0(), lowptgsfeleid::features_V1(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), TopSingleLepton::MonitorEnsemble::fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), TopDiLeptonOffline::MonitorEnsemble::fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), JetPartonMatcher::fillAlgoritDefinition(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), JetMETHLTOfflineSource::fillMEforTriggerNTfired(), METAnalyzer::fillMonitorElement(), tmtt::TP::fillNearestJetInfo(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), DeepBoostedJetTagInfoProducer::fillSVFeatures(), HcalIsoTrkSimAnalyzer::fillTree(), InconsistentMuonPFCandidateFilter::filter(), MuonBadTrackFilter::filter(), BadParticleFilter::filter(), NJetsMC::filter(), GenHTFilter::filter(), ModelpMSSMFilter::filter(), LeptonRecoSkim::filter(), WZInterestingEventSelector::filter(), PhotonMVAEstimator::findCategory(), ElectronMVAEstimatorRun2::findCategory(), DeepTauId::findMatchedElectron(), MuonVPlusJetsIDSelectionFunctor::firstDataCuts(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), ElectronDNNEstimator::getInputsVars(), PhotonDNNEstimator::getInputsVars(), reco::tau::RecoTauVertexAssociator::getLeadCand(), DPFIsolation::getPredictions(), getTheElectron(), getTheMuon(), getTheTauJet(), L1TTauOffline::getTightMuons(), MuonGmtPair::gmtPt(), PFCandidateChecker::greaterPt(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTHcalNoiseFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), EtaPtBin::inBin(), tnp::BaseTreeFiller::init(), l1t::HGCalMulticluster::iPolarP4(), l1t::HGCalMulticluster::iPt(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), PFIsolationEstimator::isChargedParticleVetoed(), cms::MuonTCMETValueMapProducer::isGoodCaloMuon(), cms::MuonTCMETValueMapProducer::isGoodMuon(), muon::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), HiGammaJetSignalDef::IsIsolated(), muon::isLooseTriggerMuon(), EwkMuLumiMonitorDQM::IsMuMatchedToHLTMu(), BPhysicsOniaDQM::isMuonInAccept(), EGammaMvaEleEstimator::isoMvaValue(), PFEGammaFilters::isPhotonSafeForJetMET(), GsfElectronProducer::isPreselected(), DQMPFCandidateAnalyzer::jetSortingRule(), JetAnalyzer::jetSortingRule(), btagbtvdeep::JetConverter::jetToFeatures(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), TauL1TPair::l1tPt(), main(), muon::makeSelectorBitset(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), PFIsolationEstimator::matchPFObject(), DQMExample_Step1::MediumEle(), pat::MHT::mht(), EwkMuLumiMonitorDQM::muIso(), ElectronMVAEstimator::mva(), SoftElectronMVAEstimator::mva(), Electron.Electron::mvaIDLoose(), Electron.Electron::mvaIDRun2(), Electron.Electron::mvaIDTight(), PhotonMVAEstimator::mvaValue(), EGammaMvaEleEstimatorCSA14::mvaValue(), EGammaMvaEleEstimator::mvaValue(), GsfEleMinEcalEtCut::operator()(), L1HPSPFTauQualityCut::operator()(), reco::TrackSelector::operator()(), GhostTrackComputer::operator()(), L1TMuonBarrelKalmanSectorProcessor::TrackSorter::operator()(), AcceptJet::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), TtHadLRJetCombObservables::operator()(), L2TauJetsMerger::SorterByPt::operator()(), deep_tau::TauWPThreshold::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WSelector::operator()(), TtSemiLepSignalSelMVATrainer::JetwithHigherPt::operator()(), TtSemiLRJetCombObservables::operator()(), WPlusJetsEventSelector::operator()(), ZElectronsSelector::operator()(), AlignmentMuonSelector::ComparePt::operator()(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::operator()(), MuScleFitUtils::byPt::operator()(), l1t::HGCalTower::operator+=(), operator<<(), reco::operator<<(), l1t::operator>(), muon::overlap(), pat::TriggerObjectStandAlone::packP4(), BadGlobalMuonTagger::partnerId(), PFEGammaFilters::passElectronSelection(), PFEGammaFilters::passGsfElePreSelWithOnlyConeHadem(), l1t::PFTau::passLooseNN(), PFEGammaFilters::passPhotonSelection(), PhotonSelectorAlgo::passPhotonSelection(), l1t::PFTau::passTightNN(), EgammaCutBasedEleId::PassTriggerCuts(), PhotonAnalyzer::photonSelection(), PhotonAnalyzer::photonSelectionSlimmed(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), PatJetAnalyzer::print(), reco::PFRecoTauChargedHadron::print(), reco::RecoTauPiZero::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), printPFCand(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), L1HLTTauMatching::produce(), PileupJPTJetIdProducer::produce(), HLTTriMuonIsolation::produce(), CaloMuonMerger::produce(), MVAJetPuIdProducer::produce(), HPSPFTauProducer::produce(), L1NNTauProducer::produce(), QjetsAdder::produce(), MuonMETcorrInputProducer::produce(), MuonReSeeder::produce(), NoPileUpPFMEtProducer::produce(), pat::PATPackedCandidateProducer::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), LeptonInJetProducer< T >::produce(), reco::PFMETProducerMVA::produce(), GenericBoostedTauSeedsProducer< JetType, CandType >::produce(), Phase1L1TJetCalibrator::produce(), SoftPFElectronTagInfoProducer::produce(), reco::CentralityProducer::produce(), AlCaHcalNoiseProducer::produce(), SoftPFMuonTagInfoProducer::produce(), Phase1L1TJetProducer::produce(), CandMCMatchTableProducer::produce(), PileupJetIdProducer::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), TauL1TPair::pt(), egHLT::OffPho::pt(), MuonGmtPair::pt(), Electron.Electron::ptErr(), ntupleDataFormat.Track::ptPull(), pat::PATMuonProducer::puppiCombinedIsolation(), MuonIsolationDQM::RecordData(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), Jet.Jet::setCorrP4(), l1t::L1Candidate::setHwPt(), reco::HcalIsolatedTrackCandidate::setL1(), L1MuKBMTrack::setPtUnconstrained(), pat::Muon::setSimPt(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), FWMuonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), cms::MuonMETValueMapProducer::should_type_MuonCandidateValuesUsed(), L1TMuonBarrelKalmanRegionModule::sort4(), sort_by_pt(), MuonVPlusJetsIDSelectionFunctor::spring10Cuts(), Phase1L1TJetProducer::subtract9x9Pileup(), MuonVPlusJetsIDSelectionFunctor::summer08Cuts(), btagbtvdeep::svToFeatures(), EgammaCutBasedEleId::TestWP(), PFMuonSelector::TopPag12LjetsCuts(), PFMuonAlgo::tracksWithBetterMET(), HGCalConcentratorCoarsenerImpl::updateCoarseTriggerCellMaps(), GsfEleMinEcalEtCut::value(), and HGCalTriggerClusterIdentificationBDT::value().
|
inlinefinalvirtual |
x coordinate of momentum vector
Implements reco::Candidate.
Definition at line 140 of file LeafCandidate.h.
References m_state, and reco::ParticleState::px().
Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), HiggsDQM::analyze(), METTester::analyze(), JetAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), btagbtvdeep::SeedingTrackInfoBuilder::buildSeedingTrackInfo(), reco::FlavorHistoryEvent::cache(), razor::CalcMTR(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), HiPuRhoProducer::calculateOrphanInput(), PFMETBenchmark::calculateQuantities(), PFMuonAlgo::cleanMismeasured(), AddCorrectionsToGenericMET::constructP4From(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), HcalIsoTrkSimAnalyzer::fillTree(), ChargedHadronTrackResolutionFilter::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), PFMuonAlgo::getMinMaxMET2(), metsig::METSignificance::getSignificance(), L1TTauOffline::getTightMuons(), PFIsolationEstimator::isChargedParticleVetoed(), TauValidation::leadingPionP4(), reco::IsolatedTauTagInfo::leadingSignalTrack(), main(), reco::WMuNuCandidate::massT(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TauValidation::motherP4(), TtSemiLRSignalSelObservables::operator()(), hitfit::METTranslatorBase< AMet >::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), MEzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFTauElecRejectionBenchmark::process(), PseudoTopProducer::produce(), L1TPFMetNoMuProducer::produce(), MuonMETcorrInputProducer::produce(), NoPileUpPFMEtProducer::produce(), JetEnergyShift::produce(), Onia2MuMuPAT::produce(), JetPlusTrackProducer::produce(), reco::PFMETProducerMVA::produce(), JetPlusTrackProducerAA::produce(), SoftPFElectronTagInfoProducer::produce(), SoftPFMuonTagInfoProducer::produce(), pat::PATMETSlimmer::OneMETShift::readAndSet(), Type1PFMET::run(), btagbtvdeep::seedingTracksToFeatures(), pat::MET::setCorShift(), pat::MET::setUncShift(), pat::MET::shiftedP2(), pat::MET::shiftedP2_74x(), pat::MET::shiftedP3(), pat::MET::shiftedP3_74x(), pat::MET::shiftedP4(), pat::MET::shiftedP4_74x(), reco::MET::significance(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), PFMuonAlgo::tracksWithBetterMET(), TauValidation::visibleTauEnergy(), and reco::WMuNuCandidatePtr::WMuNuCandidatePtr().
|
inlinefinalvirtual |
y coordinate of momentum vector
Implements reco::Candidate.
Definition at line 142 of file LeafCandidate.h.
References m_state, and reco::ParticleState::py().
Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), HiggsDQM::analyze(), METTester::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), JetAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), btagbtvdeep::SeedingTrackInfoBuilder::buildSeedingTrackInfo(), reco::FlavorHistoryEvent::cache(), razor::CalcMTR(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), HiPuRhoProducer::calculateOrphanInput(), PFMETBenchmark::calculateQuantities(), PFMuonAlgo::cleanMismeasured(), AddCorrectionsToGenericMET::constructP4From(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), HcalIsoTrkSimAnalyzer::fillTree(), ChargedHadronTrackResolutionFilter::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), PFMuonAlgo::getMinMaxMET2(), metsig::METSignificance::getSignificance(), L1TTauOffline::getTightMuons(), PFIsolationEstimator::isChargedParticleVetoed(), TauValidation::leadingPionP4(), reco::IsolatedTauTagInfo::leadingSignalTrack(), main(), reco::WMuNuCandidate::massT(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TauValidation::motherP4(), TtSemiLRSignalSelObservables::operator()(), hitfit::METTranslatorBase< AMet >::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), MEzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFTauElecRejectionBenchmark::process(), L1TPFMetNoMuProducer::produce(), MuonMETcorrInputProducer::produce(), NoPileUpPFMEtProducer::produce(), JetEnergyShift::produce(), Onia2MuMuPAT::produce(), JetPlusTrackProducer::produce(), reco::PFMETProducerMVA::produce(), JetPlusTrackProducerAA::produce(), SoftPFElectronTagInfoProducer::produce(), SoftPFMuonTagInfoProducer::produce(), pat::PATMETSlimmer::OneMETShift::readAndSet(), Type1PFMET::run(), btagbtvdeep::seedingTracksToFeatures(), pat::MET::setCorShift(), pat::MET::setUncShift(), pat::MET::shiftedP2(), pat::MET::shiftedP2_74x(), pat::MET::shiftedP3(), pat::MET::shiftedP3_74x(), pat::MET::shiftedP4(), pat::MET::shiftedP4_74x(), reco::MET::significance(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), PFMuonAlgo::tracksWithBetterMET(), and TauValidation::visibleTauEnergy().
|
inlinefinalvirtual |
z coordinate of momentum vector
Implements reco::Candidate.
Definition at line 144 of file LeafCandidate.h.
References m_state, and reco::ParticleState::pz().
Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), HiggsDQM::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), btagbtvdeep::SeedingTrackInfoBuilder::buildSeedingTrackInfo(), reco::FlavorHistoryEvent::cache(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), HiPuRhoProducer::calculateOrphanInput(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), reco::tau::fillIsoMVARun2Inputs(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), HcalIsoTrkSimAnalyzer::fillTree(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), DPFIsolation::getPredictions(), TauValidation::leadingPionP4(), reco::IsolatedTauTagInfo::leadingSignalTrack(), main(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TauValidation::motherP4(), TtSemiLRSignalSelObservables::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::GenericJet::print(), MEzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFTauElecRejectionBenchmark::process(), Onia2MuMuPAT::produce(), JetPlusTrackProducer::produce(), JetPlusTrackProducerAA::produce(), SoftPFElectronTagInfoProducer::produce(), SoftPFMuonTagInfoProducer::produce(), btagbtvdeep::seedingTracksToFeatures(), setPz(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), and TauValidation::visibleTauEnergy().
|
inlinefinalvirtual |
rapidity
Implements reco::Candidate.
Definition at line 154 of file LeafCandidate.h.
References m_state, and reco::ParticleState::rapidity().
Referenced by BPHCompositeBasicSelect::accept(), and y().
|
inlinefinalvirtual |
set electric charge
Implements reco::Candidate.
Definition at line 108 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setCharge().
Referenced by PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::TrackToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), PFAlgo::egammaFilters(), pat::GenericParticle::fillInFrom(), l1t::MuonRawDigiTranslator::fillMuonStableQuantities(), PFEGammaAlgo::fillPFCandidates(), MuScleFitFilter::filter(), reco::GsfElectron::GsfElectron(), reco::tau::RecoTauTwoProngFilter::operator()(), l1t::PFCandidate::PFCandidate(), reco::PFTauDecayMode::PFTauDecayMode(), l1t::PFTrack::PFTrack(), ParticleLevelProducer::produce(), TrackstersMergeProducer::produce(), HLTTriMuonIsolation::produce(), TauGenJetProducer::produce(), GenJetGenPartMerger::produce(), GlobalMuonToMuonProducer::produce(), Onia2MuMuPAT::produce(), MuonProducer::produce(), L1TMuonBarrelKalmanAlgo::setFloatingPointValues(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), and reco::writeSpecific().
|
inlinefinalvirtual |
long lived flag set long lived flag
Implements reco::Candidate.
Definition at line 185 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setLongLived().
|
inlinefinalvirtual |
set particle mass
Implements reco::Candidate.
Definition at line 162 of file LeafCandidate.h.
References visualization-live-secondInstance_cfg::m, m_state, and reco::ParticleState::setMass().
|
inlinefinalvirtual |
do mass constraint flag set mass constraint flag
Implements reco::Candidate.
Definition at line 190 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setMassConstraint().
|
inlinefinalvirtual |
set 4-momentum
Implements reco::Candidate.
Definition at line 158 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setP4().
Referenced by l1t::HGCalTower::addEt(), ParticleLevelProducer::addGenJet(), EMEnrichingFilterAlgo::applyBFieldCurv(), HGCalConcentratorSuperTriggerCellImpl::assignSuperTriggerCellEnergyAndPosition(), Phase1L1TJetProducer::buildJetFromSeed(), L1HPSPFTauBuilder::buildL1PFTau(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), l1t::PFJet::calibratePt(), l1t::PFCluster::calibratePt(), HGCalClusteringImpl::calibratePt(), PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), HGCalConcentratorCoarsenerImpl::coarsen(), converter::SuperClusterToCandidate::convert(), converter::TrackToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), GenParticleProducer::convertParticle(), TtFullHadKinFitter::KinFit::corJet(), PFRecoTauDiscriminationByIsolation::discriminate(), PFRecoTauDiscriminationByIsolationContainer::discriminate(), L1JetRecoTreeProducer::doPFMetNoMu(), HGCalConcentratorTrigSumImpl::doSum(), PFAlgo::egammaFilters(), pat::GenericParticle::fillInFrom(), pat::PATMuonProducer::fillMuon(), l1t::MuonRawDigiTranslator::fillMuonStableQuantities(), PFEGammaAlgo::fillPFCandidates(), MuScleFitFilter::filter(), L1GObject::initialize(), OniaPhotonConversionProducer::makePhotonCandidate(), l1t::Stage2Layer2TauAlgorithmFirmwareImp1::merging(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), pat::TriggerObjectStandAlone::packP4(), reco::PFTauDecayMode::PFTauDecayMode(), l1t::Stage2Layer2EGammaAlgorithmFirmwareImp1::processEvent(), L1TPFMetNoMuProducer::produce(), ParticleLevelProducer::produce(), DeltaBetaWeights::produce(), HLTTriMuonIsolation::produce(), TrackstersMergeProducer::produce(), PFLinker::produce(), GenJetGenPartMerger::produce(), GlobalMuonToMuonProducer::produce(), ShiftedPFCandidateProducerByMatchedObject::produce(), CaloTruthCellsProducer::produce(), NoPileUpPFMEtProducer::produce(), ShiftedParticleProducer::produce(), ShiftedPFCandidateProducerForPFMVAMEt::produce(), PuppiPhoton::produce(), pat::PATJetUpdater::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), Onia2MuMuPAT::produce(), NoPileUpPFMEtDataProducer::produce(), reco::PFMETProducerMVA::produce(), SoftKillerProducer::produce(), MuonProducer::produce(), reco::PFCandidate::rescaleMomentum(), HGCalVFEProcessorSums::run(), HGCalConcentratorAutoEncoderImpl::select(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), reco::tau::setChargedHadronP4(), Jet.Jet::setCorrP4(), MEzCalculator::SetLepton(), MEzCalculator::SetMET(), l1t::HGCalTriggerCell::setPt(), l1t::HGCalClusterT< l1t::HGCalCluster >::setPt(), L1MuKBMTrack::setPtEtaPhi(), Phase1L1TJetProducer::subtract9x9Pileup(), l1t::stage2::MPUnpacker_0x10010033::unpack(), l1t::stage2::MPUnpacker_0x10010010::unpack(), l1t::stage2::MPUnpacker::unpack(), l1t::stage2::MPUnpacker_0x1001000b::unpack(), l1t::stage2::EtSumUnpacker_0x10010057::unpack(), l1t::stage2::TauUnpacker::unpack(), l1t::stage2::EtSumUnpacker::unpack(), l1t::stage2::JetUnpacker::unpack(), l1t::stage2::EGammaUnpacker::unpack(), l1t::HGCalClusterT< l1t::HGCalCluster >::updateP4AndPosition(), and VirtualJetProducer::writeJetsWithConstituents().
|
inlinefinalvirtual |
set 4-momentum
Implements reco::Candidate.
Definition at line 160 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setP4().
Referenced by Jet.Jet::setCorrP4().
|
inlinefinalvirtual |
Implements reco::Candidate.
Definition at line 178 of file LeafCandidate.h.
References m_state, pdgId(), and reco::ParticleState::setPdgId().
Referenced by ParticleLevelProducer::addGenJet(), converter::SuperClusterToCandidate::convert(), converter::TrackToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), GenParticleProducer::convertParticle(), pat::GenericParticle::fillInFrom(), PFEGammaAlgo::fillPFCandidates(), V0Fitter::fitAll(), reco::GsfElectron::GsfElectron(), reco::mlpf::makeCandidate(), reco::PFCandidate::PFCandidate(), l1t::PFCluster::PFCluster(), reco::PFRecoTauChargedHadron::PFRecoTauChargedHadron(), reco::PFTauDecayMode::PFTauDecayMode(), ParticleLevelProducer::produce(), L2TauJetsMerger::produce(), TrackstersMergeProducer::produce(), HLTTriMuonIsolation::produce(), GenJetGenPartMerger::produce(), MuonProducer::produce(), reco::RecoTauPiZero::RecoTauPiZero(), reco::PFCandidate::setParticleType(), and reco::tau::RecoTauBuilderConePlugin::setTauQuantities().
|
inlinefinalvirtual |
Implements reco::Candidate.
Definition at line 163 of file LeafCandidate.h.
References m_state, pz(), and reco::ParticleState::setPz().
|
inlinefinalvirtual |
set status word
Implements reco::Candidate.
Definition at line 182 of file LeafCandidate.h.
References m_state, reco::ParticleState::setStatus(), and status().
Referenced by GenParticleProducer::convertParticle(), pat::GenericParticle::fillInFrom(), and reco::PFTauDecayMode::PFTauDecayMode().
|
inlinefinalvirtual |
set electric charge
Implements reco::Candidate.
Definition at line 112 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setThreeCharge().
Referenced by GenParticleProducer::convertParticle().
|
inlineoverridevirtual |
set vertex
Implements reco::Candidate.
Reimplemented in reco::Photon.
Definition at line 173 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setVertex().
Referenced by ParticleLevelProducer::addGenJet(), PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::TrackToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), GenParticleProducer::convertParticle(), PFAlgo::egammaFilters(), pat::GenericParticle::fillInFrom(), PFEGammaAlgo::fillPFCandidates(), reco::GsfElectron::GsfElectron(), OniaPhotonConversionProducer::makePhotonCandidate(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), l1t::PFTrack::PFTrack(), PFConcretePFCandidateProducer::produce(), ParticleLevelProducer::produce(), L2TauPixelTrackMatch::produce(), HLTTriMuonIsolation::produce(), GlobalMuonToMuonProducer::produce(), FastjetJetProducer::produceTrackJets(), CandCommonVertexFitterBase::set(), and CandKinematicVertexFitter::set().
|
inlineoverridevirtual |
return a Ptr to one of the source Candidates ( the candidates used to construct this Candidate)
Reimplemented from reco::Candidate.
Reimplemented in pat::Photon, pat::Tau, reco::PFTau, pat::Electron, pat::Muon, reco::PFCandidate, and reco::LeafRefCandidateT.
Definition at line 103 of file LeafCandidate.h.
|
inlinefinalvirtual |
status word
Implements reco::Candidate.
Definition at line 180 of file LeafCandidate.h.
References m_state, and reco::ParticleState::status().
Referenced by TauDecay_GenParticle::AddPi0Info(), BeamDivergenceVtxGenerator::addSmearedGenParticle(), JetAnaPythia< Jet >::analyze(), TauDecay_GenParticle::Analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), L1Validator::analyze(), L1TrackObjectNtupleMaker::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), JetPartonMatcher::fillAlgoritDefinition(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), BCToEFilterAlgo::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), TopDecaySubset::findLastParticleInChain(), reco::GenParticle::fromHardProcessFinalState(), pat::PATObject< ObjectType >::genParticleById(), GenParticlesHelper::hasAncestor(), HGCalTriggerNtupleGenTau::isChargedHadron(), HGCalTriggerNtupleGenTau::isChargedHadronFromResonance(), reco::GenParticle::isDirectHardProcessTauDecayProductFinalState(), reco::GenParticle::isDirectPromptTauDecayProductFinalState(), HGCalTriggerNtupleGenTau::isGamma(), HGCalTriggerNtupleGenTau::isGoodTau(), HGCalTriggerNtupleGenTau::isIntermediateResonance(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), HGCalTriggerNtupleGenTau::isNeutralPion(), HGCalTriggerNtupleGenTau::isNeutralPionFromResonance(), reco::GenParticle::isPromptFinalState(), HGCalTriggerNtupleGenTau::isStableLepton(), HGCalTriggerNtupleGenTau::isStableNeutralHadron(), GenParticleCustomSelector::operator()(), MCTrackMatcher::produce(), GenVisTauProducer::produce(), PartonSelector::produce(), pat::PATPackedGenParticleProducer::produce(), JetPartonMatcher::produce(), setStatus(), TauValidation::tauDecayChannel(), HistoryBase::traceRecoGenHistory(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
momentum polar angle
Implements reco::Candidate.
Definition at line 150 of file LeafCandidate.h.
References m_state, and reco::ParticleState::theta().
Referenced by FWMuonDetailView::addSceneInfo(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), EMEnrichingFilterAlgo::deltaRxyAtEE(), CaloTower::emEt(), metsig::SignAlgoResolutions::evalPF(), FWECalPFCandidateProxyBuilder::getEt(), FWHCalPFCandidateProxyBuilder::getEt(), CaloTower::hadEt(), reco::tau::PFRecoTauMassPlugin::operator()(), CaloTower::outerEt(), pf2pat::PFMETAlgo::produce(), pat::LeptonJetIsolationAngle::spaceAngle(), heppy::FSRWeightAlgo::weight(), and Tau.Tau::zImpact().
|
inlinefinalvirtual |
electric charge
Implements reco::Candidate.
Definition at line 110 of file LeafCandidate.h.
References m_state, and reco::ParticleState::threeCharge().
Referenced by TopDecaySubset::fillListing().
|
inlineoverridevirtual |
vertex position (overwritten by PF...)
Implements reco::Candidate.
Reimplemented in reco::PFCandidate.
Definition at line 165 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vertex().
Referenced by l1tpf_impl::RegionMapper::addTrack(), ElectronTagProbeAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), PFMEtSignInterfaceBase::compResolution(), reco::TemplatedSecondaryVertex< SV >::computeDist1d(), reco::TemplatedSecondaryVertex< SV >::computeDist2d(), reco::TemplatedSecondaryVertex< SV >::computeDist3d(), PFTauExtractor::depositFromObject(), PFCandWithSuperClusterExtractor::depositFromObject(), reco::CaloJet::detectorP4(), MultiTrackValidatorGenPs::dqmAnalyze(), Tau.Tau::dxy(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), TopDecaySubset::fillListing(), PF_PU_AssoMapAlgos::FindV0Vertex(), BtoCharmDecayVertexMergerT< VTX >::flightDirection(), flightDirection(), AddCorrectionsToGenericMET::getCorrectedCaloMET(), AddCorrectionsToGenericMET::getCorrectedMET(), AddCorrectionsToGenericMET::getCorrectedPFMET(), MuonMETAlgo::GetMuDepDeltas(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), fireworks::makeEveJetCone(), CorrectJet::operator()(), GenParticleCustomSelector::operator()(), reco::LeafRefCandidateT::overlap(), overlap(), EgammaHLTTrackIsolation::photonIsolation(), reco::CaloJet::physicsP4(), position(), reco::VertexCompositePtrCandidate::position(), L1TPFMetNoMuProducer::produce(), L1THLTTauMatching::produce(), pat::PATSecondaryVertexSlimmer::produce(), pat::PATTrackAndVertexUnpacker::produce(), Type1PFMET::run(), btagbtvdeep::vertexD3d(), btagbtvdeep::vertexDxy(), and reco::PFCandidate::vertexLegacy().
|
overridevirtual |
chi-squares
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 47 of file LeafCandidate.cc.
|
overridevirtual |
(i, j)-th element of error matrix, i, j = 0, ... 2
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 53 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
|
inlinefinalvirtual |
return SMatrix
Reimplemented from reco::Candidate.
Definition at line 211 of file LeafCandidate.h.
References fillVertexCovariance(), and visualization-live-secondInstance_cfg::m.
Referenced by reco::VertexCompositePtrCandidate::tError().
|
overridevirtual |
Number of degrees of freedom Meant to be Double32_t for soft-assignment fitters: tracks may contribute to the vertex with fractional weights. The ndof is then = to the sum of the track weights. see e.g. CMS NOTE-2006/032, CMS NOTE-2004/002
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 49 of file LeafCandidate.cc.
|
overridevirtual |
chi-squared divided by n.d.o.f.
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 51 of file LeafCandidate.cc.
|
inlineoverridevirtual |
x coordinate of vertex position
Implements reco::Candidate.
Reimplemented in reco::PFCandidate, and l1t::TkPhiCandidate.
Definition at line 167 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vx().
Referenced by BeamDivergenceVtxGenerator::addSmearedGenParticle(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWSecVertexCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), reco::PFTau::dump(), PFIsolationEstimator::fGetIsolationInRings(), ModelpMSSMFilter::filter(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), and btagbtvdeep::vertexDdotP().
|
inlineoverridevirtual |
y coordinate of vertex position
Implements reco::Candidate.
Reimplemented in reco::PFCandidate, and l1t::TkPhiCandidate.
Definition at line 169 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vy().
Referenced by BeamDivergenceVtxGenerator::addSmearedGenParticle(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWSecVertexCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), reco::PFTau::dump(), PFIsolationEstimator::fGetIsolationInRings(), ModelpMSSMFilter::filter(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), and btagbtvdeep::vertexDdotP().
|
inlineoverridevirtual |
z coordinate of vertex position
Implements reco::Candidate.
Reimplemented in reco::PFCandidate, and l1t::TkPhiCandidate.
Definition at line 171 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vz().
Referenced by BeamDivergenceVtxGenerator::addSmearedGenParticle(), EMEnrichingFilterAlgo::applyBFieldCurv(), FWSecVertexCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), HLTDoubletDZ< T1, T2 >::computeDZ(), PFCandWithSuperClusterExtractor::depositFromObject(), reco::PFTau::dump(), HLTObjectsMonitor::dzFinder(), l1t::TkBsCandidate::dzPhiPair(), PFIsolationEstimator::fGetIsolationInRings(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), HLTTriMuonIsolation::produce(), btagbtvdeep::vertexDdotP(), and egHLT::OffPho::zVtx().
|
inlinefinalvirtual |
rapidity
Implements reco::Candidate.
Definition at line 156 of file LeafCandidate.h.
References rapidity().
Referenced by svgfig.Ellipse::__repr__(), geometryXMLparser.Alignable::pos(), pat::PATPackedGenParticleProducer::produce(), ntupleDataFormat._HitObject::r(), ntupleDataFormat._HitObject::r3D(), pat::MET::shiftedP4(), and pat::MET::shiftedP4_74x().
|
friend |
Definition at line 304 of file LeafCandidate.h.
|
friend |
Definition at line 303 of file LeafCandidate.h.
|
friend |
Definition at line 305 of file LeafCandidate.h.
|
friend |
Definition at line 306 of file LeafCandidate.h.
|
private |
Definition at line 297 of file LeafCandidate.h.
Referenced by boostToCM(), charge(), construct(), energy(), et(), et2(), eta(), longLived(), mass(), massConstraint(), momentum(), mt(), mtSqr(), p(), p4(), pdgId(), phi(), polarP4(), pt(), px(), py(), pz(), rapidity(), setCharge(), setLongLived(), setMass(), setMassConstraint(), setP4(), setPdgId(), setPz(), setStatus(), setThreeCharge(), setVertex(), status(), theta(), threeCharge(), vertex(), vx(), vy(), and vz().