CMS 3D CMS Logo

Classes | Functions | Variables
L1EGammaCrystalsEmulatorProducer.cc File Reference
#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 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
 

Function Documentation

◆ convert_L2toL1_card()

int convert_L2toL1_card ( int  card,
int  link 
)

◆ convert_L2toL1_link()

int convert_L2toL1_link ( int  link)

◆ convert_L2toL1_tower()

int convert_L2toL1_tower ( int  tower)

Definition at line 121 of file L1EGammaCrystalsEmulatorProducer.cc.

121 { return tower; }

References hgcalTowerProducer_cfi::tower.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ get_towerEta_fromCardLinkTower()

int get_towerEta_fromCardLinkTower ( int  card,
int  link,
int  tower 
)

◆ get_towerEta_fromCardTowerInCard()

int get_towerEta_fromCardTowerInCard ( int  card,
int  towerincard 
)

Definition at line 173 of file L1EGammaCrystalsEmulatorProducer.cc.

173  {
174  return n_towers_per_link * (card % 2) + towerincard % n_towers_per_link;
175 }

References n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ get_towerPhi_fromCardLinkTower()

int get_towerPhi_fromCardLinkTower ( int  card,
int  link,
int  tower 
)

Definition at line 183 of file L1EGammaCrystalsEmulatorProducer.cc.

183 { return 4 * (card / 2) + link; }

References MainPageGenerator::link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ get_towerPhi_fromCardTowerInCard()

int get_towerPhi_fromCardTowerInCard ( int  card,
int  towerincard 
)

Definition at line 177 of file L1EGammaCrystalsEmulatorProducer.cc.

177  {
178  return 4 * (card / 2) + towerincard / n_towers_per_link;
179 }

References n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getCrystal_etaID()

int getCrystal_etaID ( float  eta)

Definition at line 113 of file L1EGammaCrystalsEmulatorProducer.cc.

113  {
114  float size_cell = 2 * ECAL_eta_range / (n_crystals_towerEta * n_towers_Eta);
115  int etaID = int((eta + ECAL_eta_range) / size_cell);
116  return etaID;
117 }

References ECAL_eta_range, PVValHelper::eta, createfilelist::int, n_crystals_towerEta, and n_towers_Eta.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getCrystal_phiID()

int getCrystal_phiID ( float  phi)

Definition at line 125 of file L1EGammaCrystalsEmulatorProducer.cc.

125  {
126  float size_cell = 2 * M_PI / (n_crystals_towerPhi * n_towers_Phi);
127  int phiID = int((phi + M_PI) / size_cell);
128  return phiID;
129 }

References createfilelist::int, M_PI, n_crystals_towerPhi, n_towers_Phi, and PVValHelper::phi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getCrystalIDInTower()

int getCrystalIDInTower ( int  etaID,
int  phiID 
)

◆ getEta_fromL2LinkCardTowerCrystal()

float getEta_fromL2LinkCardTowerCrystal ( int  link,
int  card,
int  tower,
int  crystal 
)

◆ getEtaMax_card()

int getEtaMax_card ( int  card)

Definition at line 198 of file L1EGammaCrystalsEmulatorProducer.cc.

198  {
199  int etamax = 0;
200  if (card % 2 == 0)
201  etamax = n_towers_per_link * n_crystals_towerEta - 1; // First eta half. 5 crystals in eta in 1 tower.
202  else
204  return etamax;
205 }

References muonTiming_cfi::etamax, n_crystals_towerEta, n_towers_Eta, and n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getEtaMin_card()

int getEtaMin_card ( int  card)

Definition at line 207 of file L1EGammaCrystalsEmulatorProducer.cc.

207  {
208  int etamin = 0;
209  if (card % 2 == 0)
210  etamin = 0 * n_crystals_towerEta; // First eta half. 5 crystals in eta in 1 tower.
211  else
213  return etamin;
214 }

References muonTiming_cfi::etamin, n_crystals_towerEta, and n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getPhi_fromL2LinkCardTowerCrystal()

float getPhi_fromL2LinkCardTowerCrystal ( int  link,
int  card,
int  tower,
int  crystal 
)

Definition at line 106 of file L1EGammaCrystalsEmulatorProducer.cc.

106  {
107  int phiID = n_crystals_towerPhi * ((card * 24) + (n_links_card * (link / 8)) + (tower / n_towers_per_link)) +
108  crystal / n_crystals_towerPhi;
109  float size_cell = 2 * M_PI / (n_crystals_towerPhi * n_towers_Phi);
110  return phiID * size_cell - M_PI + half_crystal_size;
111 }

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().

◆ getPhiMax_card()

int getPhiMax_card ( int  card)

Definition at line 216 of file L1EGammaCrystalsEmulatorProducer.cc.

216  {
217  int phimax = ((card / 2) + 1) * 4 * n_crystals_towerPhi - 1;
218  return phimax;
219 }

References n_crystals_towerPhi, and phimax.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getPhiMin_card()

int getPhiMin_card ( int  card)

Definition at line 221 of file L1EGammaCrystalsEmulatorProducer.cc.

221  {
222  int phimin = (card / 2) * 4 * n_crystals_towerPhi;
223  return phimin;
224 }

References n_crystals_towerPhi, and phimin.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getTower_absoluteEtaID()

int getTower_absoluteEtaID ( float  eta)

Definition at line 131 of file L1EGammaCrystalsEmulatorProducer.cc.

131  {
132  float size_cell = 2 * ECAL_eta_range / n_towers_Eta;
133  int etaID = int((eta + ECAL_eta_range) / size_cell);
134  return etaID;
135 }

References ECAL_eta_range, PVValHelper::eta, createfilelist::int, and n_towers_Eta.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getTower_absolutePhiID()

int getTower_absolutePhiID ( float  phi)

Definition at line 137 of file L1EGammaCrystalsEmulatorProducer.cc.

137  {
138  float size_cell = 2 * M_PI / n_towers_Phi;
139  int phiID = int((phi + M_PI) / size_cell);
140  return phiID;
141 }

References createfilelist::int, M_PI, n_towers_Phi, and PVValHelper::phi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getTower_etaID()

int getTower_etaID ( int  cluster_etaID)

Definition at line 194 of file L1EGammaCrystalsEmulatorProducer.cc.

194  { // Tower ID in card given crystal ID in total detector
195  return int((cluster_etaID / n_crystals_towerEta) % n_towers_per_link);
196 }

References createfilelist::int, n_crystals_towerEta, and n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getTower_phiID()

int getTower_phiID ( int  cluster_phiID)

Definition at line 190 of file L1EGammaCrystalsEmulatorProducer.cc.

190  { // Tower ID in card given crystal ID in total detector
191  return int((cluster_phiID / n_crystals_towerPhi) % 4);
192 }

References createfilelist::int, and n_crystals_towerPhi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getTowerEta_fromAbsoluteID()

float getTowerEta_fromAbsoluteID ( int  id)

Definition at line 157 of file L1EGammaCrystalsEmulatorProducer.cc.

157  {
158  float size_cell = 2 * ECAL_eta_range / n_towers_Eta;
159  float eta = (id * size_cell) - ECAL_eta_range + 0.5 * size_cell;
160  return eta;
161 }

References ECAL_eta_range, PVValHelper::eta, and n_towers_Eta.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getTowerID()

int getTowerID ( int  etaID,
int  phiID 
)

◆ getToweriEta_fromAbsoluteID()

int getToweriEta_fromAbsoluteID ( int  id)

Definition at line 143 of file L1EGammaCrystalsEmulatorProducer.cc.

143  {
144  if (id < n_towers_per_link)
145  return id - n_towers_per_link;
146  else
147  return id - toweriEta_fromAbsoluteID_shift;
148 }

References n_towers_per_link, and toweriEta_fromAbsoluteID_shift.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ getToweriPhi_fromAbsoluteID()

int getToweriPhi_fromAbsoluteID ( int  id)

◆ getTowerPhi_fromAbsoluteID()

float getTowerPhi_fromAbsoluteID ( int  id)

Definition at line 163 of file L1EGammaCrystalsEmulatorProducer.cc.

163  {
164  float size_cell = 2 * M_PI / n_towers_Phi;
165  float phi = (id * size_cell) - M_PI + 0.5 * size_cell;
166  return phi;
167 }

References M_PI, n_towers_Phi, and PVValHelper::phi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

◆ s_filler__LINE__()

static const edm::ParameterSetDescriptionFillerPluginFactory::PMaker<edm::ParameterSetDescriptionFiller< L1EGCrystalClusterEmulatorProducer > > s_filler__LINE__ ( "L1EGCrystalClusterEmulatorProducer"  )
static

◆ s_maker__LINE__()

static const edm::MakerPluginFactory ::PMaker< edm::WorkerMaker< L1EGCrystalClusterEmulatorProducer > > s_maker__LINE__ ( "L1EGCrystalClusterEmulatorProducer"  )
static

Variable Documentation

◆ a0

constexpr float a0 = 0.21
staticconstexpr

◆ a0_80

constexpr float a0_80 = 0.85
staticconstexpr

◆ a1_80

constexpr float a1_80 = 0.0080
staticconstexpr

◆ b0

constexpr float b0 = 0.38
staticconstexpr

◆ b1

constexpr float b1 = 1.9
staticconstexpr

Definition at line 82 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().

◆ b2

constexpr float b2 = 0.05
staticconstexpr

Definition at line 82 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(), 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().

◆ c0_ss

constexpr float c0_ss = 0.94
staticconstexpr

◆ c1_ss

constexpr float c1_ss = 0.052
staticconstexpr

◆ c2_ss

constexpr float c2_ss = 0.044
staticconstexpr

◆ cut_500_MeV

constexpr float cut_500_MeV = 0.5
staticconstexpr

◆ d0

constexpr float d0 = 0.96
staticconstexpr

Definition at line 84 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by SiPixelTrackResidualSource::analyze(), TkConvValidator::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), PrimaryVertexValidation::analyze(), MCAcceptanceAnalyzer::analyze(), 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()(), ZSelector::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().

◆ d1

constexpr float d1 = 0.0003
staticconstexpr

Definition at line 84 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by algorithm(), myFastSimVal::analyze(), DisplayGeom::analyze(), MCAcceptanceAnalyzer::analyze(), cond::BasicPayload::BasicPayload(), cscdqm::Collection::book(), AlignmentTask::buildGeometry(), HcalDDDSimConstants::cell(), HelixBarrelPlaneCrossingByCircle::chooseSolution(), HelixBarrelCylinderCrossing::chooseSolution(), DDHCalBarrelAlgo::constructInsideLayers(), HcalBarrelAlgo::constructInsideLayers(), trklet::Tracklet::disk(), 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(), ZSelector::operator()(), 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().

◆ do_brem

constexpr bool do_brem = true
staticconstexpr

◆ e0_looseTkss

constexpr float e0_looseTkss = 0.944
staticconstexpr

◆ e1_looseTkss

constexpr float e1_looseTkss = 0.65
staticconstexpr

◆ e2_looseTkss

constexpr float e2_looseTkss = 0.4
staticconstexpr

◆ ECAL_eta_range

constexpr float ECAL_eta_range = 1.4841
staticconstexpr

◆ half_crystal_size

constexpr float half_crystal_size = 0.00873
staticconstexpr

◆ n_borders_eta

constexpr int n_borders_eta = 18
staticconstexpr

◆ n_borders_phi

constexpr int n_borders_phi = 18
staticconstexpr

◆ n_clusters_4link

constexpr int n_clusters_4link = 4 * 3
staticconstexpr

◆ n_clusters_link

constexpr int n_clusters_link = 3
staticconstexpr

◆ n_clusters_max

constexpr int n_clusters_max = 5
staticconstexpr

◆ n_clusters_per_link

constexpr int n_clusters_per_link = 2
staticconstexpr

◆ n_crystals_3towers

constexpr int n_crystals_3towers = 3 * 5
staticconstexpr

◆ n_crystals_towerEta

constexpr int n_crystals_towerEta = 5
staticconstexpr

◆ n_crystals_towerPhi

constexpr int n_crystals_towerPhi = 5
staticconstexpr

◆ n_eta_bins

constexpr int n_eta_bins = 2
staticconstexpr

◆ n_GCTcards

constexpr int n_GCTcards = 3
staticconstexpr

◆ n_links_card

constexpr int n_links_card = 4
staticconstexpr

◆ n_links_GCTcard

constexpr int n_links_GCTcard = 48
staticconstexpr

◆ n_towers_Eta

constexpr int n_towers_Eta = 34
staticconstexpr

◆ n_towers_halfPhi

constexpr int n_towers_halfPhi = 36
staticconstexpr

◆ n_towers_per_link

constexpr int n_towers_per_link = 17
staticconstexpr

◆ n_towers_Phi

constexpr int n_towers_Phi = 72
staticconstexpr

◆ slideIsoPtThreshold

constexpr float slideIsoPtThreshold = 80
staticconstexpr

◆ toweriEta_fromAbsoluteID_shift

constexpr int toweriEta_fromAbsoluteID_shift = 16
staticconstexpr

Definition at line 91 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by getToweriEta_fromAbsoluteID().

◆ toweriPhi_fromAbsoluteID_shift_lowerHalf

constexpr int toweriPhi_fromAbsoluteID_shift_lowerHalf = 37
staticconstexpr

Definition at line 96 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by getToweriPhi_fromAbsoluteID().

◆ toweriPhi_fromAbsoluteID_shift_upperHalf

constexpr int toweriPhi_fromAbsoluteID_shift_upperHalf = 35
staticconstexpr

Definition at line 97 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by getToweriPhi_fromAbsoluteID().

MainPageGenerator.link
link
Definition: MainPageGenerator.py:271
phimin
float phimin
Definition: ReggeGribovPartonMCHadronizer.h:107
hgcalTowerProducer_cfi.tower
tower
Definition: hgcalTowerProducer_cfi.py:4
n_towers_Phi
static constexpr int n_towers_Phi
Definition: L1EGammaCrystalsEmulatorProducer.cc:73
n_links_card
static constexpr int n_links_card
Definition: L1EGammaCrystalsEmulatorProducer.cc:75
n_towers_Eta
static constexpr int n_towers_Eta
Definition: L1EGammaCrystalsEmulatorProducer.cc:72
toweriPhi_fromAbsoluteID_shift_upperHalf
static constexpr int toweriPhi_fromAbsoluteID_shift_upperHalf
Definition: L1EGammaCrystalsEmulatorProducer.cc:97
muonTiming_cfi.etamin
etamin
Definition: muonTiming_cfi.py:30
n_towers_per_link
static constexpr int n_towers_per_link
Definition: L1EGammaCrystalsEmulatorProducer.cc:70
PVValHelper::eta
Definition: PVValidationHelpers.h:69
half_crystal_size
static constexpr float half_crystal_size
Definition: L1EGammaCrystalsEmulatorProducer.cc:79
PVValHelper::phi
Definition: PVValidationHelpers.h:68
toweriPhi_fromAbsoluteID_shift_lowerHalf
static constexpr int toweriPhi_fromAbsoluteID_shift_lowerHalf
Definition: L1EGammaCrystalsEmulatorProducer.cc:96
n_crystals_towerPhi
static constexpr int n_crystals_towerPhi
Definition: L1EGammaCrystalsEmulatorProducer.cc:68
n_crystals_towerEta
static constexpr int n_crystals_towerEta
Definition: L1EGammaCrystalsEmulatorProducer.cc:67
createfilelist.int
int
Definition: createfilelist.py:10
n_clusters_4link
static constexpr int n_clusters_4link
Definition: L1EGammaCrystalsEmulatorProducer.cc:66
M_PI
#define M_PI
Definition: BXVectorInputProducer.cc:49
phimax
float phimax
Definition: ReggeGribovPartonMCHadronizer.h:106
muonTiming_cfi.etamax
etamax
Definition: muonTiming_cfi.py:23
toweriEta_fromAbsoluteID_shift
static constexpr int toweriEta_fromAbsoluteID_shift
Definition: L1EGammaCrystalsEmulatorProducer.cc:91
ECAL_eta_range
static constexpr float ECAL_eta_range
Definition: L1EGammaCrystalsEmulatorProducer.cc:78