Static Public Member Functions | |
static void | fillDescriptions (edm::ConfigurationDescriptions &descriptions) |
static const OutputCollection & | GetOutputs () |
static void | globalEndJob (const deep_tau::DeepTauCache *cache_) |
static std::unique_ptr< deep_tau::DeepTauCache > | initializeGlobalCache (const edm::ParameterSet &cfg) |
Static Public Member Functions inherited from deep_tau::DeepTauBase | |
static void | globalEndJob (const DeepTauCache *cache) |
static std::unique_ptr< DeepTauCache > | initializeGlobalCache (const edm::ParameterSet &cfg) |
Static Public Attributes | |
static constexpr float | default_value = -999. |
Private Member Functions | |
void | checkInputs (const tensorflow::Tensor &inputs, const std::string &block_name, int n_inputs, const CellGrid *grid=nullptr) const |
template<typename CandidateCastType , typename TauCastType > | |
void | createConvFeatures (const TauCastType &tau, const size_t tau_index, const edm::RefToBase< reco::BaseTau > tau_ref, const reco::Vertex &pv, double rho, const std::vector< pat::Electron > *electrons, const std::vector< pat::Muon > *muons, const edm::View< reco::Candidate > &pfCands, const CellGrid &grid, TauFunc tau_funcs, bool is_inner) |
template<typename CandidateCastType , typename TauCastType > | |
void | createEgammaBlockInputs (unsigned idx, const TauCastType &tau, const size_t tau_index, const edm::RefToBase< reco::BaseTau > tau_ref, const reco::Vertex &pv, double rho, const std::vector< pat::Electron > *electrons, const edm::View< reco::Candidate > &pfCands, const Cell &cell_map, TauFunc tau_funcs, bool is_inner) |
template<typename CandidateCastType , typename TauCastType > | |
void | createHadronsBlockInputs (unsigned idx, const TauCastType &tau, const size_t tau_index, const edm::RefToBase< reco::BaseTau > tau_ref, const reco::Vertex &pv, double rho, const edm::View< reco::Candidate > &pfCands, const Cell &cell_map, TauFunc tau_funcs, bool is_inner) |
template<typename CandidateCastType , typename TauCastType > | |
void | createMuonBlockInputs (unsigned idx, const TauCastType &tau, const size_t tau_index, const edm::RefToBase< reco::BaseTau > tau_ref, const reco::Vertex &pv, double rho, const std::vector< pat::Muon > *muons, const edm::View< reco::Candidate > &pfCands, const Cell &cell_map, TauFunc tau_funcs, bool is_inner) |
template<typename CandidateCastType , typename TauCastType > | |
void | createTauBlockInputs (const TauCastType &tau, const size_t &tau_index, const edm::RefToBase< reco::BaseTau > tau_ref, const reco::Vertex &pv, double rho, TauFunc tau_funcs) |
template<typename Collection , typename TauCastType > | |
void | fillGrids (const TauCastType &tau, const Collection &objects, CellGrid &inner_grid, CellGrid &outer_grid) |
tensorflow::Tensor | getPartialPredictions (bool is_inner) |
tensorflow::Tensor | getPredictions (edm::Event &event, edm::Handle< TauCollection > taus) override |
template<typename CandidateCastType , typename TauCastType > | |
void | getPredictionsV2 (TauCollection::const_reference &tau, const size_t tau_index, const edm::RefToBase< reco::BaseTau > tau_ref, const std::vector< pat::Electron > *electrons, const std::vector< pat::Muon > *muons, const edm::View< reco::Candidate > &pfCands, const reco::Vertex &pv, double rho, const edm::EventNumber_t &eventnr, std::vector< tensorflow::Tensor > &pred_vector, TauFunc tau_funcs) |
void | saveInputs (const tensorflow::Tensor &inputs, const std::string &block_name, int n_inputs, const CellGrid *grid=nullptr) |
void | setCellConvFeatures (tensorflow::Tensor &convTensor, const tensorflow::Tensor &features, unsigned batch_idx, int eta_index, int phi_index) |
Static Private Member Functions | |
static void | calculateElectronClusterVars (const pat::Electron *ele, float &elecEe, float &elecEgamma) |
static bool | calculateElectronClusterVarsV2 (const pat::Electron &ele, float &cc_ele_energy, float &cc_gamma_energy, int &cc_n_gamma) |
template<typename TauCastType > | |
static bool | calculateGottfriedJacksonAngleDifference (const TauCastType &tau, const size_t tau_index, double &gj_diff, TauFunc tau_funcs) |
template<typename TauCastType > | |
static float | calculateGottfriedJacksonAngleDifference (const TauCastType &tau, const size_t tau_index, TauFunc tau_funcs) |
template<typename TauCastType > | |
static const pat::Electron * | findMatchedElectron (const TauCastType &tau, const std::vector< pat::Electron > *electrons, double deltaR) |
static double | getInnerSignalConeRadius (double pt) |
template<typename T > | |
static float | getValue (T value) |
template<typename T > | |
static float | getValueLinear (T value, float min_value, float max_value, bool positive) |
template<typename T > | |
static float | getValueNorm (T value, float mean, float sigma, float n_sigmas_max=5) |
static bool | isAbove (double value, double min) |
static bool | isInEcalCrack (double eta) |
template<typename CandidateCollection , typename TauCastType > | |
static void | processIsolationPFComponents (const TauCastType &tau, const CandidateCollection &candidates, LorentzVectorXYZ &p4, float &pt, float &d_eta, float &d_phi, float &m, float &n) |
template<typename CandidateCollection , typename TauCastType > | |
static void | processSignalPFComponents (const TauCastType &tau, const CandidateCollection &candidates, LorentzVectorXYZ &p4_inner, LorentzVectorXYZ &p4_outer, float &pt_inner, float &dEta_inner, float &dPhi_inner, float &m_inner, float &pt_outer, float &dEta_outer, float &dPhi_outer, float &m_outer, float &n_inner, float &n_outer) |
Static Private Attributes | |
static constexpr float | pi = M_PI |
Definition at line 827 of file DeepTauId.cc.
|
inlineexplicit |
Definition at line 918 of file DeepTauId.cc.
References convTensor_, eGammaTensor_, nanoDQM_cfi::Electron, mps_fire::end, Exception, getPartialPredictions(), hadronsTensor_, mps_fire::i, dumpRecoGeometry_cfg::Muon, muonTensor_, dqmiodumpmetadata::n, AlCaHLTBitMon_ParallelJobs::p, scalingParamsMap_, deep_tau::Scaling::scalingParamsMap_PhaseIIv2p5, deep_tau::Scaling::scalingParamsMap_v2p1, deep_tau::Scaling::scalingParamsMap_v2p5, setCellConvFeatures(), findQualityFiles::size, jetUpdater_cfi::sort, sub_version_, tauBlockTensor_, tauInputs_indices_, findQualityFiles::v, version_, year_, and zeroOutputTensor_.
|
inlinestaticprivate |
Definition at line 2287 of file DeepTauId.cc.
References default_value, HCALHighEnergyHPDFilter_cfi::energy, and pat::Electron::superCluster().
|
inlinestaticprivate |
Definition at line 1051 of file DeepTauId.cc.
References HCALHighEnergyHPDFilter_cfi::energy, and pat::Electron::superCluster().
Referenced by createEgammaBlockInputs().
|
inlinestaticprivate |
Definition at line 2381 of file DeepTauId.cc.
References funct::abs(), funct::pow(), and metsig::tau.
Referenced by calculateGottfriedJacksonAngleDifference(), and createTauBlockInputs().
|
inlinestaticprivate |
Definition at line 2403 of file DeepTauId.cc.
References calculateGottfriedJacksonAngleDifference(), default_value, and metsig::tau.
|
inlineprivate |
Definition at line 1074 of file DeepTauId.cc.
References cms::cuda::assert(), gather_cfg::cout, debug_level, PVValHelper::eta, Exception, alignBH_cfg::fixed, dqmMemoryStats::float, getRunAppsInfo::grid, input, PixelMapPlotter::inputs, edm::isNotFinite(), and phi.
Referenced by getPredictionsV2().
|
inlineprivate |
Definition at line 1482 of file DeepTauId.cc.
References convTensor_, gather_cfg::cout, debug_level, eGammaTensor_, pwdgSkimBPark_cfi::electrons, PVValHelper::eta, getPartialPredictions(), getRunAppsInfo::grid, hadronsTensor_, heavyIonCSV_trainingSettings::idx, createfilelist::int, PDWG_BPHSkim_cff::muons, muonTensor_, phi, MetAnalyzer::pv(), rho, setCellConvFeatures(), metsig::tau, and zeroOutputTensor_.
|
inlineprivate |
Definition at line 1719 of file DeepTauId.cc.
References funct::abs(), edm::View< T >::at(), calculateElectronClusterVarsV2(), hltPixelTracks_cff::chi2, HLT_2023v12_cff::dPhi, eGammaTensor_, nanoDQM_cfi::Electron, pwdgSkimBPark_cfi::electrons, f, dqmMemoryStats::float, heavyIonCSV_trainingSettings::idx, PixelMapPlotter::inputs, isInEcalCrack(), ndof, rho, IsoPhotonEBSkim_cff::rho, scalingParamsMap_, sub_version_, metsig::tau, runTauDisplay::tau_eta, runTauDisplay::tau_pt, and year_.
|
inlineprivate |
Definition at line 2149 of file DeepTauId.cc.
References funct::abs(), edm::View< T >::at(), hltPixelTracks_cff::chi2, disable_hcalFraction_workaround_, HLT_2023v12_cff::dPhi, f, dqmMemoryStats::float, hadronsTensor_, heavyIonCSV_trainingSettings::idx, PixelMapPlotter::inputs, isInEcalCrack(), ndof, rho, IsoPhotonEBSkim_cff::rho, scalingParamsMap_, metsig::tau, runTauDisplay::tau_eta, and runTauDisplay::tau_pt.
|
inlineprivate |
Definition at line 1998 of file DeepTauId.cc.
References funct::abs(), edm::View< T >::at(), hltPixelTracks_cff::chi2, MuonSubdetId::CSC, HLT_2023v12_cff::dPhi, MuonSubdetId::DT, f, dqmMemoryStats::float, heavyIonCSV_trainingSettings::idx, PixelMapPlotter::inputs, isInEcalCrack(), dumpRecoGeometry_cfg::Muon, PDWG_BPHSkim_cff::muons, muonTensor_, ndof, pat::Muon::PV2D, rho, IsoPhotonEBSkim_cff::rho, MuonSubdetId::RPC, scalingParamsMap_, relativeConstraints::station, metsig::tau, runTauDisplay::tau_eta, and runTauDisplay::tau_pt.
|
inlineprivate |
Definition at line 1574 of file DeepTauId.cc.
References funct::abs(), calculateGottfriedJacksonAngleDifference(), disable_dxy_pca_, reco::tau::eratio(), getValueLinear(), PixelMapPlotter::inputs, deep_tau::DeepTauBase::is_online_, isAbove(), isInEcalCrack(), reco::tau::n_photons_total(), pi, reco::tau::pt_weighted_deta_strip(), reco::tau::pt_weighted_dphi_strip(), reco::tau::pt_weighted_dr_iso(), reco::tau::pt_weighted_dr_signal(), rho, IsoPhotonEBSkim_cff::rho, scalingParamsMap_, sub_version_, metsig::tau, runTauDisplay::tau_eta, runTauDisplay::tau_mass, runTauDisplay::tau_phi, runTauDisplay::tau_pt, tauBlockTensor_, and tauInputs_indices_.
|
inlinestatic |
Definition at line 873 of file DeepTauId.cc.
References edm::ConfigurationDescriptions::add(), edm::ParameterSetDescription::add(), edm::ParameterSetDescription::addOptional(), submitPVResolutionJobs::desc, ProducerED_cfi::InputTag, and AlCaHLTBitMon_QueryRunRegistry::string.
|
inlineprivate |
Definition at line 1421 of file DeepTauId.cc.
References reco::deltaPhi(), getInnerSignalConeRadius(), getRunAppsInfo::grid, dqmiodumpmetadata::n, getGTfromDQMFile::obj, funct::pow(), and metsig::tau.
Referenced by getPredictionsV2().
|
inlinestaticprivate |
Definition at line 2418 of file DeepTauId.cc.
References PbPb_ZMuSkimMuonDPG_cff::deltaR, reco::deltaR2(), pwdgSkimBPark_cfi::electrons, reco::LeafCandidate::pt(), and metsig::tau.
|
inlinestaticprivate |
Definition at line 2373 of file DeepTauId.cc.
References SiStripPI::max, cosmictrackSelector_cfi::min_pt, and DiDispStaMuonMonitor_cfi::pt.
Referenced by fillGrids(), and processSignalPFComponents().
|
inlinestatic |
Definition at line 831 of file DeepTauId.cc.
References GetRecoTauVFromDQM_MC_cff::Output, and deep_tau::DeepTauBase::outputs_.
|
inlineprivate |
Definition at line 1457 of file DeepTauId.cc.
References deep_tau::DeepTauBase::cache_, eGammaTensor_, deep_tau::DeepTauCache::getSession(), hadronsTensor_, muonTensor_, and tensorflow::run().
Referenced by createConvFeatures(), and DeepTauId().
|
inlineoverrideprivatevirtual |
Implements deep_tau::DeepTauBase.
Definition at line 1191 of file DeepTauId.cc.
References deep_tau::DeepTauBase::andPrediscriminants_, basicDiscrdR03IndexMap_, basicDiscrIndexMap_, HLT_2023v12_cff::basicTauDiscriminators, basicTauDiscriminators_inputToken_, HLT_2023v12_cff::basicTauDiscriminatorsdR03, basicTauDiscriminatorsdR03_inputToken_, discrIndicesMapped_, electrons_token_, Exception, f, deep_tau::DeepTauBase::is_online_, dqmdumpme::k, matchDiscriminatorIndices(), muons_token_, deep_tau::NumberOfOutputs, deep_tau::DeepTauBase::patPrediscriminants_, deep_tau::DeepTauBase::pfcandToken_, HLT_2023v12_cff::pfTauTransverseImpactParameters, pfTauTransverseImpactParameters_token_, deep_tau::DeepTauBase::recoPrediscriminants_, deep_tau::DeepTauBase::requiredBasicDiscriminators_, deep_tau::DeepTauBase::requiredBasicDiscriminatorsdR03_, rho, rho_token_, Tau3MuMonitor_cff::taus, version_, AlignmentTracksFromVertexSelector_cfi::vertices, and deep_tau::DeepTauBase::vtxToken_.
|
inlineprivate |
Definition at line 1315 of file DeepTauId.cc.
References cms::cuda::assert(), deep_tau::DeepTauBase::cache_, checkInputs(), convTensor_, gather_cfg::cout, debug_level, disable_CellIndex_workaround_, eGammaTensor_, pwdgSkimBPark_cfi::electrons, file_counter_, fillGrids(), deep_tau::DeepTauCache::getSession(), hadronsTensor_, heavyIonCSV_trainingSettings::idx, is_first_block_, json_file_, label, PDWG_BPHSkim_cff::muons, muonTensor_, deep_tau::NumberOfOutputs, rho, tensorflow::run(), save_inputs_, saveInputs(), AlCaHLTBitMon_QueryRunRegistry::string, metsig::tau, tauBlockTensor_, and cond::impl::to_string().
|
inlinestaticprivate |
Definition at line 1028 of file DeepTauId.cc.
References f, and relativeConstraints::value.
Referenced by getValueLinear(), and getValueNorm().
|
inlinestaticprivate |
Definition at line 1033 of file DeepTauId.cc.
References getValue(), hcaldqm::quantity::max_value, and hcaldqm::quantity::min_value.
Referenced by createTauBlockInputs().
|
inlinestaticprivate |
Definition at line 1043 of file DeepTauId.cc.
References getValue(), and SiStripPI::mean.
|
inlinestatic |
|
inlinestatic |
|
inlinestaticprivate |
Definition at line 1049 of file DeepTauId.cc.
References SiStripPI::min.
Referenced by createTauBlockInputs().
|
inlinestaticprivate |
Definition at line 2412 of file DeepTauId.cc.
References funct::abs(), and PVValHelper::eta.
Referenced by createEgammaBlockInputs(), createHadronsBlockInputs(), createMuonBlockInputs(), and createTauBlockInputs().
|
inline |
Definition at line 841 of file DeepTauId.cc.
References Exception, edm::ParameterSet::getParameter(), mps_fire::i, dqmiolumiharvest::j, edm::parameterSet(), AlCaHLTBitMon_QueryRunRegistry::string, and deep_tau::DeepTauBase::stringFromDiscriminator_.
Referenced by getPredictions().
|
inlinestaticprivate |
Definition at line 2351 of file DeepTauId.cc.
References HLT_2023v12_cff::candidates, default_value, HLT_2023v12_cff::dEta, HLT_2023v12_cff::dPhi, visualization-live-secondInstance_cfg::m, dqmiodumpmetadata::n, DiDispStaMuonMonitor_cfi::pt, and metsig::tau.
|
inlinestaticprivate |
Definition at line 2307 of file DeepTauId.cc.
References HLT_2023v12_cff::candidates, default_value, reco::deltaR(), HLT_2023v12_cff::dEta, HLT_2023v12_cff::dPhi, HGC3DClusterGenMatchSelector_cfi::dR, getInnerSignalConeRadius(), and metsig::tau.
|
inlineprivate |
Definition at line 1130 of file DeepTauId.cc.
References cms::cuda::assert(), gather_cfg::cout, debug_level, PVValHelper::eta, dqmMemoryStats::float, getRunAppsInfo::grid, input, PixelMapPlotter::inputs, is_first_block_, and phi.
Referenced by getPredictionsV2().
|
inlineprivate |
Definition at line 1563 of file DeepTauId.cc.
References lowptgsfeleseed::features(), dqmMemoryStats::float, and dqmiodumpmetadata::n.
Referenced by createConvFeatures(), and DeepTauId().
|
private |
Definition at line 2460 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2459 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2435 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2436 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2448 of file DeepTauId.cc.
Referenced by createConvFeatures(), DeepTauId(), and getPredictionsV2().
|
private |
Definition at line 2443 of file DeepTauId.cc.
Referenced by checkInputs(), createConvFeatures(), getPredictionsV2(), and saveInputs().
|
static |
Definition at line 829 of file DeepTauId.cc.
Referenced by calculateElectronClusterVars(), calculateGottfriedJacksonAngleDifference(), processIsolationPFComponents(), and processSignalPFComponents().
|
private |
Definition at line 2446 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2444 of file DeepTauId.cc.
Referenced by createTauBlockInputs().
|
private |
Definition at line 2445 of file DeepTauId.cc.
Referenced by createHadronsBlockInputs().
|
private |
Definition at line 2458 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2448 of file DeepTauId.cc.
Referenced by createConvFeatures(), createEgammaBlockInputs(), DeepTauId(), getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2432 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2454 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2448 of file DeepTauId.cc.
Referenced by createConvFeatures(), createHadronsBlockInputs(), DeepTauId(), getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2439 of file DeepTauId.cc.
|
private |
Definition at line 2453 of file DeepTauId.cc.
Referenced by getPredictionsV2(), and saveInputs().
|
private |
Definition at line 2452 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2433 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2448 of file DeepTauId.cc.
Referenced by createConvFeatures(), createMuonBlockInputs(), DeepTauId(), getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2439 of file DeepTauId.cc.
|
private |
Definition at line 2438 of file DeepTauId.cc.
Referenced by getPredictions().
|
staticprivate |
Definition at line 1025 of file DeepTauId.cc.
Referenced by createTauBlockInputs().
|
private |
Definition at line 2434 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2451 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2450 of file DeepTauId.cc.
Referenced by createEgammaBlockInputs(), createHadronsBlockInputs(), createMuonBlockInputs(), createTauBlockInputs(), and DeepTauId().
|
private |
Definition at line 2442 of file DeepTauId.cc.
Referenced by createEgammaBlockInputs(), createTauBlockInputs(), and DeepTauId().
|
private |
Definition at line 2447 of file DeepTauId.cc.
Referenced by createTauBlockInputs(), DeepTauId(), and getPredictionsV2().
|
private |
Definition at line 2455 of file DeepTauId.cc.
Referenced by createTauBlockInputs(), and DeepTauId().
|
private |
Definition at line 2441 of file DeepTauId.cc.
Referenced by DeepTauId(), and getPredictions().
|
private |
Definition at line 2440 of file DeepTauId.cc.
Referenced by createEgammaBlockInputs(), and DeepTauId().
|
private |
Definition at line 2448 of file DeepTauId.cc.
Referenced by createConvFeatures(), and DeepTauId().