#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 43 of file LeafCandidate.h.
References LeafCandidate(), operator=(), p3, p4(), pdgId(), lumiQueryAPI::q, status(), and badGlobalMuonTaggersAOD_cff::vtx.
|
default |
|
default |
|
override |
|
inlinefinalvirtual |
boost vector to boost a Lorentz vector to the particle center of mass system
Implements reco::Candidate.
Definition at line 106 of file LeafCandidate.h.
References reco::ParticleState::boostToCM(), and m_state.
|
inlinefinalvirtual |
electric charge
Implements reco::Candidate.
Definition at line 91 of file LeafCandidate.h.
References reco::ParticleState::charge(), and m_state.
Referenced by PFTester::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), EwkMuDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), HLTMuonMatchAndPlot::analyze(), ZCounting::analyzeElectrons(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), PFRecoTauDiscriminationByIsolation::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), HPSPFRecoTauAlgorithm::buildOneProng(), HPSPFRecoTauAlgorithm::buildThreeProngs(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), egHLT::OffEle::charge(), pat::MuonMvaEstimator::computeMva(), reco::PFTau::dump(), RecoMuonValidator::MuonME::fill(), EwkElecTauHistManager::fillHistograms(), WMuNuSelector::filter(), WZInterestingEventSelector::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), pat::PATObject< ObjectType >::genParticleById(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), MuonMETAlgo::GetMuDepDeltas(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), reco::tau::disc::mainTrack(), GenParticleCustomSelector::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), WPlusJetsEventSelector::operator()(), reco::operator<<(), reco::LeafRefCandidateT::overlap(), overlap(), PFEGammaFilters::passElectronSelection(), reco::PFTauDecayMode::PFTauDecayMode(), reco::PFRecoTauChargedHadron::print(), PFAlgo::processBlock(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), HLTTriMuonIsolation::produce(), pat::L1MuonMatcher::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), pat::PATLostTracks::produce(), reco::TrackJet::resetCharge(), ClassBasedElectronID::result(), MuScleFitMuonSelector::selectMuons(), TtFullHadHypothesis::setCandidate(), TtFullLepHypothesis::setCandidate(), TtSemiLepHypothesis::setCandidate(), l1t::Muon::setHwCharge(), TtSemiLepHypothesis::setNeutrino(), GsfElectronAlgo::setPixelMatchInfomation(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), FWMuonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), reco::PFCandidate::setTrackRef(), TtSemiEvtSolution::setupHyp(), reco::tau::sumPFCandCharge(), and reco::PFCandidate::translateTypeToPdgId().
|
inlineoverridevirtual |
returns a clone of the Candidate object
Implements reco::Candidate.
Reimplemented in reco::PFJet, reco::CaloJet, reco::JPTJet, reco::PFCandidate, l1extra::L1EtMissParticle, reco::GsfElectron, pat::Jet, reco::IsolatedPixelTrackCandidate, l1extra::L1MuonParticle, reco::GenJet, pat::Tau, reco::SiStripElectron, l1extra::L1JetParticle, l1extra::L1EmParticle, pat::Electron, pat::Muon, reco::PFTauDecayMode, pat::MET, pat::Photon, reco::HcalIsolatedTrackCandidate, reco::PFTau, pat::GenericParticle, reco::VertexCompositePtrCandidate, reco::MET, reco::Photon, pat::PFParticle, pat::CompositeCandidate, reco::NamedCompositeCandidate, pat::Particle, pat::Lepton< reco::BaseTau >, pat::Lepton< reco::GsfElectron >, pat::Lepton< reco::Muon >, reco::TrackJet, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, reco::PFClusterJet, reco::ShallowClonePtrCandidate, reco::VertexCompositeCandidate, reco::GenParticle, reco::EcalIsolatedParticleCandidate, reco::RecoCandidate, reco::BasicJet, reco::Muon, reco::IsolatedPFCandidate, reco::PileUpPFCandidate, reco::CaloRecHitCandidate, reco::RecoChargedCandidate, reco::RecoEcalCandidate, reco::RecoStandAloneMuonCandidate, reco::RecoCaloTowerCandidate, reco::Electron, reco::BaseTau, reco::CaloTau, reco::RecoPFClusterRefCandidate, and reco::RecoChargedRefCandidate.
Definition at line 180 of file LeafCandidate.h.
References mps_fire::i, LeafCandidate(), vertexChi2(), vertexCovariance(), vertexNdof(), and vertexNormalizedChi2().
|
inline |
Definition at line 61 of file LeafCandidate.h.
References daughter(), m_state, mother(), numberOfDaughters(), numberOfMothers(), alignCSCRings::s, AlCaHLTBitMon_QueryRunRegistry::string, and ~LeafCandidate().
return daughter at a given position (throws an exception)
Implements reco::Candidate.
Reimplemented in pat::Jet, reco::NamedCompositeCandidate, reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 40 of file LeafCandidate.cc.
Referenced by reco::CompositePtrCandidate::CompositePtrCandidate(), reco::CompositeRefBaseCandidate::CompositeRefBaseCandidate(), reco::CompositeRefCandidate::CompositeRefCandidate(), construct(), pat::Jet::hoEnergyFraction(), reco::ShallowCloneCandidate::ShallowCloneCandidate(), and reco::ShallowClonePtrCandidate::ShallowClonePtrCandidate().
return daughter at a given position (throws an exception)
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::NamedCompositeCandidate, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 62 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 54 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 48 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
|
inlinefinalvirtual |
energy
Implements reco::Candidate.
Definition at line 110 of file LeafCandidate.h.
References reco::ParticleState::energy(), and m_state.
Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), JetValidation::analyze(), PatTauAnalyzer::analyze(), QcdHighPtDQM::analyze(), TreeWriterForEcalCorrection::analyze(), EwkElecDQM::analyze(), PFCandidateChecker::analyze(), DQMHcalDiJetsAlCaReco::analyze(), SimplePhotonAnalyzer::analyze(), ResolutionCreator::analyze(), PhotonValidatorMiniAOD::analyze(), IsolatedParticlesGeneratedJets::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), PhotonValidator::analyze(), PhotonAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), reco::FlavorHistoryEvent::cache(), reco::helper::CastorJetIDHelper::calculate(), reco::helper::JetIDHelper::calculate(), pat::CaloIsolationEnergy::calculate(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), ElectronEnergyCalibrator::calibrate(), reco::CastorTower::CastorTower(), reco::JPTJet::chargedEmEnergyFraction(), reco::PFJet::chargedEmEnergyFraction(), reco::JPTJet::chargedHadronEnergyFraction(), reco::PFJet::chargedHadronEnergyFraction(), reco::PFJet::chargedMuEnergyFraction(), reco::helper::JetIDHelper::classifyJetComponents(), TauElementsOperators::computeConeSize(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), JetPlusTrackCorrector::correctAA(), L1FastjetCorrector::correction(), L1JPTOffsetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), L1FastjetCorrectorImpl::correction(), L1JPTOffsetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), reco::PFJet::electronEnergyFraction(), metsig::SignAlgoResolutions::ElectronPtResolution(), egHLT::OffPho::energy(), egHLT::OffEle::energy(), CaloTower::energyInHF(), CaloTower::energyInHO(), metsig::SignAlgoResolutions::evalPF(), pat::JetCorrFactorsProducer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), AdHocNTupler::fill(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), DeepBoostedJetTagInfoProducer::fillSVFeatures(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), PFJetIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), PFJetBenchmark::gettrue(), CaloTower::hadP4(), reco::PFJet::HFEMEnergyFraction(), reco::PFJet::HFHadronEnergyFraction(), reco::PFJet::hoEnergyFraction(), HPSPFRecoTauAlgorithm::isNarrowTau(), btagbtvdeep::JetConverter::jetToFeatures(), TauValidation::leadingPionP4(), main(), reco::tau::RecoTauIsolationMasking::mask(), MatchJet::matchCollections(), EGEtScaleSysModifier::modifyObject(), TauValidation::motherP4(), reco::PFJet::muonEnergyFraction(), reco::JPTJet::neutralEmEnergyFraction(), reco::PFJet::neutralEmEnergyFraction(), reco::JPTJet::neutralHadronEnergyFraction(), reco::PFJet::neutralHadronEnergyFraction(), GsfEleDEtaInLinearCut::operator()(), AcceptJet::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(), PFAlgo::processBlock(), FSRWeightProducer::produce(), CaloTowerCandidateCreator::produce(), EgammaHLTCaloTowerProducer::produce(), EgammaHLTPFNeutralIsolationProducer::produce(), pf2pat::PFMETAlgo::produce(), pat::PATPackedCandidateProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), JetPlusTrackProducer::produce(), NoPileUpPFMEtDataProducer::produce(), CastorClusterProducer::produce(), JetPlusTrackProducerAA::produce(), reco::CentralityProducer::produce(), JetIdSelector< T >::produce(), BoostedTopProducer::produce(), SmearedJetProducerT< T >::produce(), Jet.Jet::rawEnergy(), reco::tau::RecoTauIsolationMasking::resolution(), pf2pat::PFIsoDepositAlgo::sameParticle(), ElectronEnergyCalibrator::setEnergyAndSystVarations(), HGCalShowerShape::sigmaRRMean(), TauValidation::spinEffectsZH(), btagbtvdeep::svToFeatures(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), TauValidation::visibleTauEnergy(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
transverse energy
Implements reco::Candidate.
Definition at line 112 of file LeafCandidate.h.
References reco::ParticleState::et(), and m_state.
Referenced by l1t::HGCalTower::addEtEm(), l1t::HGCalTower::addEtHad(), StKinFitter::addKinFitInfo(), PFTester::analyze(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), PatPhotonSimpleAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), ZeePlots::analyze(), EwkDQM::analyze(), WenuPlots::analyze(), SimplePi0DiscAnalyzer::analyze(), HigPhotonJetHLTOfflineSource::analyze(), PhotonValidator::analyze(), PhotonAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoJets(), ExoticaDQM::analyzeMonoMuons(), ExoticaDQM::analyzeMonoPhotons(), EgammaObjects::analyzePhotons(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWMETGlimpseProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), razor::CalcMTR(), reco::helper::JetIDHelper::calculate(), l1t::CaloRegion::CaloRegion(), l1t::CaloTower::CaloTower(), EmDQM::checkGeneratedParticlesRequirement(), TauElementsOperators::computeConeSize(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doCaloMet(), L1JetRecoTreeProducer::doCaloMetBE(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), egHLT::OffPho::et(), egHLT::OffEle::et(), pat::ObjectResolutionCalc::etaBin(), reco::tau::qcuts::etMin_cand(), l1extra::L1EtMissParticle::etMiss(), HLTOfflineDQMTopDiLepton::MonitorDiLepton::fill(), TopDiLeptonOffline::MonitorEnsemble::fill(), AdHocNTupler::fill(), L1TEGammaOffline::fillElectrons(), L1TStage2CaloLayer2Offline::fillJets(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), METAnalyzer::fillMonitorElement(), L1TEGammaOffline::fillPhotons(), WMuNuValidator::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), HighETPhotonsFilterAlgo::filter(), HeavyChHiggsToTauNuSkim::filter(), WMuNuSelector::filter(), PhotonEnrichmentFilter::filter(), ZeeCandidateFilter::filter(), reco::tau::RecoTauQualityCuts::filterGammaCand(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), reco::tau::RecoTauQualityCuts::filterNeutralHadronCand(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), ElectronVPlusJetsIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), HLTRechitInRegionsProducer< T1 >::getEtaPhiRegions(), WtoLNuSelector::getMt(), GsfEleValueMapIsoRhoCut::getRhoCorr(), l1t::HGCalTower::HGCalTower(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), HPSPFRecoTauAlgorithm::isNarrowTau(), l1t::Jet::Jet(), JetVertexMain::Main(), reco::MET::mEtSig(), EGEtScaleSysModifier::modifyObject(), GsfEleValueMapIsoRhoCut::operator()(), GsfEleEmHadD1IsoRhoCut::operator()(), GsfEleTrkPtIsoCut::operator()(), GsfEleTrkPtIsoRhoCut::operator()(), GsfEleDEtaInLinearCut::operator()(), TtDilepLRSignalSelObservables::operator()(), TtSemiLRSignalSelObservables::operator()(), TtHadLRSignalSelObservables::CompareET::operator()(), TtSemiLRSignalSelObservables::CompareET::operator()(), EgammaHLTFilteredObjProducer< OutCollType >::SelectionCut::CutValues::operator()(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), DistortedMETProducer::produce(), ParticleTowerProducer::produce(), JetEnergyShift::produce(), HiL1Subtractor::produce(), JetPlusTrackCorrector::rebuildJta(), L1GObject::setEt(), l1t::CaloRegion::setEtEm(), l1t::CaloTower::setEtEm(), l1t::CaloRegion::setEtHad(), l1t::CaloTower::setEtHad(), l1t::EGamma::setFootprintEt(), l1t::CaloRegion::setHwEtEm(), l1t::CaloTower::setHwEtEm(), l1t::HGCalTower::setHwEtEm(), l1t::CaloRegion::setHwEtHad(), l1t::CaloTower::setHwEtHad(), l1t::HGCalTower::setHwEtHad(), l1t::EGamma::setIsoEt(), L1Analysis::L1AnalysisRecoMet::SetMet(), l1t::EGamma::setRawEt(), FWPhotonDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), PFElectronSelector::spring11Cuts(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), and l1t::Tau::Tau().
|
inlinefinalvirtual |
transverse energy squared (use this for cut!)
Implements reco::Candidate.
Definition at line 114 of file LeafCandidate.h.
References reco::ParticleState::et2(), and m_state.
|
inlinefinalvirtual |
momentum pseudorapidity
Implements reco::Candidate.
Definition at line 137 of file LeafCandidate.h.
References reco::ParticleState::eta(), and m_state.
Referenced by Particle.Particle::__str__(), reco::tau::disc::AbsEta(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), l1t::HGCalTower::addEt(), ZIterativeAlgorithmWithFit::addEvent(), StKinFitter::addKinFitInfo(), reco::tau::RecoTauConstructor::addPiZero(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), reco::tau::RecoTauConstructor::addTauChargedHadron(), GlbMuQualityCutsAnalysis::analyze(), ZMuPtScaleAnalyzer::analyze(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), CMSDAS11DijetAnalyzer::analyze(), JetValidation::analyze(), PatTauAnalyzer::analyze(), PatZjetsJetAnalyzer::analyze(), PFTester::analyze(), TopGenEventAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), RPCRecHitProbability::analyze(), RPCMonitorDigi::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), TreeWriterForEcalCorrection::analyze(), EwkMuDQM::analyze(), testAnalyzer::analyze(), EwkElecDQM::analyze(), PFCandidateChecker::analyze(), DQMHcalDiJetsAlCaReco::analyze(), ZMuMuIsolationAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), QcdPhotonsDQM::analyze(), ElectronMcFakeValidator::analyze(), PatPhotonSimpleAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), ZeePlots::analyze(), EwkDQM::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), WenuPlots::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), JetTester::analyze(), SimplePi0DiscAnalyzer::analyze(), ElectronCalibration::analyze(), MuTriggerAnalyzer::analyze(), TagAndProbeBtagTriggerMonitor::analyze(), ZMuMu_Radiative_analyzer::analyze(), gamma_radiative_analyzer::analyze(), B2GHadronicHLTValidation::analyze(), B2GDoubleLeptonHLTValidation::analyze(), B2GSingleLeptonHLTValidation::analyze(), TopSingleLeptonHLTValidation::analyze(), PhotonValidatorMiniAOD::analyze(), DQMExample_Step1::analyze(), IsolatedParticlesGeneratedJets::analyze(), TopDiLeptonHLTValidation::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), DQMPFCandidateAnalyzer::analyze(), JetAnalyzer_HeavyIons::analyze(), IsoTrackCalib::analyze(), JetAnalyzer::analyze(), PhotonAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), ZCounting::analyzeElectrons(), EgammaObjects::analyzeElectrons(), EgammaObjects::analyzePhotons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::RecoTauVertexAssociator::associatedVertex(), HPSPFRecoTauAlgorithm::associateIsolationCandidates(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWJetLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWMuonLegoProxyBuilder::build(), FWMuonDetailView::build(), FWGenParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWMETProxyBuilder::buildViewType(), reco::helper::JetMuonHitsIDHelper::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), FWMuonBuilder::calculateField(), HiFJGridEmptyAreaCalculator::calculateGridRho(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), QGTagger::calcVariables(), HGCalTriggerCellCalibration::calibrateInMipT(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), HGCalClusteringImpl::calibratePt(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), JetPlusTrackCorrector::canCorrect(), hitfit::LeptonTranslatorBase< ALepton >::CheckEta(), hitfit::JetTranslatorBase< AJet >::CheckEta(), ElectronClassification::classify(), PFMuonAlgo::cleanPunchThroughAndFakes(), compare_l1candidate(), 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(), HGCalTriggerClusterIdentificationBDT::decision(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), reco::GenJet::detectorEta(), L1TStage2CaloLayer2Offline::doesNotOverlapWithHLTObjects(), HLTObjectsMonitor::dzFinder(), l1t::EGamma::EGamma(), metsig::SignAlgoResolutions::ElectronPtResolution(), FWPFCandidateDetailView::eta(), TauL1TPair::eta(), reco::tau::disc::Eta(), egHLT::OffPho::eta(), egHLT::OffEle::eta(), pat::ObjectResolutionCalc::etaBin(), l1t::EtSum::EtSum(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), ZGlobalVsSAIsolationAnalyzer::evaluate(), pat::JetCorrFactorsProducer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), TopSingleLepton::MonitorEnsemble::fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), AdHocNTupler::fill(), ZeePlots::fillEleClassesPlots(), L1TEGammaOffline::fillElectrons(), ZeeCalibration::fillEleInfo(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), L1TStage2CaloLayer2Offline::fillJets(), METAnalyzer::fillMonitorElement(), l1t::MuonRawDigiTranslator::fillMuon(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), L1TEGammaOffline::fillPhotons(), DeepBoostedJetTagInfoProducer::fillSVFeatures(), WMuNuValidator::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), BadParticleFilter::filter(), HeavyChHiggsToTauNuSkim::filter(), WMuNuSelector::filter(), GenHTFilter::filter(), PhotonEnrichmentFilter::filter(), WZInterestingEventSelector::filter(), ZeeCandidateFilter::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), L1Validator::FindBest(), CalibratableTest::findCandidatesInDeltaR(), TtSemiLepHypGenMatch::findMatchingLepton(), TtFullLepHypGenMatch::findMatchingLepton(), PFJetIDSelectionFunctor::firstDataCuts(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), TrackIsoCalculator::getBkgSubTrackIso(), calib::CalibElectron::getCalibModulesWeights(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), ParticleTowerProducer::getNearestTower(), DPFIsolation::getPredictions(), getTheTauJet(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTower::HGCalTower(), l1t::HGCalTriggerCell::HGCalTriggerCell(), l1t::HGCalTriggerSums::HGCalTriggerSums(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), EtaPtBin::inBin(), CosmicSplitterValidation::is_gold_muon(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), PFEGammaFilters::isElectronSafeForJetMET(), muon::isGoodMuon(), cms::MuonTCMETValueMapProducer::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), MuTriggerAnalyzer::IsMuMatchedToHLTMu(), BPhysicsOniaDQM::isMuonInAccept(), PFPhotonIsolationCalculator::isNeutralParticleVetoed(), PFIsolationEstimator::isNeutralParticleVetoed(), EGammaMvaEleEstimator::isoMvaValue(), PFPhotonIsolationCalculator::isPhotonParticleVetoed(), PFIsolationEstimator::isPhotonParticleVetoed(), FWPFCandidateDetailView::isPntInRng(), l1t::Jet::Jet(), Jet.Jet::jetID(), btagbtvdeep::JetConverter::jetToFeatures(), main(), JetVertexMain::Main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), L1MuonMatcherAlgo::match(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), reco::RecoTauPiZero::maxDeltaEta(), DQMExample_Step1::MediumEle(), MuonGmtPair::MuonGmtPair(), ZToMuMuGammaAnalyzer::muonSelection(), ElectronMVAEstimator::mva(), SoftElectronMVAEstimator::mva(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), muonisolation::CaloExtractor::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseHcal(), AcceptJet::operator()(), GenParticleCustomSelector::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), deep_tau::TauWPThreshold::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WPlusJetsEventSelector::operator()(), reco::tau::PFRecoTauChargedHadronFromTrackPlugin::operator()(), hitfit::LeptonTranslatorBase< ALepton >::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::tau::disc::PiZeroEta(), reco::GenericJet::print(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), reco::RecoTauPiZero::print(), PFJetBenchmark::printGenJet(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), PFAlgo::processBlock(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetTracksAssociationDRCalo::produce(), JetVetoedTracksAssociationDRVertex::produce(), DistortedMuonProducerFromDB::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), HLTTriMuonIsolation::produce(), CaloMuonMerger::produce(), pat::BadPFCandidateJetsEEnoiseProducer::produce(), PileupJPTJetIdProducer::produce(), CaloTowerCandidateCreator::produce(), MVAJetPuIdProducer::produce(), EgammaHLTCaloTowerProducer::produce(), ParticleTowerProducer::produce(), MuonReSeeder::produce(), PFLinker::produce(), pat::PATPackedCandidateProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), BoostedTauSeedsProducer::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), CastorClusterProducer::produce(), HiL1Subtractor::produce(), reco::CentralityProducer::produce(), JetIdSelector< T >::produce(), PileupJetIdProducer::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), Jet.Jet::puJetId(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), reco::tau::RecoTauIsolationMasking::resolution(), ElectronLikelihood::result(), ElectronLikelihood::resultLog(), PFPhotonAlgo::RunPFPhoton(), pf2pat::PFIsoDepositAlgo::sameParticle(), L1MuKBMTrack::setCoarseEta(), L1GObject::setEta(), reco::HcalIsolatedTrackCandidate::SetEtaPhiEcal(), reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), reco::HcalIsolatedTrackCandidate::SetEtaPhiHcal(), L1MuKBMTrack::setFineEta(), l1t::L1Candidate::setHwEta(), reco::HcalIsolatedTrackCandidate::setL1(), FWCaloTowerDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), HiFJGridEmptyAreaCalculator::setupGridJet(), cms::MuonMETValueMapProducer::should_type_MuonCandidateValuesUsed(), HGCalShowerShape::sigmaEtaEtaTot(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), l1t::Tau::Tau(), HiFJGridEmptyAreaCalculator::tileIndexEta(), HiFJGridEmptyAreaCalculator::tileIndexEtaJet(), reco::tau::disc::TrackEta(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), HGCalTriggerClusterIdentificationBDT::value(), JVFJetIdProducer::~JVFJetIdProducer(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().
|
overridevirtual |
fill SMatrix
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 83 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
Referenced by vertexCovariance().
|
inline |
get a component
Definition at line 219 of file LeafCandidate.h.
References edm::RefToBase< T >::get(), hasMasterClone(), and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.BetterConfigParser::__updateDict(), util.rrapi.RRApi::columns(), rrapi.RRApi::columns(), util.rrapi.RRApi::count(), rrapi.RRApi::count(), rrapi.RRApi::data(), util.rrapi.RRApi::data(), AdHocNTupler::fill(), betterConfigParser.BetterConfigParser::getCompares(), ElectronLikelihood::getInputVar(), betterConfigParser.BetterConfigParser::getResultingSection(), HLTDiMuonGlbTrkFilter::hltFilter(), reco::operator<<(), rrapi.RRApi::report(), util.rrapi.RRApi::report(), util.rrapi.RRApi::reports(), rrapi.RRApi::reports(), util.rrapi.RRApi::tables(), rrapi.RRApi::tables(), rrapi.RRApi::tags(), util.rrapi.RRApi::tags(), util.rrapi.RRApi::templates(), rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
|
inline |
get a component
Definition at line 224 of file LeafCandidate.h.
References edm::RefToBase< T >::get(), hasMasterClone(), and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.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::getResultingSection(), rrapi.RRApi::report(), util.rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), rrapi.RRApi::tags(), util.rrapi.RRApi::tags(), rrapi.RRApi::templates(), util.rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
get a component
Definition at line 229 of file LeafCandidate.h.
References edm::RefToBase< T >::get(), hasMasterClone(), mps_fire::i, and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.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::getResultingSection(), rrapi.RRApi::report(), util.rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), rrapi.RRApi::tags(), util.rrapi.RRApi::tags(), rrapi.RRApi::templates(), util.rrapi.RRApi::templates(), util.rrapi.RRApi::workspaces(), and rrapi.RRApi::workspaces().
get a component
Definition at line 234 of file LeafCandidate.h.
References edm::RefToBase< T >::get(), hasMasterClone(), mps_fire::i, and masterClone().
Referenced by Options.Options::__getitem__(), betterConfigParser.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::getResultingSection(), rrapi.RRApi::report(), util.rrapi.RRApi::report(), rrapi.RRApi::reports(), util.rrapi.RRApi::reports(), rrapi.RRApi::tables(), util.rrapi.RRApi::tables(), rrapi.RRApi::tags(), util.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 13 of file LeafCandidate.cc.
Referenced by get(), numberOf(), and vertexCovariance().
|
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 17 of file LeafCandidate.cc.
Referenced by vertexCovariance().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 98 of file LeafCandidate.cc.
Referenced by numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 102 of file LeafCandidate.cc.
Referenced by numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::GsfElectron, reco::LeafRefCandidateT, reco::SiStripElectron, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, and reco::Electron.
Definition at line 88 of file LeafCandidate.cc.
Referenced by TtFullLepHypGenMatch::buildHypo(), and numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 92 of file LeafCandidate.cc.
Referenced by Muon.Muon::muonID(), and numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::Jet, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 104 of file LeafCandidate.cc.
Referenced by numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 90 of file LeafCandidate.cc.
Referenced by numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::Photon, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 100 of file LeafCandidate.cc.
Referenced by numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 94 of file LeafCandidate.cc.
Referenced by numberOf().
|
overridevirtual |
Implements reco::Candidate.
Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 96 of file LeafCandidate.cc.
Referenced by numberOf().
|
inlinefinalvirtual |
is long lived?
Implements reco::Candidate.
Definition at line 172 of file LeafCandidate.h.
References reco::ParticleState::longLived(), and m_state.
|
inlinefinalvirtual |
mass
Implements reco::Candidate.
Definition at line 116 of file LeafCandidate.h.
References m_state, and reco::ParticleState::mass().
Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), BPHCompositeBasicSelect::accept(), ZMuPtScaleAnalyzer::analyze(), JetTester::analyze(), B2GDQM::analyzeAllHad(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), BPHKx0ToKPiBuilder::build(), HPSPFRecoTauAlgorithm::buildThreeProngs(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), JetPlusTrackCorrector::correction(), BPHHistoSpecificDecay::endJob(), BPhysicsValidation::ParticleMonitor::Fill(), HSCPTreeBuilder::filter(), V0Fitter::fitAll(), reco::tau::disc::InvariantMassOfSignal(), btagbtvdeep::JetConverter::jetToFeatures(), reco::tau::disc::Mass(), massSqr(), AntiElectronIDMVA5::MVAValue(), CATopJetHelper::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), CAWZJetHelperUser::operator()(), CATopJetHelperUser::operator()(), reco::operator<<(), pat::TriggerObjectStandAlone::packP4(), reco::PFRecoTauChargedHadron::print(), WeakEffectsWeightProducer::produce(), DistortedMuonProducerFromDB::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), ISRGammaWeightProducer::produce(), FSRWeightProducer::produce(), HLTTriMuonIsolation::produce(), PdfWeightProducer::produce(), Onia2MuMuPAT::produce(), BoostedTauSeedsProducer::produce(), PatJPsiProducer::produce(), btagbtvdeep::svToFeatures(), heppy::FSRWeightAlgo::weight(), BPHMassSelect::~BPHMassSelect(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().
|
inlinefinalvirtual |
do mass constraint?
Implements reco::Candidate.
Definition at line 177 of file LeafCandidate.h.
References m_state, and reco::ParticleState::massConstraint().
Referenced by CandKinematicVertexFitter::fill().
|
inlinefinalvirtual |
mass squared
Implements reco::Candidate.
Definition at line 118 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(), numberOf(), and vertexCovariance().
|
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 22 of file LeafCandidate.cc.
References Exception.
Referenced by vertexCovariance().
|
inline |
cast master clone reference to a concrete type
Definition at line 216 of file LeafCandidate.h.
References masterClone().
|
inlinefinalvirtual |
spatial momentum vector
Implements reco::Candidate.
Definition at line 103 of file LeafCandidate.h.
References m_state, and reco::ParticleState::momentum().
Referenced by PFRecoTauAlgorithm::buildPFTau(), closestJet(), PFTauExtractor::depositFromObject(), TauElementsOperators::discriminatorByIsolTracksN(), MultiTrackValidatorGenPs::dqmAnalyze(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), PF_PU_AssoMapAlgos::FindV0Vertex(), reco::TrackSelector::operator()(), MuonWithPFIsoProducer::produce(), EgammaHLTPFChargedIsolationProducer::produce(), EgammaHLTPFNeutralIsolationProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), SoftLepton::refineJetAxis(), TauElementsOperators::replaceSubStr(), 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::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 44 of file LeafCandidate.cc.
Referenced by construct().
|
inlinefinalvirtual |
transverse mass
Implements reco::Candidate.
Definition at line 121 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 123 of file LeafCandidate.h.
References m_state, and reco::ParticleState::mtSqr().
|
inline |
number of components
Definition at line 239 of file LeafCandidate.h.
References hasMasterClone(), and masterClone().
|
inline |
number of components
Definition at line 244 of file LeafCandidate.h.
References hasMasterClone(), isCaloMuon(), isConvertedPhoton(), isElectron(), isGlobalMuon(), isJet(), isMuon(), isPhoton(), isStandAloneMuon(), isTrackerMuon(), and masterClone().
|
overridevirtual |
number of daughters
Implements reco::Candidate.
Reimplemented in pat::Jet, reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 28 of file LeafCandidate.cc.
Referenced by construct().
|
overridevirtual |
number of mothers
Implements reco::Candidate.
Reimplemented in reco::LeafRefCandidateT, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.
Definition at line 32 of file LeafCandidate.cc.
Referenced by construct().
|
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 83 of file LeafCandidate.h.
|
default |
Referenced by LeafCandidate(), and 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::GsfElectron, reco::CaloJet, reco::IsolatedPixelTrackCandidate, reco::JPTJet, reco::LeafRefCandidateT, reco::SiStripElectron, reco::HcalIsolatedTrackCandidate, reco::GenParticle, reco::GenJet, reco::GenMET, reco::CaloMET, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::MET, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, reco::TrackJet, reco::CaloTau, reco::ME0Muon, reco::PFClusterJet, reco::Electron, reco::BaseTau, reco::BasicJet, reco::CaloRecHitCandidate, reco::RecoChargedCandidate, reco::RecoEcalCandidate, reco::RecoStandAloneMuonCandidate, reco::RecoCaloTowerCandidate, and reco::RecoCandidate.
Definition at line 36 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 108 of file LeafCandidate.h.
References m_state, and reco::ParticleState::p().
Referenced by ElectronMcSignalValidatorMiniAOD::analyze(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), HiggsDQM::analyze(), ElectronCalibrationUniv::analyze(), JetTagPlotter::analyzeTag(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), DeepTauId::calculateGottfriedJacksonAngleDifference(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), PFMuonAlgo::cleanPunchThroughAndFakes(), reco::CompositeCandidate::CompositeCandidate(), CaloTower::emP4(), RecoMuonValidator::MuonME::fill(), reco::tau::fillIsoMVARun2Inputs(), GreedyMuonPFCandidateFilter::filter(), HSCPTreeBuilder::filter(), CaloTower::hadP4(), HLTMuonTrackMassFilter::hltFilter(), BPhysicsOniaDQM::isMuonInAccept(), TauValidation::leadingPionP4(), SoftElectronMVAEstimator::mva(), EGammaMvaEleEstimatorCSA14::mvaValue(), EGammaMvaEleEstimator::mvaValue(), reco::NamedCompositeCandidate::NamedCompositeCandidate(), AcceptJet::operator()(), CaloTower::p4(), CaloTower::p4_HO(), reco::GenericJet::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), and Electron.Electron::ptErr().
|
inlinefinalvirtual |
four-momentum Lorentz vector
Implements reco::Candidate.
Definition at line 99 of file LeafCandidate.h.
References m_state, and reco::ParticleState::p4().
Referenced by reco::tau::RecoTauConstructor::addPiZero(), reco::tau::RecoTauConstructor::addTauChargedHadron(), PFCandConnector::analyseNuclearWPrim(), PFCandConnector::analyseNuclearWSec(), CMSDAS11DijetAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), QcdHighPtDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ResolutionCreator::analyze(), MuonPFAnalyzer::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), HLTMuonMatchAndPlot::analyze(), B2GDQM::analyzeAllHad(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), EmbeddingLHEProducer::assign_4vector(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), TtSemiLepJetComb::bOverLightQPt(), TtSemiLepJetComb::bQuarkVar(), FWVertexCandidateProxyBuilder::build(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), HPSPFRecoTauAlgorithm::buildOneProng(), HPSPFRecoTauAlgorithm::buildThreeProngs(), DeepTauId::calculateGottfriedJacksonAngleDifference(), BJetEnergyRegressionVarProducer< T >::calculatePtRatioRelSimple(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), reco::tau::disc::ChargedOutlierAngle(), TtSemiLepJetComb::compareBNeutrino(), TtSemiLepJetComb::compareLeptonNeutrino(), TtSemiLepJetComb::compareTopNeutrino(), TtSemiLepJetComb::compareWNeutrino(), PFMEtSignInterfaceBase::compResolution(), pat::MuonMvaEstimator::computeMva(), TtFullHadKinFitter::KinFit::corJet(), pat::Jet::correctedP4(), pat::Tau::correctedP4(), TauJetCorrector::correction(), ZSPJPTJetCorrector::correction(), LXXXCorrector::correction(), LXXXCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), reco::GsfElectron::Corrections::Corrections(), PFElectronTranslator::createGsfElectrons(), DeepTauId::createInputs(), TtSemiLepJetComb::deduceMothers(), PFRecoTauDiscriminationByIsolation::discriminate(), Tau.Tau::dxy_approx(), Tau.Tau::dz(), l1t::EGamma::EGamma(), CaloTower::emEt(), reco::Photon::EnergyCorrections::EnergyCorrections(), ErsatzMEt::ersatzFabrik(), CaloTower::et(), l1t::EtSum::EtSum(), BJetEnergyRegressionMVA::fillAdditionalVariables(), JetPartonMatcher::fillAlgoritDefinition(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), pat::CaloJetSelector::filter(), VBFGenJetFilter::filter(), HLTRHemisphere::filter(), VBFGenJetFilter::filterGenJets(), DeepTauId::findMatchedElectron(), reco::Photon::getCandidateP4type(), GeneratorTau::getOpeningAngle(), DPFIsolation::getPredictions(), TauSpinnerCMS::GetRecoDaughters(), pat::PATMuonProducer::getRelMiniIsoPUCorrected(), GeneratorTau::getVisNuAngle(), CaloTower::hadEt(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTriggerCell::HGCalTriggerCell(), l1t::HGCalTriggerSums::HGCalTriggerSums(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), reco::tau::RecoTauIsolationMasking::inCone(), l1t::Jet::Jet(), reco::tau::disc::JetTauDR(), LeafCandidate(), TtSemiLepJetComb::lightQVar(), reco::tau::disc::MainTrackAngle(), ZToMuMuGammaAnalyzer::mumuGammaInvMass(), ZToMuMuGammaAnalyzer::mumuInvMass(), MuonMETAlgo::MuonMETAlgo_run(), reco::tau::disc::NeutralOutlierAngle(), TtSemiLepJetComb::neutrinoVar(), reco::tau::disc::OpeningAngle3D(), reco::tau::disc::OpeningDeltaR(), pat::RawJetExtractorT< pat::Jet >::operator()(), CorrectJet::operator()(), reco::tau::RecoTauPhotonFilter::operator()(), TtDilepLRSignalSelObservables::operator()(), PFJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), JetCleanerForType1MET_namespace::RawJetExtractorT< pat::Jet >::operator()(), CaloJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), TtHadLRJetCombObservables::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin2::operator()(), TtSemiLRJetCombObservables::operator()(), CalculateHLT::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), JetIDSelectionFunctor::operator()(), reco::operator<<(), CaloTower::outerEt(), reco::tau::disc::OutlierAngle(), reco::LeafRefCandidateT::overlap(), overlap(), CaloTower::p(), CaloTower::p4(), Lepton.Lepton::p4WithFSR(), reco::PFTauDecayMode::PFTauDecayMode(), reco::Photon::Photon(), reco::tau::disc::PiZeroAngle(), DeepTauId::processIsolationPFComponents(), DeepTauId::processSignalPFComponents(), L1TPFMetNoMuProducer::produce(), QuarkoniaTrackSelector::produce(), L1THLTTauMatching::produce(), ISRGammaWeightProducer::produce(), L1HLTTauMatching::produce(), HLTTriMuonIsolation::produce(), pat::PATSecondaryVertexSlimmer::produce(), JetTracksAssociationToTrackRefs::produce(), PFJetsTauOverlapRemoval::produce(), DeltaBetaWeights::produce(), Type0PFMETcorrInputProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), TruthTauDecayModeProducer::produce(), reco::PFMETProducerMVA::produce(), MuonProducer::produce(), BoostedDoubleSVProducer::produce(), TauSpinnerCMS::readParticlesfromReco(), TtSemiLepJetComb::relativePtHadronicTop(), reco::PFCandidate::rescaleMomentum(), TtFullHadHypothesis::setCandidate(), TtFullLepHypothesis::setCandidate(), TtSemiLepHypothesis::setCandidate(), reco::GsfElectron::setCorrectedEcalEnergy(), pat::PATMuonProducer::setMuonMiniIso(), reco::GsfElectron::setP4(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), TtSemiEvtSolution::setupHyp(), reco::tau::RecoTauConstructor::sortAndCopyIntoTau(), reco::tau::sumPFCandP4(), l1t::Tau::Tau(), reco::tau::disc::TrackAngle(), reco::GsfElectron::trackMomentumError(), pat::TriggerObjectStandAlone::triggerObject(), l1t::HGCalClusterT< l1t::HGCalCluster >::updateP4AndPosition(), reco::VertexCompositeCandidate::VertexCompositeCandidate(), reco::VertexCompositePtrCandidate::VertexCompositePtrCandidate(), and NoPileUpPFMEtDataProducer::~NoPileUpPFMEtDataProducer().
|
inlinefinalvirtual |
PDG identifier.
Implements reco::Candidate.
Definition at line 161 of file LeafCandidate.h.
References m_state, and reco::ParticleState::pdgId().
Referenced by Particle.Particle::__str__(), MCTruthHelper< P >::absPdgId(), TopDecaySubset::addRadiation(), TauDecay_GenParticle::AddRadInfo(), zPdfUnc::analyze(), EWKSystUnc::analyze(), ZLONLOHistogrammer::analyze(), ZMuPtScaleAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), PFTester::analyze(), TauDecay_GenParticle::Analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), L1Validator::analyze(), ExoticaDQM::analyzeDisplacedJets(), ExoticaDQM::analyzeDisplacedLeptons(), TauDecay_GenParticle::AnalyzeTau(), HPSPFRecoTauAlgorithm::applyElectronRejection(), reco::PFCandidate::bestTrack(), TtFullHadHypGenMatch::buildHypo(), TtSemiLepHypGenMatch::buildHypo(), PFCandidateStripMerger::candidateMatches(), TopDecaySubset::checkShowerModel(), GeneratorTau::computeDecayMode(), TauValidation::countParticles(), TopGenEvent::daughterQuarkOfTop(), GeneratorTau::decayToPDGClassification(), PFIsolationEstimator::fGetIsolationInRings(), CandKinematicVertexFitter::fill(), BPhysicsValidation::ParticleMonitor::Fill(), JetPartonMatcher::fillAlgoritDefinition(), BPhysicsValidation::FillDaughters(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), DYToMuMuGenFilter::filter(), HeavyQuarkFromMPIFilterAlgo::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), HighETPhotonsFilterAlgo::filter(), ChargedHadronTrackResolutionFilter::filter(), MuonBadTrackFilter::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), TauValidation::findFSRandBrem(), GenHFHadronMatcher::findHadronJets(), TopDecaySubset::findLastParticleInChain(), TauValidation::findMother(), GenParticlesHelper::findParticles(), 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(), doubleEMEnrichingFilterAlgo::isBCBaryon(), BCToEFilterAlgo::isBCMeson(), doubleEMEnrichingFilterAlgo::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(), LeafCandidate(), BasicGenParticleValidation::matchParticles(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), reco::RecoTauPiZero::numberOfElectrons(), reco::RecoTauPiZero::numberOfGammas(), GenParticleCustomSelector::operator()(), TtDilepLRSignalSelObservables::operator()(), reco::PFCandidate::particleId(), MCTruthHelper< P >::pdgId(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), WeakEffectsWeightProducer::produce(), ISRGammaWeightProducer::produce(), ISRWeightProducer::produce(), FSRWeightProducer::produce(), PdfWeightProducer::produce(), GenVisTauProducer::produce(), HLTTauMCProducer::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATLostTracks::produce(), PartonSelector::produce(), JetPartonMatcher::produce(), TauSpinnerCMS::readParticlesfromReco(), btagbtvdeep::recoCandidateToFeatures(), setPdgId(), TauValidation::spinEffectsZH(), TauValidation::tauMother(), toTrackRef(), HistoryBase::traceRecoGenHistory(), pat::TriggerObjectStandAlone::triggerObject(), reco::VertexCompositeCandidate::VertexCompositeCandidate(), reco::VertexCompositePtrCandidate::VertexCompositePtrCandidate(), TauValidation::visibleTauEnergy(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
momentum azimuthal angle
Implements reco::Candidate.
Definition at line 133 of file LeafCandidate.h.
References m_state, and reco::ParticleState::phi().
Referenced by Particle.Particle::__str__(), reco::WMuNuCandidate::acop(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), l1t::HGCalTower::addEt(), ZIterativeAlgorithmWithFit::addEvent(), reco::tau::RecoTauConstructor::addPiZero(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), reco::tau::RecoTauConstructor::addTauChargedHadron(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), CMSDAS11DijetAnalyzer::analyze(), PatTauAnalyzer::analyze(), PatZjetsJetAnalyzer::analyze(), PFTester::analyze(), TopGenEventAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), RPCRecHitProbability::analyze(), CaloTowerAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), PFCandidateChecker::analyze(), ZMuMuIsolationAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), QcdPhotonsDQM::analyze(), PatPhotonSimpleAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), ZeePlots::analyze(), EwkDQM::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), WenuPlots::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), JetTester::analyze(), SimplePi0DiscAnalyzer::analyze(), TagAndProbeBtagTriggerMonitor::analyze(), ZMuMu_Radiative_analyzer::analyze(), METTester::analyze(), PhotonValidatorMiniAOD::analyze(), DQMExample_Step1::analyze(), IsolatedParticlesGeneratedJets::analyze(), HigPhotonJetHLTOfflineSource::analyze(), METplusTrackMonitor::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), ObjMonitor::analyze(), TopMonitor::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), DQMPFCandidateAnalyzer::analyze(), METMonitor::analyze(), HTMonitor::analyze(), JetAnalyzer_HeavyIons::analyze(), JetAnalyzer::analyze(), ErsatzMEt::analyze(), PhotonAnalyzer::analyze(), B2GDQM::analyzeAllHad(), ZCounting::analyzeElectrons(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoJets(), ExoticaDQM::analyzeMonoMuons(), ExoticaDQM::analyzeMonoPhotons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), JetTracksAssociationXtrpCalo::associateInputTracksToJet(), HPSPFRecoTauAlgorithm::associateIsolationCandidates(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWJetLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWL1EtMissParticleLegoProxyBuilder::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWMETGlimpseProxyBuilder::build(), FWMETLegoProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWMuonLegoProxyBuilder::build(), FWMuonDetailView::build(), FWL1EmParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::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(), PFMETBenchmark::calculateQuantities(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), QGTagger::calcVariables(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), HGCalClusteringImpl::calibratePt(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), compare_l1candidate(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), L1JetRecoTreeProducer::doCaloMet(), L1JetRecoTreeProducer::doCaloMetBE(), L1TStage2CaloLayer2Offline::doesNotOverlapWithHLTObjects(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), EcalDeadCellDeltaRFilter::dPhiToMETfunc(), HLTObjectsMonitor::dzFinder(), l1t::EGamma::EGamma(), l1t::EtSum::EtSum(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), ZGlobalVsSAIsolationAnalyzer::evaluate(), pat::JetCorrFactorsProducer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), AdHocNTupler::fill(), L1TEGammaOffline::fillElectrons(), ZeeCalibration::fillEleInfo(), JetDQM::fillHistograms(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), L1TStage2CaloLayer2Offline::fillJets(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), METAnalyzer::fillMonitorElement(), l1t::MuonRawDigiTranslator::fillMuon(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), L1TEGammaOffline::fillPhotons(), WMuNuValidator::filter(), BadParticleFilter::filter(), HeavyChHiggsToTauNuSkim::filter(), WZInterestingEventSelector::filter(), ZeeCandidateFilter::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), L1Validator::FindBest(), CalibratableTest::findCandidatesInDeltaR(), TtSemiLepHypGenMatch::findMatchingLepton(), TtFullLepHypGenMatch::findMatchingLepton(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), WtoLNuSelector::getMt(), ParticleTowerProducer::getNearestTower(), DPFIsolation::getPredictions(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTower::HGCalTower(), l1t::HGCalTriggerCell::HGCalTriggerCell(), l1t::HGCalTriggerSums::HGCalTriggerSums(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), tnp::BaseTreeFiller::init(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), PFPhotonIsolationCalculator::isNeutralParticleVetoed(), PFIsolationEstimator::isNeutralParticleVetoed(), EGammaMvaEleEstimator::isoMvaValue(), PFPhotonIsolationCalculator::isPhotonParticleVetoed(), PFIsolationEstimator::isPhotonParticleVetoed(), FWPFCandidateDetailView::isPntInRng(), l1t::Jet::Jet(), TauL1TPair::l1tPhi(), main(), JetVertexMain::Main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), L1MuonMatcherAlgo::match(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), MuonGmtPair::MuonGmtPair(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WPlusJetsEventSelector::operator()(), reco::tau::PFRecoTauChargedHadronFromTrackPlugin::operator()(), JetIDStudiesSelector::operator()(), reco::operator<<(), operator<<(), pat::TriggerObjectStandAlone::packP4(), PFEGammaFilters::passElectronSelection(), PFEGammaFilters::passPhotonSelection(), FWPFCandidateDetailView::phi(), TauL1TPair::phi(), egHLT::OffPho::phi(), egHLT::OffEle::phi(), MuonIdProducer::phiOfMuonIneteractionRegion(), ntupleDataFormat.Track::phiPull(), reco::GenericJet::print(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), reco::RecoTauPiZero::print(), PFJetBenchmark::printGenJet(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), PFAlgo::processBlock(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetTracksAssociationDRCalo::produce(), DistortedMETProducer::produce(), JetVetoedTracksAssociationDRVertex::produce(), DistortedMuonProducerFromDB::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), RegressionEnergyPatElectronProducer::produce(), FSRWeightProducer::produce(), PileupJPTJetIdProducer::produce(), CaloTowerCandidateCreator::produce(), EgammaHLTCaloTowerProducer::produce(), MVAJetPuIdProducer::produce(), ParticleTowerProducer::produce(), MuonReSeeder::produce(), pf2pat::PFMETAlgo::produce(), NoPileUpPFMEtProducer::produce(), pat::PATPackedCandidateProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), BoostedTauSeedsProducer::produce(), reco::PFMETProducerMVA::produce(), CastorClusterProducer::produce(), PileupJetIdProducer::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), reco::tau::RecoTauIsolationMasking::resolution(), 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(), FWCaloTowerDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), HGCalShowerShape::sigmaPhiPhiTot(), pat::LeptonJetIsolationAngle::spaceAngle(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), l1t::Tau::Tau(), HiFJGridEmptyAreaCalculator::tileIndexPhi(), reco::IsolatedPixelTrackCandidate::towerIndex(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), heppy::FSRWeightAlgo::weight(), JVFJetIdProducer::~JVFJetIdProducer(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().
|
inlinefinalvirtual |
four-momentum Lorentz vector
Implements reco::Candidate.
Definition at line 101 of file LeafCandidate.h.
References m_state, and reco::ParticleState::polarP4().
Referenced by pat::L1MuonMatcher::produce(), and pat::PATPackedCandidateProducer::produce().
|
inlinefinalvirtual |
transverse momentum
Implements reco::Candidate.
Definition at line 131 of file LeafCandidate.h.
References m_state, and reco::ParticleState::pt().
Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), l1t::HGCalTower::addEt(), StKinFitter::addKinFitInfo(), reco::tau::RecoTauConstructor::addPiZero(), reco::tau::RecoTauConstructor::addTauChargedHadron(), GlbMuQualityCutsAnalysis::analyze(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), JetValidation::analyze(), CMSDAS11DijetAnalyzer::analyze(), PatTauAnalyzer::analyze(), PatZjetsJetAnalyzer::analyze(), TopGenEventAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), RPCRecHitProbability::analyze(), QcdHighPtDQM::analyze(), RPCMonitorDigi::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), EwkMuDQM::analyze(), testAnalyzer::analyze(), SUSYDQMAnalyzer::analyze(), EwkElecDQM::analyze(), ZMuMuIsolationAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), QcdPhotonsDQM::analyze(), ElectronMcFakeValidator::analyze(), EwkDQM::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), MuonPFAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), JetTester::analyze(), MuTriggerAnalyzer::analyze(), HiggsDQM::analyze(), TagAndProbeBtagTriggerMonitor::analyze(), gamma_radiative_analyzer::analyze(), ZMuMu_Radiative_analyzer::analyze(), B2GDoubleLeptonHLTValidation::analyze(), B2GSingleLeptonHLTValidation::analyze(), B2GHadronicHLTValidation::analyze(), TopSingleLeptonHLTValidation::analyze(), METTester::analyze(), IsolatedParticlesGeneratedJets::analyze(), DQMExample_Step1::analyze(), TopDiLeptonHLTValidation::analyze(), METplusTrackMonitor::analyze(), L1GenTreeProducer::analyze(), ObjMonitor::analyze(), TopMonitor::analyze(), HLTMuonMatchAndPlot::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), DQMPFCandidateAnalyzer::analyze(), METMonitor::analyze(), JetAnalyzer_HeavyIons::analyze(), IsoTrackCalib::analyze(), JetAnalyzer::analyze(), ErsatzMEt::analyze(), ZToMuMuGammaAnalyzer::analyze(), BeamHaloAnalyzer::analyze(), B2GDQM::analyzeAllHad(), ExoticaDQM::analyzeDisplacedLeptons(), ZCounting::analyzeElectrons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), HPSPFRecoTauAlgorithm::buildOneProng(), PFRecoTauAlgorithm::buildPFTau(), HPSPFRecoTauAlgorithm::buildThreeProngs(), reco::helper::JetIDHelper::calculate(), pat::LeptonJetIsolationAngle::calculate(), GlobalHaloAlgo::Calculate(), FWMuonBuilder::calculateField(), HiFJGridEmptyAreaCalculator::calculateGridRho(), LeptonJetVarProducer< T >::calculatePtRatioRel(), BJetEnergyRegressionVarProducer< T >::calculatePtRatioRel(), PFMETBenchmark::calculateQuantities(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), HGCalClusteringImpl::calibratePt(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), Photon.Photon::calScaledIsoValueExp(), Photon.Photon::calScaledIsoValueLin(), Photon.Photon::calScaledIsoValueQuadr(), reco::tau::disc::ChargedOutlierPt(), PFMuonAlgo::cleanMismeasured(), PFMuonAlgo::cleanPunchThroughAndFakes(), MuonPFAnalyzer::combRelIso(), btagbtvdeep::commonCandidateToFeatures(), CMSDAS11DijetAnalyzer::compare_JetPt(), CMSDAS11DijetTestAnalyzer::compare_JetPt(), compare_l1candidate(), 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(), CutBasedPhotonIDAlgo::decideEB(), CutBasedPhotonIDAlgo::decideEE(), HGCalTriggerClusterIdentificationBDT::decision(), PFCandWithSuperClusterExtractor::depositFromObject(), reco::PFTau::dump(), HLTObjectsMonitor::dzFinder(), l1t::EGamma::EGamma(), WZInterestingEventSelector::electronSelection(), reco::tau::disc::EMFraction(), l1t::EtSum::EtSum(), metsig::SignAlgoResolutions::evalPFJet(), pat::JetCorrFactorsProducer::evaluate(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), TopSingleLepton::MonitorEnsemble::fill(), L1ValidatorHists::Fill(), TopDiLeptonOffline::MonitorEnsemble::fill(), RecoMuonValidator::MuonME::fill(), AdHocNTupler::fill(), JetPartonMatcher::fillAlgoritDefinition(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), reco::tau::fillIsoMVARun2Inputs(), JetMETHLTOfflineSource::fillMEforTriggerNTfired(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), DeepBoostedJetTagInfoProducer::fillSVFeatures(), reco::tau::RecoTauPhotonFilter::filter(), HLTHcalMETNoiseCleaner::filter(), WMuNuValidator::filter(), BadParticleFilter::filter(), MuonBadTrackFilter::filter(), InconsistentMuonPFCandidateFilter::filter(), WMuNuSelector::filter(), GenHTFilter::filter(), NJetsMC::filter(), WZInterestingEventSelector::filter(), LeptonRecoSkim::filter(), HSCPTreeBuilder::filter(), PhotonMVAEstimator::findCategory(), ElectronMVAEstimatorRun2::findCategory(), DeepTauId::findMatchedElectron(), MuonVPlusJetsIDSelectionFunctor::firstDataCuts(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), DPFIsolation::getPredictions(), getTheElectron(), getTheMuon(), getTheTauJet(), L1TTauOffline::getTightMuons(), PFCandidateChecker::greaterPt(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTriggerCell::HGCalTriggerCell(), l1t::HGCalTriggerSums::HGCalTriggerSums(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTHcalNoiseFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), EtaPtBin::inBin(), tnp::BaseTreeFiller::init(), reco::tau::xclean::CrossCleanPtrs< PtrIter >::initialize(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), cms::MuonTCMETValueMapProducer::isGoodCaloMuon(), muon::isGoodMuon(), cms::MuonTCMETValueMapProducer::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), HiGammaJetSignalDef::IsIsolated(), muon::isLooseTriggerMuon(), EwkMuLumiMonitorDQM::IsMuMatchedToHLTMu(), MuTriggerAnalyzer::IsMuMatchedToHLTMu(), BPhysicsOniaDQM::isMuonInAccept(), reco::tau::disc::IsolationChargedSumHard(), reco::tau::disc::IsolationChargedSumSoft(), reco::tau::disc::IsolationECALSumHard(), reco::tau::disc::IsolationECALSumSoft(), EGammaMvaEleEstimator::isoMvaValue(), PFEGammaFilters::isPhotonSafeForJetMET(), GsfElectronAlgo::isPreselected(), l1t::Jet::Jet(), DQMPFCandidateAnalyzer::jetSortingRule(), JetAnalyzer::jetSortingRule(), btagbtvdeep::JetConverter::jetToFeatures(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), TauL1TPair::l1tPt(), main(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), PFPhotonIsolationCalculator::matchPFObject(), 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(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), reco::tau::disc::NeutralOutlierPt(), GsfEleEffAreaPFIsoCut::operator()(), PhoAnyPFIsoWithEAAndQuadScalingCut::operator()(), GsfEleRelPFIsoScaledCut::operator()(), PhoAnyPFIsoWithEAAndExpoScalingCut::operator()(), PhoAnyPFIsoWithEAAndExpoScalingEBCut::operator()(), PhoAnyPFIsoWithEACut::operator()(), GsfEleCalPFClusterIsoCut::operator()(), GenJetSort::operator()(), reco::TrackSelector::operator()(), AcceptJet::operator()(), GenParticleCustomSelector::operator()(), BasicJetSort::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), CaloJetSort::operator()(), deep_tau::TauWPThreshold::operator()(), TtHadLRJetCombObservables::operator()(), L2TauJetsMerger::SorterByPt::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WSelector::operator()(), TtSemiLepSignalSelMVATrainer::JetwithHigherPt::operator()(), WPlusJetsEventSelector::operator()(), ZElectronsSelector::operator()(), TtSemiLRJetCombObservables::operator()(), WMuNuProducer::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin::operator()(), reco::tau::PFRecoTauChargedHadronFromTrackPlugin::operator()(), AlignmentMuonSelector::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), HPSPFRecoTauAlgorithm::HPSTauPtSorter::operator()(), MuScleFitUtils::byPt::operator()(), l1t::HGCalTower::operator+=(), reco::operator<<(), l1t::operator>(), reco::tau::disc::OutlierPt(), muon::overlap(), pat::TriggerObjectStandAlone::packP4(), BadGlobalMuonTagger::partnerId(), PFEGammaFilters::passElectronSelection(), ElectronIdentifier::passID(), PhotonSelectorAlgo::passPhotonSelection(), PFEGammaFilters::passPhotonSelection(), EgammaCutBasedEleId::PassTriggerCuts(), PhotonAnalyzer::photonSelection(), PhotonAnalyzer::photonSelectionSlimmed(), reco::tau::disc::PiZeroPt(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), PatJetAnalyzer::print(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), reco::RecoTauPiZero::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), PFAlgo::processBlock(), DeepTauId::processSignalPFComponents(), DistortedMuonProducerFromDB::produce(), MuonWithPFIsoProducer::produce(), DistortedPFCandProducer::produce(), QuarkoniaTrackSelector::produce(), DistortedMuonProducer::produce(), L1THLTTauMatching::produce(), RegressionEnergyPatElectronProducer::produce(), L1HLTTauMatching::produce(), ISRWeightProducer::produce(), HLTTriMuonIsolation::produce(), reco::ParticleFlowForChargedMETProducer::produce(), pat::BadPFCandidateJetsEEnoiseProducer::produce(), CaloMuonMerger::produce(), PileupJPTJetIdProducer::produce(), MVAJetPuIdProducer::produce(), QjetsAdder::produce(), MuonReSeeder::produce(), MuonMETcorrInputProducer::produce(), EgammaHLTPFChargedIsolationProducer::produce(), EgammaHLTPFNeutralIsolationProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), pat::PATPackedCandidateProducer::produce(), WMuNuProducer::produce(), BoostedTauSeedsProducer::produce(), AlCaHcalNoiseProducer::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), reco::PFMETProducerMVA::produce(), reco::CentralityProducer::produce(), PileupJetIdProducer::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), TauL1TPair::pt(), reco::tau::disc::Pt(), egHLT::OffPho::pt(), Electron.Electron::ptErr(), reco::tau::qcuts::ptMin_cand(), ntupleDataFormat.Track::ptPull(), MuonIsolationDQM::RecordData(), reco::tau::RecoTauPhotonFilter::RecoTauPhotonFilter(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), ElectronLikelihood::result(), ElectronLikelihood::resultLog(), reco::tau::disc::ScaledOpeningDeltaR(), Jet.Jet::setCorrP4(), muon::setCutBasedSelectorFlags(), l1t::L1Candidate::setHwPt(), l1t::CaloCluster::setHwPtEm(), l1t::CaloCluster::setHwPtHad(), l1t::CaloCluster::setHwSeedPt(), reco::HcalIsolatedTrackCandidate::setL1(), L1MuKBMTrack::setPtUnconstrained(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), FWMuonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), cms::MuonMETValueMapProducer::should_type_MuonCandidateValuesUsed(), reco::tau::disc::SignalPtFraction(), reco::tau::RecoTauConstructor::sortAndCopyIntoTau(), MuonVPlusJetsIDSelectionFunctor::spring10Cuts(), MuonVPlusJetsIDSelectionFunctor::summer08Cuts(), reco::tau::sumPFCandPt(), btagbtvdeep::svToFeatures(), l1t::Tau::Tau(), EgammaCutBasedEleId::TestWP(), PFMuonSelector::TopPag12LjetsCuts(), reco::tau::disc::TrackPt(), PFMuonAlgo::tracksWithBetterMET(), GsfEleEffAreaPFIsoCut::value(), PhoAnyPFIsoWithEACut::value(), PhoAnyPFIsoWithEAAndQuadScalingCut::value(), PhoAnyPFIsoWithEAAndExpoScalingCut::value(), PhoAnyPFIsoWithEAAndExpoScalingEBCut::value(), GsfEleCalPFClusterIsoCut::value(), HGCalTriggerClusterIdentificationBDT::value(), JVFJetIdProducer::~JVFJetIdProducer(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().
|
inlinefinalvirtual |
x coordinate of momentum vector
Implements reco::Candidate.
Definition at line 125 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(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), TtFullLepHypGenMatch::buildMatchingNeutrinos(), reco::FlavorHistoryEvent::cache(), razor::CalcMTR(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), PFMETBenchmark::calculateQuantities(), PFMuonAlgo::cleanMismeasured(), AddCorrectionsToGenericMET::constructP4From(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), AdHocNTupler::fill(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), WMuNuValidator::filter(), ChargedHadronTrackResolutionFilter::filter(), WMuNuSelector::filter(), HSCPTreeBuilder::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), PFMuonAlgo::getMinMaxMET2(), metsig::METSignificance::getSignificance(), L1TTauOffline::getTightMuons(), HLTElectronPFMTFilter< T >::hltFilter(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), 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()(), CalculateHLT::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), MEzCalculator::Print(), METzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PseudoTopProducer::produce(), L1TPFMetNoMuProducer::produce(), MuonMETcorrInputProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), WMuNuProducer::produce(), Onia2MuMuPAT::produce(), JetEnergyShift::produce(), JetPlusTrackProducer::produce(), reco::PFMETProducerMVA::produce(), JetPlusTrackProducerAA::produce(), BoostedTopProducer::produce(), pat::PATMETSlimmer::OneMETShift::readAndSet(), Type1PFMET::run(), pat::MET::setCorShift(), TtSemiLepHypothesis::setNeutrino(), 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 127 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(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), HiggsDQM::analyze(), METTester::analyze(), JetAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), TtFullLepHypGenMatch::buildMatchingNeutrinos(), reco::FlavorHistoryEvent::cache(), razor::CalcMTR(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), PFMETBenchmark::calculateQuantities(), PFMuonAlgo::cleanMismeasured(), AddCorrectionsToGenericMET::constructP4From(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doPFMet(), L1JetRecoTreeProducer::doPFMetNoMu(), AdHocNTupler::fill(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), WMuNuValidator::filter(), ChargedHadronTrackResolutionFilter::filter(), WMuNuSelector::filter(), HSCPTreeBuilder::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), PFMuonAlgo::getMinMaxMET2(), metsig::METSignificance::getSignificance(), L1TTauOffline::getTightMuons(), HLTElectronPFMTFilter< T >::hltFilter(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), 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()(), CalculateHLT::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), MEzCalculator::Print(), METzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), L1TPFMetNoMuProducer::produce(), MuonMETcorrInputProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), WMuNuProducer::produce(), Onia2MuMuPAT::produce(), JetEnergyShift::produce(), JetPlusTrackProducer::produce(), reco::PFMETProducerMVA::produce(), JetPlusTrackProducerAA::produce(), BoostedTopProducer::produce(), pat::PATMETSlimmer::OneMETShift::readAndSet(), Type1PFMET::run(), pat::MET::setCorShift(), TtSemiLepHypothesis::setNeutrino(), 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 129 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(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), reco::FlavorHistoryEvent::cache(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), AdHocNTupler::fill(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), HSCPTreeBuilder::filter(), 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(), METzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), WMuNuProducer::produce(), Onia2MuMuPAT::produce(), JetPlusTrackProducer::produce(), JetPlusTrackProducerAA::produce(), BoostedTopProducer::produce(), setPz(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), and TauValidation::visibleTauEnergy().
|
inlinefinalvirtual |
rapidity
Implements reco::Candidate.
Definition at line 139 of file LeafCandidate.h.
References m_state, and reco::ParticleState::rapidity().
Referenced by BPHCompositeBasicSelect::accept(), B2GDQM::analyzeAllHad(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), and y().
|
inlinefinalvirtual |
set electric charge
Implements reco::Candidate.
Definition at line 93 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setCharge().
Referenced by PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), pat::GenericParticle::fillInFrom(), l1t::MuonRawDigiTranslator::fillMuon(), PFEGammaAlgo::fillPFCandidates(), MuScleFitFilter::filter(), reco::GsfElectron::GsfElectron(), reco::tau::RecoTauTwoProngFilter::operator()(), reco::PFTauDecayMode::PFTauDecayMode(), PFAlgo::processBlock(), ParticleLevelProducer::produce(), HLTTriMuonIsolation::produce(), TauGenJetProducer::produce(), GlobalMuonToMuonProducer::produce(), Onia2MuMuPAT::produce(), MuonProducer::produce(), reco::TrackJet::resetCharge(), L1TMuonBarrelKalmanAlgo::setFloatingPointValues(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), and reco::writeSpecific().
|
inlinefinalvirtual |
long lived flag set long lived flag
Implements reco::Candidate.
Definition at line 170 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setLongLived().
|
inlinefinalvirtual |
set particle mass
Implements reco::Candidate.
Definition at line 147 of file LeafCandidate.h.
References funct::m, m_state, and reco::ParticleState::setMass().
|
inlinefinalvirtual |
do mass constraint flag set mass constraint flag
Implements reco::Candidate.
Definition at line 175 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setMassConstraint().
|
inlinefinalvirtual |
set 4-momentum
Implements reco::Candidate.
Definition at line 143 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setP4().
Referenced by l1t::HGCalTower::addEt(), ParticleLevelProducer::addGenJet(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), HPSPFRecoTauAlgorithm::buildPFTau(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), HGCalClusteringImpl::calibratePt(), PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), GenParticleProducer::convertParticle(), TtFullHadKinFitter::KinFit::corJet(), reco::GsfElectron::Corrections::Corrections(), PFRecoTauDiscriminationByIsolation::discriminate(), L1JetRecoTreeProducer::doPFMetNoMu(), reco::Photon::EnergyCorrections::EnergyCorrections(), pat::GenericParticle::fillInFrom(), l1t::MuonRawDigiTranslator::fillMuon(), pat::PATMuonProducer::fillMuon(), PFEGammaAlgo::fillPFCandidates(), MuScleFitFilter::filter(), L1GObject::initialize(), OniaPhotonConversionProducer::makePhotonCandidate(), l1t::Stage2Layer2TauAlgorithmFirmwareImp1::merging(), TransientVertex::operator reco::VertexCompositePtrCandidate(), reco::tau::RecoTauPhotonFilter::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), reco::operator<<(), pat::TriggerObjectStandAlone::packP4(), reco::PFTauDecayMode::PFTauDecayMode(), PFAlgo::processBlock(), l1t::Stage2Layer2EGammaAlgorithmFirmwareImp1::processEvent(), L1TPFMetNoMuProducer::produce(), ParticleLevelProducer::produce(), DistortedMuonProducerFromDB::produce(), DistortedPFCandProducer::produce(), DistortedMuonProducer::produce(), HLTTriMuonIsolation::produce(), GlobalMuonToMuonProducer::produce(), PuppiPhoton::produce(), DeltaBetaWeights::produce(), ShiftedPFCandidateProducerByMatchedObject::produce(), NoPileUpPFMEtProducer::produce(), pat::PATJetUpdater::produce(), PFLinker::produce(), ShiftedPFCandidateProducerForPFMVAMEt::produce(), Onia2MuMuPAT::produce(), NoPileUpPFMEtDataProducer::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), reco::PFMETProducerMVA::produce(), SoftKillerProducer::produce(), MuonProducer::produce(), HPSPFRecoTauAlgorithm::refitThreeProng(), reco::PFCandidate::rescaleMomentum(), PFPhotonAlgo::RunPFPhoton(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), reco::tau::setChargedHadronP4(), Jet.Jet::setCorrP4(), MEzCalculator::SetLepton(), MEzCalculator::SetMET(), METzCalculator::SetMET(), METzCalculator::SetMuon(), L1MuKBMTrack::setPtEtaPhi(), l1t::stage2::MPUnpacker::unpack(), l1t::stage2::MPUnpacker_0x10010033::unpack(), l1t::stage2::MPUnpacker_0x10010010::unpack(), l1t::stage2::MPUnpacker_0x1001000b::unpack(), l1t::stage2::JetUnpacker::unpack(), l1t::stage2::EtSumUnpacker_0x10010057::unpack(), l1t::stage2::TauUnpacker::unpack(), l1t::stage2::EGammaUnpacker::unpack(), l1t::stage2::EtSumUnpacker::unpack(), l1t::HGCalClusterT< l1t::HGCalCluster >::updateP4AndPosition(), and VirtualJetProducer::writeJetsWithConstituents().
|
inlinefinalvirtual |
set 4-momentum
Implements reco::Candidate.
Definition at line 145 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setP4().
Referenced by Jet.Jet::setCorrP4().
|
inlinefinalvirtual |
Implements reco::Candidate.
Definition at line 163 of file LeafCandidate.h.
References m_state, pdgId(), and reco::ParticleState::setPdgId().
Referenced by ParticleLevelProducer::addGenJet(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), GenParticleProducer::convertParticle(), pat::GenericParticle::fillInFrom(), PFEGammaAlgo::fillPFCandidates(), V0Fitter::fitAll(), reco::GsfElectron::GsfElectron(), reco::PFCandidate::PFCandidate(), reco::PFRecoTauChargedHadron::PFRecoTauChargedHadron(), reco::PFTauDecayMode::PFTauDecayMode(), ParticleLevelProducer::produce(), L2TauJetsMerger::produce(), HLTTriMuonIsolation::produce(), MuonProducer::produce(), reco::RecoTauPiZero::RecoTauPiZero(), reco::PFCandidate::setParticleType(), and reco::tau::RecoTauBuilderConePlugin::setTauQuantities().
|
inlinefinalvirtual |
Implements reco::Candidate.
Definition at line 148 of file LeafCandidate.h.
References m_state, pz(), and reco::ParticleState::setPz().
Referenced by BoostedTopProducer::produce().
|
inlinefinalvirtual |
set status word
Implements reco::Candidate.
Definition at line 167 of file LeafCandidate.h.
References m_state, reco::ParticleState::setStatus(), and status().
Referenced by reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), GenParticleProducer::convertParticle(), pat::GenericParticle::fillInFrom(), and reco::PFTauDecayMode::PFTauDecayMode().
|
inlinefinalvirtual |
set electric charge
Implements reco::Candidate.
Definition at line 97 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setThreeCharge().
Referenced by GenParticleProducer::convertParticle().
|
inlineoverridevirtual |
set vertex
Implements reco::Candidate.
Reimplemented in reco::PFCandidate, and reco::Photon.
Definition at line 158 of file LeafCandidate.h.
References m_state, and reco::ParticleState::setVertex().
Referenced by ParticleLevelProducer::addGenJet(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), GenParticleProducer::convertParticle(), pat::GenericParticle::fillInFrom(), reco::GsfElectron::GsfElectron(), OniaPhotonConversionProducer::makePhotonCandidate(), TransientVertex::operator reco::VertexCompositePtrCandidate(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), ParticleLevelProducer::produce(), L2TauPixelTrackMatch::produce(), HLTTriMuonIsolation::produce(), GlobalMuonToMuonProducer::produce(), FastjetJetProducer::produceTrackJets(), HPSPFRecoTauAlgorithm::refitThreeProng(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), reco::V0Candidate::setRecoVertex(), reco::PFCandidate::setVertex(), and reco::PFCandidate::setVertexSource().
|
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 86 of file LeafCandidate.h.
Referenced by reco::operator<<().
|
inlinefinalvirtual |
status word
Implements reco::Candidate.
Definition at line 165 of file LeafCandidate.h.
References m_state, and reco::ParticleState::status().
Referenced by TauDecay_GenParticle::AddPi0Info(), EWKSystUnc::analyze(), ZLONLOHistogrammer::analyze(), zPdfUnc::analyze(), ZMuPtScaleAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), TauDecay_GenParticle::Analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), L1Validator::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), GeneratorTau::computeDecayMode(), GeneratorTau::computeStableDecayProducts(), GeneratorTau::decayToPDGClassification(), JetPartonMatcher::fillAlgoritDefinition(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), HeavyQuarkFromMPIFilterAlgo::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), HighETPhotonsFilterAlgo::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), TopDecaySubset::findLastParticleInChain(), GenParticlesHelper::findParticles(), pat::PATObject< ObjectType >::genParticleById(), GenParticlesHelper::hasAncestor(), HeavyQuarkFromMPIFilterAlgo::hasMPIAncestor(), HGCalTriggerNtupleGenTau::isChargedHadron(), HGCalTriggerNtupleGenTau::isChargedHadronFromResonance(), HGCalTriggerNtupleGenTau::isGamma(), HGCalTriggerNtupleGenTau::isGoodTau(), HGCalTriggerNtupleGenTau::isIntermediateResonance(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), HGCalTriggerNtupleGenTau::isNeutralPion(), HGCalTriggerNtupleGenTau::isNeutralPionFromResonance(), HGCalTriggerNtupleGenTau::isStableLepton(), HGCalTriggerNtupleGenTau::isStableNeutralHadron(), LeafCandidate(), GenParticleCustomSelector::operator()(), WeakEffectsWeightProducer::produce(), MCTrackMatcher::produce(), ISRGammaWeightProducer::produce(), FSRWeightProducer::produce(), ISRWeightProducer::produce(), PdfWeightProducer::produce(), GenVisTauProducer::produce(), PartonSelector::produce(), pat::PATPackedGenParticleProducer::produce(), JetPartonMatcher::produce(), setStatus(), TauValidation::tauDecayChannel(), HistoryBase::traceRecoGenHistory(), reco::VertexCompositeCandidate::VertexCompositeCandidate(), reco::VertexCompositePtrCandidate::VertexCompositePtrCandidate(), and heppy::FSRWeightAlgo::weight().
|
inlinefinalvirtual |
momentum polar angle
Implements reco::Candidate.
Definition at line 135 of file LeafCandidate.h.
References m_state, and reco::ParticleState::theta().
Referenced by FWMuonDetailView::addSceneInfo(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWL1EmParticleProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), CaloTower::emEt(), metsig::SignAlgoResolutions::evalPF(), FWECalPFCandidateProxyBuilder::getEt(), FWHCalPFCandidateProxyBuilder::getEt(), CaloTower::hadEt(), reco::tau::PFRecoTauMassPlugin::operator()(), CaloTower::outerEt(), FSRWeightProducer::produce(), pf2pat::PFMETAlgo::produce(), pat::LeptonJetIsolationAngle::spaceAngle(), heppy::FSRWeightAlgo::weight(), and Tau.Tau::zImpact().
|
inlinefinalvirtual |
electric charge
Implements reco::Candidate.
Definition at line 95 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 150 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vertex().
Referenced by ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), reco::Photon::caloPosition(), 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(), ErsatzMEt::ersatzFabrik(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), TopDecaySubset::fillListing(), PF_PU_AssoMapAlgos::FindV0Vertex(), BtoCharmDecayVertexMergerT< VTX >::flightDirection(), flightDirection(), AddCorrectionsToGenericMET::getCorrectedCaloMET(), AddCorrectionsToGenericMET::getCorrectedMET(), AddCorrectionsToGenericMET::getCorrectedPFMET(), MuonMETAlgo::GetMuDepDeltas(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), fireworks::makeEveJetCone(), reco::CaloJet::n60(), reco::Jet::nConstituents(), GenParticleCustomSelector::operator()(), CorrectJet::operator()(), reco::LeafRefCandidateT::overlap(), overlap(), EgammaHLTTrackIsolation::photonIsolation(), reco::CaloJet::physicsP4(), reco::VertexCompositePtrCandidate::position(), position(), L1TPFMetNoMuProducer::produce(), pat::PATSecondaryVertexSlimmer::produce(), pat::PATTrackAndVertexUnpacker::produce(), Type1PFMET::run(), reco::TemplatedSecondaryVertexTagInfo< reco::CandIPTagInfo, reco::VertexCompositePtrCandidate >::secondaryVertex(), TtFullHadHypothesis::setCandidate(), TtFullLepHypothesis::setCandidate(), TtSemiLepHypothesis::setCandidate(), TtSemiLepHypothesis::setNeutrino(), TtSemiEvtSolution::setupHyp(), reco::PFCandidate::vertex(), btagbtvdeep::vertexD3d(), and btagbtvdeep::vertexDxy().
|
overridevirtual |
chi-squares
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 66 of file LeafCandidate.cc.
Referenced by clone().
|
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 78 of file LeafCandidate.cc.
References Exception, and edm::errors::UnimplementedFeature.
|
inlinefinalvirtual |
return SMatrix
Reimplemented from reco::Candidate.
Definition at line 198 of file LeafCandidate.h.
References fillVertexCovariance(), hasMasterClone(), hasMasterClonePtr(), funct::m, masterClone(), masterClonePtr(), and findQualityFiles::v.
Referenced by clone(), reco::VertexCompositePtrCandidate::tError(), reco::VertexCompositeCandidate::vertexCovariance(), and reco::VertexCompositePtrCandidate::vertexCovariance().
|
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 70 of file LeafCandidate.cc.
Referenced by clone().
|
overridevirtual |
chi-squared divided by n.d.o.f.
Implements reco::Candidate.
Reimplemented in reco::VertexCompositePtrCandidate, and reco::VertexCompositeCandidate.
Definition at line 74 of file LeafCandidate.cc.
Referenced by clone().
|
inlineoverridevirtual |
x coordinate of vertex position
Implements reco::Candidate.
Reimplemented in reco::PFCandidate.
Definition at line 152 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vx().
Referenced by ZeePlots::analyze(), WenuPlots::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWSecVertexCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), reco::PFTau::dump(), PFIsolationEstimator::fGetIsolationInRings(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), and btagbtvdeep::vertexDdotP().
|
inlineoverridevirtual |
y coordinate of vertex position
Implements reco::Candidate.
Reimplemented in reco::PFCandidate.
Definition at line 154 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vy().
Referenced by ZeePlots::analyze(), WenuPlots::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWSecVertexCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), reco::PFTau::dump(), PFIsolationEstimator::fGetIsolationInRings(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), and btagbtvdeep::vertexDdotP().
|
inlineoverridevirtual |
z coordinate of vertex position
Implements reco::Candidate.
Reimplemented in reco::PFCandidate.
Definition at line 156 of file LeafCandidate.h.
References m_state, and reco::ParticleState::vz().
Referenced by ZeePlots::analyze(), WenuPlots::analyze(), ZMuMu_vtxAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWSecVertexCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), HLTDoubletDZ< T1, T2 >::computeDZ(), PFCandWithSuperClusterExtractor::depositFromObject(), reco::PFTau::dump(), HLTObjectsMonitor::dzFinder(), PFIsolationEstimator::fGetIsolationInRings(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), HLTTriMuonIsolation::produce(), btagbtvdeep::vertexDdotP(), and egHLT::OffPho::zVtx().
|
inlinefinalvirtual |
rapidity
Implements reco::Candidate.
Definition at line 141 of file LeafCandidate.h.
References rapidity().
Referenced by svgfig.Ellipse::__repr__(), Vispa.Gui.WidgetContainer.WidgetContainer::autosize(), Vispa.Gui.VispaWidget.VispaWidget::boundingRect(), geometryXMLparser.Alignable::pos(), Vispa.Gui.ConnectableWidget.ConnectableWidget::positionizeMenuWidget(), pat::PATPackedGenParticleProducer::produce(), ntupleDataFormat._HitObject::r(), ntupleDataFormat._HitObject::r3D(), pat::MET::shiftedP4(), and pat::MET::shiftedP4_74x().
|
friend |
Definition at line 268 of file LeafCandidate.h.
|
friend |
Definition at line 267 of file LeafCandidate.h.
|
friend |
Definition at line 269 of file LeafCandidate.h.
|
friend |
Definition at line 270 of file LeafCandidate.h.
|
private |
Definition at line 262 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().