CMS 3D CMS Logo

List of all members | Public Member Functions | Private Attributes
KDTreeLinkerTrackHcal Class Reference
Inheritance diagram for KDTreeLinkerTrackHcal:
KDTreeLinkerBase

Public Member Functions

void buildTree () override
 
void clear () override
 
void insertFieldClusterElt (reco::PFBlockElement *hcalCluster) override
 
void insertTargetElt (reco::PFBlockElement *track) override
 
 KDTreeLinkerTrackHcal (const edm::ParameterSet &conf)
 
void searchLinks () override
 
void updatePFBlockEltWithLinks () override
 
 ~KDTreeLinkerTrackHcal () override
 
- Public Member Functions inherited from KDTreeLinkerBase
const reco::PFBlockElement::TypefieldType () const
 
 KDTreeLinkerBase (const edm::ParameterSet &conf)
 
void process ()
 
void setDebug (bool isDebug)
 
void setFieldType (const reco::PFBlockElement::Type &fld)
 
void setTargetType (const reco::PFBlockElement::Type &tgt)
 
const reco::PFBlockElement::TypetargetType () const
 
virtual ~KDTreeLinkerBase ()
 

Private Attributes

bool checkExit_
 
BlockEltSet fieldClusterSet_
 
int nMaxHcalLinksPerTrack_
 
RecHit2BlockEltMap rechit2ClusterLinks_
 
RecHitSet rechitsSet_
 
BlockElt2BlockEltMap target2ClusterLinks_
 
BlockEltSet targetSet_
 
reco::PFTrajectoryPoint::LayerType trajectoryLayerEntrance_
 
std::string trajectoryLayerEntranceString_
 
reco::PFTrajectoryPoint::LayerType trajectoryLayerExit_
 
std::string trajectoryLayerExitString_
 
KDTreeLinkerAlgo< reco::PFRecHit const * > tree_
 

Additional Inherited Members

- Static Protected Member Functions inherited from KDTreeLinkerBase
template<typename T >
static std::vector< size_t > sort_indexes (const std::vector< T > &v)
 
- Protected Attributes inherited from KDTreeLinkerBase
reco::PFBlockElement::Type _fieldType
 
reco::PFBlockElement::Type _targetType
 
float cristalPhiEtaMaxSize_ = 0.04
 
float cristalXYMaxSize_ = 3.
 
const float cutOffFrac = 1E-4
 
bool debug_ = false
 
float phiOffset_ = 0.25
 

Detailed Description

Definition at line 11 of file KDTreeLinkerTrackHcal.cc.

Constructor & Destructor Documentation

◆ KDTreeLinkerTrackHcal()

KDTreeLinkerTrackHcal::KDTreeLinkerTrackHcal ( const edm::ParameterSet conf)

Definition at line 72 of file KDTreeLinkerTrackHcal.cc.

References cms::cuda::assert(), checkExit_, KDTreeLinkerBase::cristalPhiEtaMaxSize_, reco::PFTrajectoryPoint::HCALEntrance, reco::PFTrajectoryPoint::HCALExit, reco::PFTrajectoryPoint::layerTypeByName(), KDTreeLinkerBase::phiOffset_, trajectoryLayerEntrance_, trajectoryLayerEntranceString_, trajectoryLayerExit_, trajectoryLayerExitString_, reco::PFTrajectoryPoint::Unknown, and reco::PFTrajectoryPoint::VFcalEntrance.

73  : KDTreeLinkerBase(conf),
74  trajectoryLayerEntranceString_(conf.getParameter<std::string>("trajectoryLayerEntrance")),
75  trajectoryLayerExitString_(conf.getParameter<std::string>("trajectoryLayerExit")),
76  nMaxHcalLinksPerTrack_(conf.getParameter<int>("nMaxHcalLinksPerTrack")) {
77  // Initialization
79  phiOffset_ = 0.32;
80  // convert TrajectoryLayers info from string to enum
83  // make sure the requested setting is supported
90  // flag if exit layer should be checked or not
92 }
reco::PFTrajectoryPoint::LayerType trajectoryLayerEntrance_
T getParameter(std::string const &) const
Definition: ParameterSet.h:303
assert(be >=bs)
KDTreeLinkerBase(const edm::ParameterSet &conf)
std::string trajectoryLayerEntranceString_
static LayerType layerTypeByName(const std::string &name)
reco::PFTrajectoryPoint::LayerType trajectoryLayerExit_

◆ ~KDTreeLinkerTrackHcal()

KDTreeLinkerTrackHcal::~KDTreeLinkerTrackHcal ( )
override

Definition at line 94 of file KDTreeLinkerTrackHcal.cc.

References clear().

94 { clear(); }

Member Function Documentation

◆ buildTree()

void KDTreeLinkerTrackHcal::buildTree ( )
overridevirtual

Implements KDTreeLinkerBase.

Definition at line 131 of file KDTreeLinkerTrackHcal.cc.

References KDTreeLinkerAlgo< DATA, DIM >::build(), RhoEtaPhi::eta(), f, M_PI, phi, RhoEtaPhi::phi(), phimax, phimin, KDTreeLinkerBase::phiOffset_, rechitsSet_, HLT_2022v15_cff::region, and tree_.

131  {
132  // List of pseudo-rechits that will be used to create the KDTree
133  std::vector<KDTreeNodeInfo<reco::PFRecHit const*, 2>> eltList;
134 
135  // Filling of this list
136  for (RecHitSet::const_iterator it = rechitsSet_.begin(); it != rechitsSet_.end(); it++) {
137  const reco::PFRecHit::REPPoint& posrep = (*it)->positionREP();
138 
139  KDTreeNodeInfo<reco::PFRecHit const*, 2> rh1(*it, posrep.eta(), posrep.phi());
140  eltList.push_back(rh1);
141 
142  // Here we solve the problem of phi circular set by duplicating some rechits
143  // too close to -Pi (or to Pi) and adding (substracting) to them 2 * Pi.
144  if (rh1.dims[1] > (M_PI - phiOffset_)) {
145  float phi = rh1.dims[1] - 2 * M_PI;
146  KDTreeNodeInfo<reco::PFRecHit const*, 2> rh2(*it, float(posrep.eta()), phi);
147  eltList.push_back(rh2);
148  }
149 
150  if (rh1.dims[1] < (M_PI * -1.0 + phiOffset_)) {
151  float phi = rh1.dims[1] + 2 * M_PI;
152  KDTreeNodeInfo<reco::PFRecHit const*, 2> rh3(*it, float(posrep.eta()), phi);
153  eltList.push_back(rh3);
154  }
155  }
156 
157  // Here we define the upper/lower bounds of the 2D space (eta/phi).
158  float phimin = -1.0 * M_PI - phiOffset_;
159  float phimax = M_PI + phiOffset_;
160 
161  // etamin-etamax, phimin-phimax
162  KDTreeBox region(-3.0f, 3.0f, phimin, phimax);
163 
164  // We may now build the KDTree
165  tree_.build(eltList, region);
166 }
KDTreeLinkerAlgo< reco::PFRecHit const * > tree_
float phi() const
momentum azimuthal angle
Definition: PtEtaPhiMass.h:54
double f[11][100]
void build(std::vector< KDTreeNodeInfo< DATA, DIM > > &eltList, const KDTreeBox< DIM > &region)
#define M_PI
float eta() const
momentum pseudorapidity
Definition: PtEtaPhiMass.h:52

◆ clear()

void KDTreeLinkerTrackHcal::clear ( void  )
overridevirtual

Implements KDTreeLinkerBase.

Definition at line 334 of file KDTreeLinkerTrackHcal.cc.

References KDTreeLinkerAlgo< DATA, DIM >::clear(), fieldClusterSet_, rechit2ClusterLinks_, rechitsSet_, target2ClusterLinks_, targetSet_, and tree_.

Referenced by ~KDTreeLinkerTrackHcal().

334  {
335  targetSet_.clear();
336  fieldClusterSet_.clear();
337 
338  rechitsSet_.clear();
339 
340  rechit2ClusterLinks_.clear();
341  target2ClusterLinks_.clear();
342 
343  tree_.clear();
344 }
BlockElt2BlockEltMap target2ClusterLinks_
KDTreeLinkerAlgo< reco::PFRecHit const * > tree_
RecHit2BlockEltMap rechit2ClusterLinks_

◆ insertFieldClusterElt()

void KDTreeLinkerTrackHcal::insertFieldClusterElt ( reco::PFBlockElement hcalCluster)
overridevirtual

Implements KDTreeLinkerBase.

Definition at line 102 of file KDTreeLinkerTrackHcal.cc.

References reco::PFBlockElement::clusterRef(), KDTreeLinkerBase::cutOffFrac, fieldClusterSet_, funct::fract(), HLT_2022v15_cff::fraction, edm::Ref< C, T, F >::isNull(), rechit2ClusterLinks_, and rechitsSet_.

102  {
103  const reco::PFClusterRef& clusterref = hcalCluster->clusterRef();
104 
105  // This test is more or less done in PFBlockAlgo.h. In others cases, it should be switch on.
106  // if (!((clusterref->layer() == PFLayer::HCAL_ENDCAP) ||
107  // (clusterref->layer() == PFLayer::HCAL_BARREL1)))
108  // return;
109 
110  const std::vector<reco::PFRecHitFraction>& fraction = clusterref->recHitFractions();
111 
112  // We create a list of hcalCluster
113  fieldClusterSet_.insert(hcalCluster);
114  for (size_t rhit = 0; rhit < fraction.size(); ++rhit) {
115  const reco::PFRecHitRef& rh = fraction[rhit].recHitRef();
116  double fract = fraction[rhit].fraction();
117 
118  if ((rh.isNull()) || (fract < cutOffFrac))
119  continue;
120 
121  const reco::PFRecHit& rechit = *rh;
122 
123  // We save the links rechit to HcalClusters
124  rechit2ClusterLinks_[&rechit].insert(hcalCluster);
125 
126  // We create a liste of rechits
127  rechitsSet_.insert(&rechit);
128  }
129 }
Particle flow rechit (rechit + geometry and topology information). See clustering algorithm in PFClus...
Definition: PFRecHit.h:31
RecHit2BlockEltMap rechit2ClusterLinks_
virtual const PFClusterRef & clusterRef() const
const Fraction< n, m >::type & fract()
Definition: Fraction.h:36
bool isNull() const
Checks for null.
Definition: Ref.h:235
const float cutOffFrac

◆ insertTargetElt()

void KDTreeLinkerTrackHcal::insertTargetElt ( reco::PFBlockElement track)
overridevirtual

Implements KDTreeLinkerBase.

Definition at line 96 of file KDTreeLinkerTrackHcal.cc.

References targetSet_, HLT_2022v15_cff::track, and trajectoryLayerEntrance_.

96  {
97  if (track->trackRefPF()->extrapolatedPoint(trajectoryLayerEntrance_).isValid()) {
98  targetSet_.insert(track);
99  }
100 }
reco::PFTrajectoryPoint::LayerType trajectoryLayerEntrance_

◆ searchLinks()

void KDTreeLinkerTrackHcal::searchLinks ( )
overridevirtual

Implements KDTreeLinkerBase.

Definition at line 168 of file KDTreeLinkerTrackHcal.cc.

References checkExit_, KDTreeLinkerBase::cristalPhiEtaMaxSize_, PVValHelper::eta, reco::PFTrajectoryPoint::isValid(), M_PI, phi, reco::PFTrajectoryPoint::positionREP(), rpcPointValidation_cfi::recHit, rechit2ClusterLinks_, FastTrackerRecHitMaskProducer_cfi::recHits, runTheMatrix::ret, KDTreeLinkerAlgo< DATA, DIM >::search(), target2ClusterLinks_, targetSet_, trajectoryLayerEntrance_, trajectoryLayerExit_, and tree_.

168  {
169  // Most of the code has been taken from LinkByRecHit.cc
170 
171  // We iterate over the tracks.
172  for (BlockEltSet::iterator it = targetSet_.begin(); it != targetSet_.end(); it++) {
173  reco::PFRecTrackRef trackref = (*it)->trackRefPF();
174 
175  const reco::PFTrajectoryPoint& atHCAL = trackref->extrapolatedPoint(trajectoryLayerEntrance_);
176 
177  // The track didn't reach hcal
178  if (!atHCAL.isValid())
179  continue;
180 
181  // In case the exit point check is requested, check eta and phi differences between entrance and exit
182  double dHeta = 0.0;
183  float dHphi = 0.0;
184  if (checkExit_) {
185  const reco::PFTrajectoryPoint& atHCALExit = trackref->extrapolatedPoint(trajectoryLayerExit_);
186  dHeta = atHCALExit.positionREP().eta() - atHCAL.positionREP().eta();
187  dHphi = atHCALExit.positionREP().phi() - atHCAL.positionREP().phi();
188  if (dHphi > M_PI)
189  dHphi = dHphi - 2. * M_PI;
190  else if (dHphi < -M_PI)
191  dHphi = dHphi + 2. * M_PI;
192  } // checkExit_
193 
194  float tracketa = atHCAL.positionREP().eta() + 0.1 * dHeta;
195  float trackphi = atHCAL.positionREP().phi() + 0.1 * dHphi;
196 
197  if (trackphi > M_PI)
198  trackphi -= 2 * M_PI;
199  else if (trackphi < -M_PI)
200  trackphi += 2 * M_PI;
201 
202  // Estimate the maximal envelope in phi/eta that will be used to find rechit candidates.
203  // Same envelope for cap et barrel rechits.
204  double inflation = 1.;
205  float rangeeta = (cristalPhiEtaMaxSize_ * (1.5 + 0.5) + 0.2 * fabs(dHeta)) * inflation;
206  float rangephi = (cristalPhiEtaMaxSize_ * (1.5 + 0.5) + 0.2 * fabs(dHphi)) * inflation;
207 
208  // We search for all candidate recHits, ie all recHits contained in the maximal size envelope.
209  std::vector<reco::PFRecHit const*> recHits;
210  KDTreeBox trackBox(tracketa - rangeeta, tracketa + rangeeta, trackphi - rangephi, trackphi + rangephi);
211  tree_.search(trackBox, recHits);
212 
213  // Here we check all rechit candidates using the non-approximated method.
214  for (auto const& recHit : recHits) {
215  const auto& rhrep = recHit->positionREP();
216  const auto& corners = recHit->getCornersREP();
217 
218  double rhsizeeta = fabs(corners[3].eta() - corners[1].eta());
219  double rhsizephi = fabs(corners[3].phi() - corners[1].phi());
220  if (rhsizephi > M_PI)
221  rhsizephi = 2. * M_PI - rhsizephi;
222 
223  double deta = fabs(rhrep.eta() - tracketa);
224  double dphi = fabs(rhrep.phi() - trackphi);
225  if (dphi > M_PI)
226  dphi = 2. * M_PI - dphi;
227 
228  // Find all clusters associated to given rechit
229  RecHit2BlockEltMap::iterator ret = rechit2ClusterLinks_.find(recHit);
230 
231  for (BlockEltSet::iterator clusterIt = ret->second.begin(); clusterIt != ret->second.end(); clusterIt++) {
232  const reco::PFClusterRef clusterref = (*clusterIt)->clusterRef();
233  int fracsNbr = clusterref->recHitFractions().size();
234 
235  double _rhsizeeta = rhsizeeta * (1.5 + 0.5 / fracsNbr) + 0.2 * fabs(dHeta);
236  double _rhsizephi = rhsizephi * (1.5 + 0.5 / fracsNbr) + 0.2 * fabs(dHphi);
237 
238  // Check if the track and the cluster are linked
239  if (deta < (_rhsizeeta / 2.) && dphi < (_rhsizephi / 2.))
240  target2ClusterLinks_[*it].insert(*clusterIt);
241  }
242  }
243  }
244 }
reco::PFTrajectoryPoint::LayerType trajectoryLayerEntrance_
const REPPoint & positionREP() const
trajectory position in (rho, eta, phi) base
void search(const KDTreeBox< DIM > &searchBox, std::vector< DATA > &resRecHitList)
ret
prodAgent to be discontinued
BlockElt2BlockEltMap target2ClusterLinks_
KDTreeLinkerAlgo< reco::PFRecHit const * > tree_
bool isValid() const
is this point valid ?
RecHit2BlockEltMap rechit2ClusterLinks_
#define M_PI
reco::PFTrajectoryPoint::LayerType trajectoryLayerExit_
A PFTrack holds several trajectory points, which basically contain the position and momentum of a tra...

◆ updatePFBlockEltWithLinks()

void KDTreeLinkerTrackHcal::updatePFBlockEltWithLinks ( )
overridevirtual

Implements KDTreeLinkerBase.

Definition at line 246 of file KDTreeLinkerTrackHcal.cc.

References KDTreeLinkerBase::_fieldType, KDTreeLinkerBase::_targetType, checkExit_, LinkByRecHit::computeDist(), reco::deltaPhi(), mps_fire::i, reco::PFMultiLinksTC::linkedPFObjects, GetRecoTauVFromDQM_MC_cff::next, nMaxHcalLinksPerTrack_, reco::PFTrajectoryPoint::position(), reco::PFTrajectoryPoint::positionREP(), KDTreeLinkerBase::sort_indexes(), target2ClusterLinks_, trajectoryLayerEntrance_, and trajectoryLayerExit_.

246  {
247  //TODO YG : Check if cluster positionREP() is valid ?
248 
249  // Here we save in each track the list of phi/eta values of linked clusters.
250  for (BlockElt2BlockEltMap::iterator it = target2ClusterLinks_.begin(); it != target2ClusterLinks_.end(); ++it) {
251  const auto& trackElt = it->first;
252  const auto& hcalEltSet = it->second;
253  reco::PFMultiLinksTC multitracks(true);
254 
255  //
256  // No restriction on the number of HCAL links per track or isLinkedToDisplacedVertex
257  if (nMaxHcalLinksPerTrack_ < 0. || trackElt->isLinkedToDisplacedVertex()) {
258  for (const auto& hcalElt : hcalEltSet) {
259  reco::PFMultilink multiLink(hcalElt->clusterRef());
260  multitracks.linkedPFObjects.push_back(multiLink);
261 
262  // We set the multilinks flag of the track (for links to ECAL) to true. It will allow us to
263  // use it in an optimized way in prefilter
264  hcalElt->setIsValidMultilinks(true, _targetType);
265  }
266 
267  }
268  //
269  // Store only the N closest HCAL links per track.
270  else {
271  const reco::PFRecTrackRef& trackref = trackElt->trackRefPF();
272  const reco::PFTrajectoryPoint& tkAtHCALEnt = trackref->extrapolatedPoint(trajectoryLayerEntrance_);
273  const reco::PFCluster::REPPoint& tkreppos = tkAtHCALEnt.positionREP();
274  // Check exit point
275  double dHEta = 0.;
276  double dHPhi = 0.;
277  double dRHCALEx = 0.;
278  if (checkExit_) {
279  const reco::PFTrajectoryPoint& tkAtHCALEx = trackref->extrapolatedPoint(trajectoryLayerExit_);
280  dHEta = (tkAtHCALEx.positionREP().Eta() - tkAtHCALEnt.positionREP().Eta());
281  dHPhi = reco::deltaPhi(tkAtHCALEx.positionREP().Phi(), tkAtHCALEnt.positionREP().Phi());
282  dRHCALEx = tkAtHCALEx.position().R();
283  }
284 
285  std::vector<double> vDist;
286  double dist(-1.0);
287 
288  // Fill the vector of distances between HCAL clusters and the track
289  for (const auto& hcalElt : hcalEltSet) {
290  double clusterphi = hcalElt->clusterRef()->positionREP().phi();
291  double clustereta = hcalElt->clusterRef()->positionREP().eta();
292 
293  // when checkExit_ is false
294  if (!checkExit_) {
295  dist = LinkByRecHit::computeDist(clustereta, clusterphi, tkreppos.Eta(), tkreppos.Phi());
296  }
297  // when checkExit_ is true
298  else {
299  //special case ! A looper can exit the barrel inwards and hit the endcap
300  //In this case calculate the distance based on the first crossing since
301  //the looper will probably never make it to the endcap
302  if (dRHCALEx < tkAtHCALEnt.position().R()) {
303  dist = LinkByRecHit::computeDist(clustereta, clusterphi, tkreppos.Eta(), tkreppos.Phi());
304  edm::LogWarning("KDTreeLinkerTrackHcal ")
305  << "Special case of linking with track hitting HCAL and looping back in the tracker ";
306  } else {
308  clustereta, clusterphi, tkreppos.Eta() + 0.1 * dHEta, tkreppos.Phi() + 0.1 * dHPhi);
309  }
310  } // checkExit_
311 
312  vDist.push_back(dist);
313  } // loop over hcalEltSet
314 
315  // Fill multitracks
316  for (auto i : sort_indexes(vDist)) {
317  const BlockEltSet::iterator hcalEltIt = std::next(hcalEltSet.begin(), i);
318  reco::PFMultilink multiLink((*hcalEltIt)->clusterRef());
319  multitracks.linkedPFObjects.push_back(multiLink);
320  // We set the multilinks flag of the track (for links to ECAL) to true. It will allow us to
321  // use it in an optimized way in prefilter
322  (*hcalEltIt)->setIsValidMultilinks(true, _targetType);
323 
324  if (multitracks.linkedPFObjects.size() >= (unsigned)nMaxHcalLinksPerTrack_)
325  break;
326  }
327  }
328 
329  // Store multitracks
330  trackElt->setMultilinks(multitracks, _fieldType);
331  } // loop over target2ClusterLinks_
332 }
constexpr double deltaPhi(double phi1, double phi2)
Definition: deltaPhi.h:26
reco::PFTrajectoryPoint::LayerType trajectoryLayerEntrance_
const REPPoint & positionREP() const
trajectory position in (rho, eta, phi) base
static double computeDist(double eta1, double phi1, double eta2, double phi2, bool etaPhi=true)
computes a chisquare
reco::PFBlockElement::Type _fieldType
BlockElt2BlockEltMap target2ClusterLinks_
static std::vector< size_t > sort_indexes(const std::vector< T > &v)
const math::XYZPoint & position() const
cartesian position (x, y, z)
reco::PFTrajectoryPoint::LayerType trajectoryLayerExit_
reco::PFBlockElement::Type _targetType
ROOT::Math::PositionVector3D< ROOT::Math::CylindricalEta3D< double > > REPPoint
Definition: PFCluster.h:48
A PFTrack holds several trajectory points, which basically contain the position and momentum of a tra...
Log< level::Warning, false > LogWarning

Member Data Documentation

◆ checkExit_

bool KDTreeLinkerTrackHcal::checkExit_
private

◆ fieldClusterSet_

BlockEltSet KDTreeLinkerTrackHcal::fieldClusterSet_
private

Definition at line 43 of file KDTreeLinkerTrackHcal.cc.

Referenced by clear(), and insertFieldClusterElt().

◆ nMaxHcalLinksPerTrack_

int KDTreeLinkerTrackHcal::nMaxHcalLinksPerTrack_
private

Definition at line 65 of file KDTreeLinkerTrackHcal.cc.

Referenced by updatePFBlockEltWithLinks().

◆ rechit2ClusterLinks_

RecHit2BlockEltMap KDTreeLinkerTrackHcal::rechit2ClusterLinks_
private

Definition at line 52 of file KDTreeLinkerTrackHcal.cc.

Referenced by clear(), insertFieldClusterElt(), and searchLinks().

◆ rechitsSet_

RecHitSet KDTreeLinkerTrackHcal::rechitsSet_
private

Definition at line 46 of file KDTreeLinkerTrackHcal.cc.

Referenced by buildTree(), clear(), and insertFieldClusterElt().

◆ target2ClusterLinks_

BlockElt2BlockEltMap KDTreeLinkerTrackHcal::target2ClusterLinks_
private

Definition at line 49 of file KDTreeLinkerTrackHcal.cc.

Referenced by clear(), searchLinks(), and updatePFBlockEltWithLinks().

◆ targetSet_

BlockEltSet KDTreeLinkerTrackHcal::targetSet_
private

Definition at line 42 of file KDTreeLinkerTrackHcal.cc.

Referenced by clear(), insertTargetElt(), and searchLinks().

◆ trajectoryLayerEntrance_

reco::PFTrajectoryPoint::LayerType KDTreeLinkerTrackHcal::trajectoryLayerEntrance_
private

◆ trajectoryLayerEntranceString_

std::string KDTreeLinkerTrackHcal::trajectoryLayerEntranceString_
private

Definition at line 58 of file KDTreeLinkerTrackHcal.cc.

Referenced by KDTreeLinkerTrackHcal().

◆ trajectoryLayerExit_

reco::PFTrajectoryPoint::LayerType KDTreeLinkerTrackHcal::trajectoryLayerExit_
private

◆ trajectoryLayerExitString_

std::string KDTreeLinkerTrackHcal::trajectoryLayerExitString_
private

Definition at line 59 of file KDTreeLinkerTrackHcal.cc.

Referenced by KDTreeLinkerTrackHcal().

◆ tree_

KDTreeLinkerAlgo<reco::PFRecHit const*> KDTreeLinkerTrackHcal::tree_
private

Definition at line 55 of file KDTreeLinkerTrackHcal.cc.

Referenced by buildTree(), clear(), and searchLinks().