CMS 3D CMS Logo

All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Modules Pages
List of all members | Classes | Public Types | Public Member Functions | Static Public Member Functions | Private Member Functions | Private Attributes
HGCalCLUEAlgoT< TILE, STRATEGY > Class Template Reference

#include <HGCalCLUEAlgo.h>

Inheritance diagram for HGCalCLUEAlgoT< TILE, STRATEGY >:
HGCalClusteringAlgoBase

Classes

struct  CellsOnLayer
 

Public Types

typedef math::XYZPoint Point
 point in the space More...
 
- Public Types inherited from HGCalClusteringAlgoBase
enum  VerbosityLevel { pDEBUG = 0, pWARNING = 1, pINFO = 2, pERROR = 3 }
 

Public Member Functions

void computeThreshold ()
 
std::vector< reco::BasicClustergetClusters (bool) override
 
void getEventSetupPerAlgorithm (const edm::EventSetup &es) override
 
 HGCalCLUEAlgoT (const edm::ParameterSet &ps)
 
void makeClusters () override
 
void populate (const HGCRecHitCollection &hits) override
 
void reset () override
 
 ~HGCalCLUEAlgoT () override
 
- Public Member Functions inherited from HGCalClusteringAlgoBase
virtual hgcal_clustering::Density getDensity ()
 
void getEventSetup (const edm::EventSetup &es, hgcal::RecHitTools rhtools)
 
 HGCalClusteringAlgoBase (VerbosityLevel v, reco::CaloCluster::AlgoId algo)
 
void setAlgoId (reco::CaloCluster::AlgoId algo, bool isNose=false)
 
void setVerbosity (VerbosityLevel the_verbosity)
 
virtual ~HGCalClusteringAlgoBase ()
 

Static Public Member Functions

static void fillPSetDescription (edm::ParameterSetDescription &iDesc)
 

Private Member Functions

void calculateDistanceToHigher (const TILE &lt, const unsigned int layerId, float delta)
 
void calculateLocalDensity (const TILE &lt, const unsigned int layerId, float delta)
 
void calculateLocalDensity (const TILE &lt, const unsigned int layerId, float delta, HGCalSiliconStrategy strategy)
 
void calculateLocalDensity (const TILE &lt, const unsigned int layerId, float delta, HGCalScintillatorStrategy strategy)
 
float distance (const TILE &lt, int cell1, int cell2, int layerId) const
 
int findAndAssignClusters (const unsigned int layerId, float delta)
 
void prepareDataStructures (const unsigned int layerId)
 

Private Attributes

std::vector< CellsOnLayercells_
 
std::vector< double > dEdXweights_
 
int deltasi_index_regemfac_
 
bool dependSensor_
 
double ecut_
 
double fcPerEle_
 
std::vector< double > fcPerMip_
 
bool initialized_
 
double kappa_
 
unsigned maxNumberOfThickIndices_
 
double noiseMip_
 
std::vector< double > nonAgedNoises_
 
std::vector< int > numberOfClustersPerLayer_
 
float outlierDeltaFactor_ = 2.f
 
double positionDeltaRho2_
 
double sciThicknessCorrection_
 
std::vector< double > thicknessCorrection_
 
std::vector< std::vector< double > > thresholds_
 
std::vector< double > thresholdW0_
 
bool use2x2_
 
std::vector< std::vector< double > > v_sigmaNoise_
 
std::vector< double > vecDeltas_
 

Additional Inherited Members

- Public Attributes inherited from HGCalClusteringAlgoBase
unsigned int firstLayerBH_
 
bool isNose_
 
unsigned int lastLayerEE_
 
unsigned int lastLayerFH_
 
unsigned int maxlayer_
 
int scintMaxIphi_
 
- Protected Attributes inherited from HGCalClusteringAlgoBase
reco::CaloCluster::AlgoId algoId_
 
edm::ESGetToken< CaloGeometry, CaloGeometryRecordcaloGeomToken_
 
std::vector< reco::BasicClusterclusters_v_
 
hgcal::RecHitTools rhtools_
 
VerbosityLevel verbosity_
 

Detailed Description

template<typename TILE, typename STRATEGY>
class HGCalCLUEAlgoT< TILE, STRATEGY >

Definition at line 29 of file HGCalCLUEAlgo.h.

Member Typedef Documentation

◆ Point

template<typename TILE , typename STRATEGY >
typedef math::XYZPoint HGCalCLUEAlgoT< TILE, STRATEGY >::Point

point in the space

Definition at line 118 of file HGCalCLUEAlgo.h.

Constructor & Destructor Documentation

◆ HGCalCLUEAlgoT()

template<typename TILE , typename STRATEGY >
HGCalCLUEAlgoT< TILE, STRATEGY >::HGCalCLUEAlgoT ( const edm::ParameterSet ps)
inline

Definition at line 31 of file HGCalCLUEAlgo.h.

33  (HGCalClusteringAlgoBase::VerbosityLevel)ps.getUntrackedParameter<unsigned int>("verbosity", 3),
35  vecDeltas_(ps.getParameter<std::vector<double>>("deltac")),
36  kappa_(ps.getParameter<double>("kappa")),
37  ecut_(ps.getParameter<double>("ecut")),
38  dependSensor_(ps.getParameter<bool>("dependSensor")),
39  dEdXweights_(ps.getParameter<std::vector<double>>("dEdXweights")),
40  thicknessCorrection_(ps.getParameter<std::vector<double>>("thicknessCorrection")),
41  sciThicknessCorrection_(ps.getParameter<double>("sciThicknessCorrection")),
42  deltasi_index_regemfac_(ps.getParameter<int>("deltasi_index_regemfac")),
43  maxNumberOfThickIndices_(ps.getParameter<unsigned>("maxNumberOfThickIndices")),
44  fcPerMip_(ps.getParameter<std::vector<double>>("fcPerMip")),
45  fcPerEle_(ps.getParameter<double>("fcPerEle")),
46  nonAgedNoises_(ps.getParameter<std::vector<double>>("noises")),
47  noiseMip_(ps.getParameter<edm::ParameterSet>("noiseMip").getParameter<double>("noise_MIP")),
48  thresholdW0_(ps.getParameter<std::vector<double>>("thresholdW0")),
49  positionDeltaRho2_(ps.getParameter<double>("positionDeltaRho2")),
50  use2x2_(ps.getParameter<bool>("use2x2")),
51  initialized_(false) {}
std::vector< double > nonAgedNoises_
T getParameter(std::string const &) const
Definition: ParameterSet.h:307
std::vector< double > vecDeltas_
int deltasi_index_regemfac_
T getUntrackedParameter(std::string const &, T const &) const
HGCalClusteringAlgoBase(VerbosityLevel v, reco::CaloCluster::AlgoId algo)
double positionDeltaRho2_
double sciThicknessCorrection_
std::vector< double > thicknessCorrection_
std::vector< double > fcPerMip_
std::vector< double > dEdXweights_
unsigned maxNumberOfThickIndices_
std::vector< double > thresholdW0_

◆ ~HGCalCLUEAlgoT()

template<typename TILE , typename STRATEGY >
HGCalCLUEAlgoT< TILE, STRATEGY >::~HGCalCLUEAlgoT ( )
inlineoverride

Definition at line 53 of file HGCalCLUEAlgo.h.

53 {}

Member Function Documentation

◆ calculateDistanceToHigher()

template<typename TILE , typename STRATEGY >
void HGCalCLUEAlgoT< T, STRATEGY >::calculateDistanceToHigher ( const TILE &  lt,
const unsigned int  layerId,
float  delta 
)
private

Definition at line 342 of file HGCalCLUEAlgo.cc.

References ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), dumpMFGeometry_cfg::delta, HLT_2024v11_cff::distance, mps_fire::i, dqmiolumiharvest::j, LogDebug, SiStripPI::max, allConversions_cfi::maxDelta, and FastTimerService_cff::range.

342  {
343  auto& cellsOnLayer = cells_[layerId];
344  unsigned int numberOfCells = cellsOnLayer.detid.size();
345 
346  for (unsigned int i = 0; i < numberOfCells; i++) {
347  // initialize delta and nearest higher for i
349  float i_delta = maxDelta;
350  int i_nearestHigher = -1;
352  std::array<int, 4> search_box = lt.searchBox(cellsOnLayer.dim1[i] - range,
353  cellsOnLayer.dim1[i] + range,
354  cellsOnLayer.dim2[i] - range,
355  cellsOnLayer.dim2[i] + range);
356  // loop over all bins in the search box
357  for (int dim1Bin = search_box[0]; dim1Bin < search_box[1] + 1; ++dim1Bin) {
358  for (int dim2Bin = search_box[2]; dim2Bin < search_box[3] + 1; ++dim2Bin) {
359  // get the id of this bin
360  size_t binId = lt.getGlobalBinByBin(dim1Bin, dim2Bin);
361  if constexpr (std::is_same_v<STRATEGY, HGCalScintillatorStrategy>)
362  binId = lt.getGlobalBinByBin(dim1Bin, (dim2Bin % T::type::nRows));
363  // get the size of this bin
364  size_t binSize = lt[binId].size();
365 
366  // loop over all hits in this bin
367  for (unsigned int j = 0; j < binSize; j++) {
368  unsigned int otherId = lt[binId][j];
369  float dist = distance(lt, i, otherId, layerId);
370  bool foundHigher =
371  (cellsOnLayer.rho[otherId] > cellsOnLayer.rho[i]) ||
372  (cellsOnLayer.rho[otherId] == cellsOnLayer.rho[i] && cellsOnLayer.detid[otherId] > cellsOnLayer.detid[i]);
373  if (foundHigher && dist <= i_delta) {
374  // update i_delta
375  i_delta = dist;
376  // update i_nearestHigher
377  i_nearestHigher = otherId;
378  }
379  }
380  }
381  }
382  bool foundNearestHigherInSearchBox = (i_delta != maxDelta);
383  if (foundNearestHigherInSearchBox) {
384  cellsOnLayer.delta[i] = i_delta;
385  cellsOnLayer.nearestHigher[i] = i_nearestHigher;
386  } else {
387  // otherwise delta is guaranteed to be larger outlierDeltaFactor_*delta_c
388  // we can safely maximize delta to be maxDelta
389  cellsOnLayer.delta[i] = maxDelta;
390  cellsOnLayer.nearestHigher[i] = -1;
391  }
392 
393  LogDebug("HGCalCLUEAlgo") << "Debugging calculateDistanceToHigher: \n"
394  << " cell: " << i << " eta: " << cellsOnLayer.dim1[i] << " phi: " << cellsOnLayer.dim2[i]
395  << " energy: " << cellsOnLayer.weight[i] << " density: " << cellsOnLayer.rho[i]
396  << " nearest higher: " << cellsOnLayer.nearestHigher[i]
397  << " distance: " << cellsOnLayer.delta[i] << "\n";
398  }
399 }
float outlierDeltaFactor_
float distance(const TILE &lt, int cell1, int cell2, int layerId) const
std::vector< CellsOnLayer > cells_
#define LogDebug(id)

◆ calculateLocalDensity() [1/3]

template<typename TILE , typename STRATEGY >
void HGCalCLUEAlgoT< TILE, STRATEGY >::calculateLocalDensity ( const TILE &  lt,
const unsigned int  layerId,
float  delta 
)
private

◆ calculateLocalDensity() [2/3]

template<typename TILE , typename STRATEGY >
void HGCalCLUEAlgoT< TILE, STRATEGY >::calculateLocalDensity ( const TILE &  lt,
const unsigned int  layerId,
float  delta,
HGCalSiliconStrategy  strategy 
)
private

◆ calculateLocalDensity() [3/3]

template<typename TILE , typename STRATEGY >
void HGCalCLUEAlgoT< TILE, STRATEGY >::calculateLocalDensity ( const TILE &  lt,
const unsigned int  layerId,
float  delta,
HGCalScintillatorStrategy  strategy 
)
private

◆ computeThreshold()

template<typename T , typename STRATEGY >
void HGCalCLUEAlgoT< T, STRATEGY >::computeThreshold ( )

Definition at line 447 of file HGCalCLUEAlgo.cc.

References LogDebug.

447  {
448  // To support the TDR geometry and also the post-TDR one (v9 onwards), we
449  // need to change the logic of the vectors containing signal to noise and
450  // thresholds. The first 3 indices will keep on addressing the different
451  // thicknesses of the Silicon detectors in CE_E , the next 3 indices will address
452  // the thicknesses of the Silicon detectors in CE_H, while the last one, number 6 (the
453  // seventh) will address the Scintillators. This change will support both
454  // geometries at the same time.
455 
456  if (initialized_)
457  return; // only need to calculate thresholds once
458 
459  initialized_ = true;
460 
461  std::vector<double> dummy;
462 
463  dummy.resize(maxNumberOfThickIndices_ + !isNose_, 0); // +1 to accomodate for the Scintillators
464  thresholds_.resize(maxlayer_, dummy);
465  v_sigmaNoise_.resize(maxlayer_, dummy);
466 
467  for (unsigned ilayer = 1; ilayer <= maxlayer_; ++ilayer) {
468  for (unsigned ithick = 0; ithick < maxNumberOfThickIndices_; ++ithick) {
469  float sigmaNoise = 0.001f * fcPerEle_ * nonAgedNoises_[ithick] * dEdXweights_[ilayer] /
470  (fcPerMip_[ithick] * thicknessCorrection_[ithick]);
471  thresholds_[ilayer - 1][ithick] = sigmaNoise * ecut_;
472  v_sigmaNoise_[ilayer - 1][ithick] = sigmaNoise;
473  LogDebug("HGCalCLUEAlgo") << "ilayer: " << ilayer << " nonAgedNoises: " << nonAgedNoises_[ithick]
474  << " fcPerEle: " << fcPerEle_ << " fcPerMip: " << fcPerMip_[ithick]
475  << " noiseMip: " << fcPerEle_ * nonAgedNoises_[ithick] / fcPerMip_[ithick]
476  << " sigmaNoise: " << sigmaNoise << "\n";
477  }
478 
479  if (!isNose_) {
480  float scintillators_sigmaNoise = 0.001f * noiseMip_ * dEdXweights_[ilayer] / sciThicknessCorrection_;
481  thresholds_[ilayer - 1][maxNumberOfThickIndices_] = ecut_ * scintillators_sigmaNoise;
482  v_sigmaNoise_[ilayer - 1][maxNumberOfThickIndices_] = scintillators_sigmaNoise;
483  LogDebug("HGCalCLUEAlgo") << "ilayer: " << ilayer << " noiseMip: " << noiseMip_
484  << " scintillators_sigmaNoise: " << scintillators_sigmaNoise << "\n";
485  }
486  }
487 }
std::vector< double > nonAgedNoises_
double sciThicknessCorrection_
std::vector< double > thicknessCorrection_
std::vector< double > fcPerMip_
std::vector< double > dEdXweights_
std::vector< std::vector< double > > v_sigmaNoise_
unsigned maxNumberOfThickIndices_
std::vector< std::vector< double > > thresholds_
#define LogDebug(id)

◆ distance()

template<typename TILE , typename STRATEGY >
float HGCalCLUEAlgoT< TILE, STRATEGY >::distance ( const TILE &  lt,
int  cell1,
int  cell2,
int  layerId 
) const
inlineprivate

Definition at line 201 of file HGCalCLUEAlgo.h.

References hgcalTopologyTester_cfi::cell1, hgcalTopologyTester_cfi::cell2, HGCalCLUEAlgoT< TILE, STRATEGY >::cells_, and mathSSE::sqrt().

201  { // 2-d distance on the layer (x-y)
202  return std::sqrt(lt.distance2(cells_[layerId].dim1[cell1],
203  cells_[layerId].dim2[cell1],
204  cells_[layerId].dim1[cell2],
205  cells_[layerId].dim2[cell2]));
206  }
T sqrt(T t)
Definition: SSEVec.h:19
std::vector< CellsOnLayer > cells_

◆ fillPSetDescription()

template<typename TILE , typename STRATEGY >
static void HGCalCLUEAlgoT< TILE, STRATEGY >::fillPSetDescription ( edm::ParameterSetDescription iDesc)
inlinestatic

Definition at line 82 of file HGCalCLUEAlgo.h.

References edm::ParameterSetDescription::add(), edm::ParameterSetDescription::addUntracked(), and AlCaHLTBitMon_QueryRunRegistry::string.

82  {
83  iDesc.add<std::vector<double>>("thresholdW0", {2.9, 2.9, 2.9});
84  iDesc.add<double>("positionDeltaRho2", 1.69);
85  iDesc.add<std::vector<double>>("deltac",
86  {
87  1.3,
88  1.3,
89  1.3,
90  0.0315, // for scintillator
91  });
92  iDesc.add<bool>("dependSensor", true);
93  iDesc.add<double>("ecut", 3.0);
94  iDesc.add<double>("kappa", 9.0);
95  iDesc.addUntracked<unsigned int>("verbosity", 3);
96  iDesc.add<std::vector<double>>("dEdXweights", {});
97  iDesc.add<std::vector<double>>("thicknessCorrection", {});
98  iDesc.add<double>("sciThicknessCorrection", 0.9);
99  iDesc.add<int>("deltasi_index_regemfac", 3);
100  iDesc.add<unsigned>("maxNumberOfThickIndices", 6);
101  iDesc.add<std::vector<double>>("fcPerMip", {});
102  iDesc.add<double>("fcPerEle", 0.0);
103  iDesc.add<std::vector<double>>("noises", {});
104  edm::ParameterSetDescription descNestedNoiseMIP;
105  descNestedNoiseMIP.add<bool>("scaleByDose", false);
106  descNestedNoiseMIP.add<unsigned int>("scaleByDoseAlgo", 0);
107  descNestedNoiseMIP.add<double>("scaleByDoseFactor", 1.);
108  descNestedNoiseMIP.add<std::string>("doseMap", "");
109  descNestedNoiseMIP.add<std::string>("sipmMap", "");
110  descNestedNoiseMIP.add<double>("referenceIdark", -1);
111  descNestedNoiseMIP.add<double>("referenceXtalk", -1);
112  descNestedNoiseMIP.add<double>("noise_MIP", 1. / 100.);
113  iDesc.add<edm::ParameterSetDescription>("noiseMip", descNestedNoiseMIP);
114  iDesc.add<bool>("use2x2", true); // use 2x2 or 3x3 scenario for scint density calculation
115  }
ParameterDescriptionBase * addUntracked(U const &iLabel, T const &value)
ParameterDescriptionBase * add(U const &iLabel, T const &value)

◆ findAndAssignClusters()

template<typename T , typename STRATEGY >
int HGCalCLUEAlgoT< T, STRATEGY >::findAndAssignClusters ( const unsigned int  layerId,
float  delta 
)
private

Definition at line 402 of file HGCalCLUEAlgo.cc.

References dumpMFGeometry_cfg::delta, mps_fire::i, and dqmiolumiharvest::j.

402  {
403  // this is called once per layer and endcap...
404  // so when filling the cluster temporary vector of Hexels we resize each time
405  // by the number of clusters found. This is always equal to the number of
406  // cluster centers...
407  unsigned int nClustersOnLayer = 0;
408  auto& cellsOnLayer = cells_[layerId];
409  unsigned int numberOfCells = cellsOnLayer.detid.size();
410  std::vector<int> localStack;
411  // find cluster seeds and outlier
412  for (unsigned int i = 0; i < numberOfCells; i++) {
413  float rho_c = kappa_ * cellsOnLayer.sigmaNoise[i];
414  // initialize clusterIndex
415  cellsOnLayer.clusterIndex[i] = -1;
416  bool isSeed = (cellsOnLayer.delta[i] > delta) && (cellsOnLayer.rho[i] >= rho_c);
417  bool isOutlier = (cellsOnLayer.delta[i] > outlierDeltaFactor_ * delta) && (cellsOnLayer.rho[i] < rho_c);
418  if (isSeed) {
419  cellsOnLayer.clusterIndex[i] = nClustersOnLayer;
420  cellsOnLayer.isSeed[i] = true;
421  nClustersOnLayer++;
422  localStack.push_back(i);
423 
424  } else if (!isOutlier) {
425  cellsOnLayer.followers[cellsOnLayer.nearestHigher[i]].push_back(i);
426  }
427  }
428 
429  // need to pass clusterIndex to their followers
430  while (!localStack.empty()) {
431  int endStack = localStack.back();
432  auto& thisSeed = cellsOnLayer.followers[endStack];
433  localStack.pop_back();
434 
435  // loop over followers
436  for (int j : thisSeed) {
437  // pass id to a follower
438  cellsOnLayer.clusterIndex[j] = cellsOnLayer.clusterIndex[endStack];
439  // push this follower to localStack
440  localStack.push_back(j);
441  }
442  }
443  return nClustersOnLayer;
444 }
float outlierDeltaFactor_
std::vector< CellsOnLayer > cells_

◆ getClusters()

template<typename T , typename STRATEGY >
std::vector< reco::BasicCluster > HGCalCLUEAlgoT< T, STRATEGY >::getClusters ( bool  )
overridevirtual

Implements HGCalClusteringAlgoBase.

Definition at line 133 of file HGCalCLUEAlgo.cc.

References haddnano::cl, ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), d1, reco::CaloID::DET_HGCAL_ENDCAP, hcalRecHitTable_cff::energy, mps_fire::i, dqm-mbProfile::log, SiStripPI::max, SiStripPI::min, unpackBuffers-CaloStage1::offsets, position, and x.

133  {
134  std::vector<int> offsets(numberOfClustersPerLayer_.size(), 0);
135 
136  int maxClustersOnLayer = numberOfClustersPerLayer_[0];
137 
138  for (unsigned layerId = 1; layerId < offsets.size(); ++layerId) {
139  offsets[layerId] = offsets[layerId - 1] + numberOfClustersPerLayer_[layerId - 1];
140 
141  maxClustersOnLayer = std::max(maxClustersOnLayer, numberOfClustersPerLayer_[layerId]);
142  }
143 
144  auto totalNumberOfClusters = offsets.back() + numberOfClustersPerLayer_.back();
145  clusters_v_.resize(totalNumberOfClusters);
146  std::vector<std::vector<int>> cellsIdInCluster;
147  cellsIdInCluster.reserve(maxClustersOnLayer);
148 
149  for (unsigned int layerId = 0; layerId < 2 * maxlayer_ + 2; ++layerId) {
150  cellsIdInCluster.resize(numberOfClustersPerLayer_[layerId]);
151  auto& cellsOnLayer = cells_[layerId];
152  unsigned int numberOfCells = cellsOnLayer.detid.size();
153  auto firstClusterIdx = offsets[layerId];
154 
155  for (unsigned int i = 0; i < numberOfCells; ++i) {
156  auto clusterIndex = cellsOnLayer.clusterIndex[i];
157  if (clusterIndex != -1)
158  cellsIdInCluster[clusterIndex].push_back(i);
159  }
160 
161  std::vector<std::pair<DetId, float>> thisCluster;
162 
163  for (auto& cl : cellsIdInCluster) {
164  float maxEnergyValue = std::numeric_limits<float>::min();
165  int maxEnergyCellIndex = -1;
166  DetId maxEnergyDetId;
167  float energy = 0.f;
168  int seedDetId = -1;
169  float x = 0.f;
170  float y = 0.f;
171  float z = cellsOnLayer.layerDim3;
172  // TODO Felice: maybe use the seed for the position calculation
173  for (auto cellIdx : cl) {
174  energy += cellsOnLayer.weight[cellIdx];
175  if (cellsOnLayer.weight[cellIdx] > maxEnergyValue) {
176  maxEnergyValue = cellsOnLayer.weight[cellIdx];
177  maxEnergyCellIndex = cellIdx;
178  maxEnergyDetId = cellsOnLayer.detid[cellIdx];
179  }
180  thisCluster.emplace_back(cellsOnLayer.detid[cellIdx], 1.f);
181  if (cellsOnLayer.isSeed[cellIdx]) {
182  seedDetId = cellsOnLayer.detid[cellIdx];
183  }
184  }
185 
186  float total_weight_log = 0.f;
187  float total_weight = energy;
188 
189  if constexpr (std::is_same_v<STRATEGY, HGCalSiliconStrategy>) {
190  auto thick = rhtools_.getSiThickIndex(maxEnergyDetId);
191  for (auto cellIdx : cl) {
192  const float d1 = cellsOnLayer.dim1[cellIdx] - cellsOnLayer.dim1[maxEnergyCellIndex];
193  const float d2 = cellsOnLayer.dim2[cellIdx] - cellsOnLayer.dim2[maxEnergyCellIndex];
194  if ((d1 * d1 + d2 * d2) < positionDeltaRho2_) {
195  float Wi = std::max(thresholdW0_[thick] + std::log(cellsOnLayer.weight[cellIdx] / energy), 0.);
196  x += cellsOnLayer.dim1[cellIdx] * Wi;
197  y += cellsOnLayer.dim2[cellIdx] * Wi;
198  total_weight_log += Wi;
199  }
200  }
201  } else {
202  for (auto cellIdx : cl) {
203  auto position = rhtools_.getPosition(cellsOnLayer.detid[cellIdx]);
204  x += position.x() * cellsOnLayer.weight[cellIdx];
205  y += position.y() * cellsOnLayer.weight[cellIdx];
206  }
207  }
208 
209  if constexpr (std::is_same_v<STRATEGY, HGCalSiliconStrategy>) {
210  total_weight = total_weight_log;
211  }
212 
213  if (total_weight != 0.) {
214  float inv_tot_weight = 1.f / total_weight;
215  x *= inv_tot_weight;
216  y *= inv_tot_weight;
217  } else {
218  x = y = 0.f;
219  }
221 
222  auto globalClusterIndex = cellsOnLayer.clusterIndex[cl[0]] + firstClusterIdx;
223 
224  clusters_v_[globalClusterIndex] =
226  clusters_v_[globalClusterIndex].setSeed(seedDetId);
227  thisCluster.clear();
228  }
229 
230  cellsIdInCluster.clear();
231  }
232  return clusters_v_;
233 }
CaloCluster BasicCluster
std::vector< reco::BasicCluster > clusters_v_
double positionDeltaRho2_
GlobalPoint getPosition(const DetId &id) const
Definition: RecHitTools.cc:140
reco::CaloCluster::AlgoId algoId_
Definition: DetId.h:17
std::vector< int > numberOfClustersPerLayer_
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
std::vector< double > thresholdW0_
std::vector< CellsOnLayer > cells_
static int position[264][3]
Definition: ReadPGInfo.cc:289
static constexpr float d1
int getSiThickIndex(const DetId &) const
Definition: RecHitTools.cc:216

◆ getEventSetupPerAlgorithm()

template<typename T , typename STRATEGY >
void HGCalCLUEAlgoT< T, STRATEGY >::getEventSetupPerAlgorithm ( const edm::EventSetup es)
overridevirtual

Reimplemented from HGCalClusteringAlgoBase.

Definition at line 20 of file HGCalCLUEAlgo.cc.

20  {
21  cells_.clear();
23  cells_.resize(2 * (maxlayer_ + 1));
24  numberOfClustersPerLayer_.resize(2 * (maxlayer_ + 1), 0);
25 }
std::vector< int > numberOfClustersPerLayer_
std::vector< CellsOnLayer > cells_

◆ makeClusters()

template<typename T , typename STRATEGY >
void HGCalCLUEAlgoT< T, STRATEGY >::makeClusters ( )
overridevirtual

Implements HGCalClusteringAlgoBase.

Definition at line 98 of file HGCalCLUEAlgo.cc.

References ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), dumpMFGeometry_cfg::delta, hitfit::delta_r(), mps_fire::i, and LogDebug.

98  {
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) {
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 
128  });
129  });
130 }
std::vector< double > vecDeltas_
void calculateDistanceToHigher(const TILE &lt, const unsigned int layerId, float delta)
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
std::vector< int > numberOfClustersPerLayer_
void calculateLocalDensity(const TILE &lt, const unsigned int layerId, float delta)
std::vector< CellsOnLayer > cells_
void prepareDataStructures(const unsigned int layerId)
long double T
int findAndAssignClusters(const unsigned int layerId, float delta)
#define LogDebug(id)

◆ populate()

template<typename T , typename STRATEGY >
void HGCalCLUEAlgoT< T, STRATEGY >::populate ( const HGCRecHitCollection hits)
overridevirtual

Implements HGCalClusteringAlgoBase.

Definition at line 28 of file HGCalCLUEAlgo.cc.

References ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), DetId::det(), CaloRecHit::detid(), CaloRecHit::energy(), DetId::HGCalHSi, HGCHEF, hfClusterShapes_cfi::hits, mps_fire::i, infinity, hltrates_dqm_sourceclient-live_cfg::offset, position, and DetId::subdetId().

28  {
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
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;
62  int offset = ((rhtools_.zside(detid) + 1) >> 1) * maxlayer_;
63  int layer = layerOnSide + offset;
64  // setting the layer position only once per layer
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 }
void computeThreshold()
constexpr const DetId & detid() const
Definition: CaloRecHit.h:33
constexpr Detector det() const
get the detector field from this detid
Definition: DetId.h:46
int zside(const DetId &id) const
Definition: RecHitTools.cc:174
int deltasi_index_regemfac_
constexpr float energy() const
Definition: CaloRecHit.h:29
GlobalPoint getPosition(const DetId &id) const
Definition: RecHitTools.cc:140
const double infinity
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
std::vector< std::vector< double > > v_sigmaNoise_
unsigned maxNumberOfThickIndices_
std::vector< CellsOnLayer > cells_
static int position[264][3]
Definition: ReadPGInfo.cc:289
std::vector< std::vector< double > > thresholds_
int getSiThickIndex(const DetId &) const
Definition: RecHitTools.cc:216
unsigned int getLayerWithOffset(const DetId &) const
Definition: RecHitTools.cc:376

◆ prepareDataStructures()

template<typename T , typename STRATEGY >
void HGCalCLUEAlgoT< T, STRATEGY >::prepareDataStructures ( const unsigned int  layerId)
private

Definition at line 83 of file HGCalCLUEAlgo.cc.

References f, and MainPageGenerator::l.

83  {
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 }
double f[11][100]
std::vector< CellsOnLayer > cells_

◆ reset()

template<typename TILE , typename STRATEGY >
void HGCalCLUEAlgoT< TILE, STRATEGY >::reset ( void  )
inlineoverridevirtual

Implements HGCalClusteringAlgoBase.

Definition at line 67 of file HGCalCLUEAlgo.h.

References hgcalTBTopologyTester_cfi::cells, HGCalCLUEAlgoT< TILE, STRATEGY >::cells_, haddnano::cl, HGCalClusteringAlgoBase::clusters_v_, and HGCalCLUEAlgoT< TILE, STRATEGY >::numberOfClustersPerLayer_.

67  {
68  clusters_v_.clear();
69  clusters_v_.shrink_to_fit();
70  for (auto& cl : numberOfClustersPerLayer_) {
71  cl = 0;
72  }
73 
74  for (auto& cells : cells_) {
75  cells.clear();
76  cells.shrink_to_fit();
77  }
78  }
std::vector< reco::BasicCluster > clusters_v_
std::vector< int > numberOfClustersPerLayer_
std::vector< CellsOnLayer > cells_

Member Data Documentation

◆ cells_

template<typename TILE , typename STRATEGY >
std::vector<CellsOnLayer> HGCalCLUEAlgoT< TILE, STRATEGY >::cells_
private

◆ dEdXweights_

template<typename TILE , typename STRATEGY >
std::vector<double> HGCalCLUEAlgoT< TILE, STRATEGY >::dEdXweights_
private

Definition at line 131 of file HGCalCLUEAlgo.h.

◆ deltasi_index_regemfac_

template<typename TILE , typename STRATEGY >
int HGCalCLUEAlgoT< TILE, STRATEGY >::deltasi_index_regemfac_
private

Definition at line 134 of file HGCalCLUEAlgo.h.

◆ dependSensor_

template<typename TILE , typename STRATEGY >
bool HGCalCLUEAlgoT< TILE, STRATEGY >::dependSensor_
private

Definition at line 130 of file HGCalCLUEAlgo.h.

◆ ecut_

template<typename TILE , typename STRATEGY >
double HGCalCLUEAlgoT< TILE, STRATEGY >::ecut_
private

Definition at line 126 of file HGCalCLUEAlgo.h.

◆ fcPerEle_

template<typename TILE , typename STRATEGY >
double HGCalCLUEAlgoT< TILE, STRATEGY >::fcPerEle_
private

Definition at line 137 of file HGCalCLUEAlgo.h.

◆ fcPerMip_

template<typename TILE , typename STRATEGY >
std::vector<double> HGCalCLUEAlgoT< TILE, STRATEGY >::fcPerMip_
private

Definition at line 136 of file HGCalCLUEAlgo.h.

◆ initialized_

template<typename TILE , typename STRATEGY >
bool HGCalCLUEAlgoT< TILE, STRATEGY >::initialized_
private

Definition at line 148 of file HGCalCLUEAlgo.h.

◆ kappa_

template<typename TILE , typename STRATEGY >
double HGCalCLUEAlgoT< TILE, STRATEGY >::kappa_
private

Definition at line 123 of file HGCalCLUEAlgo.h.

◆ maxNumberOfThickIndices_

template<typename TILE , typename STRATEGY >
unsigned HGCalCLUEAlgoT< TILE, STRATEGY >::maxNumberOfThickIndices_
private

Definition at line 135 of file HGCalCLUEAlgo.h.

◆ noiseMip_

template<typename TILE , typename STRATEGY >
double HGCalCLUEAlgoT< TILE, STRATEGY >::noiseMip_
private

Definition at line 139 of file HGCalCLUEAlgo.h.

◆ nonAgedNoises_

template<typename TILE , typename STRATEGY >
std::vector<double> HGCalCLUEAlgoT< TILE, STRATEGY >::nonAgedNoises_
private

Definition at line 138 of file HGCalCLUEAlgo.h.

◆ numberOfClustersPerLayer_

template<typename TILE , typename STRATEGY >
std::vector<int> HGCalCLUEAlgoT< TILE, STRATEGY >::numberOfClustersPerLayer_
private

Definition at line 199 of file HGCalCLUEAlgo.h.

Referenced by HGCalCLUEAlgoT< TILE, STRATEGY >::reset().

◆ outlierDeltaFactor_

template<typename TILE , typename STRATEGY >
float HGCalCLUEAlgoT< TILE, STRATEGY >::outlierDeltaFactor_ = 2.f
private

Definition at line 150 of file HGCalCLUEAlgo.h.

◆ positionDeltaRho2_

template<typename TILE , typename STRATEGY >
double HGCalCLUEAlgoT< TILE, STRATEGY >::positionDeltaRho2_
private

Definition at line 143 of file HGCalCLUEAlgo.h.

◆ sciThicknessCorrection_

template<typename TILE , typename STRATEGY >
double HGCalCLUEAlgoT< TILE, STRATEGY >::sciThicknessCorrection_
private

Definition at line 133 of file HGCalCLUEAlgo.h.

◆ thicknessCorrection_

template<typename TILE , typename STRATEGY >
std::vector<double> HGCalCLUEAlgoT< TILE, STRATEGY >::thicknessCorrection_
private

Definition at line 132 of file HGCalCLUEAlgo.h.

◆ thresholds_

template<typename TILE , typename STRATEGY >
std::vector<std::vector<double> > HGCalCLUEAlgoT< TILE, STRATEGY >::thresholds_
private

Definition at line 140 of file HGCalCLUEAlgo.h.

◆ thresholdW0_

template<typename TILE , typename STRATEGY >
std::vector<double> HGCalCLUEAlgoT< TILE, STRATEGY >::thresholdW0_
private

Definition at line 142 of file HGCalCLUEAlgo.h.

◆ use2x2_

template<typename TILE , typename STRATEGY >
bool HGCalCLUEAlgoT< TILE, STRATEGY >::use2x2_
private

Definition at line 145 of file HGCalCLUEAlgo.h.

◆ v_sigmaNoise_

template<typename TILE , typename STRATEGY >
std::vector<std::vector<double> > HGCalCLUEAlgoT< TILE, STRATEGY >::v_sigmaNoise_
private

Definition at line 141 of file HGCalCLUEAlgo.h.

◆ vecDeltas_

template<typename TILE , typename STRATEGY >
std::vector<double> HGCalCLUEAlgoT< TILE, STRATEGY >::vecDeltas_
private

Definition at line 122 of file HGCalCLUEAlgo.h.