#include <PFAlgo.h>
Public Member Functions | |
void | checkCleaning (const reco::PFRecHitCollection &cleanedHF) |
Check HF Cleaning. More... | |
PFMuonAlgo * | getPFMuonAlgo () |
PFAlgo () | |
constructor More... | |
const std::auto_ptr < reco::PFCandidateCollection > & | pfCandidates () const |
void | reconstructParticles (const reco::PFBlockHandle &blockHandle) |
virtual void | reconstructParticles (const reco::PFBlockCollection &blocks) |
reconstruct particles More... | |
void | setAlgo (int algo) |
void | setCandConnectorParameters (const edm::ParameterSet &iCfgCandConnector) |
void | setCandConnectorParameters (bool bCorrect, bool bCalibPrimary, double dptRel_PrimaryTrack, double dptRel_MergedTrack, double ptErrorSecondary, std::vector< double > nuclCalibFactors) |
void | setDebug (bool debug) |
void | setDisplacedVerticesParameters (bool rejectTracks_Bad, bool rejectTracks_Step45, bool usePFNuclearInteractions, bool usePFConversions, bool usePFDecays, double dptRel_DispVtx) |
void | setEGElectronCollection (const reco::GsfElectronCollection &egelectrons) |
void | setElectronExtraRef (const edm::OrphanHandle< reco::PFCandidateElectronExtraCollection > &extrah) |
void | setHOTag (bool ho) |
void | setMuonHandle (const edm::Handle< reco::MuonCollection > &) |
void | setParameters (double nSigmaECAL, double nSigmaHCAL, const boost::shared_ptr< PFEnergyCalibration > &calibration, const boost::shared_ptr< PFEnergyCalibrationHF > &thepfEnergyCalibrationHF) |
void | setPFEleParameters (double mvaEleCut, std::string mvaWeightFileEleID, bool usePFElectrons, const boost::shared_ptr< PFSCEnergyCalibration > &thePFSCEnergyCalibration, const boost::shared_ptr< PFEnergyCalibration > &thePFEnergyCalibration, double sumEtEcalIsoForEgammaSC_barrel, double sumEtEcalIsoForEgammaSC_endcap, double coneEcalIsoForEgammaSC, double sumPtTrackIsoForEgammaSC_barrel, double sumPtTrackIsoForEgammaSC_endcap, unsigned int nTrackIsoForEgammaSC, double coneTrackIsoForEgammaSC, bool applyCrackCorrections=false, bool usePFSCEleCalib=true, bool useEGElectrons=false, bool useEGammaSupercluster=true) |
void | setPFMuonAlgo (PFMuonAlgo *algo) |
void | setPFMuonAndFakeParameters (const edm::ParameterSet &pset) |
void | setPFPhotonParameters (bool usePFPhoton, std::string mvaWeightFileConvID, double mvaConvCut, bool useReg, std::string X0_Map, const boost::shared_ptr< PFEnergyCalibration > &thePFEnergyCalibration, double sumPtTrackIsoForPhoton, double sumPtTrackIsoSlopeForPhoton) |
void | setPFPhotonRegWeights (const GBRForest *LCorrForestEB, const GBRForest *LCorrForestEE, const GBRForest *GCorrForestBarrel, const GBRForest *GCorrForestEndcapHr9, const GBRForest *GCorrForestEndcapLr9, const GBRForest *PFEcalResolution) |
void | setPFVertexParameters (bool useVertex, const reco::VertexCollection *primaryVertices) |
void | setPhotonExtraRef (const edm::OrphanHandle< reco::PFCandidatePhotonExtraCollection > &pf_extrah) |
void | setPostHFCleaningParameters (bool postHFCleaning, double minHFCleaningPt, double minSignificance, double maxSignificance, double minSignificanceReduction, double maxDeltaPhiPt, double minDeltaMet) |
boost::shared_ptr < PFEnergyCalibration > | thePFEnergyCalibration () |
return the pointer to the calibration function More... | |
std::auto_ptr < reco::PFCandidateCollection > | transferCandidates () |
std::auto_ptr < reco::PFCandidateCollection > & | transferCleanedCandidates () |
std::auto_ptr < reco::PFCandidateCollection > | transferElectronCandidates () |
std::auto_ptr < reco::PFCandidateElectronExtraCollection > | transferElectronExtra () |
std::auto_ptr < reco::PFCandidatePhotonExtraCollection > | transferPhotonExtra () |
virtual | ~PFAlgo () |
destructor More... | |
Protected Member Functions | |
void | associatePSClusters (unsigned iEcal, reco::PFBlockElement::Type psElementType, const reco::PFBlock &block, const edm::OwnVector< reco::PFBlockElement > &elements, const reco::PFBlock::LinkData &linkData, std::vector< bool > &active, std::vector< double > &psEne) |
Associate PS clusters to a given ECAL cluster, and return their energy. More... | |
bool | isFromSecInt (const reco::PFBlockElement &eTrack, std::string order) const |
double | neutralHadronEnergyResolution (double clusterEnergy, double clusterEta) const |
todo: use PFClusterTools for this More... | |
double | nSigmaHCAL (double clusterEnergy, double clusterEta) const |
void | postCleaning () |
virtual void | processBlock (const reco::PFBlockRef &blockref, std::list< reco::PFBlockRef > &hcalBlockRefs, std::list< reco::PFBlockRef > &ecalBlockRefs) |
unsigned | reconstructCluster (const reco::PFCluster &cluster, double particleEnergy, bool useDirection=false, double particleX=0., double particleY=0., double particleZ=0.) |
unsigned | reconstructTrack (const reco::PFBlockElement &elt, bool allowLoose=false) |
Protected Attributes | |
std::auto_ptr < reco::PFCandidateCollection > | pfCandidates_ |
std::auto_ptr < reco::PFCandidateCollection > | pfCleanedCandidates_ |
std::auto_ptr < reco::PFCandidateCollection > | pfElectronCandidates_ |
the unfiltered electron collection More... | |
reco::PFCandidateElectronExtraCollection | pfElectronExtra_ |
the unfiltered electron collection More... | |
std::auto_ptr < reco::PFCandidateCollection > | pfPhotonCandidates_ |
the unfiltered photon collection More... | |
reco::PFCandidatePhotonExtraCollection | pfPhotonExtra_ |
the extra photon collection More... | |
Private Member Functions | |
reco::PFBlockRef | createBlockRef (const reco::PFBlockCollection &blocks, unsigned bi) |
Friends | |
std::ostream & | operator<< (std::ostream &out, const PFAlgo &algo) |
PFAlgo::PFAlgo | ( | ) |
constructor
Definition at line 57 of file PFAlgo.cc.
|
virtual |
destructor
Definition at line 68 of file PFAlgo.cc.
References pfele_, pfpho_, usePFElectrons_, and usePFPhotons_.
|
protected |
Associate PS clusters to a given ECAL cluster, and return their energy.
Definition at line 3167 of file PFAlgo.cc.
References reco::PFBlock::associatedElements(), reco::PFBlockElement::ECAL, edm::Ref< C, T, F >::isNull(), and reco::PFBlock::LINKTEST_ALL.
Referenced by processBlock().
void PFAlgo::checkCleaning | ( | const reco::PFRecHitCollection & | cleanedHF | ) |
Check HF Cleaning.
Definition at line 3365 of file PFAlgo.cc.
References gather_cfg::cout, debug_, reco::PFRecHit::energy(), i, j, reco::PFRecHit::layer(), minDeltaMet_, pfCandidates_, reco::PFRecHit::position(), reco::LeafCandidate::pt(), reco::LeafCandidate::px(), reco::LeafCandidate::py(), reconstructCluster(), createPayload::skip, mathSSE::sqrt(), and reco::PFRecHit::time().
Referenced by PFRootEventManager::particleFlow().
|
private |
create a reference to a block, transient or persistent depending on the needs
Definition at line 3155 of file PFAlgo.cc.
References blockHandle_, and edm::HandleBase::isValid().
Referenced by reconstructParticles().
PFMuonAlgo * PFAlgo::getPFMuonAlgo | ( | ) |
|
protected |
Definition at line 3222 of file PFAlgo.cc.
References reco::PFBlockElement::T_FROM_DISP, reco::PFBlockElement::T_FROM_V0, reco::PFBlockElement::T_TO_DISP, reco::PFBlockElement::trackType(), usePFDecays_, and usePFNuclearInteractions_.
Referenced by processBlock(), and reconstructTrack().
|
protected |
todo: use PFClusterTools for this
Definition at line 3102 of file PFAlgo.cc.
References mathSSE::sqrt().
Referenced by processBlock().
|
protected |
Definition at line 3117 of file PFAlgo.cc.
References create_public_lumi_plots::exp, and nSigmaHCAL_.
Referenced by processBlock(), and setParameters().
|
inline |
Definition at line 170 of file PFAlgo.h.
References pfCandidates_.
Referenced by operator<<().
|
protected |
Definition at line 3258 of file PFAlgo.cc.
References gather_cfg::cout, SiPixelRawToDigiRegional_cfi::deltaPhi, reco::PFCandidate::egamma_HF, reco::PFCandidate::h_HF, i, j, maxDeltaPhiPt_, maxSignificance_, minDeltaMet_, minHFCleaningPt_, minSignificance_, minSignificanceReduction_, reco::PFCandidate::particleId(), pfCandidates_, pfCleanedCandidates_, postHFCleaning_, reco::LeafCandidate::pt(), reco::LeafCandidate::px(), reco::LeafCandidate::py(), createPayload::skip, and mathSSE::sqrt().
Referenced by reconstructParticles().
|
protectedvirtual |
process one block. can be reimplemented in more sophisticated algorithms
Reimplemented in PFAlgoTestBenchConversions, and PFAlgoTestBenchElectrons.
Definition at line 466 of file PFAlgo.cc.
References a, abs, associatePSClusters(), b, edm::OwnVector< T, P >::begin(), Association::block, alignmentValidation::c1, calibration_, dtNoiseDBValidation_cfg::cerr, CastorDataFrameFilter_impl::check(), gather_cfg::cout, debug_, dptRel_DispVtx_, ECAL, reco::PFBlockElement::ECAL, asciidump::elements, reco::PFCandidate::elementsInBlocks(), reco::LeafCandidate::energy(), eta(), factors45_, first, PFElectronAlgo::getAllElectronCandidates(), PFElectronAlgo::getElectronCandidates(), PFElectronAlgo::getElectronExtra(), reco::PFBlockElement::GSF, HCAL, reco::PFBlockElement::HCAL, PFLayer::HF_EM, PFLayer::HF_HAD, reco::TrackBase::highPurity, reco::PFBlockElement::HO, i, cuy::ii, getHLTprescales::index, PFElectronAlgo::isElectronValidCandidate(), isFromSecInt(), PFMuonAlgo::isIsolatedMuon(), PFMuonAlgo::isLooseMuon(), PFMuonAlgo::isMuon(), edm::Ref< C, T, F >::isNull(), PFPhotonAlgo::isPhotonValidCandidate(), j, reco::PFBlock::LINKTEST_ALL, max(), min, reco::PFCandidate::mu, muonECAL_, muonHCAL_, muonHO_, reco::btau::neutralEnergy, neutralHadronEnergyResolution(), nSigmaECAL_, nSigmaHCAL(), nSigmaTRACK_, convertSQLiteXML::ok, AlCaHLTBitMon_ParallelJobs::p, pfCandidates_, pfele_, pfElectronCandidates_, pfElectronExtra_, pfpho_, pfPhotonCandidates_, pfPhotonExtra_, primaryVertex_, reco::PFBlockElement::PS1, reco::PFBlockElement::PS2, ptError_, edm::OwnVector< T, P >::push_back(), reconstructCluster(), reconstructTrack(), rejectTracks_Bad_, rejectTracks_Step45_, edm::second(), reco::PFCandidate::setEcalEnergy(), reco::PFCandidate::setHcalEnergy(), reco::PFCandidate::setHoEnergy(), reco::PFBlockElementTrack::setPositionAtECALEntrance(), edm::OwnVector< T, P >::size(), createPayload::skip, mathSSE::sqrt(), reco::PFBlockElement::T_FROM_GAMMACONV, thepfEnergyCalibrationHF_, reco::PFBlockElement::TRACK, reco::btau::trackMomentum, reco::PFBlockElementTrack::trackType(), funct::true, useHO_, usePFConversions_, usePFElectrons_, usePFPhotons_, x, X, and Gflash::Z.
Referenced by reconstructParticles().
|
protected |
Reconstruct a neutral particle from a cluster. If chargedEnergy is specified, the neutral particle is created only if the cluster energy is significantly larger than the chargedEnergy. In this case, the energy of the neutral particle is cluster energy - chargedEnergy
Definition at line 2990 of file PFAlgo.cc.
References DeDxDiscriminatorTools::charge(), gather_cfg::cout, debug_, PFLayer::ECAL_BARREL, PFLayer::ECAL_ENDCAP, PFLayer::HCAL_BARREL1, PFLayer::HCAL_ENDCAP, PFLayer::HF_EM, PFLayer::HF_HAD, reco::PFCluster::layer(), pfCandidates_, reco::CaloCluster::position(), primaryVertex_, mathSSE::sqrt(), tmp, useVertices_, reco::PFCandidate::X, reco::Vertex::x(), reco::Vertex::y(), and reco::Vertex::z().
Referenced by checkCleaning(), and processBlock().
void PFAlgo::reconstructParticles | ( | const reco::PFBlockHandle & | blockHandle | ) |
reconstruct particles (full framework case) will keep track of the block handle to build persistent references, and call reconstructParticles( const reco::PFBlockCollection& blocks )
Definition at line 343 of file PFAlgo.cc.
References blockHandle_.
Referenced by PFRootEventManager::particleFlow().
|
virtual |
reconstruct particles
Definition at line 351 of file PFAlgo.cc.
References PFMuonAlgo::addMissingMuons(), Association::block, gather_cfg::cout, createBlockRef(), debug_, reco::PFBlockElement::ECAL, reco::PFBlock::elements(), asciidump::elements, relativeConstraints::empty, reco::PFBlockElement::HCAL, reco::PFBlockElement::HO, i, edm::HandleBase::isValid(), muonHandle_, pfCandidates_, pfCleanedCandidates_, pfElectronCandidates_, pfElectronExtra_, pfmu_, pfPhotonCandidates_, pfPhotonExtra_, PFMuonAlgo::postClean(), postCleaning(), processBlock(), and edm::OwnVector< T, P >::size().
|
protected |
Reconstruct a charged particle from a track Returns the index of the newly created candidate in pfCandidates_ Michalis added a flag here to treat muons inside jets
Definition at line 2916 of file PFAlgo.cc.
References DeDxDiscriminatorTools::charge(), reco::TrackBase::charge(), gather_cfg::cout, debug_, reco::PFBlockElementTrack::displacedVertexRef(), dptRel_DispVtx_, relval_parameters_module::energy, reco::PFCandidate::h, isFromSecInt(), reco::isMuon(), edm::Ref< C, T, F >::isNonnull(), reco::PFBlockElementTrack::muonRef(), reco::TrackBase::p(), pfCandidates_, pfmu_, reco::PFBlockElementTrack::positionAtECALEntrance(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), PFMuonAlgo::reconstructMuon(), mathSSE::sqrt(), reco::PFBlockElement::T_FROM_DISP, reco::PFCandidate::T_FROM_DISP, reco::PFBlockElement::T_TO_DISP, reco::PFCandidate::T_TO_DISP, and reco::PFBlockElementTrack::trackRef().
Referenced by processBlock().
|
inline |
Definition at line 61 of file PFAlgo.h.
References algo_.
Referenced by PFRootEventManager::readOptions().
|
inline |
Definition at line 71 of file PFAlgo.h.
References connector_, and PFCandConnector::setParameters().
Referenced by PFRootEventManager::readOptions().
|
inline |
Definition at line 75 of file PFAlgo.h.
References connector_, and PFCandConnector::setParameters().
|
inline |
Definition at line 64 of file PFAlgo.h.
References connector_, debug, debug_, and PFCandConnector::setDebug().
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setDisplacedVerticesParameters | ( | bool | rejectTracks_Bad, |
bool | rejectTracks_Step45, | ||
bool | usePFNuclearInteractions, | ||
bool | usePFConversions, | ||
bool | usePFDecays, | ||
double | dptRel_DispVtx | ||
) |
Definition at line 282 of file PFAlgo.cc.
References dptRel_DispVtx_, rejectTracks_Bad_, rejectTracks_Step45_, usePFConversions_, usePFDecays_, and usePFNuclearInteractions_.
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setEGElectronCollection | ( | const reco::GsfElectronCollection & | egelectrons | ) |
Definition at line 3253 of file PFAlgo.cc.
References pfele_, PFElectronAlgo::setEGElectronCollection(), and useEGElectrons_.
Referenced by PFRootEventManager::particleFlow().
void PFAlgo::setElectronExtraRef | ( | const edm::OrphanHandle< reco::PFCandidateElectronExtraCollection > & | extrah | ) |
Definition at line 3470 of file PFAlgo.cc.
References alignCSCRings::e, pfCandidates_, pfElectronCandidates_, pfElectronExtra_, findQualityFiles::size, and usePFElectrons_.
Referenced by PFRootEventManager::particleFlow().
|
inline |
Definition at line 60 of file PFAlgo.h.
References useHO_.
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setMuonHandle | ( | const edm::Handle< reco::MuonCollection > & | muons | ) |
void PFAlgo::setParameters | ( | double | nSigmaECAL, |
double | nSigmaHCAL, | ||
const boost::shared_ptr< PFEnergyCalibration > & | calibration, | ||
const boost::shared_ptr< PFEnergyCalibrationHF > & | thepfEnergyCalibrationHF | ||
) |
Definition at line 75 of file PFAlgo.cc.
References calibration_, nSigmaECAL_, nSigmaHCAL(), nSigmaHCAL_, and thepfEnergyCalibrationHF_.
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setPFEleParameters | ( | double | mvaEleCut, |
std::string | mvaWeightFileEleID, | ||
bool | usePFElectrons, | ||
const boost::shared_ptr< PFSCEnergyCalibration > & | thePFSCEnergyCalibration, | ||
const boost::shared_ptr< PFEnergyCalibration > & | thePFEnergyCalibration, | ||
double | sumEtEcalIsoForEgammaSC_barrel, | ||
double | sumEtEcalIsoForEgammaSC_endcap, | ||
double | coneEcalIsoForEgammaSC, | ||
double | sumPtTrackIsoForEgammaSC_barrel, | ||
double | sumPtTrackIsoForEgammaSC_endcap, | ||
unsigned int | nTrackIsoForEgammaSC, | ||
double | coneTrackIsoForEgammaSC, | ||
bool | applyCrackCorrections = false , |
||
bool | usePFSCEleCalib = true , |
||
bool | useEGElectrons = false , |
||
bool | useEGammaSupercluster = true |
||
) |
Definition at line 95 of file PFAlgo.cc.
References applyCrackCorrectionsElectrons_, coneEcalIsoForEgammaSC_, coneTrackIsoForEgammaSC_, mvaEleCut_, mvaWeightFileEleID_, nTrackIsoForEgammaSC_, pfele_, sumEtEcalIsoForEgammaSC_barrel_, sumEtEcalIsoForEgammaSC_endcap_, sumPtTrackIsoForEgammaSC_barrel_, sumPtTrackIsoForEgammaSC_endcap_, thePFSCEnergyCalibration_, useEGammaSupercluster_, useEGElectrons_, usePFElectrons_, and usePFSCEleCalib_.
Referenced by PFRootEventManager::readOptions().
|
inline |
void PFAlgo::setPFMuonAndFakeParameters | ( | const edm::ParameterSet & | pset | ) |
Definition at line 230 of file PFAlgo.cc.
References factors45_, edm::ParameterSet::getParameter(), muonECAL_, muonHCAL_, muonHO_, nSigmaTRACK_, pfmu_, ptError_, and PFMuonAlgo::setParameters().
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setPFPhotonParameters | ( | bool | usePFPhoton, |
std::string | mvaWeightFileConvID, | ||
double | mvaConvCut, | ||
bool | useReg, | ||
std::string | X0_Map, | ||
const boost::shared_ptr< PFEnergyCalibration > & | thePFEnergyCalibration, | ||
double | sumPtTrackIsoForPhoton, | ||
double | sumPtTrackIsoSlopeForPhoton | ||
) |
Definition at line 157 of file PFAlgo.cc.
References alignCSCRings::e, AlCaHLTBitMon_ParallelJobs::p, pfpho_, primaryVertex_, usePFPhotons_, and useVertices_.
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setPFPhotonRegWeights | ( | const GBRForest * | LCorrForestEB, |
const GBRForest * | LCorrForestEE, | ||
const GBRForest * | GCorrForestBarrel, | ||
const GBRForest * | GCorrForestEndcapHr9, | ||
const GBRForest * | GCorrForestEndcapLr9, | ||
const GBRForest * | PFEcalResolution | ||
) |
Definition at line 217 of file PFAlgo.cc.
References pfpho_, and PFPhotonAlgo::setGBRForest().
Referenced by PFRootEventManager::readOptions().
void PFAlgo::setPFVertexParameters | ( | bool | useVertex, |
const reco::VertexCollection * | primaryVertices | ||
) |
Definition at line 300 of file PFAlgo.cc.
References alignCSCRings::e, i, AlCaHLTBitMon_ParallelJobs::p, pfmu_, pfpho_, primaryVertex_, PFMuonAlgo::setInputsForCleaning(), PFPhotonAlgo::setnPU(), PFPhotonAlgo::setPhotonPrimaryVtx(), usePFPhotons_, and useVertices_.
Referenced by PFRootEventManager::particleFlow().
void PFAlgo::setPhotonExtraRef | ( | const edm::OrphanHandle< reco::PFCandidatePhotonExtraCollection > & | pf_extrah | ) |
Definition at line 3522 of file PFAlgo.cc.
References newFWLiteAna::found, pfCandidates_, pfPhotonExtra_, findQualityFiles::size, and usePFPhotons_.
void PFAlgo::setPostHFCleaningParameters | ( | bool | postHFCleaning, |
double | minHFCleaningPt, | ||
double | minSignificance, | ||
double | maxSignificance, | ||
double | minSignificanceReduction, | ||
double | maxDeltaPhiPt, | ||
double | minDeltaMet | ||
) |
Definition at line 265 of file PFAlgo.cc.
References maxDeltaPhiPt_, maxSignificance_, minDeltaMet_, minHFCleaningPt_, minSignificance_, minSignificanceReduction_, and postHFCleaning_.
Referenced by PFRootEventManager::readOptions().
|
inline |
return the pointer to the calibration function
Definition at line 208 of file PFAlgo.h.
References calibration_.
|
inline |
Definition at line 203 of file PFAlgo.h.
References PFCandConnector::connect(), connector_, and pfCandidates_.
Referenced by PFRootEventManager::particleFlow().
|
inline |
Definition at line 198 of file PFAlgo.h.
References pfCleanedCandidates_.
|
inline |
Definition at line 175 of file PFAlgo.h.
References pfElectronCandidates_.
|
inline |
Definition at line 181 of file PFAlgo.h.
References pfElectronExtra_, and query::result.
Referenced by PFRootEventManager::particleFlow().
|
inline |
Definition at line 190 of file PFAlgo.h.
References pfPhotonExtra_, and query::result.
|
friend |
|
private |
Definition at line 318 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
input block handle (full framework case)
Definition at line 296 of file PFAlgo.h.
Referenced by createBlockRef(), and reconstructParticles().
|
private |
Definition at line 304 of file PFAlgo.h.
Referenced by operator<<(), processBlock(), setParameters(), and thePFEnergyCalibration().
|
private |
Definition at line 324 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 327 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
A tool used for a postprocessing of displaced vertices based on reconstructed PFCandidates
Definition at line 352 of file PFAlgo.h.
Referenced by setCandConnectorParameters(), setDebug(), and transferCandidates().
|
private |
Definition at line 310 of file PFAlgo.h.
Referenced by checkCleaning(), processBlock(), reconstructCluster(), reconstructParticles(), reconstructTrack(), and setDebug().
|
private |
Maximal relative uncertainty on the tracks going to or incoming from the displcaed vertex to be used in the PFAlgo
Definition at line 347 of file PFAlgo.h.
Referenced by processBlock(), reconstructTrack(), and setDisplacedVerticesParameters().
|
private |
Definition at line 360 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 369 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 367 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 370 of file PFAlgo.h.
Referenced by checkCleaning(), postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 365 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 366 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 368 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 356 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 377 of file PFAlgo.h.
Referenced by reconstructParticles(), and setMuonHandle().
|
private |
Variables for muons and fakes.
Definition at line 355 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 357 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 315 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Variables for PFElectrons.
Definition at line 313 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
number of sigma to judge energy excess in ECAL
Definition at line 299 of file PFAlgo.h.
Referenced by operator<<(), processBlock(), and setParameters().
|
private |
number of sigma to judge energy excess in HCAL
Definition at line 302 of file PFAlgo.h.
Referenced by nSigmaHCAL(), operator<<(), and setParameters().
|
private |
Definition at line 358 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 328 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
protected |
Definition at line 258 of file PFAlgo.h.
Referenced by checkCleaning(), operator<<(), pfCandidates(), postCleaning(), processBlock(), reconstructCluster(), reconstructParticles(), reconstructTrack(), setElectronExtraRef(), setPhotonExtraRef(), and transferCandidates().
|
protected |
Definition at line 264 of file PFAlgo.h.
Referenced by postCleaning(), reconstructParticles(), and transferCleanedCandidates().
|
private |
Definition at line 329 of file PFAlgo.h.
Referenced by processBlock(), setEGElectronCollection(), setPFEleParameters(), and ~PFAlgo().
|
protected |
the unfiltered electron collection
Definition at line 260 of file PFAlgo.h.
Referenced by processBlock(), reconstructParticles(), setElectronExtraRef(), and transferElectronCandidates().
|
protected |
the unfiltered electron collection
Definition at line 267 of file PFAlgo.h.
Referenced by processBlock(), reconstructParticles(), setElectronExtraRef(), and transferElectronExtra().
|
private |
Definition at line 331 of file PFAlgo.h.
Referenced by getPFMuonAlgo(), reconstructParticles(), reconstructTrack(), setPFMuonAlgo(), setPFMuonAndFakeParameters(), and setPFVertexParameters().
|
private |
Definition at line 330 of file PFAlgo.h.
Referenced by processBlock(), setPFPhotonParameters(), setPFPhotonRegWeights(), setPFVertexParameters(), and ~PFAlgo().
|
protected |
the unfiltered photon collection
Definition at line 262 of file PFAlgo.h.
Referenced by processBlock(), and reconstructParticles().
|
protected |
the extra photon collection
Definition at line 269 of file PFAlgo.h.
Referenced by processBlock(), reconstructParticles(), setPhotonExtraRef(), and transferPhotonExtra().
|
private |
Definition at line 363 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 374 of file PFAlgo.h.
Referenced by processBlock(), reconstructCluster(), setPFPhotonParameters(), and setPFVertexParameters().
|
private |
Definition at line 359 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Flags to use the protection against fakes and not reconstructed displaced vertices
Definition at line 338 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 339 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 322 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 323 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 325 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 326 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 305 of file PFAlgo.h.
Referenced by processBlock(), and setParameters().
|
private |
Definition at line 306 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 321 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 320 of file PFAlgo.h.
Referenced by setEGElectronCollection(), and setPFEleParameters().
|
private |
Definition at line 308 of file PFAlgo.h.
Referenced by processBlock(), and setHOTag().
|
private |
Definition at line 342 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 343 of file PFAlgo.h.
Referenced by isFromSecInt(), and setDisplacedVerticesParameters().
|
private |
Definition at line 316 of file PFAlgo.h.
Referenced by processBlock(), setElectronExtraRef(), setPFEleParameters(), and ~PFAlgo().
|
private |
Definition at line 341 of file PFAlgo.h.
Referenced by isFromSecInt(), and setDisplacedVerticesParameters().
|
private |
Definition at line 317 of file PFAlgo.h.
Referenced by processBlock(), setPFPhotonParameters(), setPFVertexParameters(), setPhotonExtraRef(), and ~PFAlgo().
|
private |
Definition at line 319 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 375 of file PFAlgo.h.
Referenced by reconstructCluster(), setPFPhotonParameters(), and setPFVertexParameters().