Classes | |
struct | Output |
struct | TauDiscInfo |
Public Member Functions | |
DeepTauId (const edm::ParameterSet &cfg, const deep_tau::DeepTauCache *cache) | |
const std::map< BasicDiscriminator, size_t > | matchDiscriminatorIndices (edm::Event &event, edm::EDGetTokenT< reco::TauDiscriminatorContainer > discriminatorContainerToken, std::vector< BasicDiscriminator > requiredDiscr) |
void | produce (edm::Event &event, const edm::EventSetup &es) override |
Public Member Functions inherited from edm::stream::EDProducer< edm::GlobalCache< deep_tau::DeepTauCache > > | |
EDProducer ()=default | |
EDProducer (const EDProducer &)=delete | |
bool | hasAbilityToProduceInBeginLumis () const final |
bool | hasAbilityToProduceInBeginProcessBlocks () const final |
bool | hasAbilityToProduceInBeginRuns () const final |
bool | hasAbilityToProduceInEndLumis () const final |
bool | hasAbilityToProduceInEndProcessBlocks () const final |
bool | hasAbilityToProduceInEndRuns () const final |
const EDProducer & | operator= (const EDProducer &)=delete |
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) |
Public Attributes | |
uint8_t | andPrediscriminants_ |
std::vector< TauDiscInfo< pat::PATTauDiscriminator > > | patPrediscriminants_ |
std::vector< TauDiscInfo< reco::PFTauDiscriminator > > | recoPrediscriminants_ |
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) |
void | createOutputs (edm::Event &event, const tensorflow::Tensor &pred, edm::Handle< TauCollection > taus) |
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) |
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 895 of file DeepTauId.cc.
Definition at line 960 of file DeepTauId.cc.
Definition at line 899 of file DeepTauId.cc.
using DeepTauId::Cutter = tau::TauWPThreshold |
Definition at line 905 of file DeepTauId.cc.
using DeepTauId::CutterPtr = std::unique_ptr<Cutter> |
Definition at line 906 of file DeepTauId.cc.
Definition at line 902 of file DeepTauId.cc.
using DeepTauId::LorentzVectorXYZ = ROOT::Math::LorentzVector<ROOT::Math::PxPyPzE4D<double> > |
Definition at line 904 of file DeepTauId.cc.
Definition at line 903 of file DeepTauId.cc.
using DeepTauId::OutputCollection = std::map<std::string, Output> |
Definition at line 946 of file DeepTauId.cc.
Definition at line 898 of file DeepTauId.cc.
Definition at line 897 of file DeepTauId.cc.
using DeepTauId::TauRef = edm::Ref<TauCollection> |
Definition at line 900 of file DeepTauId.cc.
Definition at line 901 of file DeepTauId.cc.
using DeepTauId::WPList = std::vector<CutterPtr> |
Definition at line 907 of file DeepTauId.cc.
|
inlineexplicit |
Definition at line 1039 of file DeepTauId.cc.
References andPrediscriminants_, looper::cfg, convTensor_, DMR_cfg::cut, DeepTauId::TauDiscInfo< ConsumeType >::cut, DeepTauId::TauDiscInfo< ConsumeType >::disc_token, eGammaTensor_, nanoDQM_cfi::Electron, mps_fire::end, Exception, edm::ParameterSet::getParameter(), edm::ParameterSet::getParameterNamesForType(), getPartialPredictions(), hadronsTensor_, mps_fire::i, is_online_, label, DeepTauId::TauDiscInfo< ConsumeType >::label, dumpRecoGeometry_cfg::Muon, muonTensor_, dqmiodumpmetadata::n, outputs_, AlCaHLTBitMon_ParallelJobs::p, patPrediscriminants_, recoPrediscriminants_, scalingParamsMap_, deep_tau::Scaling::scalingParamsMap_PhaseIIv2p5, deep_tau::Scaling::scalingParamsMap_v2p1, deep_tau::Scaling::scalingParamsMap_v2p5, setCellConvFeatures(), findQualityFiles::size, jetUpdater_cfi::sort, AlCaHLTBitMon_QueryRunRegistry::string, sub_version_, tauBlockTensor_, tauInputs_indices_, HcalDetIdTransform::transform(), findQualityFiles::v, version_, workingPoints_, year_, and zeroOutputTensor_.
|
inlinestaticprivate |
Definition at line 2544 of file DeepTauId.cc.
References default_value, hcalRecHitTable_cff::energy, and pat::Electron::superCluster().
|
inlinestaticprivate |
Definition at line 1308 of file DeepTauId.cc.
References hcalRecHitTable_cff::energy, and pat::Electron::superCluster().
Referenced by createEgammaBlockInputs().
|
inlinestaticprivate |
Definition at line 2638 of file DeepTauId.cc.
References funct::abs(), and conifer::pow().
Referenced by calculateGottfriedJacksonAngleDifference(), and createTauBlockInputs().
|
inlinestaticprivate |
Definition at line 2660 of file DeepTauId.cc.
References calculateGottfriedJacksonAngleDifference(), and default_value.
|
inlineprivate |
Definition at line 1331 of file DeepTauId.cc.
References cms::cuda::assert(), gather_cfg::cout, debug_level, PVValHelper::eta, Exception, alignBH_cfg::fixed, nano_mu_digi_cff::float, getRunAppsInfo::grid, input, PixelMapPlotter::inputs, edm::isNotFinite(), and phi.
Referenced by getPredictionsV2().
|
inlineprivate |
Definition at line 1739 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 1976 of file DeepTauId.cc.
References funct::abs(), edm::View< T >::at(), calculateElectronClusterVarsV2(), nano_mu_local_reco_cff::chi2, HLT_2023v12_cff::dPhi, eGammaTensor_, nanoDQM_cfi::Electron, pwdgSkimBPark_cfi::electrons, f, nano_mu_digi_cff::float, heavyIonCSV_trainingSettings::idx, PixelMapPlotter::inputs, isInEcalCrack(), ndof, rho, IsoPhotonEBSkim_cff::rho, scalingParamsMap_, sub_version_, runTauDisplay::tau_eta, runTauDisplay::tau_pt, and year_.
|
inlineprivate |
Definition at line 2406 of file DeepTauId.cc.
References funct::abs(), edm::View< T >::at(), nano_mu_local_reco_cff::chi2, disable_hcalFraction_workaround_, HLT_2023v12_cff::dPhi, f, nano_mu_digi_cff::float, hadronsTensor_, heavyIonCSV_trainingSettings::idx, PixelMapPlotter::inputs, isInEcalCrack(), ndof, rho, IsoPhotonEBSkim_cff::rho, scalingParamsMap_, runTauDisplay::tau_eta, and runTauDisplay::tau_pt.
|
inlineprivate |
Definition at line 2255 of file DeepTauId.cc.
References funct::abs(), edm::View< T >::at(), nano_mu_local_reco_cff::chi2, MuonSubdetId::CSC, HLT_2023v12_cff::dPhi, MuonSubdetId::DT, f, nano_mu_digi_cff::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, runTauDisplay::tau_eta, and runTauDisplay::tau_pt.
|
inlineprivate |
Definition at line 1273 of file DeepTauId.cc.
References is_online_, eostools::move(), outputs_, mps_fire::result, Tau3MuMonitor_cff::taus, FWLite::working_points, and workingPoints_.
Referenced by produce().
|
inlineprivate |
Definition at line 1831 of file DeepTauId.cc.
References funct::abs(), calculateGottfriedJacksonAngleDifference(), disable_dxy_pca_, run3scouting_cff::dzError, reco::tau::eratio(), getValueLinear(), PixelMapPlotter::inputs, 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_, runTauDisplay::tau_eta, runTauDisplay::tau_mass, runTauDisplay::tau_phi, runTauDisplay::tau_pt, tauBlockTensor_, and tauInputs_indices_.
|
inlinestatic |
Definition at line 994 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 1678 of file DeepTauId.cc.
References reco::deltaPhi(), getInnerSignalConeRadius(), getRunAppsInfo::grid, dqmiodumpmetadata::n, getGTfromDQMFile::obj, and conifer::pow().
Referenced by getPredictionsV2().
|
inlinestaticprivate |
Definition at line 2675 of file DeepTauId.cc.
References PbPb_ZMuSkimMuonDPG_cff::deltaR, reco::deltaR2(), pwdgSkimBPark_cfi::electrons, and reco::LeafCandidate::pt().
|
inlinestaticprivate |
Definition at line 2630 of file DeepTauId.cc.
References SiStripPI::max, cosmictrackSelector_cfi::min_pt, and DiDispStaMuonMonitor_cfi::pt.
Referenced by fillGrids(), and processSignalPFComponents().
|
inlinestatic |
Definition at line 950 of file DeepTauId.cc.
References GetRecoTauVFromDQM_MC_cff::Output, and outputs_.
|
inlineprivate |
Definition at line 1714 of file DeepTauId.cc.
References cache_, eGammaTensor_, deep_tau::DeepTauCache::getSession(), hadronsTensor_, muonTensor_, and tensorflow::run().
Referenced by createConvFeatures(), and DeepTauId().
|
inlineprivate |
Definition at line 1448 of file DeepTauId.cc.
References andPrediscriminants_, basicDiscrdR03IndexMap_, basicDiscrIndexMap_, HLT_2023v12_cff::basicTauDiscriminators, basicTauDiscriminators_inputToken_, HLT_2023v12_cff::basicTauDiscriminatorsdR03, basicTauDiscriminatorsdR03_inputToken_, discrIndicesMapped_, electrons_token_, Exception, f, is_online_, dqmdumpme::k, matchDiscriminatorIndices(), muons_token_, deep_tau::NumberOfOutputs, patPrediscriminants_, pfcandToken_, HLT_2023v12_cff::pfTauTransverseImpactParameters, pfTauTransverseImpactParameters_token_, recoPrediscriminants_, requiredBasicDiscriminators_, requiredBasicDiscriminatorsdR03_, rho, rho_token_, Tau3MuMonitor_cff::taus, version_, AlignmentTracksFromVertexSelector_cfi::vertices, and vtxToken_.
Referenced by produce().
|
inlineprivate |
Definition at line 1572 of file DeepTauId.cc.
References cms::cuda::assert(), 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 to_string().
|
inlinestaticprivate |
Definition at line 1285 of file DeepTauId.cc.
References f, and relativeConstraints::value.
Referenced by getValueLinear(), and getValueNorm().
|
inlinestaticprivate |
Definition at line 1290 of file DeepTauId.cc.
References getValue(), hcaldqm::quantity::max_value, and hcaldqm::quantity::min_value.
Referenced by createTauBlockInputs().
|
inlinestaticprivate |
Definition at line 1300 of file DeepTauId.cc.
References getValue(), and SiStripPI::mean.
|
inlinestatic |
Definition at line 1254 of file DeepTauId.cc.
|
inlinestatic |
Definition at line 1232 of file DeepTauId.cc.
References looper::cfg, mps_splice::entry, edm::FileInPath::fullPath(), HLT_2023v12_cff::graph_file, HLT_2023v12_cff::mem_mapped, and AlCaHLTBitMon_QueryRunRegistry::string.
|
inlinestaticprivate |
Definition at line 1306 of file DeepTauId.cc.
References SiStripPI::min.
Referenced by createTauBlockInputs().
|
inlinestaticprivate |
Definition at line 2669 of file DeepTauId.cc.
References funct::abs(), and PVValHelper::eta.
Referenced by createEgammaBlockInputs(), createHadronsBlockInputs(), createMuonBlockInputs(), and createTauBlockInputs().
|
inline |
Definition at line 962 of file DeepTauId.cc.
References Exception, edm::ParameterSet::getParameter(), mps_fire::i, dqmiolumiharvest::j, edm::parameterSet(), AlCaHLTBitMon_QueryRunRegistry::string, and stringFromDiscriminator_.
Referenced by getPredictions().
|
inlinestaticprivate |
Definition at line 2608 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, and DiDispStaMuonMonitor_cfi::pt.
|
inlinestaticprivate |
Definition at line 2564 of file DeepTauId.cc.
References HLT_2023v12_cff::candidates, default_value, reco::deltaR(), HLT_2023v12_cff::dEta, HLT_2023v12_cff::dPhi, HGC3DClusterGenMatchSelector_cfi::dR, and getInnerSignalConeRadius().
|
inlineoverride |
Definition at line 1193 of file DeepTauId.cc.
References createOutputs(), Exception, getPredictions(), is_online_, deep_tau::NumberOfOutputs, patPrediscriminants_, recoPrediscriminants_, Tau3MuMonitor_cff::taus, and tausToken_.
|
inlineprivate |
Definition at line 1387 of file DeepTauId.cc.
References cms::cuda::assert(), gather_cfg::cout, debug_level, PVValHelper::eta, nano_mu_digi_cff::float, getRunAppsInfo::grid, input, PixelMapPlotter::inputs, is_first_block_, and phi.
Referenced by getPredictionsV2().
|
inlineprivate |
Definition at line 1820 of file DeepTauId.cc.
References lowptgsfeleseed::features(), nano_mu_digi_cff::float, and dqmiodumpmetadata::n.
Referenced by createConvFeatures(), and DeepTauId().
uint8_t DeepTauId::andPrediscriminants_ |
Definition at line 1266 of file DeepTauId.cc.
Referenced by DeepTauId(), and getPredictions().
|
private |
Definition at line 2744 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2743 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2719 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2720 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2695 of file DeepTauId.cc.
Referenced by getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2732 of file DeepTauId.cc.
Referenced by createConvFeatures(), DeepTauId(), and getPredictionsV2().
|
private |
Definition at line 2727 of file DeepTauId.cc.
Referenced by checkInputs(), createConvFeatures(), getPredictionsV2(), and saveInputs().
|
static |
Definition at line 948 of file DeepTauId.cc.
Referenced by calculateElectronClusterVars(), calculateGottfriedJacksonAngleDifference(), processIsolationPFComponents(), and processSignalPFComponents().
|
private |
Definition at line 2730 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2728 of file DeepTauId.cc.
Referenced by createTauBlockInputs().
|
private |
Definition at line 2729 of file DeepTauId.cc.
Referenced by createHadronsBlockInputs().
|
private |
Definition at line 2742 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2732 of file DeepTauId.cc.
Referenced by createConvFeatures(), createEgammaBlockInputs(), DeepTauId(), getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2716 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2738 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2732 of file DeepTauId.cc.
Referenced by createConvFeatures(), createHadronsBlockInputs(), DeepTauId(), getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2723 of file DeepTauId.cc.
|
private |
Definition at line 2737 of file DeepTauId.cc.
Referenced by getPredictionsV2(), and saveInputs().
|
private |
Definition at line 2693 of file DeepTauId.cc.
Referenced by createOutputs(), createTauBlockInputs(), DeepTauId(), getPredictions(), and produce().
|
private |
Definition at line 2736 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2717 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2732 of file DeepTauId.cc.
Referenced by createConvFeatures(), createMuonBlockInputs(), DeepTauId(), getPartialPredictions(), and getPredictionsV2().
|
private |
Definition at line 2723 of file DeepTauId.cc.
|
private |
Definition at line 2694 of file DeepTauId.cc.
Referenced by createOutputs(), DeepTauId(), and GetOutputs().
std::vector<TauDiscInfo<pat::PATTauDiscriminator> > DeepTauId::patPrediscriminants_ |
Definition at line 1267 of file DeepTauId.cc.
Referenced by DeepTauId(), getPredictions(), and produce().
|
private |
Definition at line 2690 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2722 of file DeepTauId.cc.
Referenced by getPredictions().
|
staticprivate |
Definition at line 1271 of file DeepTauId.cc.
Referenced by createTauBlockInputs().
std::vector<TauDiscInfo<reco::PFTauDiscriminator> > DeepTauId::recoPrediscriminants_ |
Definition at line 1268 of file DeepTauId.cc.
Referenced by DeepTauId(), getPredictions(), and produce().
|
private |
|
private |
|
private |
Definition at line 2718 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2735 of file DeepTauId.cc.
Referenced by getPredictionsV2().
|
private |
Definition at line 2734 of file DeepTauId.cc.
Referenced by createEgammaBlockInputs(), createHadronsBlockInputs(), createMuonBlockInputs(), createTauBlockInputs(), and DeepTauId().
|
private |
Definition at line 2697 of file DeepTauId.cc.
Referenced by matchDiscriminatorIndices().
|
private |
Definition at line 2726 of file DeepTauId.cc.
Referenced by createEgammaBlockInputs(), createTauBlockInputs(), and DeepTauId().
|
private |
Definition at line 2731 of file DeepTauId.cc.
Referenced by createTauBlockInputs(), DeepTauId(), and getPredictionsV2().
|
private |
Definition at line 2739 of file DeepTauId.cc.
Referenced by createTauBlockInputs(), and DeepTauId().
|
private |
Definition at line 2689 of file DeepTauId.cc.
Referenced by produce().
|
private |
Definition at line 2725 of file DeepTauId.cc.
Referenced by DeepTauId(), and getPredictions().
|
private |
Definition at line 2691 of file DeepTauId.cc.
Referenced by getPredictions().
|
private |
Definition at line 2692 of file DeepTauId.cc.
Referenced by createOutputs(), and DeepTauId().
|
private |
Definition at line 2724 of file DeepTauId.cc.
Referenced by createEgammaBlockInputs(), and DeepTauId().
|
private |
Definition at line 2732 of file DeepTauId.cc.
Referenced by createConvFeatures(), and DeepTauId().