CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Groups Pages
List of all members | Public Member Functions | Protected Attributes | Static Protected Attributes
EcalPhiSymRecHitProducerBase Class Reference
Inheritance diagram for EcalPhiSymRecHitProducerBase:
EcalPhiSymRecHitProducerLumi EcalPhiSymRecHitProducerRun

Public Member Functions

 EcalPhiSymRecHitProducerBase (const edm::ParameterSet &pSet, edm::ConsumesCollector &&cc)
 
void initializeConfigCache (edm::EventSetup const &setup, edm::ESGetToken< CaloGeometry, CaloGeometryRecord > const &geoToken, std::shared_ptr< ConfigCache > &cache) const
 
void initializeJob ()
 
void initializePhiSymCache (edm::EventSetup const &setup, edm::ESGetToken< EcalChannelStatus, EcalChannelStatusRcd > const &chStatusToken, ConfigCache const *config, std::shared_ptr< PhiSymCache > &cache) const
 
void initializeStreamCache (ConfigCache const *config, PhiSymCache *cache) const
 
void processEvent (edm::Event const &event, edm::EventSetup const &setup, ConfigCache const *config, PhiSymCache *cache) const
 
void sumCache (PhiSymCache *summaryc, PhiSymCache *streamc) const
 
 ~EcalPhiSymRecHitProducerBase ()
 

Protected Attributes

std::vector< double > A_
 
std::vector< double > B_
 
EcalRingCalibrationTools calibRing_
 
edm::EDGetTokenT
< EBRecHitCollection
ebToken_
 
edm::EDGetTokenT
< EBRecHitCollection
eeToken_
 
float etCutEB_
 
float etCutEE_
 
std::vector< double > eThresholdsEB_
 
float eThresholdsEE_ [kNRingsEE]
 
edm::ESGetToken< CaloGeometry,
CaloGeometryRecord
geoToken_
 
edm::ESGetToken
< EcalLaserDbService,
EcalLaserDbRecord
laserDbToken_
 
std::vector< double > misCalibRangeEB_
 
std::vector< double > misCalibRangeEE_
 
std::vector< float > misCalibStepsEB_
 
std::vector< float > misCalibStepsEE_
 
int nMisCalib_
 
int nSumEtValues_
 
float thrEEmod_
 

Static Protected Attributes

static const short kNRingsEB = EcalRingCalibrationTools::N_RING_BARREL
 
static const short kNRingsEE = EcalRingCalibrationTools::N_RING_ENDCAP
 
static const short ringsInOneEE = kNRingsEE / 2
 

Detailed Description

Definition at line 69 of file EcalPhiSymRecHitProducers.cc.

Constructor & Destructor Documentation

EcalPhiSymRecHitProducerBase::EcalPhiSymRecHitProducerBase ( const edm::ParameterSet pSet,
edm::ConsumesCollector &&  cc 
)
explicit

Definition at line 121 of file EcalPhiSymRecHitProducers.cc.

122  : geoToken_(cc.esConsumes()),
124  ebToken_(cc.consumes<EBRecHitCollection>(pSet.getParameter<edm::InputTag>("barrelHitCollection"))),
125  eeToken_(cc.consumes<EBRecHitCollection>(pSet.getParameter<edm::InputTag>("endcapHitCollection"))),
126  etCutEB_(pSet.getParameter<double>("etCut_barrel")),
127  eThresholdsEB_(pSet.getParameter<std::vector<double> >("eThresholds_barrel")),
128  etCutEE_(pSet.getParameter<double>("etCut_endcap")),
129  A_(pSet.getParameter<std::vector<double> >("A")),
130  B_(pSet.getParameter<std::vector<double> >("B")),
131  thrEEmod_(pSet.getParameter<double>("thrEEmod")),
132  nMisCalib_(pSet.getParameter<int>("nMisCalib") / 2),
133  nSumEtValues_(nMisCalib_ * 2 + 1),
134  misCalibRangeEB_(pSet.getParameter<std::vector<double> >("misCalibRangeEB")),
135  misCalibRangeEE_(pSet.getParameter<std::vector<double> >("misCalibRangeEE")) {}
EDGetTokenT< ProductType > consumes(edm::InputTag const &tag)
edm::ESGetToken< EcalLaserDbService, EcalLaserDbRecord > laserDbToken_
edm::ESGetToken< CaloGeometry, CaloGeometryRecord > geoToken_
edm::EDGetTokenT< EBRecHitCollection > eeToken_
T getParameter(std::string const &) const
Definition: ParameterSet.h:303
edm::EDGetTokenT< EBRecHitCollection > ebToken_
EcalPhiSymRecHitProducerBase::~EcalPhiSymRecHitProducerBase ( )
inline

Definition at line 72 of file EcalPhiSymRecHitProducers.cc.

72 {};

Member Function Documentation

void EcalPhiSymRecHitProducerBase::initializeConfigCache ( edm::EventSetup const &  setup,
edm::ESGetToken< CaloGeometry, CaloGeometryRecord > const &  geoToken,
std::shared_ptr< ConfigCache > &  cache 
) const

Definition at line 313 of file EcalPhiSymRecHitProducers.cc.

References calibRing_, DetId::Ecal, EcalBarrel, EcalEndcap, PVValHelper::eta, etCutEB_, etCutEE_, eThresholdsEB_, eThresholdsEE_, relativeConstraints::geometry, edm::EventSetup::getData(), EcalRingCalibrationTools::getRingIndex(), gpuClustering::id, EEDetId::IX_MAX, kNRingsEB, relativeConstraints::ring, ringsInOneEE, and EcalRingCalibrationTools::setCaloGeometry().

Referenced by EcalPhiSymRecHitProducerLumi::globalBeginLuminosityBlock(), and EcalPhiSymRecHitProducerRun::globalBeginRun().

316  {
317  //---get the ecal geometry
318  const auto* geometry = &setup.getData(geoToken);
320 
321  const auto* barrelGeometry = geometry->getSubdetectorGeometry(DetId::Ecal, EcalBarrel);
322  const auto* endcapGeometry = geometry->getSubdetectorGeometry(DetId::Ecal, EcalEndcap);
323  cache->barrelDetIds = barrelGeometry->getValidDetIds(DetId::Ecal, EcalBarrel);
324  cache->endcapDetIds = endcapGeometry->getValidDetIds(DetId::Ecal, EcalEndcap);
325 
326  for (auto& ebDetId : cache->barrelDetIds) {
327  EBDetId id(ebDetId);
328  int ring = calibRing_.getRingIndex(id);
329  //---set etCut if first pass
330  if (id.iphi() == 1) {
331  auto cellGeometry = barrelGeometry->getGeometry(id);
332  float eta = cellGeometry->getPosition().eta();
333  cache->etCutsEB[ring] = eThresholdsEB_[ring] / cosh(eta) + etCutEB_;
334  }
335  }
336  for (auto& eeDetId : cache->endcapDetIds) {
337  EEDetId id(eeDetId);
338  int ring = calibRing_.getRingIndex(id) - kNRingsEB;
339  //---set eCutEE if first pass
340  if (ring < ringsInOneEE && id.ix() == EEDetId::IX_MAX / 2) {
341  auto cellGeometry = endcapGeometry->getGeometry(id);
342  cache->etCutsEE[ring] = eThresholdsEE_[ring] / cosh(cellGeometry->getPosition().eta()) + etCutEE_;
343  cache->etCutsEE[ring + ringsInOneEE] = cache->etCutsEE[ring];
344  }
345  }
346 }
static void setCaloGeometry(const CaloGeometry *geometry)
uint16_t *__restrict__ id
static short getRingIndex(DetId aDetId)
Retrieve the phi-ring index corresponding to a DetId.
static const int IX_MAX
Definition: EEDetId.h:298
def cache
Definition: utilities.py:3
void EcalPhiSymRecHitProducerBase::initializeJob ( )

Definition at line 137 of file EcalPhiSymRecHitProducers.cc.

References A_, funct::abs(), B_, eThresholdsEE_, misCalibRangeEB_, misCalibRangeEE_, misCalibStepsEB_, misCalibStepsEE_, nMisCalib_, nSumEtValues_, ringsInOneEE, and thrEEmod_.

Referenced by EcalPhiSymRecHitProducerLumi::beginJob(), and EcalPhiSymRecHitProducerRun::beginJob().

137  {
138  //---Compute the endcap thresholds using the provived parametric formula
139  for (int iRing = 0; iRing < ringsInOneEE; ++iRing) {
140  if (iRing < 30)
141  eThresholdsEE_[iRing] = thrEEmod_ * (B_[0] + A_[0] * iRing) / 1000;
142  else
143  eThresholdsEE_[iRing] = thrEEmod_ * (B_[1] + A_[1] * iRing) / 1000;
144  eThresholdsEE_[iRing + ringsInOneEE] = eThresholdsEE_[iRing];
145  }
146 
147  //---misCalib value init (nMisCalib is half of the correct value!)
148  float misCalibStepEB = std::abs(misCalibRangeEB_[1] - misCalibRangeEB_[0]) / (nMisCalib_ * 2);
149  float misCalibStepEE = std::abs(misCalibRangeEE_[1] - misCalibRangeEE_[0]) / (nMisCalib_ * 2);
152  for (int iMis = -nMisCalib_; iMis <= nMisCalib_; ++iMis) {
153  //--- 0 -> 0; -i -> [1...n/2]; +i -> [n/2+1...n]
154  int index = iMis > 0 ? iMis + nMisCalib_ : iMis == 0 ? 0 : iMis + nMisCalib_ + 1;
155  misCalibStepsEB_[index] = iMis * misCalibStepEB;
156  misCalibStepsEE_[index] = iMis * misCalibStepEE;
157  }
158 }
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
void EcalPhiSymRecHitProducerBase::initializePhiSymCache ( edm::EventSetup const &  setup,
edm::ESGetToken< EcalChannelStatus, EcalChannelStatusRcd > const &  chStatusToken,
ConfigCache const *  config,
std::shared_ptr< PhiSymCache > &  cache 
) const

Definition at line 286 of file EcalPhiSymRecHitProducers.cc.

References ConfigCache::barrelDetIds, calibRing_, ConfigCache::endcapDetIds, edm::EventSetup::getData(), EcalRingCalibrationTools::getRingIndex(), gpuClustering::id, kNRingsEB, kNRingsEE, nSumEtValues_, relativeConstraints::ring, and EcalPhiSymRecHit::setEERing().

Referenced by EcalPhiSymRecHitProducerLumi::globalBeginLuminosityBlockSummary(), and EcalPhiSymRecHitProducerRun::globalBeginRunSummary().

290  {
291  cache->clear();
292 
293  //---get the channels status
294  auto const& chStatus = setup.getData(chStatusToken);
295 
296  cache->recHitCollEB.resize(config->barrelDetIds.size());
297  cache->recHitCollEE.resize(config->endcapDetIds.size());
298  for (auto& ebDetId : config->barrelDetIds) {
299  EBDetId id(ebDetId);
300  cache->recHitCollEB.at(id.denseIndex()) =
301  EcalPhiSymRecHit(ebDetId.rawId(), nSumEtValues_, chStatus[id].getStatusCode());
302  }
303  for (auto& eeDetId : config->endcapDetIds) {
304  EEDetId id(eeDetId);
306  cache->recHitCollEE.at(id.denseIndex()) =
307  EcalPhiSymRecHit(eeDetId.rawId(), nSumEtValues_, chStatus[id].getStatusCode());
308  cache->recHitCollEE.at(id.denseIndex())
309  .setEERing(ring < kNRingsEE / 2 ? ring - kNRingsEE / 2 : ring - kNRingsEE / 2 + 1);
310  }
311 }
uint16_t *__restrict__ id
static short getRingIndex(DetId aDetId)
Retrieve the phi-ring index corresponding to a DetId.
tuple config
parse the configuration file
def cache
Definition: utilities.py:3
void EcalPhiSymRecHitProducerBase::initializeStreamCache ( ConfigCache const *  config,
PhiSymCache cache 
) const

Definition at line 269 of file EcalPhiSymRecHitProducers.cc.

References ConfigCache::barrelDetIds, PhiSymCache::clear(), ConfigCache::endcapDetIds, gpuClustering::id, nSumEtValues_, PhiSymCache::recHitCollEB, and PhiSymCache::recHitCollEE.

Referenced by EcalPhiSymRecHitProducerLumi::streamBeginLuminosityBlock(), and EcalPhiSymRecHitProducerRun::streamBeginRun().

269  {
270  //---Initialize the per-stream RecHitCollection
271  // both collections are initialized to contain the total
272  // number of crystals, ordered accrodingly to the hashedIndex.
273  cache->clear();
274  cache->recHitCollEB.resize(config->barrelDetIds.size());
275  cache->recHitCollEE.resize(config->endcapDetIds.size());
276  for (auto& ebDetId : config->barrelDetIds) {
277  EBDetId id(ebDetId);
278  cache->recHitCollEB.at(id.denseIndex()) = EcalPhiSymRecHit(id.rawId(), nSumEtValues_);
279  }
280  for (auto& eeDetId : config->endcapDetIds) {
281  EEDetId id(eeDetId);
282  cache->recHitCollEE.at(id.denseIndex()) = EcalPhiSymRecHit(id.rawId(), nSumEtValues_);
283  }
284 }
uint16_t *__restrict__ id
tuple config
parse the configuration file
EcalPhiSymRecHitCollection recHitCollEB
EcalPhiSymRecHitCollection recHitCollEE
void EcalPhiSymRecHitProducerBase::processEvent ( edm::Event const &  event,
edm::EventSetup const &  setup,
ConfigCache const *  config,
PhiSymCache cache 
) const

Definition at line 160 of file EcalPhiSymRecHitProducers.cc.

References HLT_FULL_cff::barrelRecHits, calibRing_, EBDetId::denseIndex(), EEDetId::denseIndex(), ebToken_, DetId::Ecal, EcalBarrel, EcalEndcap, PhiSymCache::ecalLumiInfo, eeToken_, HLT_FULL_cff::endcapRecHits, relval_parameters_module::energy, PVValHelper::eta, ConfigCache::etCutsEB, ConfigCache::etCutsEE, eThresholdsEB_, eThresholdsEE_, relativeConstraints::geometry, geoToken_, edm::EventSetup::getData(), EcalRingCalibrationTools::getRingIndex(), kNRingsEB, EcalCondDBWriter_cfi::laser, laserDbToken_, misCalibRangeEB_, misCalibRangeEE_, misCalibStepsEB_, misCalibStepsEE_, nMisCalib_, nSumEtValues_, PhiSymCache::recHitCollEB, PhiSymCache::recHitCollEE, relativeConstraints::ring, edm::EventBase::time(), and edm::Timestamp::value().

Referenced by EcalPhiSymRecHitProducerLumi::accumulate(), and EcalPhiSymRecHitProducerRun::accumulate().

163  {
164  uint64_t totHitsEB = 0;
165  uint64_t totHitsEE = 0;
166 
167  //---get recHits collections
168  auto barrelRecHits = event.get(ebToken_);
169  auto endcapRecHits = event.get(eeToken_);
170 
171  //---get the laser corrections
172  edm::Timestamp evtTimeStamp(event.time().value());
173  auto const& laser = setup.getData(laserDbToken_);
174 
175  //---get the geometry
176  auto const& geometry = setup.getData(geoToken_);
177  auto barrelGeometry = geometry.getSubdetectorGeometry(DetId::Ecal, EcalBarrel);
178  auto endcapGeometry = geometry.getSubdetectorGeometry(DetId::Ecal, EcalEndcap);
179 
180  //---EB---
181  for (auto& recHit : barrelRecHits) {
182  float energy = recHit.energy();
183  EBDetId ebHit = EBDetId(recHit.id());
184  int ring = calibRing_.getRingIndex(ebHit);
185  //---if recHit energy is below thr even with the highest miscalib skip this recHit
186  if (energy * misCalibRangeEB_[1] < eThresholdsEB_[ring])
187  continue;
188  float eta = barrelGeometry->getGeometry(ebHit)->getPosition().eta();
189 
190  //---compute et + miscalibration
191  std::vector<float> etValues(nSumEtValues_, 0);
192  //---one can do this in one for loop from -nMis to +nMis but in this way the
193  //---program is faster
194  //---NOTE: nMisCalib is half on the value set in the cfg python
195  etValues[0] = recHit.energy() / cosh(eta);
196  for (int iMis = -nMisCalib_; iMis < 0; ++iMis) {
197  //--- 0 -> 0; -i -> [1...n/2]; +i -> [n/2+1...n]
198  int index = iMis + nMisCalib_ + 1;
199  etValues[index] = etValues[0] * (1 + misCalibStepsEB_[index]);
200  //---set et to zero if out of range [e_thr, et_thr+1]
201  if (etValues[index] * cosh(eta) < eThresholdsEB_[ring] || etValues[index] > configCache->etCutsEB[ring])
202  etValues[index] = 0;
203  }
204  for (int iMis = 1; iMis <= nMisCalib_; ++iMis) {
205  //--- 0 -> 0; -i -> [1...n/2]; +i -> [n/2+1...n]
206  int index = iMis + nMisCalib_;
207  etValues[index] = etValues[0] * (1 + misCalibStepsEB_[index]);
208  //---set et to zero if out of range [e_thr, et_thr+1]
209  if (etValues[index] * cosh(eta) < eThresholdsEB_[ring] || etValues[index] > configCache->etCutsEB[ring])
210  etValues[index] = 0;
211  }
212  //---set et to zero if out of range [e_thr, et_thr+1]
213  if (energy < eThresholdsEB_[ring] || etValues[0] > configCache->etCutsEB[ring])
214  etValues[0] = 0;
215  else
216  ++totHitsEB;
217  //---update the rechHit sumEt
218  streamCache->recHitCollEB.at(ebHit.denseIndex())
219  .addHit(etValues, laser.getLaserCorrection(recHit.id(), evtTimeStamp));
220  }
221 
222  //---EE---
223  for (auto& recHit : endcapRecHits) {
224  EEDetId eeHit = EEDetId(recHit.id());
225  int ring = calibRing_.getRingIndex(eeHit) - kNRingsEB;
226  float energy = recHit.energy();
227  //---if recHit energy is below thr even with the highest miscalib skip this recHit
228  if (energy * misCalibRangeEE_[1] < eThresholdsEE_[ring])
229  continue;
230  float eta = endcapGeometry->getGeometry(eeHit)->getPosition().eta();
231 
232  //---compute et + miscalibration
233  std::vector<float> etValues(nSumEtValues_, 0);
234  //---one can do this in one for loop from -nMis to +nMis but in this way the
235  //---program is faster
236  //---NOTE: nMisCalib is half on the value set in the cfg python
237  etValues[0] = recHit.energy() / cosh(eta);
238  for (int iMis = -nMisCalib_; iMis < 0; ++iMis) {
239  //--- 0 -> 0; -i -> [1...n/2]; +i -> [n/2+1...n]
240  int index = iMis + nMisCalib_ + 1;
241  etValues[index] = etValues[0] * (1 + misCalibStepsEE_[index]);
242  //---set et to zero if out of range [e_thr, et_thr+1]
243  if (etValues[index] * cosh(eta) < eThresholdsEE_[ring] || etValues[index] > configCache->etCutsEE[ring])
244  etValues[index] = 0;
245  }
246  for (int iMis = 1; iMis <= nMisCalib_; ++iMis) {
247  //--- 0 -> 0; -i -> [1...n/2]; +i -> [n/2+1...n]
248  int index = iMis + nMisCalib_;
249  etValues[index] = etValues[0] * (1 + misCalibStepsEE_[index]);
250  //---set et to zero if out of range [e_thr, et_thr+1]
251  if (etValues[index] * cosh(eta) < eThresholdsEE_[ring] || etValues[index] > configCache->etCutsEE[ring])
252  etValues[index] = 0;
253  }
254  //---set et to zero if out of range [e_thr, et_thr+1]
255  if (energy < eThresholdsEE_[ring] || etValues[0] > configCache->etCutsEE[ring])
256  etValues[0] = 0;
257  else
258  ++totHitsEE;
259  //---update the rechHit sumEt
260  streamCache->recHitCollEE.at(eeHit.denseIndex())
261  .addHit(etValues, laser.getLaserCorrection(recHit.id(), evtTimeStamp));
262  }
263 
264  //---update the lumi info
265  EcalPhiSymInfo thisEvent(totHitsEB, totHitsEE, 1, 0, 0, 0, 0);
266  streamCache->ecalLumiInfo += thisEvent;
267 }
edm::ESGetToken< EcalLaserDbService, EcalLaserDbRecord > laserDbToken_
edm::ESGetToken< CaloGeometry, CaloGeometryRecord > geoToken_
static short getRingIndex(DetId aDetId)
Retrieve the phi-ring index corresponding to a DetId.
edm::EDGetTokenT< EBRecHitCollection > eeToken_
unsigned long long uint64_t
Definition: Time.h:13
uint32_t denseIndex() const
Definition: EEDetId.h:192
edm::EDGetTokenT< EBRecHitCollection > ebToken_
uint32_t denseIndex() const
Definition: EBDetId.h:84
void EcalPhiSymRecHitProducerBase::sumCache ( PhiSymCache summaryc,
PhiSymCache streamc 
) const

Definition at line 348 of file EcalPhiSymRecHitProducers.cc.

References PhiSymCache::ecalLumiInfo, for(), mps_fire::i, PhiSymCache::recHitCollEB, and PhiSymCache::recHitCollEE.

Referenced by EcalPhiSymRecHitProducerLumi::streamEndLuminosityBlockSummary(), and EcalPhiSymRecHitProducerRun::streamEndRunSummary().

348  {
349  //---The first argument is the summary cache that
350  // contains the lumi/run summary information.
351  // The stream partial sums are passed as second argument
352  summaryc->ecalLumiInfo += streamc->ecalLumiInfo;
353  for (unsigned int i = 0; i < summaryc->recHitCollEB.size(); ++i)
354  summaryc->recHitCollEB[i] += streamc->recHitCollEB[i];
355  for (unsigned int i = 0; i < summaryc->recHitCollEE.size(); ++i)
356  summaryc->recHitCollEE[i] += streamc->recHitCollEE[i];
357 }
EcalPhiSymInfo ecalLumiInfo
for(Iditer=Id.begin();Iditer!=Id.end();Iditer++)
EcalPhiSymRecHitCollection recHitCollEB
EcalPhiSymRecHitCollection recHitCollEE

Member Data Documentation

std::vector<double> EcalPhiSymRecHitProducerBase::A_
protected

Definition at line 103 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeJob().

std::vector<double> EcalPhiSymRecHitProducerBase::B_
protected

Definition at line 104 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeJob().

EcalRingCalibrationTools EcalPhiSymRecHitProducerBase::calibRing_
protected
edm::EDGetTokenT<EBRecHitCollection> EcalPhiSymRecHitProducerBase::ebToken_
protected

Definition at line 98 of file EcalPhiSymRecHitProducers.cc.

Referenced by processEvent().

edm::EDGetTokenT<EBRecHitCollection> EcalPhiSymRecHitProducerBase::eeToken_
protected

Definition at line 99 of file EcalPhiSymRecHitProducers.cc.

Referenced by processEvent().

float EcalPhiSymRecHitProducerBase::etCutEB_
protected

Definition at line 100 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeConfigCache().

float EcalPhiSymRecHitProducerBase::etCutEE_
protected

Definition at line 102 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeConfigCache().

std::vector<double> EcalPhiSymRecHitProducerBase::eThresholdsEB_
protected

Definition at line 101 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeConfigCache(), and processEvent().

float EcalPhiSymRecHitProducerBase::eThresholdsEE_[kNRingsEE]
protected
edm::ESGetToken<CaloGeometry, CaloGeometryRecord> EcalPhiSymRecHitProducerBase::geoToken_
protected

Definition at line 96 of file EcalPhiSymRecHitProducers.cc.

Referenced by processEvent().

const short EcalPhiSymRecHitProducerBase::kNRingsEB = EcalRingCalibrationTools::N_RING_BARREL
staticprotected
const short EcalPhiSymRecHitProducerBase::kNRingsEE = EcalRingCalibrationTools::N_RING_ENDCAP
staticprotected

Definition at line 115 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializePhiSymCache().

edm::ESGetToken<EcalLaserDbService, EcalLaserDbRecord> EcalPhiSymRecHitProducerBase::laserDbToken_
protected

Definition at line 97 of file EcalPhiSymRecHitProducers.cc.

Referenced by processEvent().

std::vector<double> EcalPhiSymRecHitProducerBase::misCalibRangeEB_
protected
std::vector<double> EcalPhiSymRecHitProducerBase::misCalibRangeEE_
protected
std::vector<float> EcalPhiSymRecHitProducerBase::misCalibStepsEB_
protected

Definition at line 109 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeJob(), and processEvent().

std::vector<float> EcalPhiSymRecHitProducerBase::misCalibStepsEE_
protected

Definition at line 111 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeJob(), and processEvent().

int EcalPhiSymRecHitProducerBase::nMisCalib_
protected
int EcalPhiSymRecHitProducerBase::nSumEtValues_
protected
const short EcalPhiSymRecHitProducerBase::ringsInOneEE = kNRingsEE / 2
staticprotected

Definition at line 116 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeConfigCache(), and initializeJob().

float EcalPhiSymRecHitProducerBase::thrEEmod_
protected

Definition at line 105 of file EcalPhiSymRecHitProducers.cc.

Referenced by initializeJob().