CMS 3D CMS Logo

List of all members | Public Member Functions | Private Types | Private Attributes
l1tpf_calo::SingleCaloClusterer Class Reference

#include <CaloClusterer.h>

Public Member Functions

void add (const reco::Candidate &c)
 
void add (float pt, float eta, float phi)
 
void clear ()
 
const Clustercluster (int i) const
 
const std::vector< Cluster > & clusters () const
 
template<typename Corrector >
void correct (const Corrector &corrector)
 
std::unique_ptr< l1t::PFClusterCollectionfetch (const edm::OrphanHandle< l1t::PFClusterCollection > &cells, float ptMin=0.) const
 
std::unique_ptr< l1t::PFClusterCollectionfetch (float ptMin=0.) const
 
std::unique_ptr< l1t::PFClusterCollectionfetchCells (bool unclusteredOnly=false, float ptMin=0.) const
 
void grow ()
 possibly grow clusters by adding unclustered energy on the sides More...
 
const IndexGridindexGrid () const
 
EtGridraw ()
 non-const access to the energy: be careful to use it only before 'run()' More...
 
const EtGridraw () const
 
void run ()
 
 SingleCaloClusterer (const edm::ParameterSet &pset)
 
 ~SingleCaloClusterer ()
 

Private Types

enum  EnergyShareAlgo { EnergyShareAlgo::Fractions, EnergyShareAlgo::None, EnergyShareAlgo::Greedy, EnergyShareAlgo::Crude }
 

Private Attributes

IndexGrid cellKey_
 
IndexGrid clusterIndex_
 
std::vector< Clusterclusters_
 
EnergyShareAlgo energyShareAlgo_
 
bool energyWeightedPosition_
 
const Gridgrid_
 
float minClusterEt_
 
float minEtToGrow_
 
const Cluster nullCluster_
 
PreClusterGrid precluster_
 
EtGrid rawet_
 
float seedEt_
 
EtGrid unclustered_
 
float zsEt_
 

Detailed Description

Definition at line 180 of file CaloClusterer.h.

Member Enumeration Documentation

◆ EnergyShareAlgo

Enumerator
Fractions 
None 
Greedy 
Crude 

Definition at line 218 of file CaloClusterer.h.

218  {
219  Fractions, /* each local maximum neighbour takes a share proportional to its value */
220  None, /* each local maximum neighbour takes all the value (double counting!) */
221  Greedy, /* assing cell to the highest local maximum neighbour */
222  Crude
223  }; /* if there's more than one local maximum neighbour, they all take half of the value (no fp division) */

Constructor & Destructor Documentation

◆ SingleCaloClusterer()

l1tpf_calo::SingleCaloClusterer::SingleCaloClusterer ( const edm::ParameterSet pset)

Definition at line 164 of file CaloClusterer.cc.

165  : grid_(getGrid(pset.getParameter<std::string>("grid"))),
166  rawet_(*grid_),
168  precluster_(*grid_),
170  cellKey_(*grid_),
171  clusters_(),
172  nullCluster_(),
173  zsEt_(pset.getParameter<double>("zsEt")),
174  seedEt_(pset.getParameter<double>("seedEt")),
175  minClusterEt_(pset.getParameter<double>("minClusterEt")),
176  minEtToGrow_(pset.existsAs<double>("minEtToGrow") ? pset.getParameter<double>("minEtToGrow") : -1),
177  energyWeightedPosition_(pset.getParameter<bool>("energyWeightedPosition")) {
178  std::string energyShareAlgo = pset.getParameter<std::string>("energyShareAlgo");
179  if (energyShareAlgo == "fractions")
181  else if (energyShareAlgo == "none")
183  else if (energyShareAlgo == "greedy")
185  else if (energyShareAlgo == "crude")
187  else
188  throw cms::Exception("Configuration") << "Unsupported energyShareAlgo '" << energyShareAlgo << "'\n";
189 }

References Crude, pfClustersFromCombinedCalo_cfi::energyShareAlgo, energyShareAlgo_, Exception, Fractions, Greedy, None, muonDTDigis_cfi::pset, and AlCaHLTBitMon_QueryRunRegistry::string.

◆ ~SingleCaloClusterer()

l1tpf_calo::SingleCaloClusterer::~SingleCaloClusterer ( )

Definition at line 191 of file CaloClusterer.cc.

191 {}

Member Function Documentation

◆ add() [1/2]

void l1tpf_calo::SingleCaloClusterer::add ( const reco::Candidate c)
inline

◆ add() [2/2]

void l1tpf_calo::SingleCaloClusterer::add ( float  pt,
float  eta,
float  phi 
)
inline

Definition at line 186 of file CaloClusterer.h.

186 { rawet_(eta, phi) += pt; }

References PVValHelper::eta, DiDispStaMuonMonitor_cfi::pt, and rawet_.

Referenced by counter.Counter::register().

◆ clear()

void l1tpf_calo::SingleCaloClusterer::clear ( void  )

Definition at line 193 of file CaloClusterer.cc.

193  {
194  rawet_.zero();
195  clusters_.clear();
196  clusterIndex_.fill(-1);
197 }

Referenced by L1TPFCaloProducer::produce().

◆ cluster()

const Cluster& l1tpf_calo::SingleCaloClusterer::cluster ( int  i) const
inline

Definition at line 196 of file CaloClusterer.h.

196  {
197  return (i == -1 || clusterIndex_[i] == -1) ? nullCluster_ : clusters_[clusterIndex_[i]];
198  }

References clusterIndex_, clusters_, mps_fire::i, and nullCluster_.

◆ clusters()

const std::vector<Cluster>& l1tpf_calo::SingleCaloClusterer::clusters ( ) const
inline

Definition at line 195 of file CaloClusterer.h.

195 { return clusters_; }

References clusters_.

◆ correct()

template<typename Corrector >
void l1tpf_calo::SingleCaloClusterer::correct ( const Corrector &  corrector)
inline

◆ fetch() [1/2]

std::unique_ptr< l1t::PFClusterCollection > l1tpf_calo::SingleCaloClusterer::fetch ( const edm::OrphanHandle< l1t::PFClusterCollection > &  cells,
float  ptMin = 0. 
) const

Definition at line 393 of file CaloClusterer.cc.

394  {
395  auto ret = std::make_unique<l1t::PFClusterCollection>();
396  for (const Cluster &cluster : clusters_) {
397  if (cluster.et > ptMin) {
398  ret->emplace_back(cluster.et, cluster.eta, cluster.phi);
399  for (const auto &pair : cluster.constituents) {
400  edm::Ptr<l1t::PFCluster> ref(cells, cellKey_[pair.first]);
401  ret->back().addConstituent(ref, pair.second);
402  }
403  }
404  }
405  return ret;
406 }

References postprocess-scan-build::cells, ptMin, and runTheMatrix::ret.

◆ fetch() [2/2]

std::unique_ptr< l1t::PFClusterCollection > l1tpf_calo::SingleCaloClusterer::fetch ( float  ptMin = 0.) const

Definition at line 383 of file CaloClusterer.cc.

383  {
384  auto ret = std::make_unique<l1t::PFClusterCollection>();
385  for (const Cluster &cluster : clusters_) {
386  if (cluster.et > ptMin) {
387  ret->emplace_back(cluster.et, cluster.eta, cluster.phi);
388  }
389  }
390  return ret;
391 }

References ptMin, and runTheMatrix::ret.

Referenced by L1TPFCaloProducer::produce().

◆ fetchCells()

std::unique_ptr< l1t::PFClusterCollection > l1tpf_calo::SingleCaloClusterer::fetchCells ( bool  unclusteredOnly = false,
float  ptMin = 0. 
) const

Definition at line 366 of file CaloClusterer.cc.

367  {
368  auto ret = std::make_unique<l1t::PFClusterCollection>();
369  const EtGrid &src = (unclusteredOnly ? unclustered_ : rawet_);
370  for (unsigned int i = 0, ncells = grid_->size(); i < ncells; ++i) {
371  if (src[i] <= ptMin)
372  continue;
373  if ((unclusteredOnly == false) && (ptMin == 0)) {
374  assert(cellKey_[i] == int(ret->size()));
375  }
376  ret->emplace_back(src[i], grid_->eta(i), grid_->phi(i));
377  ret->back().setHwEta(grid_->ieta(i));
378  ret->back().setHwPhi(grid_->iphi(i));
379  }
380  return ret;
381 }

References cms::cuda::assert(), mps_fire::i, ptMin, runTheMatrix::ret, and TrackRefitter_38T_cff::src.

Referenced by L1TPFCaloProducer::produce().

◆ grow()

void l1tpf_calo::SingleCaloClusterer::grow ( )

possibly grow clusters by adding unclustered energy on the sides

Definition at line 339 of file CaloClusterer.cc.

339  {
340  int selneighs[4] = {1, 3, 4, 6}; // -eta, -phi, +phi, +eta
341  std::vector<int> toreset;
342  for (Cluster &cluster : clusters_) {
343  if (cluster.et > minEtToGrow_) {
344  int i = cluster.constituents.front().first;
345  for (int side = 0; side < 4; ++side) {
346  int neigh = grid_->neighbour(i, selneighs[side]);
347  if (neigh == -1)
348  continue;
349  for (int in = 0; in < 8; ++in) {
350  int n2 = grid_->neighbour(neigh, in);
351  if (n2 == -1)
352  continue;
353  cluster.et += unclustered_[n2];
354  if (unclustered_[n2]) {
355  cluster.constituents.emplace_back(n2, 1.0);
356  toreset.push_back(n2);
357  }
358  }
359  }
360  }
361  }
362  for (int i : toreset)
363  unclustered_[i] = 0;
364 }

References mps_fire::i, and recoMuon::in.

◆ indexGrid()

const IndexGrid& l1tpf_calo::SingleCaloClusterer::indexGrid ( ) const
inline

Definition at line 194 of file CaloClusterer.h.

194 { return clusterIndex_; }

References clusterIndex_.

◆ raw() [1/2]

EtGrid& l1tpf_calo::SingleCaloClusterer::raw ( )
inline

non-const access to the energy: be careful to use it only before 'run()'

Definition at line 201 of file CaloClusterer.h.

201 { return rawet_; }

References rawet_.

◆ raw() [2/2]

const EtGrid& l1tpf_calo::SingleCaloClusterer::raw ( ) const
inline

Definition at line 193 of file CaloClusterer.h.

193 { return rawet_; }

References rawet_.

◆ run()

void l1tpf_calo::SingleCaloClusterer::run ( )

Definition at line 199 of file CaloClusterer.cc.

199  {
200  unsigned int i, ncells = grid_->size();
201 
202  // kill zeros. count non-zeros, for linking later
203  cellKey_.fill(-1);
204  int key = 0;
205  for (i = 0; i < ncells; ++i) {
206  if (rawet_[i] < zsEt_) {
207  rawet_[i] = 0;
208  } else {
209  cellKey_[i] = key++;
210  }
211  }
212 
213  precluster_.clear();
214  // pre-cluster step 1: at each cell, set the value equal to itself if it's a local maxima, zero otherwise
215  // can be done in parallel on all cells
216  for (i = 0; i < ncells; ++i) {
217  if (rawet_[i] > seedEt_) {
218  precluster_[i].ptLocalMax = rawet_[i];
220  //printf(" candidate precluster pt %7.2f at %4d (ieta %+3d iphi %2d)\n", rawet_[i], i, grid_->ieta(i), grid_->iphi(i));
221  for (int ineigh = 0; ineigh <= 3; ++ineigh) {
222  if (rawet_.neigh(i, ineigh) > rawet_[i])
223  precluster_[i].ptLocalMax = 0;
225  //int ncell = grid_->neighbour(i,ineigh);
226  //if (ncell == -1) printf(" \t neigh %d is null\n", ineigh);
227  //else printf(" \t neigh %d at %4d (ieta %+3d iphi %2d) has pt %7.2f: comparison %1d \n", ineigh, ncell, grid_->ieta(ncell), grid_->iphi(ncell), rawet_[ncell], precluster_[i].ptLocalMax > 0);
228  }
229  for (int ineigh = 4; ineigh < 8; ++ineigh) {
230  if (rawet_.neigh(i, ineigh) >= rawet_[i])
231  precluster_[i].ptLocalMax = 0;
233  //int ncell = grid_->neighbour(i,ineigh);
234  //if (ncell == -1) printf(" \t neigh %d is null\n", ineigh);
235  //else printf(" \t neigh %d at %4d (ieta %+3d iphi %2d) has pt %7.2f: comparison %1d \n", ineigh, ncell, grid_->ieta(ncell), grid_->iphi(ncell), rawet_[ncell], precluster_[i].ptLocalMax > 0);
236  }
237  }
238  }
239  // pre-cluster step 2: compute information from neighbouring local max, for energy sharing purposes
240  for (i = 0; i < ncells; ++i) {
241  if (precluster_[i].ptLocalMax == 0) {
242  switch (energyShareAlgo_) {
244  float tot = 0;
245  for (int ineigh = 0; ineigh < 8; ++ineigh) {
246  tot += precluster_.neigh(i, ineigh).ptLocalMax;
247  }
248  precluster_[i].ptOverNeighLocalMaxSum = tot ? rawet_[i] / tot : 0;
249  } break;
251  precluster_[i].ptOverNeighLocalMaxSum = rawet_[i];
252  break;
254  float maxet = 0;
255  for (int ineigh = 0; ineigh < 8; ++ineigh) {
257  }
258  precluster_[i].ptOverNeighLocalMaxSum = maxet;
259  } break;
260  case EnergyShareAlgo::Crude: {
261  int number = 0;
262  for (int ineigh = 0; ineigh < 8; ++ineigh) {
263  number += (precluster_.neigh(i, ineigh).ptLocalMax > 0);
264  }
265  precluster_[i].ptOverNeighLocalMaxSum = (number > 1 ? 0.5 : 1.0) * rawet_[i];
266  } break;
267  }
268  }
269  }
270 
271  clusterIndex_.fill(-1);
272  clusters_.clear();
274  // cluster: at each localMax cell, take itself plus the weighted contributions of the neighbours
275  Cluster cluster;
276  for (i = 0; i < ncells; ++i) {
277  if (precluster_[i].ptLocalMax > 0) {
278  float myet = rawet_[i];
279  float tot = myet;
280  float avg_eta = 0;
281  float avg_phi = 0;
282  cluster.clear();
283  cluster.constituents.emplace_back(i, 1.0);
284  for (int ineigh = 0; ineigh < 8; ++ineigh) {
285  int ineighcell = grid_->neighbour(i, ineigh);
286  if (ineighcell == -1)
287  continue; // skip dummy cells
288  float fracet = 0;
289  switch (energyShareAlgo_) {
291  fracet = myet * precluster_.neigh(i, ineigh).ptOverNeighLocalMaxSum;
292  break;
294  fracet = precluster_.neigh(i, ineigh).ptOverNeighLocalMaxSum;
295  break;
297  fracet = (myet == precluster_.neigh(i, ineigh).ptOverNeighLocalMaxSum ? rawet_.neigh(i, ineigh) : 0);
298  break;
300  fracet = precluster_.neigh(i, ineigh).ptOverNeighLocalMaxSum;
301  break;
302  }
303  if (fracet == 0)
304  continue;
305  tot += fracet;
306  cluster.constituents.emplace_back(ineighcell, fracet / rawet_.neigh(i, ineigh));
308  avg_eta += fracet * (grid_->eta(ineighcell) - grid_->eta(i));
309  avg_phi += fracet * deltaPhi(grid_->phi(ineighcell), grid_->phi(i));
310  }
311  }
312  if (tot > minClusterEt_) {
313  cluster.et = tot;
314  unclustered_[i] = 0;
315  for (int ineigh = 0; ineigh < 8; ++ineigh) {
316  int ineighcell = grid_->neighbour(i, ineigh);
317  if (ineighcell == -1)
318  continue; // skip dummy cells
319  unclustered_[ineighcell] = 0;
320  }
322  cluster.eta = grid_->eta(i) + avg_eta / tot;
323  cluster.phi = grid_->phi(i) + avg_phi / tot;
324  // wrap around phi
326  } else {
327  cluster.eta = grid_->eta(i);
328  cluster.phi = grid_->phi(i);
329  }
330  clusterIndex_[i] = clusters_.size();
331  clusters_.push_back(cluster);
332  }
333  }
334  }
335  if (minEtToGrow_ > 0)
336  grow();
337 }

References l1tpf_calo::Cluster::clear(), l1tpf_calo::Cluster::constituents, SiPixelRawToDigiRegional_cfi::deltaPhi, l1tpf_calo::Cluster::et, l1tpf_calo::Cluster::eta, mps_fire::i, crabWrapper::key, SiStripPI::max, HiEvtPlane_cfi::maxet, None, contentValuesFiles::number, l1tpf_calo::Cluster::phi, and reco::reduceRange().

Referenced by L1TPFCaloProducer::produce().

Member Data Documentation

◆ cellKey_

IndexGrid l1tpf_calo::SingleCaloClusterer::cellKey_
private

Definition at line 227 of file CaloClusterer.h.

◆ clusterIndex_

IndexGrid l1tpf_calo::SingleCaloClusterer::clusterIndex_
private

Definition at line 227 of file CaloClusterer.h.

Referenced by cluster(), and indexGrid().

◆ clusters_

std::vector<Cluster> l1tpf_calo::SingleCaloClusterer::clusters_
private

Definition at line 228 of file CaloClusterer.h.

Referenced by cluster(), clusters(), and correct().

◆ energyShareAlgo_

EnergyShareAlgo l1tpf_calo::SingleCaloClusterer::energyShareAlgo_
private

Definition at line 231 of file CaloClusterer.h.

Referenced by SingleCaloClusterer().

◆ energyWeightedPosition_

bool l1tpf_calo::SingleCaloClusterer::energyWeightedPosition_
private

Definition at line 232 of file CaloClusterer.h.

◆ grid_

const Grid* l1tpf_calo::SingleCaloClusterer::grid_
private

Definition at line 224 of file CaloClusterer.h.

◆ minClusterEt_

float l1tpf_calo::SingleCaloClusterer::minClusterEt_
private

Definition at line 230 of file CaloClusterer.h.

◆ minEtToGrow_

float l1tpf_calo::SingleCaloClusterer::minEtToGrow_
private

Definition at line 230 of file CaloClusterer.h.

◆ nullCluster_

const Cluster l1tpf_calo::SingleCaloClusterer::nullCluster_
private

Definition at line 229 of file CaloClusterer.h.

Referenced by cluster().

◆ precluster_

PreClusterGrid l1tpf_calo::SingleCaloClusterer::precluster_
private

Definition at line 226 of file CaloClusterer.h.

◆ rawet_

EtGrid l1tpf_calo::SingleCaloClusterer::rawet_
private

Definition at line 225 of file CaloClusterer.h.

Referenced by add(), and raw().

◆ seedEt_

float l1tpf_calo::SingleCaloClusterer::seedEt_
private

Definition at line 230 of file CaloClusterer.h.

◆ unclustered_

EtGrid l1tpf_calo::SingleCaloClusterer::unclustered_
private

Definition at line 225 of file CaloClusterer.h.

◆ zsEt_

float l1tpf_calo::SingleCaloClusterer::zsEt_
private

Definition at line 230 of file CaloClusterer.h.

runTheMatrix.ret
ret
prodAgent to be discontinued
Definition: runTheMatrix.py:355
l1tpf_calo::GridData::clear
void clear()
Definition: CaloClusterer.h:139
mps_fire.i
i
Definition: mps_fire.py:355
l1tpf_calo::GridData::fill
void fill(const T &val)
Definition: CaloClusterer.h:135
l1tpf_calo::getGrid
const Grid * getGrid(const std::string &type)
Definition: CaloClusterer.cc:153
l1tpf_calo::SingleCaloClusterer::nullCluster_
const Cluster nullCluster_
Definition: CaloClusterer.h:229
DiDispStaMuonMonitor_cfi.pt
pt
Definition: DiDispStaMuonMonitor_cfi.py:39
l1tpf_calo::SingleCaloClusterer::clusters_
std::vector< Cluster > clusters_
Definition: CaloClusterer.h:228
ptMin
constexpr float ptMin
Definition: PhotonIDValueMapProducer.cc:153
cms::cuda::assert
assert(be >=bs)
l1tpf_calo::SingleCaloClusterer::seedEt_
float seedEt_
Definition: CaloClusterer.h:230
l1tpf_calo::SingleCaloClusterer::zsEt_
float zsEt_
Definition: CaloClusterer.h:230
pfClustersFromCombinedCalo_cfi.energyShareAlgo
energyShareAlgo
Definition: pfClustersFromCombinedCalo_cfi.py:22
l1tpf_calo::Cluster::constituents
std::vector< std::pair< int, float > > constituents
Definition: CaloClusterer.h:163
pfClustersFromHGC3DClusters_cfi.corrector
corrector
Definition: pfClustersFromHGC3DClusters_cfi.py:5
l1tpf_calo::Grid::iphi
int iphi(int icell) const
Definition: CaloClusterer.h:33
None
Definition: APVGainStruct.h:52
l1tpf_calo::Cluster::clear
void clear()
Definition: CaloClusterer.h:164
l1tpf_calo::SingleCaloClusterer::add
void add(const reco::Candidate &c)
Definition: CaloClusterer.h:185
contentValuesFiles.number
number
Definition: contentValuesFiles.py:53
l1tpf_calo::SingleCaloClusterer::grow
void grow()
possibly grow clusters by adding unclustered energy on the sides
Definition: CaloClusterer.cc:339
SiPixelRawToDigiRegional_cfi.deltaPhi
deltaPhi
Definition: SiPixelRawToDigiRegional_cfi.py:9
PVValHelper::eta
Definition: PVValidationHelpers.h:69
l1tpf_calo::SingleCaloClusterer::minClusterEt_
float minClusterEt_
Definition: CaloClusterer.h:230
l1tpf_calo::Grid::phi
float phi(int icell) const
Definition: CaloClusterer.h:29
l1tpf_calo::GridData::zero
void zero()
Definition: CaloClusterer.h:136
AlCaHLTBitMon_QueryRunRegistry.string
string
Definition: AlCaHLTBitMon_QueryRunRegistry.py:256
l1tpf_calo::SingleCaloClusterer::cellKey_
IndexGrid cellKey_
Definition: CaloClusterer.h:227
l1tpf_calo::PreCluster::ptLocalMax
float ptLocalMax
Definition: CaloClusterer.h:154
l1tpf_calo::PreCluster::ptOverNeighLocalMaxSum
float ptOverNeighLocalMaxSum
Definition: CaloClusterer.h:155
TrackRefitter_38T_cff.src
src
Definition: TrackRefitter_38T_cff.py:24
l1tpf_calo::GridData::neigh
const T & neigh(int icell, unsigned int idx) const
Definition: CaloClusterer.h:116
l1tpf_calo::Grid::size
unsigned int size() const
Definition: CaloClusterer.h:25
SiStripPI::max
Definition: SiStripPayloadInspectorHelper.h:169
l1tpf_calo::SingleCaloClusterer::rawet_
EtGrid rawet_
Definition: CaloClusterer.h:225
recoMuon::in
Definition: RecoMuonEnumerators.h:6
l1tpf_calo::SingleCaloClusterer::unclustered_
EtGrid unclustered_
Definition: CaloClusterer.h:225
l1tpf_calo::SingleCaloClusterer::minEtToGrow_
float minEtToGrow_
Definition: CaloClusterer.h:230
l1tpf_calo::SingleCaloClusterer::grid_
const Grid * grid_
Definition: CaloClusterer.h:224
l1tpf_calo::Grid::neighbour
int neighbour(int icell, unsigned int idx) const
Definition: CaloClusterer.h:27
l1tpf_calo::Cluster::eta
float eta
Definition: CaloClusterer.h:162
HltBtagPostValidation_cff.c
c
Definition: HltBtagPostValidation_cff.py:31
l1tpf_calo::SingleCaloClusterer::EnergyShareAlgo::Fractions
edm::Ptr
Definition: AssociationVector.h:31
l1tpf_calo::Cluster::et
float et
Definition: CaloClusterer.h:162
DDAxes::phi
l1tpf_calo::SingleCaloClusterer::EnergyShareAlgo::Greedy
l1tpf_calo::Cluster::phi
float phi
Definition: CaloClusterer.h:162
l1tpf_calo::SingleCaloClusterer::EnergyShareAlgo::Crude
l1tpf_calo::Grid::ieta
int ieta(int icell) const
Definition: CaloClusterer.h:32
l1tpf_calo::SingleCaloClusterer::clusterIndex_
IndexGrid clusterIndex_
Definition: CaloClusterer.h:227
Exception
Definition: hltDiff.cc:246
postprocess-scan-build.cells
cells
Definition: postprocess-scan-build.py:13
l1tpf_calo::SingleCaloClusterer::EnergyShareAlgo::None
l1tpf_calo::EtGrid
GridData< float > EtGrid
Definition: CaloClusterer.h:149
l1tpf_calo::SingleCaloClusterer::energyWeightedPosition_
bool energyWeightedPosition_
Definition: CaloClusterer.h:232
l1tpf_calo::SingleCaloClusterer::cluster
const Cluster & cluster(int i) const
Definition: CaloClusterer.h:196
l1tpf_calo::Grid::eta
float eta(int icell) const
Definition: CaloClusterer.h:28
l1tpf_calo::SingleCaloClusterer::precluster_
PreClusterGrid precluster_
Definition: CaloClusterer.h:226
crabWrapper.key
key
Definition: crabWrapper.py:19
l1tpf_calo::SingleCaloClusterer::energyShareAlgo_
EnergyShareAlgo energyShareAlgo_
Definition: CaloClusterer.h:231
HiEvtPlane_cfi.maxet
maxet
Definition: HiEvtPlane_cfi.py:18
muonDTDigis_cfi.pset
pset
Definition: muonDTDigis_cfi.py:27
reco::reduceRange
constexpr T reduceRange(T x)
Definition: deltaPhi.h:18