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/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_L1card = 8
 
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
 

Function Documentation

◆ convert_L2toL1_card()

int convert_L2toL1_card ( int  card,
int  link 
)

Definition at line 121 of file L1EGammaCrystalsEmulatorProducer.cc.

References MainPageGenerator::link, n_clusters_4link, and n_links_card.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

121 { return card * n_clusters_4link + link / n_links_card; }
static constexpr int n_clusters_4link
static constexpr int n_links_card

◆ convert_L2toL1_link()

int convert_L2toL1_link ( int  link)

◆ convert_L2toL1_tower()

int convert_L2toL1_tower ( int  tower)

◆ 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 171 of file L1EGammaCrystalsEmulatorProducer.cc.

References n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

171  {
172  return n_towers_per_link * (card % 2) + towerincard % n_towers_per_link;
173 }
static constexpr int n_towers_per_link

◆ get_towerPhi_fromCardLinkTower()

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

Definition at line 181 of file L1EGammaCrystalsEmulatorProducer.cc.

References MainPageGenerator::link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

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

◆ get_towerPhi_fromCardTowerInCard()

int get_towerPhi_fromCardTowerInCard ( int  card,
int  towerincard 
)

Definition at line 175 of file L1EGammaCrystalsEmulatorProducer.cc.

References n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

175  {
176  return 4 * (card / 2) + towerincard / n_towers_per_link;
177 }
static constexpr int n_towers_per_link

◆ getCrystal_etaID()

int getCrystal_etaID ( float  eta)

Definition at line 111 of file L1EGammaCrystalsEmulatorProducer.cc.

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

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

111  {
112  float size_cell = 2 * ECAL_eta_range / (n_crystals_towerEta * n_towers_Eta);
113  int etaID = int((eta + ECAL_eta_range) / size_cell);
114  return etaID;
115 }
static constexpr float ECAL_eta_range
static constexpr int n_crystals_towerEta
static constexpr int n_towers_Eta

◆ getCrystal_phiID()

int getCrystal_phiID ( float  phi)

Definition at line 123 of file L1EGammaCrystalsEmulatorProducer.cc.

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

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

123  {
124  float size_cell = 2 * M_PI / (n_crystals_towerPhi * n_towers_Phi);
125  int phiID = int((phi + M_PI) / size_cell);
126  return phiID;
127 }
static constexpr int n_crystals_towerPhi
#define M_PI
static constexpr int n_towers_Phi

◆ getCrystalIDInTower()

int getCrystalIDInTower ( int  etaID,
int  phiID 
)

Definition at line 167 of file L1EGammaCrystalsEmulatorProducer.cc.

References createfilelist::int, n_crystals_towerEta, and n_crystals_towerPhi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

167  {
168  return int(n_crystals_towerPhi * (phiID % n_crystals_towerPhi) + (etaID % n_crystals_towerEta));
169 }
static constexpr int n_crystals_towerPhi
static constexpr int n_crystals_towerEta

◆ getEta_fromL2LinkCardTowerCrystal()

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

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

97  {
99  crystal % n_crystals_towerEta;
100  float size_cell = 2 * ECAL_eta_range / (n_crystals_towerEta * n_towers_Eta);
101  return etaID * size_cell - ECAL_eta_range + half_crystal_size;
102 }
static constexpr float ECAL_eta_range
static constexpr int n_towers_per_link
static constexpr float half_crystal_size
static constexpr int n_links_card
static constexpr int n_crystals_towerEta
static constexpr int n_towers_Eta

◆ getEtaMax_card()

int getEtaMax_card ( int  card)

Definition at line 196 of file L1EGammaCrystalsEmulatorProducer.cc.

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

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

196  {
197  int etamax = 0;
198  if (card % 2 == 0)
199  etamax = n_towers_per_link * n_crystals_towerEta - 1; // First eta half. 5 crystals in eta in 1 tower.
200  else
202  return etamax;
203 }
static constexpr int n_towers_per_link
static constexpr int n_crystals_towerEta
static constexpr int n_towers_Eta

◆ getEtaMin_card()

int getEtaMin_card ( int  card)

Definition at line 205 of file L1EGammaCrystalsEmulatorProducer.cc.

References muonTiming_cfi::etamin, n_crystals_towerEta, and n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

205  {
206  int etamin = 0;
207  if (card % 2 == 0)
208  etamin = 0 * n_crystals_towerEta; // First eta half. 5 crystals in eta in 1 tower.
209  else
211  return etamin;
212 }
static constexpr int n_towers_per_link
static constexpr int n_crystals_towerEta

◆ getPhi_fromL2LinkCardTowerCrystal()

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

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

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

◆ getPhiMax_card()

int getPhiMax_card ( int  card)

Definition at line 214 of file L1EGammaCrystalsEmulatorProducer.cc.

References n_crystals_towerPhi, and phimax.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

214  {
215  int phimax = ((card / 2) + 1) * 4 * n_crystals_towerPhi - 1;
216  return phimax;
217 }
static constexpr int n_crystals_towerPhi

◆ getPhiMin_card()

int getPhiMin_card ( int  card)

Definition at line 219 of file L1EGammaCrystalsEmulatorProducer.cc.

References n_crystals_towerPhi, and phimin.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

219  {
220  int phimin = (card / 2) * 4 * n_crystals_towerPhi;
221  return phimin;
222 }
static constexpr int n_crystals_towerPhi

◆ getTower_absoluteEtaID()

int getTower_absoluteEtaID ( float  eta)

Definition at line 129 of file L1EGammaCrystalsEmulatorProducer.cc.

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

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

129  {
130  float size_cell = 2 * ECAL_eta_range / n_towers_Eta;
131  int etaID = int((eta + ECAL_eta_range) / size_cell);
132  return etaID;
133 }
static constexpr float ECAL_eta_range
static constexpr int n_towers_Eta

◆ getTower_absolutePhiID()

int getTower_absolutePhiID ( float  phi)

Definition at line 135 of file L1EGammaCrystalsEmulatorProducer.cc.

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

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

135  {
136  float size_cell = 2 * M_PI / n_towers_Phi;
137  int phiID = int((phi + M_PI) / size_cell);
138  return phiID;
139 }
#define M_PI
static constexpr int n_towers_Phi

◆ getTower_etaID()

int getTower_etaID ( int  cluster_etaID)

Definition at line 192 of file L1EGammaCrystalsEmulatorProducer.cc.

References createfilelist::int, n_crystals_towerEta, and n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

192  { // Tower ID in card given crystal ID in total detector
193  return int((cluster_etaID / n_crystals_towerEta) % n_towers_per_link);
194 }
static constexpr int n_towers_per_link
static constexpr int n_crystals_towerEta

◆ getTower_phiID()

int getTower_phiID ( int  cluster_phiID)

Definition at line 188 of file L1EGammaCrystalsEmulatorProducer.cc.

References createfilelist::int, and n_crystals_towerPhi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

188  { // Tower ID in card given crystal ID in total detector
189  return int((cluster_phiID / n_crystals_towerPhi) % 4);
190 }
static constexpr int n_crystals_towerPhi

◆ getTowerEta_fromAbsoluteID()

float getTowerEta_fromAbsoluteID ( int  id)

Definition at line 155 of file L1EGammaCrystalsEmulatorProducer.cc.

References ECAL_eta_range, PVValHelper::eta, and n_towers_Eta.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

155  {
156  float size_cell = 2 * ECAL_eta_range / n_towers_Eta;
157  float eta = (id * size_cell) - ECAL_eta_range + 0.5 * size_cell;
158  return eta;
159 }
static constexpr float ECAL_eta_range
static constexpr int n_towers_Eta

◆ getTowerID()

int getTowerID ( int  etaID,
int  phiID 
)

Definition at line 183 of file L1EGammaCrystalsEmulatorProducer.cc.

References createfilelist::int, n_crystals_towerEta, n_crystals_towerPhi, and n_towers_per_link.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

183  {
184  return int(n_towers_per_link * ((phiID / n_crystals_towerPhi) % 4) +
186 }
static constexpr int n_crystals_towerPhi
static constexpr int n_towers_per_link
static constexpr int n_crystals_towerEta

◆ getToweriEta_fromAbsoluteID()

int getToweriEta_fromAbsoluteID ( int  id)

Definition at line 141 of file L1EGammaCrystalsEmulatorProducer.cc.

References n_towers_per_link, and toweriEta_fromAbsoluteID_shift.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

141  {
142  if (id < n_towers_per_link)
143  return id - n_towers_per_link;
144  else
145  return id - toweriEta_fromAbsoluteID_shift;
146 }
static constexpr int toweriEta_fromAbsoluteID_shift
static constexpr int n_towers_per_link

◆ getToweriPhi_fromAbsoluteID()

int getToweriPhi_fromAbsoluteID ( int  id)

Definition at line 148 of file L1EGammaCrystalsEmulatorProducer.cc.

References n_towers_Phi, toweriPhi_fromAbsoluteID_shift_lowerHalf, and toweriPhi_fromAbsoluteID_shift_upperHalf.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

148  {
149  if (id < n_towers_Phi / 2)
151  else
153 }
static constexpr int toweriPhi_fromAbsoluteID_shift_upperHalf
static constexpr int toweriPhi_fromAbsoluteID_shift_lowerHalf
static constexpr int n_towers_Phi

◆ getTowerPhi_fromAbsoluteID()

float getTowerPhi_fromAbsoluteID ( int  id)

Definition at line 161 of file L1EGammaCrystalsEmulatorProducer.cc.

References M_PI, n_towers_Phi, and PVValHelper::phi.

Referenced by L1EGCrystalClusterEmulatorProducer::produce().

161  {
162  float size_cell = 2 * M_PI / n_towers_Phi;
163  float phi = (id * size_cell) - M_PI + 0.5 * size_cell;
164  return phi;
165 }
#define M_PI
static constexpr int n_towers_Phi

◆ 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
static

◆ a0_80

constexpr float a0_80 = 0.85
static

◆ a1_80

constexpr float a1_80 = 0.0080
static

◆ b0

constexpr float b0 = 0.38
static

◆ b1

constexpr float b1 = 1.9
static

Definition at line 80 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(), VVIObjDetails::expint(), VVIObjFDetails::expint(), sistripvvi::VVIObjDetails::expint(), GlobalLogicParser::expressionResult(), L1GtLogicParser::expressionResult(), GlobalLogicParser::expressionResultNumExp(), L1GtLogicParser::expressionResultNumExp(), GlobalLogicParser::expressionSeedsOperandList(), L1GtLogicParser::expressionSeedsOperandList(), VVIObj::fcn(), sistripvvi::VVIObj::fcn(), VVIObjF::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(), HectorTransport::setBeamLine(), CTPPSFastTrackingProducer::SetBeamLine(), UCTCTP7RawData::setFB(), 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
static

Definition at line 80 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(), DDEcalBarrelNewAlgo::execute(), DDEcalBarrelAlgo::execute(), VVIObjDetails::expint(), VVIObjFDetails::expint(), sistripvvi::VVIObjDetails::expint(), GlobalLogicParser::expressionResult(), L1GtLogicParser::expressionResult(), GlobalLogicParser::expressionResultNumExp(), L1GtLogicParser::expressionResultNumExp(), GlobalLogicParser::expressionSeedsOperandList(), L1GtLogicParser::expressionSeedsOperandList(), riemannFit::fastFit(), VVIObj::fcn(), sistripvvi::VVIObj::fcn(), VVIObjF::fcn(), DD4hep_TrackingMaterialPlotter::fill_gradient(), TrackingMaterialPlotter::fill_gradient(), DD4hep_ListGroups::fillGradient(), ListGroups::fillGradient(), FWRecoGeometryESProducer::fillShapeAndPlacement(), MkFitGeometryESProducer::fillShapeAndPlacement(), heppy::Davismt2::find_high(), DTLinearFit::fitNpar(), TFParams::fitpj(), GridInterpolator3DException::GridInterpolator3DException(), Hector::Hector(), HLTJetSortedVBFFilter< T >::hltFilter(), CircleFromThreePoints::init(), mkfit::intersectThirdLayer(), 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
static

◆ c1_ss

constexpr float c1_ss = 0.052
static

◆ c2_ss

constexpr float c2_ss = 0.044
static

◆ cut_500_MeV

constexpr float cut_500_MeV = 0.5
static

◆ d0

constexpr float d0 = 0.96
static

Definition at line 82 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by SiPixelTrackResidualSource::analyze(), TkConvValidator::analyze(), PhotonValidator::analyze(), PrimaryVertexValidation::analyze(), trklet::TrackletCalculatorDisplaced::approxproj(), trklet::TrackletCalculatorDisplaced::approxprojdisk(), trklet::TrackletCalculatorDisplaced::approxtracklet(), AlignmentTrackSelector::basicCuts(), cond::BasicPayload::BasicPayload(), PhotonIsolationCalculator::calculateTrackIso(), QGTagger::calcVariables(), mkfit::StdSeq::clean_cms_seedtracks_iter(), Phase2L1GMT::TrackConverter::convert(), Phase2L1TGMTSAMuonProducer::Convertl1tMuon(), 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(), TrackEfficiencyMonitor::testTrackerTracks(), and TTTrack_TrackWord::TTTrack_TrackWord().

◆ d1

constexpr float d1 = 0.0003
static

Definition at line 82 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(), brokenline::fastFit(), 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(), trklet::SLHCEvent::layersHit(), EvolutionECAL::LightCollectionEfficiency(), EvolutionECAL::LightCollectionEfficiencyWeighted(), heppy::Davismt2::mt2_bisect(), heppy::Davismt2::nsols(), heppy::Davismt2::nsols_massless(), DCCTBDataFieldComparator::operator()(), L1EGCrystalClusterEmulatorProducer::passes_photon(), brokenline::prepareBrokenLineData(), 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
static

◆ e0_looseTkss

constexpr float e0_looseTkss = 0.944
static

◆ e1_looseTkss

constexpr float e1_looseTkss = 0.65
static

◆ e2_looseTkss

constexpr float e2_looseTkss = 0.4
static

◆ ECAL_eta_range

constexpr float ECAL_eta_range = 1.4841
static

◆ half_crystal_size

constexpr float half_crystal_size = 0.00873
static

◆ n_borders_eta

constexpr int n_borders_eta = 18
static

◆ n_borders_phi

constexpr int n_borders_phi = 18
static

◆ n_clusters_4link

constexpr int n_clusters_4link = 4 * 3
static

◆ n_clusters_link

constexpr int n_clusters_link = 3
static

◆ n_clusters_max

constexpr int n_clusters_max = 5
static

◆ n_clusters_per_L1card

constexpr int n_clusters_per_L1card = 8
static

◆ n_clusters_per_link

constexpr int n_clusters_per_link = 2
static

◆ n_crystals_3towers

constexpr int n_crystals_3towers = 3 * 5
static

◆ n_crystals_towerEta

constexpr int n_crystals_towerEta = 5
static

◆ n_crystals_towerPhi

constexpr int n_crystals_towerPhi = 5
static

◆ n_eta_bins

constexpr int n_eta_bins = 2
static

◆ n_GCTcards

constexpr int n_GCTcards = 3
static

◆ n_links_card

constexpr int n_links_card = 4
static

◆ n_links_GCTcard

constexpr int n_links_GCTcard = 48
static

◆ n_towers_Eta

constexpr int n_towers_Eta = 34
static

◆ n_towers_halfPhi

constexpr int n_towers_halfPhi = 36
static

◆ n_towers_per_link

constexpr int n_towers_per_link = 17
static

◆ n_towers_Phi

constexpr int n_towers_Phi = 72
static

◆ plateau_ss

constexpr float plateau_ss = 130.0
static

◆ slideIsoPtThreshold

constexpr float slideIsoPtThreshold = 80
static

◆ toweriEta_fromAbsoluteID_shift

constexpr int toweriEta_fromAbsoluteID_shift = 16
static

Definition at line 89 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by getToweriEta_fromAbsoluteID().

◆ toweriPhi_fromAbsoluteID_shift_lowerHalf

constexpr int toweriPhi_fromAbsoluteID_shift_lowerHalf = 37
static

Definition at line 94 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by getToweriPhi_fromAbsoluteID().

◆ toweriPhi_fromAbsoluteID_shift_upperHalf

constexpr int toweriPhi_fromAbsoluteID_shift_upperHalf = 35
static

Definition at line 95 of file L1EGammaCrystalsEmulatorProducer.cc.

Referenced by getToweriPhi_fromAbsoluteID().