CMS 3D CMS Logo

HGCalCLUEAlgo.cc
Go to the documentation of this file.
2 
3 // Geometry
8 
10 //
12 #include "oneapi/tbb/task_arena.h"
13 #include "oneapi/tbb.h"
14 #include <limits>
16 
17 using namespace hgcal_clustering;
18 
19 template <typename T, typename STRATEGY>
21  cells_.clear();
22  numberOfClustersPerLayer_.clear();
23  cells_.resize(2 * (maxlayer_ + 1));
24  numberOfClustersPerLayer_.resize(2 * (maxlayer_ + 1), 0);
25 }
26 
27 template <typename T, typename STRATEGY>
29  // loop over all hits and create the Hexel structure, skip energies below ecut
30  if (dependSensor_) {
31  // for each layer and wafer calculate the thresholds (sigmaNoise and energy)
32  // once
33  computeThreshold();
34  }
35 
36  for (unsigned int i = 0; i < hits.size(); ++i) {
37  const HGCRecHit& hgrh = hits[i];
38  DetId detid = hgrh.detid();
39  unsigned int layerOnSide = (rhtools_.getLayerWithOffset(detid) - 1);
40 
41  // set sigmaNoise default value 1 to use kappa value directly in case of
42  // sensor-independent thresholds
43  float sigmaNoise = 1.f;
44  if (dependSensor_) {
45  int thickness_index = rhtools_.getSiThickIndex(detid);
46  if (thickness_index == -1)
47  thickness_index = maxNumberOfThickIndices_;
48 
49  double storedThreshold = thresholds_[layerOnSide][thickness_index];
50  if (detid.det() == DetId::HGCalHSi || detid.subdetId() == HGCHEF) {
51  storedThreshold = thresholds_[layerOnSide][thickness_index + deltasi_index_regemfac_];
52  }
53  sigmaNoise = v_sigmaNoise_[layerOnSide][thickness_index];
54 
55  if (hgrh.energy() < storedThreshold)
56  continue; // this sets the ZS threshold at ecut times the sigma noise
57  // for the sensor
58  }
59  if (!dependSensor_ && hgrh.energy() < ecut_)
60  continue;
61  const GlobalPoint position(rhtools_.getPosition(detid));
62  int offset = ((rhtools_.zside(detid) + 1) >> 1) * maxlayer_;
63  int layer = layerOnSide + offset;
64  // setting the layer position only once per layer
65  if (cells_[layer].layerDim3 == std::numeric_limits<float>::infinity())
66  cells_[layer].layerDim3 = position.z();
67 
68  cells_[layer].detid.emplace_back(detid);
69  if constexpr (std::is_same_v<STRATEGY, HGCalScintillatorStrategy>) {
70  cells_[layer].dim1.emplace_back(position.eta());
71  cells_[layer].dim2.emplace_back(position.phi());
72  } // else, isSilicon == true and eta phi values will not be used
73  else {
74  cells_[layer].dim1.emplace_back(position.x());
75  cells_[layer].dim2.emplace_back(position.y());
76  }
77  cells_[layer].weight.emplace_back(hgrh.energy());
78  cells_[layer].sigmaNoise.emplace_back(sigmaNoise);
79  }
80 }
81 
82 template <typename T, typename STRATEGY>
84  auto cellsSize = cells_[l].detid.size();
85  cells_[l].rho.resize(cellsSize, 0.f);
86  cells_[l].delta.resize(cellsSize, 9999999);
87  cells_[l].nearestHigher.resize(cellsSize, -1);
88  cells_[l].clusterIndex.resize(cellsSize, -1);
89  cells_[l].followers.resize(cellsSize);
90  cells_[l].isSeed.resize(cellsSize, false);
91 }
92 
93 // Create a vector of Hexels associated to one cluster from a collection of
94 // HGCalRecHits - this can be used directly to make the final cluster list -
95 // this method can be invoked multiple times for the same event with different
96 // input (reset should be called between events)
97 template <typename T, typename STRATEGY>
99  // assign all hits in each layer to a cluster core
100  tbb::this_task_arena::isolate([&] {
101  tbb::parallel_for(size_t(0), size_t(2 * maxlayer_ + 2), [&](size_t i) {
102  prepareDataStructures(i);
103  T lt;
104  lt.clear();
105  lt.fill(cells_[i].dim1, cells_[i].dim2);
106 
107  float delta;
108  if constexpr (std::is_same_v<STRATEGY, HGCalSiliconStrategy>) {
109  // maximum search distance (critical distance) for local density calculation
110  float delta_c;
111  if (i % maxlayer_ < lastLayerEE_)
112  delta_c = vecDeltas_[0];
113  else if (i % maxlayer_ < (firstLayerBH_ - 1))
114  delta_c = vecDeltas_[1];
115  else
116  delta_c = vecDeltas_[2];
117  delta = delta_c;
118  } else {
119  float delta_r = vecDeltas_[3];
120  delta = delta_r;
121  }
122  LogDebug("HGCalCLUEAlgo") << "maxlayer: " << maxlayer_ << " lastLayerEE: " << lastLayerEE_
123  << " firstLayerBH: " << firstLayerBH_ << "\n";
124 
125  calculateLocalDensity(lt, i, delta);
126  calculateDistanceToHigher(lt, i, delta);
127  numberOfClustersPerLayer_[i] = findAndAssignClusters(i, delta);
128  });
129  });
130 #if DEBUG_CLUSTERS_ALPAKA
131  hgcalUtils::DumpLegacySoA dumperLegacySoA;
132  dumperLegacySoA.dumpInfos(cells_, moduleType_);
133 #endif
134 }
135 
136 template <typename T, typename STRATEGY>
137 std::vector<reco::BasicCluster> HGCalCLUEAlgoT<T, STRATEGY>::getClusters(bool) {
138  std::vector<int> offsets(numberOfClustersPerLayer_.size(), 0);
139 
140  int maxClustersOnLayer = numberOfClustersPerLayer_[0];
141 
142  for (unsigned layerId = 1; layerId < offsets.size(); ++layerId) {
143  offsets[layerId] = offsets[layerId - 1] + numberOfClustersPerLayer_[layerId - 1];
144 
145  maxClustersOnLayer = std::max(maxClustersOnLayer, numberOfClustersPerLayer_[layerId]);
146  }
147 
148  auto totalNumberOfClusters = offsets.back() + numberOfClustersPerLayer_.back();
149  clusters_v_.resize(totalNumberOfClusters);
150  std::vector<std::vector<int>> cellsIdInCluster;
151  cellsIdInCluster.reserve(maxClustersOnLayer);
152 
153  for (unsigned int layerId = 0; layerId < 2 * maxlayer_ + 2; ++layerId) {
154  cellsIdInCluster.resize(numberOfClustersPerLayer_[layerId]);
155  auto& cellsOnLayer = cells_[layerId];
156  unsigned int numberOfCells = cellsOnLayer.detid.size();
157  auto firstClusterIdx = offsets[layerId];
158 
159  for (unsigned int i = 0; i < numberOfCells; ++i) {
160  auto clusterIndex = cellsOnLayer.clusterIndex[i];
161  if (clusterIndex != -1)
162  cellsIdInCluster[clusterIndex].push_back(i);
163  }
164 
165  std::vector<std::pair<DetId, float>> thisCluster;
166 
167  for (auto& cl : cellsIdInCluster) {
168  float maxEnergyValue = std::numeric_limits<float>::min();
169  int maxEnergyCellIndex = -1;
170  DetId maxEnergyDetId;
171  float energy = 0.f;
172  int seedDetId = -1;
173  float x = 0.f;
174  float y = 0.f;
175  float z = cellsOnLayer.layerDim3;
176  // TODO Felice: maybe use the seed for the position calculation
177  for (auto cellIdx : cl) {
178  energy += cellsOnLayer.weight[cellIdx];
179  if (cellsOnLayer.weight[cellIdx] > maxEnergyValue) {
180  maxEnergyValue = cellsOnLayer.weight[cellIdx];
181  maxEnergyCellIndex = cellIdx;
182  maxEnergyDetId = cellsOnLayer.detid[cellIdx];
183  }
184  thisCluster.emplace_back(cellsOnLayer.detid[cellIdx], 1.f);
185  if (cellsOnLayer.isSeed[cellIdx]) {
186  seedDetId = cellsOnLayer.detid[cellIdx];
187  }
188  }
189 
190  float total_weight_log = 0.f;
191  float total_weight = energy;
192 
193  if constexpr (std::is_same_v<STRATEGY, HGCalSiliconStrategy>) {
194  auto thick = rhtools_.getSiThickIndex(maxEnergyDetId);
195  for (auto cellIdx : cl) {
196  const float d1 = cellsOnLayer.dim1[cellIdx] - cellsOnLayer.dim1[maxEnergyCellIndex];
197  const float d2 = cellsOnLayer.dim2[cellIdx] - cellsOnLayer.dim2[maxEnergyCellIndex];
198  if ((d1 * d1 + d2 * d2) < positionDeltaRho2_) {
199  float Wi = std::max(thresholdW0_[thick] + std::log(cellsOnLayer.weight[cellIdx] / energy), 0.);
200  x += cellsOnLayer.dim1[cellIdx] * Wi;
201  y += cellsOnLayer.dim2[cellIdx] * Wi;
202  total_weight_log += Wi;
203  }
204  }
205  } else {
206  for (auto cellIdx : cl) {
207  auto position = rhtools_.getPosition(cellsOnLayer.detid[cellIdx]);
208  x += position.x() * cellsOnLayer.weight[cellIdx];
209  y += position.y() * cellsOnLayer.weight[cellIdx];
210  }
211  }
212 
213  if constexpr (std::is_same_v<STRATEGY, HGCalSiliconStrategy>) {
214  total_weight = total_weight_log;
215  }
216 
217  if (total_weight != 0.) {
218  float inv_tot_weight = 1.f / total_weight;
219  x *= inv_tot_weight;
220  y *= inv_tot_weight;
221  } else {
222  x = cellsOnLayer.dim1[maxEnergyCellIndex];
223  y = cellsOnLayer.dim2[maxEnergyCellIndex];
224  }
226 
227  auto globalClusterIndex = cellsOnLayer.clusterIndex[cl[0]] + firstClusterIdx;
228 
229  clusters_v_[globalClusterIndex] =
231  clusters_v_[globalClusterIndex].setSeed(seedDetId);
232  thisCluster.clear();
233  }
234 
235  cellsIdInCluster.clear();
236  }
237  return clusters_v_;
238 }
239 template <typename T, typename STRATEGY>
241  const unsigned int layerId,
242  float delta,
244  auto& cellsOnLayer = cells_[layerId];
245  unsigned int numberOfCells = cellsOnLayer.detid.size();
246  for (unsigned int i = 0; i < numberOfCells; i++) {
247  std::array<int, 4> search_box = lt.searchBox(cellsOnLayer.dim1[i] - delta,
248  cellsOnLayer.dim1[i] + delta,
249  cellsOnLayer.dim2[i] - delta,
250  cellsOnLayer.dim2[i] + delta);
251 
252  for (int xBin = search_box[0]; xBin < search_box[1] + 1; ++xBin) {
253  for (int yBin = search_box[2]; yBin < search_box[3] + 1; ++yBin) {
254  int binId = lt.getGlobalBinByBin(xBin, yBin);
255  size_t binSize = lt[binId].size();
256 
257  for (unsigned int j = 0; j < binSize; j++) {
258  unsigned int otherId = lt[binId][j];
259  if (distance(lt, i, otherId, layerId) < delta) {
260  cellsOnLayer.rho[i] += (i == otherId ? 1.f : 0.5f) * cellsOnLayer.weight[otherId];
261  }
262  }
263  }
264  }
265  LogDebug("HGCalCLUEAlgo") << "Debugging calculateLocalDensity: \n"
266  << " cell: " << i << " eta: " << cellsOnLayer.dim1[i] << " phi: " << cellsOnLayer.dim2[i]
267  << " energy: " << cellsOnLayer.weight[i] << " density: " << cellsOnLayer.rho[i] << "\n";
268  }
269 }
270 template <typename T, typename STRATEGY>
272  const unsigned int layerId,
273  float delta,
275  auto& cellsOnLayer = cells_[layerId];
276  unsigned int numberOfCells = cellsOnLayer.detid.size();
277  for (unsigned int i = 0; i < numberOfCells; i++) {
278  std::array<int, 4> search_box = lt.searchBox(cellsOnLayer.dim1[i] - delta,
279  cellsOnLayer.dim1[i] + delta,
280  cellsOnLayer.dim2[i] - delta,
281  cellsOnLayer.dim2[i] + delta);
282  cellsOnLayer.rho[i] += cellsOnLayer.weight[i];
283  float northeast(0), northwest(0), southeast(0), southwest(0), all(0);
284  for (int etaBin = search_box[0]; etaBin < search_box[1] + 1; ++etaBin) {
285  for (int phiBin = search_box[2]; phiBin < search_box[3] + 1; ++phiBin) {
286  int phi = (phiBin % T::type::nRows);
287  int binId = lt.getGlobalBinByBin(etaBin, phi);
288  size_t binSize = lt[binId].size();
289  for (unsigned int j = 0; j < binSize; j++) {
290  unsigned int otherId = lt[binId][j];
291  if (distance(lt, i, otherId, layerId) < delta) {
292  int iPhi = HGCScintillatorDetId(cellsOnLayer.detid[i]).iphi();
293  int otherIPhi = HGCScintillatorDetId(cellsOnLayer.detid[otherId]).iphi();
294  int iEta = HGCScintillatorDetId(cellsOnLayer.detid[i]).ieta();
295  int otherIEta = HGCScintillatorDetId(cellsOnLayer.detid[otherId]).ieta();
296  int dIPhi = otherIPhi - iPhi;
297  dIPhi += abs(dIPhi) < 2 ? 0
298  : dIPhi < 0 ? scintMaxIphi_
299  : -scintMaxIphi_; // cells with iPhi=288 and iPhi=1 should be neiboring cells
300  int dIEta = otherIEta - iEta;
301  LogDebug("HGCalCLUEAlgo") << " Debugging calculateLocalDensity for Scintillator: \n"
302  << " cell: " << otherId << " energy: " << cellsOnLayer.weight[otherId]
303  << " otherIPhi: " << otherIPhi << " iPhi: " << iPhi << " otherIEta: " << otherIEta
304  << " iEta: " << iEta << "\n";
305 
306  if (otherId != i) {
307  auto neighborCellContribution = 0.5f * cellsOnLayer.weight[otherId];
308  all += neighborCellContribution;
309  if (dIPhi >= 0 && dIEta >= 0)
310  northeast += neighborCellContribution;
311  if (dIPhi <= 0 && dIEta >= 0)
312  southeast += neighborCellContribution;
313  if (dIPhi >= 0 && dIEta <= 0)
314  northwest += neighborCellContribution;
315  if (dIPhi <= 0 && dIEta <= 0)
316  southwest += neighborCellContribution;
317  }
318  LogDebug("HGCalCLUEAlgo") << " Debugging calculateLocalDensity for Scintillator: \n"
319  << " northeast: " << northeast << " southeast: " << southeast
320  << " northwest: " << northwest << " southwest: " << southwest << "\n";
321  }
322  }
323  }
324  }
325  float neighborsval = (std::max(northeast, northwest) > std::max(southeast, southwest))
326  ? std::max(northeast, northwest)
327  : std::max(southeast, southwest);
328  if (use2x2_)
329  cellsOnLayer.rho[i] += neighborsval;
330  else
331  cellsOnLayer.rho[i] += all;
332  LogDebug("HGCalCLUEAlgo") << "Debugging calculateLocalDensity: \n"
333  << " cell: " << i << " eta: " << cellsOnLayer.dim1[i] << " phi: " << cellsOnLayer.dim2[i]
334  << " energy: " << cellsOnLayer.weight[i] << " density: " << cellsOnLayer.rho[i] << "\n";
335  }
336 }
337 template <typename T, typename STRATEGY>
338 void HGCalCLUEAlgoT<T, STRATEGY>::calculateLocalDensity(const T& lt, const unsigned int layerId, float delta) {
339  if constexpr (std::is_same_v<STRATEGY, HGCalSiliconStrategy>) {
340  calculateLocalDensity(lt, layerId, delta, HGCalSiliconStrategy());
341  } else {
342  calculateLocalDensity(lt, layerId, delta, HGCalScintillatorStrategy());
343  }
344 }
345 
346 template <typename T, typename STRATEGY>
347 void HGCalCLUEAlgoT<T, STRATEGY>::calculateDistanceToHigher(const T& lt, const unsigned int layerId, float delta) {
348  auto& cellsOnLayer = cells_[layerId];
349  unsigned int numberOfCells = cellsOnLayer.detid.size();
350 
351  for (unsigned int i = 0; i < numberOfCells; i++) {
352  // initialize delta and nearest higher for i
354  float i_delta = maxDelta;
355  int i_nearestHigher = -1;
356  float rho_max = 0.f;
357  auto range = outlierDeltaFactor_ * delta;
358  std::array<int, 4> search_box = lt.searchBox(cellsOnLayer.dim1[i] - range,
359  cellsOnLayer.dim1[i] + range,
360  cellsOnLayer.dim2[i] - range,
361  cellsOnLayer.dim2[i] + range);
362  // loop over all bins in the search box
363  for (int dim1Bin = search_box[0]; dim1Bin < search_box[1] + 1; ++dim1Bin) {
364  for (int dim2Bin = search_box[2]; dim2Bin < search_box[3] + 1; ++dim2Bin) {
365  // get the id of this bin
366  size_t binId = lt.getGlobalBinByBin(dim1Bin, dim2Bin);
367  if constexpr (std::is_same_v<STRATEGY, HGCalScintillatorStrategy>)
368  binId = lt.getGlobalBinByBin(dim1Bin, (dim2Bin % T::type::nRows));
369  // get the size of this bin
370  size_t binSize = lt[binId].size();
371 
372  // loop over all hits in this bin
373  for (unsigned int j = 0; j < binSize; j++) {
374  unsigned int otherId = lt[binId][j];
375  float dist = distance2(lt, i, otherId, layerId);
376  bool foundHigher =
377  (cellsOnLayer.rho[otherId] > cellsOnLayer.rho[i]) ||
378  (cellsOnLayer.rho[otherId] == cellsOnLayer.rho[i] && cellsOnLayer.detid[otherId] > cellsOnLayer.detid[i]);
379  if (!foundHigher) {
380  continue;
381  }
382  if ((dist < i_delta) || ((dist == i_delta) && (cellsOnLayer.rho[otherId] > rho_max)) ||
383  ((dist == i_delta) && (cellsOnLayer.rho[otherId] == rho_max) &&
384  (cellsOnLayer.detid[otherId] > cellsOnLayer.detid[i]))) {
385  rho_max = cellsOnLayer.rho[otherId];
386  i_delta = dist;
387  i_nearestHigher = otherId;
388  }
389  }
390  }
391  }
392  bool foundNearestHigherInSearchBox = (i_delta != maxDelta);
393  if (foundNearestHigherInSearchBox) {
394  cellsOnLayer.delta[i] = std::sqrt(i_delta);
395  cellsOnLayer.nearestHigher[i] = i_nearestHigher;
396  } else {
397  // otherwise delta is guaranteed to be larger outlierDeltaFactor_*delta_c
398  // we can safely maximize delta to be maxDelta
399  cellsOnLayer.delta[i] = maxDelta;
400  cellsOnLayer.nearestHigher[i] = -1;
401  }
402 
403  LogDebug("HGCalCLUEAlgo") << "Debugging calculateDistanceToHigher: \n"
404  << " cell: " << i << " eta: " << cellsOnLayer.dim1[i] << " phi: " << cellsOnLayer.dim2[i]
405  << " energy: " << cellsOnLayer.weight[i] << " density: " << cellsOnLayer.rho[i]
406  << " nearest higher: " << cellsOnLayer.nearestHigher[i]
407  << " distance: " << cellsOnLayer.delta[i] << "\n";
408  }
409 }
410 
411 template <typename T, typename STRATEGY>
412 int HGCalCLUEAlgoT<T, STRATEGY>::findAndAssignClusters(const unsigned int layerId, float delta) {
413  // this is called once per layer and endcap...
414  // so when filling the cluster temporary vector of Hexels we resize each time
415  // by the number of clusters found. This is always equal to the number of
416  // cluster centers...
417  unsigned int nClustersOnLayer = 0;
418  auto& cellsOnLayer = cells_[layerId];
419  unsigned int numberOfCells = cellsOnLayer.detid.size();
420  std::vector<int> localStack;
421  // find cluster seeds and outlier
422  for (unsigned int i = 0; i < numberOfCells; i++) {
423  float rho_c = kappa_ * cellsOnLayer.sigmaNoise[i];
424  // initialize clusterIndex
425  cellsOnLayer.clusterIndex[i] = -1;
426  bool isSeed = (cellsOnLayer.delta[i] > delta) && (cellsOnLayer.rho[i] >= rho_c);
427  bool isOutlier = (cellsOnLayer.delta[i] > outlierDeltaFactor_ * delta) && (cellsOnLayer.rho[i] < rho_c);
428  if (isSeed) {
429  cellsOnLayer.clusterIndex[i] = nClustersOnLayer;
430  cellsOnLayer.isSeed[i] = true;
431  nClustersOnLayer++;
432  localStack.push_back(i);
433 
434  } else if (!isOutlier) {
435  cellsOnLayer.followers[cellsOnLayer.nearestHigher[i]].push_back(i);
436  }
437  }
438 
439  // need to pass clusterIndex to their followers
440  while (!localStack.empty()) {
441  int endStack = localStack.back();
442  auto& thisSeed = cellsOnLayer.followers[endStack];
443  localStack.pop_back();
444 
445  // loop over followers
446  for (int j : thisSeed) {
447  // pass id to a follower
448  cellsOnLayer.clusterIndex[j] = cellsOnLayer.clusterIndex[endStack];
449  // push this follower to localStack
450  localStack.push_back(j);
451  }
452  }
453  return nClustersOnLayer;
454 }
455 
456 template <typename T, typename STRATEGY>
458  // To support the TDR geometry and also the post-TDR one (v9 onwards), we
459  // need to change the logic of the vectors containing signal to noise and
460  // thresholds. The first 3 indices will keep on addressing the different
461  // thicknesses of the Silicon detectors in CE_E , the next 3 indices will address
462  // the thicknesses of the Silicon detectors in CE_H, while the last one, number 6 (the
463  // seventh) will address the Scintillators. This change will support both
464  // geometries at the same time.
465 
466  if (initialized_)
467  return; // only need to calculate thresholds once
468 
469  initialized_ = true;
470 
471  std::vector<double> dummy;
472 
473  dummy.resize(maxNumberOfThickIndices_ + !isNose_, 0); // +1 to accomodate for the Scintillators
474  thresholds_.resize(maxlayer_, dummy);
475  v_sigmaNoise_.resize(maxlayer_, dummy);
476 
477  for (unsigned ilayer = 1; ilayer <= maxlayer_; ++ilayer) {
478  for (unsigned ithick = 0; ithick < maxNumberOfThickIndices_; ++ithick) {
479  float sigmaNoise = 0.001f * fcPerEle_ * nonAgedNoises_[ithick] * dEdXweights_[ilayer] /
480  (fcPerMip_[ithick] * thicknessCorrection_[ithick]);
481  thresholds_[ilayer - 1][ithick] = sigmaNoise * ecut_;
482  v_sigmaNoise_[ilayer - 1][ithick] = sigmaNoise;
483  LogDebug("HGCalCLUEAlgo") << "ilayer: " << ilayer << " nonAgedNoises: " << nonAgedNoises_[ithick]
484  << " fcPerEle: " << fcPerEle_ << " fcPerMip: " << fcPerMip_[ithick]
485  << " noiseMip: " << fcPerEle_ * nonAgedNoises_[ithick] / fcPerMip_[ithick]
486  << " sigmaNoise: " << sigmaNoise << "\n";
487  }
488 
489  if (!isNose_) {
490  float scintillators_sigmaNoise = 0.001f * noiseMip_ * dEdXweights_[ilayer] / sciThicknessCorrection_;
491  thresholds_[ilayer - 1][maxNumberOfThickIndices_] = ecut_ * scintillators_sigmaNoise;
492  v_sigmaNoise_[ilayer - 1][maxNumberOfThickIndices_] = scintillators_sigmaNoise;
493  LogDebug("HGCalCLUEAlgo") << "ilayer: " << ilayer << " noiseMip: " << noiseMip_
494  << " scintillators_sigmaNoise: " << scintillators_sigmaNoise << "\n";
495  }
496  }
497 }
498 
499 // explicit template instantiation
constexpr int ieta() const
void computeThreshold()
constexpr int iphi() const
get the phi index
constexpr const DetId & detid() const
Definition: CaloRecHit.h:33
def all(container)
workaround iterator generators for ROOT classes
Definition: cmstools.py:25
CaloCluster BasicCluster
void calculateDistanceToHigher(const TILE &lt, const unsigned int layerId, float delta)
constexpr Detector det() const
get the detector field from this detid
Definition: DetId.h:46
void populate(const HGCRecHitCollection &hits) override
constexpr float energy() const
Definition: CaloRecHit.h:29
void dumpInfos(const T &cells, const std::string &moduleType) const
T sqrt(T t)
Definition: SSEVec.h:23
double delta_r(const Fourvec &a, const Fourvec &b)
Find the distance between two four-vectors in the two-dimensional space .
Definition: fourvec.cc:238
const double infinity
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
void makeClusters() override
double f[11][100]
constexpr int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:48
Definition: DetId.h:17
void getEventSetupPerAlgorithm(const edm::EventSetup &es) override
void calculateLocalDensity(const TILE &lt, const unsigned int layerId, float delta)
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
void prepareDataStructures(const unsigned int layerId)
static int position[264][3]
Definition: ReadPGInfo.cc:289
float x
static constexpr float d1
long double T
strategy
Definition: nnet_common.h:18
int findAndAssignClusters(const unsigned int layerId, float delta)
std::vector< reco::BasicCluster > getClusters(bool) override
#define LogDebug(id)