#include <PFAlgo.h>
Public Member Functions | |
void | checkCleaning (const reco::PFRecHitCollection &cleanedHF) |
Check HF Cleaning. More... | |
reco::PFCandidateCollection & | getCleanedCandidates () |
PFMuonAlgo * | getPFMuonAlgo () |
reco::PFCandidateCollection | makeConnectedCandidates () |
PFAlgo (double nSigmaECAL, double nSigmaHCAL, double nSigmaHFEM, double nSigmaHFHAD, std::vector< double > resolHF_square, PFEnergyCalibration &calibration, PFEnergyCalibrationHF &thepfEnergyCalibrationHF, const edm::ParameterSet &pset) | |
constructor More... | |
void | reconstructParticles (const reco::PFBlockHandle &blockHandle, PFEGammaFilters const *pfegamma) |
reconstruct particles More... | |
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 | 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, bool useProtectionsForJetMET) |
void | setEGElectronCollection (const reco::GsfElectronCollection &egelectrons) |
void | setHOTag (bool ho) |
void | setMuonHandle (const edm::Handle< reco::MuonCollection > &muons) |
void | setPFVertexParameters (bool useVertex, reco::VertexCollection const &primaryVertices) |
void | setPostHFCleaningParameters (bool postHFCleaning, const edm::ParameterSet &pfHFCleaningParams) |
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... | |
bool | checkAndReconstructSecondaryInteraction (const reco::PFBlockRef &blockref, const edm::OwnVector< reco::PFBlockElement > &elements, bool isActive, int iElement) |
bool | checkGoodTrackDeadHcal (const reco::TrackRef &trackRef, bool hasDeadHcal) |
bool | checkHasDeadHcal (const std::multimap< double, unsigned > &hcalElems, const std::vector< bool > &deadArea) |
void | conversionAlgo (const edm::OwnVector< reco::PFBlockElement > &elements, std::vector< bool > &active) |
void | createCandidatesECAL (const reco::PFBlock &block, reco::PFBlock::LinkData &linkData, const edm::OwnVector< reco::PFBlockElement > &elements, std::vector< bool > &active, const reco::PFBlockRef &blockref, ElementIndices &inds, std::vector< bool > &deadArea) |
void | createCandidatesHCAL (const reco::PFBlock &block, reco::PFBlock::LinkData &linkData, const edm::OwnVector< reco::PFBlockElement > &elements, std::vector< bool > &active, const reco::PFBlockRef &blockref, ElementIndices &inds, std::vector< bool > &deadArea) |
void | createCandidatesHCALUnlinked (const reco::PFBlock &block, reco::PFBlock::LinkData &linkData, const edm::OwnVector< reco::PFBlockElement > &elements, std::vector< bool > &active, const reco::PFBlockRef &blockref, ElementIndices &inds, std::vector< bool > &deadArea) |
void | createCandidatesHF (const reco::PFBlock &block, reco::PFBlock::LinkData &linkData, const edm::OwnVector< reco::PFBlockElement > &elements, std::vector< bool > &active, const reco::PFBlockRef &blockref, ElementIndices &inds) |
int | decideType (const edm::OwnVector< reco::PFBlockElement > &elements, const reco::PFBlockElement::Type type, std::vector< bool > &active, ElementIndices &inds, std::vector< bool > &deadArea, unsigned int iEle) |
void | egammaFilters (const reco::PFBlockRef &blockref, std::vector< bool > &active, PFEGammaFilters const *pfegamma) |
void | elementLoop (const reco::PFBlock &block, reco::PFBlock::LinkData &linkData, const edm::OwnVector< reco::PFBlockElement > &elements, std::vector< bool > &active, const reco::PFBlockRef &blockref, ElementIndices &inds, std::vector< bool > &deadArea) |
double | hfEnergyResolution (double clusterEnergy) const |
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 |
double | nSigmaHFEM (double clusterEnergy) const |
double | nSigmaHFHAD (double clusterEnergy) const |
void | postCleaning () |
void | processBlock (const reco::PFBlockRef &blockref, std::list< reco::PFBlockRef > &hcalBlockRefs, std::list< reco::PFBlockRef > &ecalBlockRefs, PFEGammaFilters const *pfegamma) |
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) |
bool | recoTracksNotHCAL (const reco::PFBlock &block, reco::PFBlock::LinkData &linkData, const edm::OwnVector< reco::PFBlockElement > &elements, const reco::PFBlockRef &blockref, std::vector< bool > &active, bool goodTrackDeadHcal, bool hasDeadHcal, unsigned int iTrack, std::multimap< double, unsigned > &ecalElems, reco::TrackRef &trackRef) |
void | relinkTrackToHcal (const reco::PFBlock &block, std::multimap< double, unsigned > &ecalElems, std::multimap< double, unsigned > &hcalElems, const std::vector< bool > &active, reco::PFBlock::LinkData &linkData, unsigned int iTrack) |
void | setHcalDepthInfo (reco::PFCandidate &cand, const reco::PFCluster &cluster) const |
Friends | |
std::ostream & | operator<< (std::ostream &out, const PFAlgo &algo) |
PFAlgo::PFAlgo | ( | double | nSigmaECAL, |
double | nSigmaHCAL, | ||
double | nSigmaHFEM, | ||
double | nSigmaHFHAD, | ||
std::vector< double > | resolHF_square, | ||
PFEnergyCalibration & | calibration, | ||
PFEnergyCalibrationHF & | thepfEnergyCalibrationHF, | ||
const edm::ParameterSet & | pset | ||
) |
constructor
Definition at line 15 of file PFAlgo.cc.
References cms::cuda::assert(), factors45_, 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_, muonECAL_, muonHCAL_, muonHO_, nSigmaTRACK_, pfmu_, HLT_2024v12_cff::postMuonCleaning, muonDTDigis_cfi::pset, ptError_, and resolHF_square_.
|
private |
Associate PS clusters to a given ECAL cluster, and return their energy.
Definition at line 3439 of file PFAlgo.cc.
References cms::cuda::assert(), groupFilesInBlocks::block, reco::PFBlockElement::ECAL, bookConverter::elements, edm::Ref< C, T, F >::isNull(), and reco::PFBlock::LINKTEST_ALL.
Referenced by recoTracksNotHCAL().
|
private |
Definition at line 855 of file PFAlgo.cc.
References bookConverter::elements, isFromSecInt(), LogTrace, reconstructTrack(), and runTheMatrix::ret.
Referenced by elementLoop().
void PFAlgo::checkCleaning | ( | const reco::PFRecHitCollection & | cleanedHF | ) |
Check HF Cleaning.
Definition at line 3607 of file PFAlgo.cc.
References mps_fire::i, LogTrace, minDeltaMet_, GetRecoTauVFromDQM_MC_cff::next, pfCandidates_, DiDispStaMuonMonitor_cfi::pt, multPhiCorr_741_25nsDY_cfi::px, multPhiCorr_741_25nsDY_cfi::py, reconstructCluster(), optionsL1T::skip, mathSSE::sqrt(), hit::x, hit::y, and hit::z.
Referenced by PFProducer::produce().
|
private |
Definition at line 902 of file PFAlgo.cc.
References funct::abs(), 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_, LogTrace, reco::Vertex::position(), and primaryVertex_.
Referenced by elementLoop().
|
private |
Definition at line 875 of file PFAlgo.cc.
Referenced by elementLoop().
|
private |
Definition at line 370 of file PFAlgo.cc.
References reco::TrackBase::conversionStep, bookConverter::elements, relativeConstraints::empty, reco::TrackBase::highPurity, LogTrace, quality, and reco::PFBlockElement::T_FROM_GAMMACONV.
Referenced by processBlock().
|
private |
Definition at line 3026 of file PFAlgo.cc.
References cms::cuda::assert(), ECAL, electrons_cff::ecalEnergy, ElementIndices::ecalIs, bookConverter::elements, mps_fire::i, edm::Ref< C, T, F >::isNull(), LogTrace, and reconstructCluster().
Referenced by processBlock().
|
private |
Definition at line 1700 of file PFAlgo.cc.
References a, funct::abs(), cms::cuda::assert(), b, groupFilesInBlocks::block, calibration_, l1ctLayer1_cff::caloResolution, HPSPFTauProducerPuppi_cfi::chargedHadron, RPCNoise_example::check, Calorimetry_cff::dp, dptRel_DispVtx_, MillePedeFileConverter_cfg::e, ECAL, reco::PFBlockElement::ECAL, RecoEcal_cff::ecalClusters, electrons_cff::ecalEnergy, bookConverter::elements, PFEnergyCalibration::energyEmHad(), PFTrackAlgoTools::errorScale(), factors45_, dqmdumpme::first, HLT_2024v12_cff::fraction, HCAL, ElementIndices::hcalIs, photonIsolationHIProducer_cfi::ho, DigiToRawDM_cff::HO, reco::PFBlockElement::HO, mps_fire::i, cuy::ii, isFromSecInt(), PFMuonAlgo::isIsolatedMuon(), PFMuonAlgo::isLooseMuon(), PFMuonAlgo::isMuon(), edm::Ref< C, T, F >::isNull(), phase2tkutil::isPrimary(), dqmiolumiharvest::j, reco::PFBlock::LINKTEST_ALL, LogTrace, SiStripPI::max, SiStripPI::min, muonECAL_, muonHCAL_, muonHO_, neutralHadronEnergyResolution(), custom_jme_cff::nMuons, nSigmaHCAL(), nSigmaTRACK_, convertSQLiteXML::ok, AlCaHLTBitMon_ParallelJobs::p, pfCandidates_, ptError_, bTagCommon_cff::ratioMax, reconstructCluster(), reconstructTrack(), rejectTracks_Bad_, rejectTracks_Step45_, edm::second(), setHcalDepthInfo(), reco::PFBlockElementTrack::setPositionAtECALEntrance(), mathSSE::sqrt(), PFTrackAlgoTools::step5(), reco::PFBlockElement::TRACK, reco::btau::trackMomentum, useHO_, x, X, beamSpotPI::Y, and beamSpotPI::Z.
Referenced by processBlock().
|
private |
Definition at line 2827 of file PFAlgo.cc.
References cms::cuda::assert(), groupFilesInBlocks::block, calibration_, ECAL, reco::PFBlockElement::ECAL, electrons_cff::ecalEnergy, bookConverter::elements, PFEnergyCalibration::energyEmHad(), reco::PFBlockElement::HCAL, hltEgammaHLTExtra_cfi::hcal, ElementIndices::hcalIs, PFLayer::HF_EM, PFLayer::HF_HAD, photonIsolationHIProducer_cfi::ho, DigiToRawDM_cff::HO, reco::PFBlockElement::HO, edm::Ref< C, T, F >::isNull(), reco::PFBlock::LINKTEST_ALL, LogTrace, SiStripPI::max, reconstructCluster(), and useHO_.
Referenced by processBlock().
|
private |
Definition at line 1257 of file PFAlgo.cc.
References cms::cuda::assert(), groupFilesInBlocks::block, fftjetpileupestimator_calo_uncalib_cfi::c0, alignmentValidation::c1, l1ctLayer1_cff::caloResolution, Calorimetry_cff::dp, bookConverter::elements, PFEnergyCalibrationHF::energyEm(), PFEnergyCalibrationHF::energyEmHad(), PFEnergyCalibrationHF::energyHad(), HcalResponse_cfi::energyHF, DivergingColor::frac, PFEnergyCalibrationHF::getcalibHF_use(), PFLayer::HF_EM, PFLayer::HF_HAD, reco::PFBlockElement::HFEM, ElementIndices::hfEmIs, hfEnergyResolution(), ElementIndices::hfHadIs, cuy::ii, edm::Ref< C, T, F >::isNull(), reco::PFBlock::LINKTEST_ALL, LogTrace, SiStripPI::max, nSigmaHFEM(), nSigmaHFHAD(), reconstructCluster(), reconstructTrack(), mathSSE::sqrt(), thepfEnergyCalibrationHF_, reco::PFBlockElement::TRACK, ElementIndices::trackIs, and reco::btau::trackMomentum.
Referenced by processBlock().
|
private |
Definition at line 1199 of file PFAlgo.cc.
References reco::CaloCluster::badHcalMarker, ECAL, ElementIndices::ecalIs, bookConverter::elements, HLT_2024v12_cff::flags, HCAL, ElementIndices::hcalIs, ElementIndices::hfEmIs, ElementIndices::hfHadIs, DigiToRawDM_cff::HO, ElementIndices::hoIs, LogTrace, ElementIndices::trackIs, and useHO_.
Referenced by elementLoop().
|
private |
Definition at line 220 of file PFAlgo.cc.
References reco::LeafCandidate::charge(), reco::PFCandidate::e, reco::PFCandidate::egammaExtraRef(), reco::LeafCandidate::eta(), reco::PFCandidate::gamma, PFEGammaFilters::isElectron(), PFEGammaFilters::isElectronSafeForJetMET(), edm::Ref< C, T, F >::isNonnull(), PFEGammaFilters::isPhotonSafeForJetMET(), LogTrace, reco::PFCandidate::mva_e_pi(), nVtx_, PbPb_ZMuSkimMuonDPG_cff::particleType, PFEGammaFilters::passElectronSelection(), PFEGammaFilters::passPhotonSelection(), pfCandidates_, pfEgammaCandidates_, reco::LeafCandidate::phi(), primaryVertex_, reco::LeafCandidate::pt(), edm::View< T >::refAt(), reco::PFCandidate::set_dnn_e_bkgNonIsolated(), reco::PFCandidate::set_dnn_e_bkgPhoton(), reco::PFCandidate::set_dnn_e_bkgTau(), reco::PFCandidate::set_dnn_e_sigIsolated(), reco::PFCandidate::set_dnn_e_sigNonIsolated(), reco::PFCandidate::set_dnn_gamma(), reco::PFCandidate::set_mva_e_pi(), reco::PFCandidate::set_mva_Isolated(), reco::PFCandidate::set_mva_nothing_gamma(), reco::LeafCandidate::setCharge(), reco::LeafCandidate::setP4(), reco::PFCandidate::setParticleType(), reco::LeafCandidate::setVertex(), edm::View< T >::size(), useProtectionsForJetMET_, findQualityFiles::v, reco::Vertex::x(), reco::Vertex::y(), and reco::Vertex::z().
Referenced by processBlock().
|
private |
Definition at line 995 of file PFAlgo.cc.
References cms::cuda::assert(), groupFilesInBlocks::block, checkAndReconstructSecondaryInteraction(), checkGoodTrackDeadHcal(), checkHasDeadHcal(), decideType(), ECAL, reco::PFBlockElement::ECAL, ElementIndices::ecalIs, bookConverter::elements, reco::PFBlockElement::GSF, HCAL, reco::PFBlockElement::HCAL, ElementIndices::hcalIs, reco::PFBlockElement::HFEM, ElementIndices::hfEmIs, reco::PFBlockElement::HFHAD, ElementIndices::hfHadIs, ElementIndices::hoIs, edm::Ref< C, T, F >::isNull(), reco::PFBlock::LINKTEST_ALL, LogTrace, recoTracksNotHCAL(), relinkTrackToHcal(), and ElementIndices::trackIs.
Referenced by processBlock().
|
inline |
Definition at line 112 of file PFAlgo.h.
References pfCleanedCandidates_.
Referenced by PFProducer::produce().
PFMuonAlgo * PFAlgo::getPFMuonAlgo | ( | ) |
|
private |
Definition at line 3392 of file PFAlgo.cc.
References SiStripPI::max, funct::pow(), pfClustersFromCombinedCaloHF_cfi::resol, resolHF_square_, and mathSSE::sqrt().
Referenced by createCandidatesHF().
|
private |
Definition at line 3482 of file PFAlgo.cc.
References eventshapeDQM_cfi::order, reco::PFBlockElement::T_FROM_DISP, reco::PFBlockElement::T_FROM_V0, reco::PFBlockElement::T_TO_DISP, reco::PFBlockElement::trackType(), usePFDecays_, and usePFNuclearInteractions_.
Referenced by checkAndReconstructSecondaryInteraction(), createCandidatesHCAL(), reconstructTrack(), and recoTracksNotHCAL().
|
inline |
Definition at line 115 of file PFAlgo.h.
References PFCandConnector::connect(), connector_, and pfCandidates_.
Referenced by PFProducer::produce().
|
private |
todo: use PFClusterTools for this
Definition at line 3375 of file PFAlgo.cc.
References PVValHelper::eta, SiStripPI::max, pfClustersFromCombinedCaloHF_cfi::resol, and mathSSE::sqrt().
Referenced by createCandidatesHCAL(), and recoTracksNotHCAL().
|
private |
Definition at line 3385 of file PFAlgo.cc.
References PVValHelper::eta, JetChargeProducer_cfi::exp, nSigmaEConstHCAL, and nSigmaHCAL_.
Referenced by createCandidatesHCAL().
|
private |
Definition at line 3404 of file PFAlgo.cc.
References JetChargeProducer_cfi::exp, nSigmaEConstHFEM, and nSigmaHFEM_.
Referenced by createCandidatesHF().
|
private |
Definition at line 3409 of file PFAlgo.cc.
References JetChargeProducer_cfi::exp, nSigmaEConstHFHAD, and nSigmaHFHAD_.
Referenced by createCandidatesHF().
|
private |
Definition at line 3511 of file PFAlgo.cc.
References SiPixelRawToDigiRegional_cfi::deltaPhi, reco::PFCandidate::egamma_HF, reco::PFCandidate::h_HF, mps_fire::i, dqmiolumiharvest::j, maxDeltaPhiPt_, maxSignificance_, minDeltaMet_, minHFCleaningPt_, minSignificance_, minSignificanceReduction_, GetRecoTauVFromDQM_MC_cff::next, reco::PFCandidate::particleId(), pfCandidates_, pfCleanedCandidates_, reco::LeafCandidate::pt(), reco::LeafCandidate::px(), reco::LeafCandidate::py(), met_cff::significance, optionsL1T::skip, and mathSSE::sqrt().
Referenced by reconstructParticles().
|
private |
process one block. can be reimplemented in more sophisticated algorithms
Definition at line 3075 of file PFAlgo.cc.
References cms::cuda::assert(), groupFilesInBlocks::block, conversionAlgo(), createCandidatesECAL(), createCandidatesHCAL(), createCandidatesHCALUnlinked(), createCandidatesHF(), egammaFilters(), elementLoop(), bookConverter::elements, edm::Ref< C, T, F >::isNull(), LogDebug, LogTrace, useEGammaFilters_, and usePFConversions_.
Referenced by reconstructParticles().
|
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 3234 of file PFAlgo.cc.
References cms::cuda::assert(), ALCARECOTkAlJpsiMuMu_cff::charge, PFLayer::ECAL_BARREL, PFLayer::ECAL_ENDCAP, CustomPhysics_cfi::gamma, PFLayer::HCAL_BARREL1, PFLayer::HCAL_ENDCAP, PFLayer::HF_EM, PFLayer::HF_HAD, reco::PFCluster::layer(), LogTrace, EgHLTOffHistBins_cfi::mass, PbPb_ZMuSkimMuonDPG_cff::particleType, pfElectronTranslator_cfi::PFCandidate, pfCandidates_, reco::CaloCluster::position(), primaryVertex_, setHcalDepthInfo(), mathSSE::sqrt(), createJobs::tmp, useVertices_, reco::PFCandidate::X, reco::Vertex::x(), reco::Vertex::y(), and reco::Vertex::z().
Referenced by checkCleaning(), createCandidatesECAL(), createCandidatesHCAL(), createCandidatesHCALUnlinked(), createCandidatesHF(), and recoTracksNotHCAL().
void PFAlgo::reconstructParticles | ( | const reco::PFBlockHandle & | blockHandle, |
PFEGammaFilters const * | pfegamma | ||
) |
reconstruct particles
Definition at line 130 of file PFAlgo.cc.
References groupFilesInBlocks::block, gather_cfg::blocks, reco::PFBlockElement::ECAL, bookConverter::elements, relativeConstraints::empty, reco::PFBlockElement::HCAL, reco::PFBlockElement::HO, mps_fire::i, edm::HandleBase::isValid(), LogTrace, muonHandle_, trackingPlots::other, pfCandidates_, pfCleanedCandidates_, pfmu_, postCleaning(), postHFCleaning_, and processBlock().
Referenced by PFProducer::produce().
|
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 3155 of file PFAlgo.cc.
References ALCARECOTkAlJpsiMuMu_cff::charge, dptRel_DispVtx_, hcalRecHitTable_cff::energy, reco::PFCandidate::h, isFromSecInt(), reco::isMuon(), edm::Ref< C, T, F >::isNonnull(), reco::PFBlockElement::isTimeValid(), LogTrace, reco::TrackBase::p(), PbPb_ZMuSkimMuonDPG_cff::particleType, pfElectronTranslator_cfi::PFCandidate, pfCandidates_, pfmu_, multPhiCorr_741_25nsDY_cfi::px, reco::TrackBase::px(), multPhiCorr_741_25nsDY_cfi::py, reco::TrackBase::py(), reco::TrackBase::pz(), 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 HLT_2024v12_cff::track.
Referenced by checkAndReconstructSecondaryInteraction(), createCandidatesHCAL(), createCandidatesHF(), and recoTracksNotHCAL().
|
private |
Definition at line 399 of file PFAlgo.cc.
References funct::abs(), cms::cuda::assert(), associatePSClusters(), groupFilesInBlocks::block, calibration_, dptRel_DispVtx_, ECAL, reco::PFBlockElement::ECAL, electrons_cff::ecalEnergy, bookConverter::elements, reco::PFCandidate::elementsInBlocks(), PFEnergyCalibration::energyEmHad(), PVValHelper::eta, HLT_2024v12_cff::fraction, isFromSecInt(), PFMuonAlgo::isMuon(), edm::Ref< C, T, F >::isNull(), phase2tkutil::isPrimary(), reco::PFBlock::LINKTEST_ALL, LogTrace, SiStripPI::max, SiStripPI::min, reco::PFCandidate::mu, muonECAL_, neutralHadronEnergyResolution(), nHits, nSigmaECAL_, nSigmaTRACK_, pfCandidates_, reco::Vertex::position(), primaryVertex_, reco::PFBlockElement::PS1, reco::PFBlockElement::PS2, ptError_, reconstructCluster(), reconstructTrack(), rejectTracks_Step45_, pfClustersFromCombinedCaloHF_cfi::resol, reco::PFBlockElementTrack::setPositionAtECALEntrance(), optionsL1T::skip, PFTrackAlgoTools::step45(), reco::PFBlockElement::TRACK, and reco::btau::trackMomentum.
Referenced by elementLoop().
|
private |
Definition at line 941 of file PFAlgo.cc.
References groupFilesInBlocks::block, reco::PFBlockElement::ECAL, reco::PFBlockElement::HCAL, reco::PFBlock::LINKTEST_ALL, LogTrace, and reco::PFBlockElement::TRACK.
Referenced by elementLoop().
|
inline |
Definition at line 68 of file PFAlgo.h.
References connector_, HLT_2024v12_cff::iCfgCandConnector, and PFCandConnector::setParameters().
|
inline |
Definition at line 72 of file PFAlgo.h.
References HLT_2024v12_cff::bCalibPrimary, HLT_2024v12_cff::bCorrect, connector_, particleFlowTmpBarrel_cfi::dptRel_MergedTrack, particleFlowTmpBarrel_cfi::dptRel_PrimaryTrack, HLT_2024v12_cff::nuclCalibFactors, particleFlowTmpBarrel_cfi::ptErrorSecondary, and PFCandConnector::setParameters().
void PFAlgo::setDisplacedVerticesParameters | ( | bool | rejectTracks_Bad, |
bool | rejectTracks_Step45, | ||
bool | usePFNuclearInteractions, | ||
bool | usePFConversions, | ||
bool | usePFDecays, | ||
double | dptRel_DispVtx | ||
) |
Definition at line 96 of file PFAlgo.cc.
References HLT_2024v12_cff::dptRel_DispVtx, dptRel_DispVtx_, HLT_2024v12_cff::rejectTracks_Bad, rejectTracks_Bad_, HLT_2024v12_cff::rejectTracks_Step45, rejectTracks_Step45_, HLT_2024v12_cff::usePFConversions, usePFConversions_, HLT_2024v12_cff::usePFDecays, usePFDecays_, HLT_2024v12_cff::usePFNuclearInteractions, and usePFNuclearInteractions_.
void PFAlgo::setEGammaCollections | ( | const edm::View< reco::PFCandidate > & | pfEgammaCandidates, |
const edm::ValueMap< reco::GsfElectronRef > & | valueMapGedElectrons, | ||
const edm::ValueMap< reco::PhotonRef > & | valueMapGedPhotons | ||
) |
Definition at line 76 of file PFAlgo.cc.
References gedPhotonCore_cfi::pfEgammaCandidates, pfEgammaCandidates_, useEGammaFilters_, valueMapGedElectrons_, and valueMapGedPhotons_.
Referenced by PFProducer::produce().
void PFAlgo::setEGammaParameters | ( | bool | use_EGammaFilters, |
bool | useProtectionsForJetMET | ||
) |
Definition at line 68 of file PFAlgo.cc.
References useEGammaFilters_, HLT_2024v12_cff::useProtectionsForJetMET, and useProtectionsForJetMET_.
void PFAlgo::setEGElectronCollection | ( | const reco::GsfElectronCollection & | egelectrons | ) |
|
private |
Definition at line 3345 of file PFAlgo.cc.
References Exception, ntuplemaker::fill, DetId::Hcal, mps_fire::i, and reco::PFCluster::recHitFractions().
Referenced by createCandidatesHCAL(), and reconstructCluster().
|
inline |
|
inline |
Definition at line 66 of file PFAlgo.h.
References muonHandle_, and DiMuonV_cfg::muons.
Referenced by PFProducer::produce().
void PFAlgo::setPFVertexParameters | ( | bool | useVertex, |
reco::VertexCollection const & | primaryVertices | ||
) |
Definition at line 110 of file PFAlgo.cc.
References nVtx_, pfmu_, primaryVertex_, HLT_2024v12_cff::primaryVertices, VerticesFromLeptons_cfi::useVertex, useVertices_, and bphysicsOniaDQM_cfi::vertex.
Referenced by PFProducer::produce().
void PFAlgo::setPostHFCleaningParameters | ( | bool | postHFCleaning, |
const edm::ParameterSet & | pfHFCleaningParams | ||
) |
Definition at line 86 of file PFAlgo.cc.
References edm::ParameterSet::getParameter(), maxDeltaPhiPt_, maxSignificance_, minDeltaMet_, minHFCleaningPt_, minSignificance_, minSignificanceReduction_, HLT_2024v12_cff::postHFCleaning, and postHFCleaning_.
|
friend |
|
private |
Definition at line 257 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), createCandidatesHCALUnlinked(), and recoTracksNotHCAL().
|
private |
A tool used for a postprocessing of displaced vertices based on reconstructed PFCandidates
Definition at line 290 of file PFAlgo.h.
Referenced by makeConnectedCandidates(), and setCandConnectorParameters().
|
private |
Maximal relative uncertainty on the tracks going to or incoming from the displcaed vertex to be used in the PFAlgo
Definition at line 285 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), reconstructTrack(), recoTracksNotHCAL(), and setDisplacedVerticesParameters().
|
private |
Definition at line 298 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), and PFAlgo().
|
private |
Definition at line 310 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 313 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 314 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 311 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 312 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 308 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 307 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 309 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 302 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 305 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 303 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Variables for track cleaning in bad HCal areas.
Definition at line 301 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 304 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), and PFAlgo().
|
private |
Definition at line 323 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 321 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 324 of file PFAlgo.h.
Referenced by checkCleaning(), postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 319 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 320 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 322 of file PFAlgo.h.
Referenced by postCleaning(), and setPostHFCleaningParameters().
|
private |
Definition at line 294 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), PFAlgo(), and recoTracksNotHCAL().
|
private |
Definition at line 331 of file PFAlgo.h.
Referenced by reconstructParticles(), and setMuonHandle().
|
private |
Variables for muons and fakes.
Definition at line 293 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), and PFAlgo().
|
private |
Definition at line 295 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), and PFAlgo().
|
private |
number of sigma to judge energy excess in ECAL
Definition at line 245 of file PFAlgo.h.
Referenced by recoTracksNotHCAL().
|
private |
Definition at line 334 of file PFAlgo.h.
Referenced by nSigmaHCAL().
|
private |
Definition at line 335 of file PFAlgo.h.
Referenced by nSigmaHFEM().
|
private |
Definition at line 336 of file PFAlgo.h.
Referenced by nSigmaHFHAD().
|
private |
number of sigma to judge energy excess in HCAL
Definition at line 248 of file PFAlgo.h.
Referenced by nSigmaHCAL().
|
private |
number of sigma to judge energy excess in HF
Definition at line 251 of file PFAlgo.h.
Referenced by nSigmaHFEM().
|
private |
Definition at line 252 of file PFAlgo.h.
Referenced by nSigmaHFHAD().
|
private |
Definition at line 296 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), PFAlgo(), and recoTracksNotHCAL().
|
private |
Definition at line 286 of file PFAlgo.h.
Referenced by egammaFilters(), and setPFVertexParameters().
|
private |
Definition at line 226 of file PFAlgo.h.
Referenced by checkCleaning(), createCandidatesHCAL(), egammaFilters(), makeConnectedCandidates(), postCleaning(), reconstructCluster(), reconstructParticles(), reconstructTrack(), and recoTracksNotHCAL().
|
private |
Definition at line 228 of file PFAlgo.h.
Referenced by getCleanedCandidates(), postCleaning(), and reconstructParticles().
|
private |
Definition at line 267 of file PFAlgo.h.
Referenced by egammaFilters(), and setEGammaCollections().
|
private |
Definition at line 262 of file PFAlgo.h.
Referenced by getPFMuonAlgo(), PFAlgo(), reconstructParticles(), reconstructTrack(), and setPFVertexParameters().
|
private |
Definition at line 317 of file PFAlgo.h.
Referenced by reconstructParticles(), and setPostHFCleaningParameters().
|
private |
Definition at line 328 of file PFAlgo.h.
Referenced by checkGoodTrackDeadHcal(), egammaFilters(), reconstructCluster(), recoTracksNotHCAL(), and setPFVertexParameters().
|
private |
Definition at line 297 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), PFAlgo(), and recoTracksNotHCAL().
|
private |
Flags to use the protection against fakes and not reconstructed displaced vertices
Definition at line 276 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), and setDisplacedVerticesParameters().
|
private |
Definition at line 277 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), recoTracksNotHCAL(), and setDisplacedVerticesParameters().
|
private |
Definition at line 255 of file PFAlgo.h.
Referenced by hfEnergyResolution(), and PFAlgo().
|
private |
Definition at line 258 of file PFAlgo.h.
Referenced by createCandidatesHF().
|
private |
Variables for NEW EGAMMA selection.
Definition at line 265 of file PFAlgo.h.
Referenced by processBlock(), setEGammaCollections(), and setEGammaParameters().
|
private |
Definition at line 260 of file PFAlgo.h.
Referenced by createCandidatesHCAL(), createCandidatesHCALUnlinked(), decideType(), and setHOTag().
|
private |
Definition at line 280 of file PFAlgo.h.
Referenced by processBlock(), and setDisplacedVerticesParameters().
|
private |
Definition at line 281 of file PFAlgo.h.
Referenced by isFromSecInt(), and setDisplacedVerticesParameters().
|
private |
Definition at line 279 of file PFAlgo.h.
Referenced by isFromSecInt(), and setDisplacedVerticesParameters().
|
private |
Definition at line 266 of file PFAlgo.h.
Referenced by egammaFilters(), and setEGammaParameters().
|
private |
Definition at line 329 of file PFAlgo.h.
Referenced by reconstructCluster(), and setPFVertexParameters().
|
private |
Definition at line 268 of file PFAlgo.h.
Referenced by setEGammaCollections().
|
private |
Definition at line 269 of file PFAlgo.h.
Referenced by setEGammaCollections().