#include <PFAlgo.h>
Public Member Functions | |
void | checkCleaning (const reco::PFRecHitCollection &cleanedHF) |
Check HF Cleaning. More... | |
PFMuonAlgo * | getPFMuonAlgo () |
PFAlgo () | |
constructor More... | |
const std::unique_ptr< reco::PFCandidateCollection > & | pfCandidates () const |
void | reconstructParticles (const reco::PFBlockHandle &blockHandle) |
void | reconstructParticles (const reco::PFBlockCollection &blocks) |
reconstruct particles More... | |
void | setAlgo (int algo) |
void | setBadHcalTrackParams (const edm::ParameterSet &pset) |
void | setCandConnectorParameters (const edm::ParameterSet &iCfgCandConnector) |
void | setCandConnectorParameters (bool bCorrect, bool bCalibPrimary, double dptRel_PrimaryTrack, double dptRel_MergedTrack, double ptErrorSecondary, const 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 | setEGammaCollections (const edm::View< reco::PFCandidate > &pfEgammaCandidates, const edm::ValueMap< reco::GsfElectronRef > &valueMapGedElectrons, const edm::ValueMap< reco::PhotonRef > &valueMapGedPhotons) |
void | setEGammaParameters (bool use_EGammaFilters, std::string ele_iso_path_mvaWeightFile, double ele_iso_pt, double ele_iso_mva_barrel, double ele_iso_mva_endcap, double ele_iso_combIso_barrel, double ele_iso_combIso_endcap, double ele_noniso_mva, unsigned int ele_missinghits, bool useProtectionsForJetMET, const edm::ParameterSet &ele_protectionsForJetMET, const edm::ParameterSet &ele_protectionsForBadHcal, double ph_MinEt, double ph_combIso, double ph_HoE, double ph_sietaieta_eb, double ph_sietaieta_ee, const edm::ParameterSet &ph_protectionsForJetMET, const edm::ParameterSet &ph_protectionsForBadHcal) |
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 std::shared_ptr< PFEnergyCalibration > &calibration, const std::shared_ptr< PFEnergyCalibrationHF > &thepfEnergyCalibrationHF) |
void | setPFEleParameters (double mvaEleCut, std::string mvaWeightFileEleID, bool usePFElectrons, const std::shared_ptr< PFSCEnergyCalibration > &thePFSCEnergyCalibration, const std::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 std::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) |
std::shared_ptr< PFEnergyCalibration > | thePFEnergyCalibration () |
return the pointer to the calibration function More... | |
std::unique_ptr< reco::PFCandidateCollection > | transferCandidates () |
std::unique_ptr< reco::PFCandidateCollection > | transferCleanedCandidates () |
std::unique_ptr< reco::PFCandidateCollection > | transferElectronCandidates () |
std::unique_ptr< reco::PFCandidateElectronExtraCollection > | transferElectronExtra () |
std::unique_ptr< reco::PFCandidatePhotonExtraCollection > | transferPhotonExtra () |
~PFAlgo () | |
destructor More... | |
Private 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... | |
reco::PFBlockRef | createBlockRef (const reco::PFBlockCollection &blocks, unsigned bi) |
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 () |
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) |
void | setHcalDepthInfo (reco::PFCandidate &cand, const reco::PFCluster &cluster) const |
Friends | |
std::ostream & | operator<< (std::ostream &out, const PFAlgo &algo) |
PFAlgo::PFAlgo | ( | ) |
constructor
Definition at line 51 of file PFAlgo.cc.
PFAlgo::~PFAlgo | ( | ) |
destructor
Definition at line 63 of file PFAlgo.cc.
References pfegamma_, pfele_, pfpho_, useEGammaFilters_, usePFElectrons_, and usePFPhotons_.
|
private |
Associate PS clusters to a given ECAL cluster, and return their energy.
Definition at line 3467 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 3660 of file PFAlgo.cc.
References gather_cfg::cout, debug_, reco::PFRecHit::energy(), mps_fire::i, reco::PFRecHit::layer(), Basic3DVector< T >::mag2(), minDeltaMet_, GetRecoTauVFromDQM_MC_cff::next, pfCandidates_, reco::PFRecHit::position(), EnergyCorrector::pt, reconstructCluster(), createPayload::skip, mathSSE::sqrt(), reco::PFRecHit::time(), Basic3DVector< T >::x(), Basic3DVector< T >::y(), and Basic3DVector< T >::z().
Referenced by setCandConnectorParameters().
|
private |
create a reference to a block, transient or persistent depending on the needs
Definition at line 3455 of file PFAlgo.cc.
References blockHandle_, and edm::HandleBase::isValid().
Referenced by reconstructParticles().
PFMuonAlgo * PFAlgo::getPFMuonAlgo | ( | ) |
Definition at line 85 of file PFAlgo.cc.
References pfmu_.
Referenced by setCandConnectorParameters().
|
private |
Definition at line 3521 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().
|
private |
todo: use PFClusterTools for this
Definition at line 3406 of file PFAlgo.cc.
References mathSSE::sqrt().
Referenced by processBlock(), and thePFEnergyCalibration().
|
private |
Definition at line 3421 of file PFAlgo.cc.
References JetChargeProducer_cfi::exp, and nSigmaHCAL_.
Referenced by processBlock(), setDebug(), setParameters(), and thePFEnergyCalibration().
|
inline |
Definition at line 197 of file PFAlgo.h.
References pfCandidates_.
Referenced by operator<<().
|
private |
Definition at line 3557 of file PFAlgo.cc.
References gather_cfg::cout, hiPixelPairStep_cff::deltaPhi, reco::PFCandidate::egamma_HF, reco::PFCandidate::h_HF, mps_fire::i, maxDeltaPhiPt_, maxSignificance_, minDeltaMet_, minHFCleaningPt_, minSignificance_, minSignificanceReduction_, GetRecoTauVFromDQM_MC_cff::next, reco::PFCandidate::particleId(), pfCandidates_, pfCleanedCandidates_, postHFCleaning_, reco::LeafCandidate::pt(), reco::LeafCandidate::px(), reco::LeafCandidate::py(), createPayload::skip, and mathSSE::sqrt().
Referenced by reconstructParticles().
|
private |
process one block. can be reimplemented in more sophisticated algorithms
Definition at line 530 of file PFAlgo.cc.
References a, funct::abs(), patPFMETCorrections_cff::algo, associatePSClusters(), b, reco::CaloCluster::badHcalMarker, edm::OwnVector< T, P >::begin(), groupFilesInBlocks::block, fftjetpileupestimator_calo_uncalib_cfi::c0, alignmentValidation::c1, calibration_, MessageLogger_cfi::cerr, reco::LeafCandidate::charge(), muons2muons_cfi::chargedHadron, trackerTree::check(), reco::TrackBase::conversionStep, gather_cfg::cout, debug_, dptRel_DispVtx_, reco::PFCandidate::e, RecoEcal_EventContent_cff::ec, ECAL, digitizers_cfi::ecal, reco::PFBlockElement::ECAL, RecoEcal_cff::ecalClusters, reco::PFCandidate::egammaExtraRef(), allElectronIsolations_cfi::elements, reco::PFCandidate::elementsInBlocks(), edm::OwnVector< T, P >::empty(), reco::LeafCandidate::energy(), PFTrackAlgoTools::errorScale(), PVValHelper::eta, reco::LeafCandidate::eta(), factors45_, plotBeamSpotDB::first, flags, dedxEstimators_cff::fraction, reco::PFCandidate::gamma, PFElectronAlgo::getAllElectronCandidates(), PFElectronAlgo::getElectronCandidates(), PFElectronAlgo::getElectronExtra(), goodPixelTrackDeadHcal_chi2n_, goodPixelTrackDeadHcal_dxy_, goodPixelTrackDeadHcal_dz_, goodPixelTrackDeadHcal_maxLost3Hit_, goodPixelTrackDeadHcal_maxLost4Hit_, goodPixelTrackDeadHcal_maxPt_, goodPixelTrackDeadHcal_minEta_, goodPixelTrackDeadHcal_ptErrRel_, goodTrackDeadHcal_chi2n_, goodTrackDeadHcal_dxy_, goodTrackDeadHcal_layers_, goodTrackDeadHcal_ptErrRel_, goodTrackDeadHcal_validFr_, reco::PFBlockElement::GSF, HCAL, digitizers_cfi::hcal, reco::PFBlockElement::HCAL, PFLayer::HF_EM, PFLayer::HF_HAD, reco::TrackBase::highPurity, photonIsolationHIProducer_cfi::ho, reco::PFBlockElement::HO, hcaldqm::constants::HO, mps_fire::i, cuy::ii, PFEGammaFilters::isElectron(), PFEGammaFilters::isElectronSafeForJetMET(), PFElectronAlgo::isElectronValidCandidate(), isFromSecInt(), PFMuonAlgo::isGlobalTightMuon(), PFMuonAlgo::isIsolatedMuon(), PFMuonAlgo::isLooseMuon(), PFMuonAlgo::isMuon(), edm::Ref< C, T, F >::isNonnull(), edm::Ref< C, T, F >::isNull(), PFEGammaFilters::isPhotonSafeForJetMET(), PFPhotonAlgo::isPhotonValidCandidate(), PFMuonAlgo::isTrackerTightMuon(), reco::PFBlock::LINKTEST_ALL, SiStripPI::max, min(), reco::PFCandidate::mu, muonECAL_, muonHCAL_, muonHO_, reco::PFCandidate::mva_e_pi(), neutralHadronEnergyResolution(), jets_cff::nMuons, nSigmaECAL_, nSigmaHCAL(), nSigmaTRACK_, nVtx_, convertSQLiteXML::ok, AlCaHLTBitMon_ParallelJobs::p, objects.autophobj::particleType, PFEGammaFilters::passElectronSelection(), PFEGammaFilters::passPhotonSelection(), pfCandidates_, pfegamma_, pfEgammaCandidates_, pfele_, pfElectronCandidates_, pfElectronExtra_, pfpho_, pfPhotonCandidates_, pfPhotonExtra_, reco::LeafCandidate::phi(), reco::Vertex::position(), primaryVertex_, reco::PFBlockElement::PS1, reco::PFBlockElement::PS2, reco::LeafCandidate::pt(), ptError_, edm::OwnVector< T, P >::push_back(), jets_cff::quality, reconstructCluster(), reconstructTrack(), edm::View< T >::refAt(), rejectTracks_Bad_, rejectTracks_Step45_, edm::second(), reco::PFCandidate::set_mva_e_pi(), reco::PFCandidate::set_mva_Isolated(), reco::PFCandidate::set_mva_nothing_gamma(), reco::LeafCandidate::setCharge(), reco::PFCandidate::setEcalEnergy(), setHcalDepthInfo(), reco::PFCandidate::setHcalEnergy(), reco::PFCandidate::setHoEnergy(), reco::LeafCandidate::setP4(), reco::PFCandidate::setParticleType(), reco::PFBlockElementTrack::setPositionAtECALEntrance(), reco::PFCandidate::setVertex(), edm::OwnVector< T, P >::size(), edm::View< T >::size(), createPayload::skip, mathSSE::sqrt(), PFTrackAlgoTools::step45(), PFTrackAlgoTools::step5(), reco::PFBlockElement::T_FROM_GAMMACONV, thepfEnergyCalibrationHF_, reco::PFBlockElement::TRACK, reco::btau::trackMomentum, funct::true, useEGammaFilters_, useHO_, usePFConversions_, usePFElectrons_, usePFPhotons_, useProtectionsForJetMET_, findQualityFiles::v, x, X, reco::Vertex::x(), DOFs::Y, reco::Vertex::y(), DOFs::Z, and reco::Vertex::z().
Referenced by reconstructParticles(), and thePFEnergyCalibration().
|
private |
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 3261 of file PFAlgo.cc.
References ALCARECOTkAlJpsiMuMu_cff::charge, gather_cfg::cout, debug_, PFLayer::ECAL_BARREL, PFLayer::ECAL_ENDCAP, CustomPhysics_cfi::gamma, PFLayer::HCAL_BARREL1, PFLayer::HCAL_ENDCAP, PFLayer::HF_EM, PFLayer::HF_HAD, reco::PFCluster::layer(), ResonanceBuilder::mass, objects.autophobj::particleType, pfElectronTranslator_cfi::PFCandidate, pfCandidates_, reco::CaloCluster::position(), primaryVertex_, setHcalDepthInfo(), mathSSE::sqrt(), tmp, useVertices_, reco::PFCandidate::X, reco::Vertex::x(), reco::Vertex::y(), and reco::Vertex::z().
Referenced by checkCleaning(), processBlock(), and thePFEnergyCalibration().
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 407 of file PFAlgo.cc.
References blockHandle_.
Referenced by setCandConnectorParameters().
void PFAlgo::reconstructParticles | ( | const reco::PFBlockCollection & | blocks | ) |
reconstruct particles
Definition at line 415 of file PFAlgo.cc.
References PFMuonAlgo::addMissingMuons(), groupFilesInBlocks::block, gather_cfg::cout, createBlockRef(), debug_, digitizers_cfi::ecal, reco::PFBlockElement::ECAL, allElectronIsolations_cfi::elements, reco::PFBlock::elements(), relativeConstraints::empty, reco::PFBlockElement::HCAL, reco::PFBlockElement::HO, mps_fire::i, edm::HandleBase::isValid(), muonHandle_, trackingPlots::other, pfCandidates_, pfCleanedCandidates_, pfElectronCandidates_, pfElectronExtra_, pfmu_, pfPhotonCandidates_, pfPhotonExtra_, PFMuonAlgo::postClean(), postCleaning(), processBlock(), and edm::OwnVector< T, P >::size().
|
private |
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 3182 of file PFAlgo.cc.
References ALCARECOTkAlJpsiMuMu_cff::charge, reco::TrackBase::charge(), gather_cfg::cout, debug_, dptRel_DispVtx_, reco::TrackBase::eta(), reco::PFCandidate::h, isFromSecInt(), reco::isMuon(), edm::Ref< C, T, F >::isNonnull(), reco::PFBlockElement::isTimeValid(), reco::TrackBase::p(), objects.autophobj::particleType, pfElectronTranslator_cfi::PFCandidate, pfCandidates_, pfmu_, reco::TrackBase::phi(), reco::TrackBase::pt(), 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, reco::PFBlockElement::time(), reco::PFBlockElement::timeError(), and HiIsolationCommonParameters_cff::track.
Referenced by processBlock(), and thePFEnergyCalibration().
|
inline |
void PFAlgo::setBadHcalTrackParams | ( | const edm::ParameterSet & | pset | ) |
Definition at line 304 of file PFAlgo.cc.
References edm::ParameterSet::getParameter(), goodPixelTrackDeadHcal_chi2n_, goodPixelTrackDeadHcal_dxy_, goodPixelTrackDeadHcal_dz_, goodPixelTrackDeadHcal_maxLost3Hit_, goodPixelTrackDeadHcal_maxLost4Hit_, goodPixelTrackDeadHcal_maxPt_, goodPixelTrackDeadHcal_minEta_, goodPixelTrackDeadHcal_ptErrRel_, goodTrackDeadHcal_chi2n_, goodTrackDeadHcal_dxy_, goodTrackDeadHcal_layers_, goodTrackDeadHcal_ptErrRel_, and goodTrackDeadHcal_validFr_.
Referenced by setCandConnectorParameters().
|
inline |
Definition at line 70 of file PFAlgo.h.
References connector_, and PFCandConnector::setParameters().
|
inline |
Definition at line 74 of file PFAlgo.h.
References particleFlowSuperClusterECAL_cfi::applyCrackCorrections, gather_cfg::blocks, checkCleaning(), particleFlow_cfi::cleanedHF, particleFlow_cfi::coneEcalIsoForEgammaSC, particleFlow_cfi::coneTrackIsoForEgammaSC, connector_, particleFlow_cfi::dptRel_DispVtx, getPFMuonAlgo(), particleFlow_cfi::maxDeltaPhiPt, particleFlow_cfi::maxSignificance, particleFlow_cfi::minDeltaMet, particleFlow_cfi::minHFCleaningPt, particleFlow_cfi::minSignificance, particleFlow_cfi::minSignificanceReduction, particleFlow_cfi::nTrackIsoForEgammaSC, particleBasedIsoProducer_cfi::pfEgammaCandidates, particleFlow_cfi::postHFCleaning, jets_cff::primaryVertices, muonDTDigis_cfi::pset, reconstructParticles(), hltParticleFlowForJets_cfi::rejectTracks_Bad, hltParticleFlowForJets_cfi::rejectTracks_Step45, setBadHcalTrackParams(), setDisplacedVerticesParameters(), setEGammaCollections(), setEGammaParameters(), setEGElectronCollection(), setElectronExtraRef(), PFCandConnector::setParameters(), setPFEleParameters(), setPFMuonAndFakeParameters(), setPFPhotonParameters(), setPFPhotonRegWeights(), setPFVertexParameters(), setPhotonExtraRef(), setPostHFCleaningParameters(), AlCaHLTBitMon_QueryRunRegistry::string, particleFlow_cfi::sumEtEcalIsoForEgammaSC_barrel, particleFlow_cfi::sumEtEcalIsoForEgammaSC_endcap, particleFlow_cfi::sumPtTrackIsoForEgammaSC_barrel, particleFlow_cfi::sumPtTrackIsoForEgammaSC_endcap, particleFlow_cfi::sumPtTrackIsoForPhoton, particleFlow_cfi::sumPtTrackIsoSlopeForPhoton, thePFEnergyCalibration(), hltParticleFlowForJets_cfi::useEGammaSupercluster, Reconstruction_hiPF_cff::usePFConversions, particleFlow_cfi::usePFDecays, Reconstruction_hiPF_cff::usePFElectrons, hltParticleFlowForJets_cfi::usePFNuclearInteractions, hltParticleFlowForJets_cfi::usePFSCEleCalib, hltParticleFlowForJets_cfi::useProtectionsForJetMET, VerticesFromLeptons_cfi::useVertex, and particleFlow_cfi::X0_Map.
|
inline |
Definition at line 63 of file PFAlgo.h.
References connector_, debug, debug_, nSigmaHCAL(), pfegamma_, PFEGammaFilters::setDebug(), PFCandConnector::setDebug(), and setParameters().
void PFAlgo::setDisplacedVerticesParameters | ( | bool | rejectTracks_Bad, |
bool | rejectTracks_Step45, | ||
bool | usePFNuclearInteractions, | ||
bool | usePFConversions, | ||
bool | usePFDecays, | ||
double | dptRel_DispVtx | ||
) |
Definition at line 346 of file PFAlgo.cc.
References particleFlow_cfi::dptRel_DispVtx, dptRel_DispVtx_, hltParticleFlowForJets_cfi::rejectTracks_Bad, rejectTracks_Bad_, hltParticleFlowForJets_cfi::rejectTracks_Step45, rejectTracks_Step45_, Reconstruction_hiPF_cff::usePFConversions, usePFConversions_, particleFlow_cfi::usePFDecays, usePFDecays_, hltParticleFlowForJets_cfi::usePFNuclearInteractions, and usePFNuclearInteractions_.
Referenced by setCandConnectorParameters().
void PFAlgo::setEGammaCollections | ( | const edm::View< reco::PFCandidate > & | pfEgammaCandidates, |
const edm::ValueMap< reco::GsfElectronRef > & | valueMapGedElectrons, | ||
const edm::ValueMap< reco::PhotonRef > & | valueMapGedPhotons | ||
) |
Definition at line 263 of file PFAlgo.cc.
References particleBasedIsoProducer_cfi::pfEgammaCandidates, pfEgammaCandidates_, useEGammaFilters_, valueMapGedElectrons_, and valueMapGedPhotons_.
Referenced by setCandConnectorParameters().
void PFAlgo::setEGammaParameters | ( | bool | use_EGammaFilters, |
std::string | ele_iso_path_mvaWeightFile, | ||
double | ele_iso_pt, | ||
double | ele_iso_mva_barrel, | ||
double | ele_iso_mva_endcap, | ||
double | ele_iso_combIso_barrel, | ||
double | ele_iso_combIso_endcap, | ||
double | ele_noniso_mva, | ||
unsigned int | ele_missinghits, | ||
bool | useProtectionsForJetMET, | ||
const edm::ParameterSet & | ele_protectionsForJetMET, | ||
const edm::ParameterSet & | ele_protectionsForBadHcal, | ||
double | ph_MinEt, | ||
double | ph_combIso, | ||
double | ph_HoE, | ||
double | ph_sietaieta_eb, | ||
double | ph_sietaieta_ee, | ||
const edm::ParameterSet & | ph_protectionsForJetMET, | ||
const edm::ParameterSet & | ph_protectionsForBadHcal | ||
) |
Definition at line 204 of file PFAlgo.cc.
References pfegamma_, useEGammaFilters_, hltParticleFlowForJets_cfi::useProtectionsForJetMET, and useProtectionsForJetMET_.
Referenced by setCandConnectorParameters().
void PFAlgo::setEGElectronCollection | ( | const reco::GsfElectronCollection & | egelectrons | ) |
Definition at line 3552 of file PFAlgo.cc.
References pfele_, PFElectronAlgo::setEGElectronCollection(), and useEGElectrons_.
Referenced by setCandConnectorParameters().
void PFAlgo::setElectronExtraRef | ( | const edm::OrphanHandle< reco::PFCandidateElectronExtraCollection > & | extrah | ) |
Definition at line 3764 of file PFAlgo.cc.
References MillePedeFileConverter_cfg::e, pfCandidates_, pfElectronCandidates_, pfElectronExtra_, and usePFElectrons_.
Referenced by setCandConnectorParameters().
|
private |
Definition at line 3375 of file PFAlgo.cc.
References Exception, lumiContext::fill, DetId::Hcal, mps_fire::i, reco::PFCluster::recHitFractions(), and reco::PFCandidate::setHcalDepthEnergyFractions().
Referenced by processBlock(), reconstructCluster(), and thePFEnergyCalibration().
|
inline |
void PFAlgo::setMuonHandle | ( | const edm::Handle< reco::MuonCollection > & | muons | ) |
Definition at line 323 of file PFAlgo.cc.
References muonHandle_, and extraflags_cff::muons.
Referenced by setPFMuonAlgo().
void PFAlgo::setParameters | ( | double | nSigmaECAL, |
double | nSigmaHCAL, | ||
const std::shared_ptr< PFEnergyCalibration > & | calibration, | ||
const std::shared_ptr< PFEnergyCalibrationHF > & | thepfEnergyCalibrationHF | ||
) |
Definition at line 71 of file PFAlgo.cc.
References calibration_, nSigmaECAL_, nSigmaHCAL(), nSigmaHCAL_, and thepfEnergyCalibrationHF_.
Referenced by setDebug().
void PFAlgo::setPFEleParameters | ( | double | mvaEleCut, |
std::string | mvaWeightFileEleID, | ||
bool | usePFElectrons, | ||
const std::shared_ptr< PFSCEnergyCalibration > & | thePFSCEnergyCalibration, | ||
const std::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 91 of file PFAlgo.cc.
References particleFlowSuperClusterECAL_cfi::applyCrackCorrections, applyCrackCorrectionsElectrons_, particleFlow_cfi::coneEcalIsoForEgammaSC, coneEcalIsoForEgammaSC_, particleFlow_cfi::coneTrackIsoForEgammaSC, coneTrackIsoForEgammaSC_, mvaEleCut_, mvaWeightFileEleID_, particleFlow_cfi::nTrackIsoForEgammaSC, nTrackIsoForEgammaSC_, pfele_, particleFlow_cfi::sumEtEcalIsoForEgammaSC_barrel, sumEtEcalIsoForEgammaSC_barrel_, particleFlow_cfi::sumEtEcalIsoForEgammaSC_endcap, sumEtEcalIsoForEgammaSC_endcap_, particleFlow_cfi::sumPtTrackIsoForEgammaSC_barrel, sumPtTrackIsoForEgammaSC_barrel_, particleFlow_cfi::sumPtTrackIsoForEgammaSC_endcap, sumPtTrackIsoForEgammaSC_endcap_, thePFSCEnergyCalibration_, hltParticleFlowForJets_cfi::useEGammaSupercluster, useEGammaSupercluster_, useEGElectrons_, Reconstruction_hiPF_cff::usePFElectrons, usePFElectrons_, hltParticleFlowForJets_cfi::usePFSCEleCalib, and usePFSCEleCalib_.
Referenced by setCandConnectorParameters().
|
inline |
Definition at line 61 of file PFAlgo.h.
References patPFMETCorrections_cff::algo, pfmu_, and setMuonHandle().
void PFAlgo::setPFMuonAndFakeParameters | ( | const edm::ParameterSet & | pset | ) |
Definition at line 287 of file PFAlgo.cc.
References factors45_, edm::ParameterSet::getParameter(), muonECAL_, muonHCAL_, muonHO_, nSigmaTRACK_, pfmu_, ptError_, and PFMuonAlgo::setParameters().
Referenced by setCandConnectorParameters().
void PFAlgo::setPFPhotonParameters | ( | bool | usePFPhoton, |
std::string | mvaWeightFileConvID, | ||
double | mvaConvCut, | ||
bool | useReg, | ||
std::string | X0_Map, | ||
const std::shared_ptr< PFEnergyCalibration > & | thePFEnergyCalibration, | ||
double | sumPtTrackIsoForPhoton, | ||
double | sumPtTrackIsoSlopeForPhoton | ||
) |
Definition at line 153 of file PFAlgo.cc.
References MillePedeFileConverter_cfg::e, AlCaHLTBitMon_ParallelJobs::p, pfpho_, primaryVertex_, MetAnalyzer::pv(), particleFlow_cfi::usePFPhotons, usePFPhotons_, and useVertices_.
Referenced by setCandConnectorParameters().
void PFAlgo::setPFPhotonRegWeights | ( | const GBRForest * | LCorrForestEB, |
const GBRForest * | LCorrForestEE, | ||
const GBRForest * | GCorrForestBarrel, | ||
const GBRForest * | GCorrForestEndcapHr9, | ||
const GBRForest * | GCorrForestEndcapLr9, | ||
const GBRForest * | PFEcalResolution | ||
) |
Definition at line 274 of file PFAlgo.cc.
References pfpho_, and PFPhotonAlgo::setGBRForest().
Referenced by setCandConnectorParameters().
void PFAlgo::setPFVertexParameters | ( | bool | useVertex, |
const reco::VertexCollection * | primaryVertices | ||
) |
Definition at line 364 of file PFAlgo.cc.
References MillePedeFileConverter_cfg::e, nVtx_, AlCaHLTBitMon_ParallelJobs::p, pfmu_, pfpho_, primaryVertex_, PFMuonAlgo::setInputsForCleaning(), PFPhotonAlgo::setnPU(), PFPhotonAlgo::setPhotonPrimaryVtx(), usePFPhotons_, VerticesFromLeptons_cfi::useVertex, and useVertices_.
Referenced by setCandConnectorParameters().
void PFAlgo::setPhotonExtraRef | ( | const edm::OrphanHandle< reco::PFCandidatePhotonExtraCollection > & | pf_extrah | ) |
Definition at line 3813 of file PFAlgo.cc.
References runEdmFileComparison::found, CustomPhysics_cfi::gamma, pfCandidates_, pfPhotonExtra_, muons2muons_cfi::photon, and usePFPhotons_.
Referenced by setCandConnectorParameters().
void PFAlgo::setPostHFCleaningParameters | ( | bool | postHFCleaning, |
double | minHFCleaningPt, | ||
double | minSignificance, | ||
double | maxSignificance, | ||
double | minSignificanceReduction, | ||
double | maxDeltaPhiPt, | ||
double | minDeltaMet | ||
) |
Definition at line 329 of file PFAlgo.cc.
References particleFlow_cfi::maxDeltaPhiPt, maxDeltaPhiPt_, particleFlow_cfi::maxSignificance, maxSignificance_, particleFlow_cfi::minDeltaMet, minDeltaMet_, particleFlow_cfi::minHFCleaningPt, minHFCleaningPt_, particleFlow_cfi::minSignificance, minSignificance_, particleFlow_cfi::minSignificanceReduction, minSignificanceReduction_, particleFlow_cfi::postHFCleaning, and postHFCleaning_.
Referenced by setCandConnectorParameters().
|
inline |
return the pointer to the calibration function
Definition at line 235 of file PFAlgo.h.
References patPFMETCorrections_cff::algo, calibration_, neutralHadronEnergyResolution(), nSigmaHCAL(), operator<<, MillePedeFileConverter_cfg::out, processBlock(), reconstructCluster(), reconstructTrack(), and setHcalDepthInfo().
Referenced by setCandConnectorParameters().
|
inline |
Definition at line 230 of file PFAlgo.h.
References PFCandConnector::connect(), connector_, and pfCandidates_.
|
inline |
Definition at line 225 of file PFAlgo.h.
References eostools::move(), and pfCleanedCandidates_.
|
inline |
Definition at line 202 of file PFAlgo.h.
References eostools::move(), and pfElectronCandidates_.
|
inline |
Definition at line 208 of file PFAlgo.h.
References pfElectronExtra_, and mps_fire::result.
|
inline |
Definition at line 217 of file PFAlgo.h.
References pfPhotonExtra_, and mps_fire::result.
|
friend |
Referenced by thePFEnergyCalibration().
|
private |
Definition at line 342 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
input block handle (full framework case)
Definition at line 320 of file PFAlgo.h.
Referenced by createBlockRef(), and reconstructParticles().
|
private |
Definition at line 328 of file PFAlgo.h.
Referenced by operator<<(), processBlock(), setParameters(), and thePFEnergyCalibration().
|
private |
Definition at line 348 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 351 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
A tool used for a postprocessing of displaced vertices based on reconstructed PFCandidates
Definition at line 386 of file PFAlgo.h.
Referenced by setCandConnectorParameters(), setDebug(), and transferCandidates().
|
private |
Definition at line 334 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 381 of file PFAlgo.h.
Referenced by processBlock(), reconstructTrack(), and setDisplacedVerticesParameters().
|
private |
Definition at line 394 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 406 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 409 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 410 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 407 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 408 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 404 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 403 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 405 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 398 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 401 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 399 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Variables for track cleaning in bad HCal areas.
Definition at line 397 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 400 of file PFAlgo.h.
Referenced by processBlock(), and setBadHcalTrackParams().
|
private |
Definition at line 420 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 418 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 421 of file PFAlgo.h.
Referenced by checkCleaning(), postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 416 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 417 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 419 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 390 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 428 of file PFAlgo.h.
Referenced by reconstructParticles(), and setMuonHandle().
|
private |
Variables for muons and fakes.
Definition at line 389 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 391 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 339 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Variables for PFElectrons.
Definition at line 337 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
number of sigma to judge energy excess in ECAL
Definition at line 323 of file PFAlgo.h.
Referenced by operator<<(), processBlock(), and setParameters().
|
private |
number of sigma to judge energy excess in HCAL
Definition at line 326 of file PFAlgo.h.
Referenced by nSigmaHCAL(), operator<<(), and setParameters().
|
private |
Definition at line 392 of file PFAlgo.h.
Referenced by processBlock(), and setPFMuonAndFakeParameters().
|
private |
Definition at line 352 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 382 of file PFAlgo.h.
Referenced by processBlock(), and setPFVertexParameters().
|
private |
Definition at line 286 of file PFAlgo.h.
Referenced by checkCleaning(), operator<<(), pfCandidates(), postCleaning(), processBlock(), reconstructCluster(), reconstructParticles(), reconstructTrack(), setElectronExtraRef(), setPhotonExtraRef(), and transferCandidates().
|
private |
Definition at line 292 of file PFAlgo.h.
Referenced by postCleaning(), reconstructParticles(), and transferCleanedCandidates().
|
private |
Definition at line 360 of file PFAlgo.h.
Referenced by processBlock(), setDebug(), setEGammaParameters(), and ~PFAlgo().
|
private |
Definition at line 362 of file PFAlgo.h.
Referenced by processBlock(), and setEGammaCollections().
|
private |
Definition at line 353 of file PFAlgo.h.
Referenced by processBlock(), setEGElectronCollection(), setPFEleParameters(), and ~PFAlgo().
|
private |
the unfiltered electron collection
Definition at line 288 of file PFAlgo.h.
Referenced by processBlock(), reconstructParticles(), setElectronExtraRef(), and transferElectronCandidates().
|
private |
the unfiltered electron collection
Definition at line 295 of file PFAlgo.h.
Referenced by processBlock(), reconstructParticles(), setElectronExtraRef(), and transferElectronExtra().
|
private |
Definition at line 355 of file PFAlgo.h.
Referenced by getPFMuonAlgo(), reconstructParticles(), reconstructTrack(), setPFMuonAlgo(), setPFMuonAndFakeParameters(), and setPFVertexParameters().
|
private |
Definition at line 354 of file PFAlgo.h.
Referenced by processBlock(), setPFPhotonParameters(), setPFPhotonRegWeights(), setPFVertexParameters(), and ~PFAlgo().
|
private |
the unfiltered photon collection
Definition at line 290 of file PFAlgo.h.
Referenced by processBlock(), and reconstructParticles().
|
private |
the extra photon collection
Definition at line 297 of file PFAlgo.h.
Referenced by processBlock(), reconstructParticles(), setPhotonExtraRef(), and transferPhotonExtra().
|
private |
Definition at line 414 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 425 of file PFAlgo.h.
Referenced by processBlock(), reconstructCluster(), setPFPhotonParameters(), and setPFVertexParameters().
|
private |
Definition at line 393 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 372 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 373 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 346 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 347 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 349 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 350 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 329 of file PFAlgo.h.
Referenced by processBlock(), and setParameters().
|
private |
Definition at line 330 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Variables for NEW EGAMMA selection.
Definition at line 359 of file PFAlgo.h.
Referenced by processBlock(), setEGammaCollections(), setEGammaParameters(), and ~PFAlgo().
|
private |
Definition at line 345 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 344 of file PFAlgo.h.
Referenced by setEGElectronCollection(), and setPFEleParameters().
|
private |
Definition at line 332 of file PFAlgo.h.
Referenced by processBlock(), and setHOTag().
|
private |
Definition at line 376 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 377 of file PFAlgo.h.
Referenced by isFromSecInt(), and setDisplacedVerticesParameters().
|
private |
Definition at line 340 of file PFAlgo.h.
Referenced by processBlock(), setElectronExtraRef(), setPFEleParameters(), and ~PFAlgo().
|
private |
Definition at line 375 of file PFAlgo.h.
Referenced by isFromSecInt(), and setDisplacedVerticesParameters().
|
private |
Definition at line 341 of file PFAlgo.h.
Referenced by processBlock(), setPFPhotonParameters(), setPFVertexParameters(), setPhotonExtraRef(), and ~PFAlgo().
|
private |
Definition at line 343 of file PFAlgo.h.
Referenced by setPFEleParameters().
|
private |
Definition at line 361 of file PFAlgo.h.
Referenced by processBlock(), and setEGammaParameters().
|
private |
Definition at line 426 of file PFAlgo.h.
Referenced by reconstructCluster(), setPFPhotonParameters(), and setPFVertexParameters().
|
private |
Definition at line 363 of file PFAlgo.h.
Referenced by setEGammaCollections().
|
private |
Definition at line 364 of file PFAlgo.h.
Referenced by setEGammaCollections().