#include <memory>
#include <array>
#include <iostream>
#include <cmath>
#include "FWCore/Framework/interface/stream/EDProducer.h"
#include "FWCore/Framework/interface/Event.h"
#include "FWCore/Framework/interface/ESHandle.h"
#include "FWCore/Framework/interface/EventSetup.h"
#include "FWCore/ParameterSet/interface/ParameterSet.h"
#include "CalibFormats/CaloTPG/interface/CaloTPGTranscoder.h"
#include "CalibFormats/CaloTPG/interface/CaloTPGRecord.h"
#include "Geometry/CaloGeometry/interface/CaloGeometry.h"
#include "Geometry/EcalAlgo/interface/EcalBarrelGeometry.h"
#include "Geometry/HcalTowerAlgo/interface/HcalTrigTowerGeometry.h"
#include "FWCore/Framework/interface/MakerMacros.h"
#include "DataFormats/HcalDetId/interface/HcalSubdetector.h"
#include "DataFormats/HcalDetId/interface/HcalDetId.h"
#include "DataFormats/EcalDigi/interface/EcalDigiCollections.h"
#include "DataFormats/HcalDigi/interface/HcalTriggerPrimitiveDigi.h"
#include "DataFormats/L1TCalorimeterPhase2/interface/CaloCrystalCluster.h"
#include "DataFormats/L1TCalorimeterPhase2/interface/CaloTower.h"
#include "DataFormats/L1Trigger/interface/EGamma.h"
#include "L1Trigger/L1CaloTrigger/interface/ParametricCalibration.h"
#include "L1Trigger/L1TCalorimeter/interface/CaloTools.h"
#include "FWCore/MessageLogger/interface/MessageLogger.h"
Go to the source code of this file.
Classes | |
class | L1EGCrystalClusterEmulatorProducer |
struct | L1EGCrystalClusterEmulatorProducer::mycluster |
class | L1EGCrystalClusterEmulatorProducer::SimpleCaloHit |
Functions | |
int | convert_L2toL1_card (int card, int link) |
int | convert_L2toL1_link (int link) |
int | convert_L2toL1_tower (int tower) |
int | get_towerEta_fromCardLinkTower (int card, int link, int tower) |
int | get_towerEta_fromCardTowerInCard (int card, int towerincard) |
int | get_towerPhi_fromCardLinkTower (int card, int link, int tower) |
int | get_towerPhi_fromCardTowerInCard (int card, int towerincard) |
int | getCrystal_etaID (float eta) |
int | getCrystal_phiID (float phi) |
int | getCrystalIDInTower (int etaID, int phiID) |
float | getEta_fromL2LinkCardTowerCrystal (int link, int card, int tower, int crystal) |
int | getEtaMax_card (int card) |
int | getEtaMin_card (int card) |
float | getPhi_fromL2LinkCardTowerCrystal (int link, int card, int tower, int crystal) |
int | getPhiMax_card (int card) |
int | getPhiMin_card (int card) |
int | getTower_absoluteEtaID (float eta) |
int | getTower_absolutePhiID (float phi) |
int | getTower_etaID (int cluster_etaID) |
int | getTower_phiID (int cluster_phiID) |
float | getTowerEta_fromAbsoluteID (int id) |
int | getTowerID (int etaID, int phiID) |
int | getToweriEta_fromAbsoluteID (int id) |
int | getToweriPhi_fromAbsoluteID (int id) |
float | getTowerPhi_fromAbsoluteID (int id) |
static const edm::ParameterSetDescriptionFillerPluginFactory::PMaker< edm::ParameterSetDescriptionFiller< L1EGCrystalClusterEmulatorProducer > > | s_filler__LINE__ ("L1EGCrystalClusterEmulatorProducer") |
static const edm::MakerPluginFactory ::PMaker< edm::WorkerMaker< L1EGCrystalClusterEmulatorProducer > > | s_maker__LINE__ ("L1EGCrystalClusterEmulatorProducer") |
Variables | |
static constexpr float | a0 = 0.21 |
static constexpr float | a0_80 = 0.85 |
static constexpr float | a1_80 = 0.0080 |
static constexpr float | b0 = 0.38 |
static constexpr float | b1 = 1.9 |
static constexpr float | b2 = 0.05 |
static constexpr float | c0_ss = 0.94 |
static constexpr float | c1_ss = 0.052 |
static constexpr float | c2_ss = 0.044 |
static constexpr float | cut_500_MeV = 0.5 |
static constexpr float | d0 = 0.96 |
static constexpr float | d1 = 0.0003 |
static constexpr bool | do_brem = true |
static constexpr float | e0_looseTkss = 0.944 |
static constexpr float | e1_looseTkss = 0.65 |
static constexpr float | e2_looseTkss = 0.4 |
static constexpr float | ECAL_eta_range = 1.4841 |
static constexpr float | half_crystal_size = 0.00873 |
static constexpr int | n_borders_eta = 18 |
static constexpr int | n_borders_phi = 18 |
static constexpr int | n_clusters_4link = 4 * 3 |
static constexpr int | n_clusters_link = 3 |
static constexpr int | n_clusters_max = 5 |
static constexpr int | n_clusters_per_link = 2 |
static constexpr int | n_crystals_3towers = 3 * 5 |
static constexpr int | n_crystals_towerEta = 5 |
static constexpr int | n_crystals_towerPhi = 5 |
static constexpr int | n_eta_bins = 2 |
static constexpr int | n_GCTcards = 3 |
static constexpr int | n_links_card = 4 |
static constexpr int | n_links_GCTcard = 48 |
static constexpr int | n_towers_Eta = 34 |
static constexpr int | n_towers_halfPhi = 36 |
static constexpr int | n_towers_per_link = 17 |
static constexpr int | n_towers_Phi = 72 |
static constexpr float | plateau_ss = 130.0 |
static constexpr float | slideIsoPtThreshold = 80 |
static constexpr int | toweriEta_fromAbsoluteID_shift = 16 |
static constexpr int | toweriPhi_fromAbsoluteID_shift_lowerHalf = 37 |
static constexpr int | toweriPhi_fromAbsoluteID_shift_upperHalf = 35 |
int convert_L2toL1_card | ( | int | card, |
int | link | ||
) |
Definition at line 124 of file L1EGammaCrystalsEmulatorProducer.cc.
References MainPageGenerator::link, n_clusters_4link, and n_links_card.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int convert_L2toL1_link | ( | int | link | ) |
Definition at line 120 of file L1EGammaCrystalsEmulatorProducer.cc.
References MainPageGenerator::link, and n_links_card.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int convert_L2toL1_tower | ( | int | tower | ) |
Definition at line 122 of file L1EGammaCrystalsEmulatorProducer.cc.
References hgcalTowerProducer_cfi::tower.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int get_towerEta_fromCardLinkTower | ( | int | card, |
int | link, | ||
int | tower | ||
) |
Definition at line 182 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_towers_per_link, and hgcalTowerProducer_cfi::tower.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int get_towerEta_fromCardTowerInCard | ( | int | card, |
int | towerincard | ||
) |
Definition at line 174 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_towers_per_link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int get_towerPhi_fromCardLinkTower | ( | int | card, |
int | link, | ||
int | tower | ||
) |
Definition at line 184 of file L1EGammaCrystalsEmulatorProducer.cc.
References MainPageGenerator::link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int get_towerPhi_fromCardTowerInCard | ( | int | card, |
int | towerincard | ||
) |
Definition at line 178 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_towers_per_link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getCrystal_etaID | ( | float | eta | ) |
Definition at line 114 of file L1EGammaCrystalsEmulatorProducer.cc.
References ECAL_eta_range, PVValHelper::eta, createfilelist::int, n_crystals_towerEta, and n_towers_Eta.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getCrystal_phiID | ( | float | phi | ) |
Definition at line 126 of file L1EGammaCrystalsEmulatorProducer.cc.
References createfilelist::int, M_PI, n_crystals_towerPhi, n_towers_Phi, and PVValHelper::phi.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getCrystalIDInTower | ( | int | etaID, |
int | phiID | ||
) |
Definition at line 170 of file L1EGammaCrystalsEmulatorProducer.cc.
References createfilelist::int, n_crystals_towerEta, and n_crystals_towerPhi.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
float getEta_fromL2LinkCardTowerCrystal | ( | int | link, |
int | card, | ||
int | tower, | ||
int | crystal | ||
) |
Definition at line 100 of file L1EGammaCrystalsEmulatorProducer.cc.
References ECAL_eta_range, half_crystal_size, MainPageGenerator::link, n_crystals_towerEta, n_links_card, n_towers_Eta, n_towers_per_link, and hgcalTowerProducer_cfi::tower.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getEtaMax_card | ( | int | card | ) |
Definition at line 199 of file L1EGammaCrystalsEmulatorProducer.cc.
References muonTiming_cfi::etamax, n_crystals_towerEta, n_towers_Eta, and n_towers_per_link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getEtaMin_card | ( | int | card | ) |
Definition at line 208 of file L1EGammaCrystalsEmulatorProducer.cc.
References muonTiming_cfi::etamin, n_crystals_towerEta, and n_towers_per_link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
float getPhi_fromL2LinkCardTowerCrystal | ( | int | link, |
int | card, | ||
int | tower, | ||
int | crystal | ||
) |
Definition at line 107 of file L1EGammaCrystalsEmulatorProducer.cc.
References half_crystal_size, MainPageGenerator::link, M_PI, n_crystals_towerPhi, n_links_card, n_towers_per_link, n_towers_Phi, and hgcalTowerProducer_cfi::tower.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getPhiMax_card | ( | int | card | ) |
Definition at line 217 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_crystals_towerPhi, and phimax.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getPhiMin_card | ( | int | card | ) |
Definition at line 222 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_crystals_towerPhi, and phimin.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getTower_absoluteEtaID | ( | float | eta | ) |
Definition at line 132 of file L1EGammaCrystalsEmulatorProducer.cc.
References ECAL_eta_range, PVValHelper::eta, createfilelist::int, and n_towers_Eta.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getTower_absolutePhiID | ( | float | phi | ) |
Definition at line 138 of file L1EGammaCrystalsEmulatorProducer.cc.
References createfilelist::int, M_PI, n_towers_Phi, and PVValHelper::phi.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getTower_etaID | ( | int | cluster_etaID | ) |
Definition at line 195 of file L1EGammaCrystalsEmulatorProducer.cc.
References createfilelist::int, n_crystals_towerEta, and n_towers_per_link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getTower_phiID | ( | int | cluster_phiID | ) |
Definition at line 191 of file L1EGammaCrystalsEmulatorProducer.cc.
References createfilelist::int, and n_crystals_towerPhi.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
float getTowerEta_fromAbsoluteID | ( | int | id | ) |
Definition at line 158 of file L1EGammaCrystalsEmulatorProducer.cc.
References ECAL_eta_range, PVValHelper::eta, and n_towers_Eta.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getTowerID | ( | int | etaID, |
int | phiID | ||
) |
Definition at line 186 of file L1EGammaCrystalsEmulatorProducer.cc.
References createfilelist::int, n_crystals_towerEta, n_crystals_towerPhi, and n_towers_per_link.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getToweriEta_fromAbsoluteID | ( | int | id | ) |
Definition at line 144 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_towers_per_link, and toweriEta_fromAbsoluteID_shift.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
int getToweriPhi_fromAbsoluteID | ( | int | id | ) |
Definition at line 151 of file L1EGammaCrystalsEmulatorProducer.cc.
References n_towers_Phi, toweriPhi_fromAbsoluteID_shift_lowerHalf, and toweriPhi_fromAbsoluteID_shift_upperHalf.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
float getTowerPhi_fromAbsoluteID | ( | int | id | ) |
Definition at line 164 of file L1EGammaCrystalsEmulatorProducer.cc.
References M_PI, n_towers_Phi, and PVValHelper::phi.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
static |
|
static |
|
staticconstexpr |
Definition at line 82 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by dqm::impl::MonitorElement::divide(), SurveyPxbDicer::doDice(), EcalMatacqAnalyzer::endJob(), VVIObj::fcn(), VVIObjF::fcn(), sistripvvi::VVIObj::fcn(), MillePedeMonitor::fillPxbSurveyHistsLocalPars(), Fit_MaximumPoint(), lumi::fPoly::getCorrection(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), L1EGCrystalClusterEmulatorProducer::passes_iso(), L1TkFastVertexProducer::produce(), DTTSCand::setBitsBkmod(), DTSectCollPhCand::setBitsSectColl(), TBposition(), and SurveyPxbDicer::transform().
|
staticconstexpr |
Definition at line 82 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_iso().
|
staticconstexpr |
Definition at line 82 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_iso().
|
staticconstexpr |
Definition at line 83 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by AnalyticalCurvilinearJacobian::computeInfinitesimalJacobian(), VVIObjDetails::cosint(), sistripvvi::VVIObjDetails::cosint(), VVIObj::fcn(), VVIObjF::fcn(), sistripvvi::VVIObj::fcn(), BPHWriteSpecificDecay::fill(), Fit_MaximumPoint(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), SteppingHelixPropagator::makeAtomStep(), L1EGCrystalClusterEmulatorProducer::passes_looseTkiso(), TtFullLepKinSolver::quartic(), SteppingHelixPropagator::refToDest(), VVIObjDetails::sincosint(), sistripvvi::VVIObjDetails::sincosint(), VVIObjDetails::sinint(), sistripvvi::VVIObjDetails::sinint(), and FW3DViewBase::updateClipPlanes().
|
staticconstexpr |
Definition at line 83 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by algorithm(), lhef::LHEEvent::asHepMCEvent(), PtAssignmentEngine2017::calculate_address(), VVIObjDetails::cosint(), sistripvvi::VVIObjDetails::cosint(), EMShower::deposit(), SRBlockFormatter::DigiToRaw(), FWDetailViewBase::drawCanvasBox(), FWDetailViewBase::drawCanvasDot(), L1GtAlgorithmEvaluation::evaluateAlgorithm(), l1t::AlgorithmEvaluation::evaluateAlgorithm(), trklet::TrackletCalculatorDisplaced::exacttracklet(), DDEcalBarrelAlgo::execute(), DDEcalBarrelNewAlgo::execute(), VVIObjFDetails::expint(), VVIObjDetails::expint(), sistripvvi::VVIObjDetails::expint(), GlobalLogicParser::expressionResult(), L1GtLogicParser::expressionResult(), GlobalLogicParser::expressionResultNumExp(), L1GtLogicParser::expressionResultNumExp(), GlobalLogicParser::expressionSeedsOperandList(), L1GtLogicParser::expressionSeedsOperandList(), VVIObj::fcn(), VVIObjF::fcn(), sistripvvi::VVIObj::fcn(), TrackingMaterialPlotter::fill_gradient(), DD4hep_TrackingMaterialPlotter::fill_gradient(), CMTRawAnalyzer::fillDigiAmplitudeQIE11(), DD4hep_ListGroups::fillGradient(), ListGroups::fillGradient(), heppy::Davismt2::find_high(), DTLinearFit::fitNpar(), TFParams::fitpj(), PhotonMIPHaloTagger::GetMipTrailFit(), GridInterpolator3DException::GridInterpolator3DException(), Hector::Hector(), HLTJetSortedVBFFilter< T >::hltFilter(), TFParams::lastShape(), TFParams::lastShape2(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), TruncatedPyramid::localCorners(), main(), TFParams::mixShape(), heppy::Davismt2::mt2_bisect(), heppy::Davismt2::nsols(), OverlapChecker::operator()(), operator==(), L1EGCrystalClusterEmulatorProducer::passes_looseTkiso(), PrimitiveMatching::process(), cscdqm::EventProcessor::processCSC(), PseudoTopProducer::produce(), TFParams::pulseShapepj(), TFParams::pulseShapepj2(), TtFullLepKinSolver::quartic(), RecoProducerFP420::RecoProducerFP420(), UrbanMscModel93::SampleCosineTheta(), HectorTransport::setBeamLine(), CTPPSFastTrackingProducer::SetBeamLine(), DTGeometryESProducer::setupGeometry(), VVIObjDetails::sincosint(), sistripvvi::VVIObjDetails::sincosint(), VVIObjDetails::sinint(), sistripvvi::VVIObjDetails::sinint(), heppy::mt2w_bisect::mt2w::teco(), FullModelReactionDynamics::TwoBody(), FullModelReactionDynamics::TwoCluster(), and FW3DViewBase::updateClipPlanes().
|
staticconstexpr |
Definition at line 83 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by algorithm(), lhef::LHEEvent::asHepMCEvent(), AnalyticalCurvilinearJacobian::computeInfinitesimalJacobian(), EGEnergyCorrector::CorrectedEnergyWithError(), VVIObjDetails::cosint(), sistripvvi::VVIObjDetails::cosint(), FWTGeoRecoGeometryESProducer::createShape(), EMShower::deposit(), SRBlockFormatter::DigiToRaw(), FWDetailViewBase::drawCanvasBox(), FWDetailViewBase::drawCanvasDot(), L1GtAlgorithmEvaluation::evaluateAlgorithm(), l1t::AlgorithmEvaluation::evaluateAlgorithm(), trklet::TrackletCalculatorDisplaced::exacttracklet(), DDEcalBarrelAlgo::execute(), DDEcalBarrelNewAlgo::execute(), VVIObjFDetails::expint(), VVIObjDetails::expint(), sistripvvi::VVIObjDetails::expint(), GlobalLogicParser::expressionResult(), L1GtLogicParser::expressionResult(), GlobalLogicParser::expressionResultNumExp(), L1GtLogicParser::expressionResultNumExp(), GlobalLogicParser::expressionSeedsOperandList(), L1GtLogicParser::expressionSeedsOperandList(), riemannFit::fastFit(), VVIObj::fcn(), VVIObjF::fcn(), sistripvvi::VVIObj::fcn(), DD4hep_TrackingMaterialPlotter::fill_gradient(), TrackingMaterialPlotter::fill_gradient(), DD4hep_ListGroups::fillGradient(), ListGroups::fillGradient(), FWRecoGeometryESProducer::fillShapeAndPlacement(), heppy::Davismt2::find_high(), DTLinearFit::fitNpar(), TFParams::fitpj(), GridInterpolator3DException::GridInterpolator3DException(), Hector::Hector(), HLTJetSortedVBFFilter< T >::hltFilter(), CircleFromThreePoints::init(), TFParams::lastShape(), TFParams::lastShape2(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), TruncatedPyramid::localCorners(), TFParams::mixShape(), heppy::Davismt2::mt2_bisect(), heppy::Davismt2::mt2_massless(), heppy::Davismt2::nsols(), heppy::Davismt2::nsols_massless(), OverlapChecker::operator()(), EcalTBHodoscopeRecInfoAlgo::BeamTrack::operator<(), operator==(), L1EGCrystalClusterEmulatorProducer::passes_looseTkiso(), cscdqm::EventProcessor::processCSC(), PseudoTopProducer::produce(), BaseParticlePropagator::propagate(), TFParams::pulseShapepj(), TtFullLepKinSolver::quartic(), HcalLaserEventFilter2012::readEventListFile(), RecoProducerFP420::RecoProducerFP420(), HectorTransport::setBeamLine(), CTPPSFastTrackingProducer::SetBeamLine(), VVIObjDetails::sincosint(), sistripvvi::VVIObjDetails::sincosint(), VVIObjDetails::sinint(), sistripvvi::VVIObjDetails::sinint(), heppy::mt2w_bisect::mt2w::teco(), FullModelReactionDynamics::TwoBody(), FullModelReactionDynamics::TwoCluster(), ThirdHitPredictionFromCircle::HelixRZ::zAtR(), and MCFilterZboostHelper::zboost().
|
staticconstexpr |
Definition at line 84 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_ss().
|
staticconstexpr |
Definition at line 84 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_ss().
|
staticconstexpr |
Definition at line 84 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_ss().
|
staticconstexpr |
Definition at line 87 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 85 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by SiPixelTrackResidualSource::analyze(), TkConvValidator::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), trklet::TrackletCalculatorDisplaced::approxproj(), trklet::TrackletCalculatorDisplaced::approxprojdisk(), trklet::TrackletCalculatorDisplaced::approxtracklet(), AlignmentTrackSelector::basicCuts(), cond::BasicPayload::BasicPayload(), PhotonIsolationCalculator::calculateTrackIso(), QGTagger::calcVariables(), trklet::TrackletCalculatorDisplaced::DDLSeeding(), ElectronVPlusJetsIDSelectionFunctor::ElectronVPlusJetsIDSelectionFunctor(), trklet::TrackletCalculatorDisplaced::exactproj(), trklet::TrackletCalculatorDisplaced::exacttracklet(), PrimaryVertexValidation::fillTrackHistos(), EcalTangentFilter::filter(), tmtt::KFbase::fit(), TrackFitter::getCotThetaAndUpdateZip(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), ElectronVPlusJetsIDSelectionFunctor::initialize(), MuonVPlusJetsIDSelectionFunctor::initialize(), MVAJetPuId::initVariables(), PileupJetIdAlgo::initVariables(), MuIsolatorResultProducer< BT >::initVetos(), cms::MuonTCMETValueMapProducer::isGoodMuon(), tmtt::KFParamsComb::isGoodState(), cms::MuonTCMETValueMapProducer::isGoodTrack(), TCMETAlgo::isGoodTrack(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), trklet::TrackletCalculatorDisplaced::LLDSeeding(), trklet::TrackletCalculatorDisplaced::LLLSeeding(), QualityCutsAnalyzer::LoopOverJetTracksAssociation(), tmtt::ConverterToTTTrack::makeTTTrack(), MuonVPlusJetsIDSelectionFunctor::MuonVPlusJetsIDSelectionFunctor(), EGammaMvaEleEstimator::mvaValue(), HIProtoTrackFilter::operator()(), HIPixelTrackFilter::operator()(), L1EGCrystalClusterEmulatorProducer::passes_photon(), CastorFastTowerProducer::produce(), HLTScoutingEgammaProducer::produce(), TtFullLepKinSolver::quartic(), HIPAlignmentAlgorithm::run(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), CosmicTrackSelector::select(), HIProtoTrackSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), GflashTrajectory::setD0(), TTTrack_TrackWord::setTrackWord(), TrackEfficiencyMonitor::testSTATracks(), and TrackEfficiencyMonitor::testTrackerTracks().
|
staticconstexpr |
Definition at line 85 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by algorithm(), myFastSimVal::analyze(), DisplayGeom::analyze(), cond::BasicPayload::BasicPayload(), cscdqm::Collection::book(), AlignmentTask::buildGeometry(), HcalDDDSimConstants::cell(), HelixBarrelPlaneCrossingByCircle::chooseSolution(), HelixBarrelCylinderCrossing::chooseSolution(), DDHCalBarrelAlgo::constructInsideLayers(), HcalBarrelAlgo::constructInsideLayers(), trklet::Tracklet::disk(), MuonCSCDigisHarvestor::dqmEndJob(), DDPixBarLayerAlgo::execute(), EcalHitMaker::fastInsideCell(), CandCommonVertexFitterBase::fill(), CandKinematicVertexFitter::fill(), NtupleManager::FillMeasurements(), HLTEcalResonanceFilter::filter(), HLTRegionalEcalResonanceFilter::filter(), heppy::Davismt2::find_high(), hitfit::Chisq_Constrainer::fit(), GEMCSCSegFit::fit2(), DTLinearFit::fitNpar(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), SimHitsValidationHcal::idType::idType(), TensorIndex< d1, d2, d3, d4 >::indexOf(), TensorIndex_base1< d1, d2, d3, d4 >::indexOf(), CSCUpgradeMotherboard::intersection(), trklet::SLHCEvent::layersHit(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), CSCGEMMotherboard::matchingPads(), heppy::Davismt2::mt2_bisect(), heppy::Davismt2::nsols(), heppy::Davismt2::nsols_massless(), DCCTBDataFieldComparator::operator()(), L1EGCrystalClusterEmulatorProducer::passes_photon(), TopologyWorker::planes_sphe(), TopologyWorker::planes_sphe_wei(), TopologyWorker::planes_thrust(), EcalHitMaker::prepareCrystalNumberArray(), CastorFastTowerProducer::produce(), TtFullLepKinSolver::quartic(), Conv4HitsReco2::Reconstruct(), HcalTopology::segmentBoundaries(), LMFLaserConfigDat::setData(), TangentHelix::TangentHelix(), heppy::mt2w_bisect::mt2w::teco(), trklet::FitTrack::trackFitChisq(), VVIObj::VVIObj(), sistripvvi::VVIObj::VVIObj(), and VVIObjF::VVIObjF().
|
staticconstexpr |
Definition at line 59 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 86 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_looseTkss().
|
staticconstexpr |
Definition at line 86 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_looseTkss().
|
staticconstexpr |
Definition at line 86 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_looseTkss().
|
staticconstexpr |
Definition at line 78 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getCrystal_etaID(), getEta_fromL2LinkCardTowerCrystal(), getTower_absoluteEtaID(), and getTowerEta_fromAbsoluteID().
|
staticconstexpr |
Definition at line 79 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getEta_fromL2LinkCardTowerCrystal(), and getPhi_fromL2LinkCardTowerCrystal().
|
staticconstexpr |
Definition at line 63 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 62 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 66 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by convert_L2toL1_card(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 65 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 64 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 71 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 69 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 67 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getCrystal_etaID(), getCrystalIDInTower(), getEta_fromL2LinkCardTowerCrystal(), getEtaMax_card(), getEtaMin_card(), getTower_etaID(), getTowerID(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 68 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getCrystal_phiID(), getCrystalIDInTower(), getPhi_fromL2LinkCardTowerCrystal(), getPhiMax_card(), getPhiMin_card(), getTower_phiID(), getTowerID(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 61 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by etaBin(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 77 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 75 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by convert_L2toL1_card(), convert_L2toL1_link(), getEta_fromL2LinkCardTowerCrystal(), getPhi_fromL2LinkCardTowerCrystal(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 76 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 72 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getCrystal_etaID(), getEta_fromL2LinkCardTowerCrystal(), getEtaMax_card(), getTower_absoluteEtaID(), and getTowerEta_fromAbsoluteID().
|
staticconstexpr |
Definition at line 74 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 70 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by get_towerEta_fromCardLinkTower(), get_towerEta_fromCardTowerInCard(), get_towerPhi_fromCardTowerInCard(), getEta_fromL2LinkCardTowerCrystal(), getEtaMax_card(), getEtaMin_card(), getPhi_fromL2LinkCardTowerCrystal(), getTower_etaID(), getTowerID(), getToweriEta_fromAbsoluteID(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 73 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getCrystal_phiID(), getPhi_fromL2LinkCardTowerCrystal(), getTower_absolutePhiID(), getToweriPhi_fromAbsoluteID(), getTowerPhi_fromAbsoluteID(), and L1EGCrystalClusterEmulatorProducer::produce().
|
staticconstexpr |
Definition at line 81 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_iso(), L1EGCrystalClusterEmulatorProducer::passes_looseTkiso(), L1EGCrystalClusterEmulatorProducer::passes_looseTkss(), L1EGCrystalClusterEmulatorProducer::passes_photon(), and L1EGCrystalClusterEmulatorProducer::passes_ss().
|
staticconstexpr |
Definition at line 80 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by L1EGCrystalClusterEmulatorProducer::passes_iso().
|
staticconstexpr |
Definition at line 92 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getToweriEta_fromAbsoluteID().
|
staticconstexpr |
Definition at line 97 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getToweriPhi_fromAbsoluteID().
|
staticconstexpr |
Definition at line 98 of file L1EGammaCrystalsEmulatorProducer.cc.
Referenced by getToweriPhi_fromAbsoluteID().