ATLAS Offline Software
TrigInDetPattRecoTools/src/SeedingToolBase.cxx
Go to the documentation of this file.
1 /*
2  Copyright (C) 2002-2025 CERN for the benefit of the ATLAS collaboration
3 */
4 
7 
9 
11 
12 #include "GNN_TrackingFilter.h"
13 
15 
16 #include "SeedingToolBase.h"
17 
18 
21 
22  ATH_CHECK(m_layerNumberTool.retrieve());
23 
24 
25  ATH_CHECK(detStore()->retrieve(m_atlasId, "AtlasID"));
26 
27  ATH_CHECK(detStore()->retrieve(m_pixelId, "PixelID"));
28 
29  ATH_CHECK(detStore()->retrieve(m_sctId, "SCT_ID"));
30 
31  std::string conn_fileName = PathResolver::find_file(m_connectionFile, "DATAPATH");
32  if (conn_fileName.empty()) {
33  ATH_MSG_FATAL("Cannot find layer connections file " << conn_fileName);
34  return StatusCode::FAILURE;
35  }
36  else {
37 
38  std::ifstream ifs(conn_fileName.c_str());
39 
40  m_connector = std::make_unique<GNN_FASTRACK_CONNECTOR>(ifs, m_LRTmode);
41  if (m_etaBinOverride != 0.0f) {
42  m_connector->m_etaBin = m_etaBinOverride;
43  }
44 
45  ATH_MSG_INFO("Layer connections are initialized from file " << conn_fileName);
46  }
47 
48  const std::vector<TrigInDetSiLayer>* pVL = m_layerNumberTool->layerGeometry();
49 
50  std::copy(pVL->begin(),pVL->end(), std::back_inserter(m_layerGeometry));
51 
52  m_geo = std::make_unique<TrigFTF_GNN_Geometry>(m_layerGeometry, m_connector);
53 
54 
55  if (m_useML) {
56  std::string lut_fileName = PathResolver::find_file(m_lutFile, "DATAPATH");
57  if (lut_fileName.empty()) {
58  ATH_MSG_FATAL("Cannot find ML predictor LUT file " << lut_fileName);
59  return StatusCode::FAILURE;
60  }
61  else {
62  m_mlLUT.reserve(100);
63  std::ifstream ifs(lut_fileName.c_str());
64  while (!ifs.eof()) {
65  float cl_width, min1, max1, min2, max2;
66  ifs >> cl_width >> min1 >> max1 >> min2 >> max2;
67  if (ifs.eof()) break;
68  std::array<float, 5> lut_line = {cl_width, min1, max1, min2, max2};
69  m_mlLUT.emplace_back(lut_line);
70  }
71  ifs.close();
72  ATH_MSG_INFO("ML predictor is initialized from file " << lut_fileName<<" LUT has "<<m_mlLUT.size()<<" entries");
73  }
74  }
75 
77 
78  ATH_MSG_INFO("SeedingToolBase initialized ");
79 
80  ATH_MSG_DEBUG("Property useML "<< m_useML);
81  ATH_MSG_DEBUG("Property DoPhiFiltering "<<m_filter_phi);
82  ATH_MSG_DEBUG("Property pTmin "<<m_minPt);
83  ATH_MSG_DEBUG("Property LRTmode "<<m_LRTmode);
84 
85  return StatusCode::SUCCESS;
86 }
87 
90  return sc;
91 }
92 
93 std::pair<int, int> SeedingToolBase::buildTheGraph(const IRoiDescriptor& roi, const std::unique_ptr<TrigFTF_GNN_DataStorage>& storage, std::vector<TrigFTF_GNN_Edge>& edgeStorage) const {
94 
95  constexpr float M_2PI = 2.0*M_PI;
96 
97  const float cut_dphi_max = m_LRTmode ? 0.07f : 0.012f;
98  const float cut_dcurv_max = m_LRTmode ? 0.015f : 0.001f;
99  const float cut_tau_ratio_max = m_LRTmode ? 0.015f : static_cast<float>(m_tau_ratio_cut);
100  const float min_z0 = m_LRTmode ? -600.0 : roi.zedMinus();
101  const float max_z0 = m_LRTmode ? 600.0 : roi.zedPlus();
102  const float min_deltaPhi = m_LRTmode ? 0.01f : 0.001f;
103 
104  const float maxOuterRadius = m_LRTmode ? 1050.0 : 550.0;
105 
106  const float cut_zMinU = min_z0 + maxOuterRadius*roi.dzdrMinus();
107  const float cut_zMaxU = max_z0 + maxOuterRadius*roi.dzdrPlus();
108 
109  constexpr float ptCoeff = 0.29997*1.9972/2.0;// ~0.3*B/2 - assuming nominal field of 2*T
110 
111  float tripletPtMin = 0.8f*m_minPt;//correction due to limited pT resolution
112  const float pt_scale = 900.0f/m_minPt;//to re-scale original tunings done for the 900 MeV pT cut
113 
114  float maxCurv = ptCoeff/tripletPtMin;
115 
116  float maxKappa_high_eta = m_LRTmode ? 1.0f*maxCurv : std::sqrt(0.8f)*maxCurv;
117  float maxKappa_low_eta = m_LRTmode ? 1.0f*maxCurv : std::sqrt(0.6f)*maxCurv;
118 
119  if(!m_useOldTunings && !m_LRTmode) {//new settings for curvature cuts
120  maxKappa_high_eta = 4.75e-4f*pt_scale;
121  maxKappa_low_eta = 3.75e-4f*pt_scale;
122  }
123 
124  const float dphi_coeff = m_LRTmode ? 1.0f*maxCurv : 0.68f*maxCurv;
125 
126  const float minDeltaRadius = 2.0;
127 
128  float deltaPhi = 0.5f*m_phiSliceWidth;//the default sliding window along phi
129 
130  unsigned int nConnections = 0;
131 
132  edgeStorage.reserve(m_nMaxEdges);
133 
134  int nEdges = 0;
135 
136  for(const auto& bg : m_geo->bin_groups()) {//loop over bin groups
137 
138  TrigFTF_GNN_EtaBin& B1 = storage->getEtaBin(bg.first);
139 
140  if(B1.empty()) continue;
141 
142  float rb1 = B1.getMinBinRadius();
143 
144  for(const auto& b2_idx : bg.second) {
145 
146  const TrigFTF_GNN_EtaBin& B2 = storage->getEtaBin(b2_idx);
147 
148  if(B2.empty()) continue;
149 
150  float rb2 = B2.getMaxBinRadius();
151 
152  if(m_useEtaBinning) {
153  float abs_dr = std::fabs(rb2-rb1);
154  if (m_useOldTunings) {
155  deltaPhi = min_deltaPhi + dphi_coeff*abs_dr;
156  }
157  else {
158  if(abs_dr < 60.0) {
159  deltaPhi = 0.002f + 4.33e-4f*pt_scale*abs_dr;
160  } else {
161  deltaPhi = 0.015f + 2.2e-4f*pt_scale*abs_dr;
162  }
163  }
164  }
165 
166  unsigned int first_it = 0;
167 
168  for(unsigned int n1Idx = 0;n1Idx<B1.m_vn.size();n1Idx++) {//loop over nodes in Layer 1
169 
170  std::vector<unsigned int>& v1In = B1.m_in[n1Idx];
171 
172  if(v1In.size() >= MAX_SEG_PER_NODE) continue;
173 
174  const std::array<float, 5>& n1pars = B1.m_params[n1Idx];
175 
176  float phi1 = n1pars[2];
177  float r1 = n1pars[3];
178  float z1 = n1pars[4];
179 
180  //sliding window phi1 +/- deltaPhi
181 
182  float minPhi = phi1 - deltaPhi;
183  float maxPhi = phi1 + deltaPhi;
184 
185  for(unsigned int n2PhiIdx = first_it; n2PhiIdx<B2.m_vPhiNodes.size();n2PhiIdx++) {//sliding window over nodes in Layer 2
186 
187  float phi2 = B2.m_vPhiNodes[n2PhiIdx].first;
188 
189  if(phi2 < minPhi) {
190  first_it = n2PhiIdx;
191  continue;
192  }
193  if(phi2 > maxPhi) break;
194 
195  unsigned int n2Idx = B2.m_vPhiNodes[n2PhiIdx].second;
196 
197  const std::vector<unsigned int>& v2In = B2.m_in[n2Idx];
198 
199  if(v2In.size() >= MAX_SEG_PER_NODE) continue;
200 
201  const std::array<float, 5>& n2pars = B2.m_params[n2Idx];
202 
203  float r2 = n2pars[3];
204 
205  float dr = r2 - r1;
206 
207  if(dr < minDeltaRadius) {
208  continue;
209  }
210 
211  float z2 = n2pars[4];
212 
213  float dz = z2 - z1;
214  float tau = dz/dr;
215  float ftau = std::fabs(tau);
216  if (ftau > 36.0) {
217  continue;
218  }
219 
220  if(ftau < n1pars[0]) continue;
221  if(ftau > n1pars[1]) continue;
222 
223  if(ftau < n2pars[0]) continue;
224  if(ftau > n2pars[1]) continue;
225 
226  if (m_doubletFilterRZ) {
227 
228  float z0 = z1 - r1*tau;
229 
230  if(z0 < min_z0 || z0 > max_z0) continue;
231 
232  float zouter = z0 + maxOuterRadius*tau;
233 
234  if(zouter < cut_zMinU || zouter > cut_zMaxU) continue;
235  }
236 
237  float curv = (phi2-phi1)/dr;
238  float abs_curv = std::abs(curv);
239 
240  if(ftau < 4.0) {//eta = 2.1
241  if(abs_curv > maxKappa_low_eta) {
242  continue;
243  }
244  }
245  else {
246  if(abs_curv > maxKappa_high_eta) {
247  continue;
248  }
249  }
250 
251  float exp_eta = std::sqrt(1.f+tau*tau)-tau;
252 
253  if (m_matchBeforeCreate) {//match edge candidate against edges incoming to n2
254 
255  bool isGood = v2In.size() <= 2;//we must have enough incoming edges to decide
256 
257  if(!isGood) {
258 
259  float uat_1 = 1.0f/exp_eta;
260 
261  for(const auto& n2_in_idx : v2In) {
262 
263  float tau2 = edgeStorage.at(n2_in_idx).m_p[0];
264  float tau_ratio = tau2*uat_1 - 1.0f;
265 
266  if(std::fabs(tau_ratio) > cut_tau_ratio_max){//bad match
267  continue;
268  }
269  isGood = true;//good match found
270  break;
271  }
272  }
273 
274  if(!isGood) {//no match found, skip creating [n1 <- n2] edge
275  continue;
276  }
277  }
278 
279  float dPhi2 = curv*r2;
280  float dPhi1 = curv*r1;
281 
282  if(nEdges < m_nMaxEdges) {
283 
284  edgeStorage.emplace_back(B1.m_vn[n1Idx], B2.m_vn[n2Idx], exp_eta, curv, phi1 + dPhi1);
285 
286  if(v1In.size() < MAX_SEG_PER_NODE) v1In.push_back(nEdges);
287 
288  int outEdgeIdx = nEdges;
289 
290  float uat_2 = 1.f/exp_eta;
291  float Phi2 = phi2 + dPhi2;
292  float curv2 = curv;
293 
294  for(const auto& inEdgeIdx : v2In) {//looking for neighbours of the new edge
295 
296  TrigFTF_GNN_Edge* pS = &(edgeStorage.at(inEdgeIdx));
297 
298  if(pS->m_nNei >= N_SEG_CONNS) continue;
299 
300  float tau_ratio = pS->m_p[0]*uat_2 - 1.0f;
301 
302  if(std::abs(tau_ratio) > cut_tau_ratio_max){//bad match
303  continue;
304  }
305 
306  float dPhi = Phi2 - pS->m_p[2];
307 
308  if(dPhi<-M_PI) dPhi += M_2PI;
309  else if(dPhi>M_PI) dPhi -= M_2PI;
310 
311  if(dPhi < -cut_dphi_max || dPhi > cut_dphi_max) {
312  continue;
313  }
314 
315  float dcurv = curv2 - pS->m_p[1];
316 
317  if(dcurv < -cut_dcurv_max || dcurv > cut_dcurv_max) {
318  continue;
319  }
320 
321  pS->m_vNei[pS->m_nNei++] = outEdgeIdx;
322 
323  nConnections++;
324 
325  }
326  nEdges++;
327  }
328  } //loop over n2 (outer) nodes
329  } //loop over n1 (inner) nodes
330  } //loop over bins in Layer 2
331  } //loop over bin groups
332 
333  if(nEdges >= m_nMaxEdges) {
334  ATH_MSG_WARNING("Maximum number of graph edges exceeded - possible efficiency loss "<< nEdges);
335  }
336 
337  return std::make_pair(nEdges, nConnections);
338 }
339 
340 int SeedingToolBase::runCCA(int nEdges, std::vector<TrigFTF_GNN_Edge>& edgeStorage) const {
341 
342  constexpr int maxIter = 15;
343 
344  int maxLevel = 0;
345 
346  int iter = 0;
347 
348  std::vector<TrigFTF_GNN_Edge*> v_old;
349 
350  for(int edgeIndex=0;edgeIndex<nEdges;edgeIndex++) {
351 
352  TrigFTF_GNN_Edge* pS = &(edgeStorage[edgeIndex]);
353  if(pS->m_nNei == 0) continue;
354 
355  v_old.push_back(pS);//TO-DO: increment level for segments as they already have at least one neighbour
356  }
357 
358  std::vector<TrigFTF_GNN_Edge*> v_new;
359  v_new.reserve(v_old.size());
360 
361  for(;iter<maxIter;iter++) {
362 
363  //generate proposals
364  v_new.clear();
365 
366  for(auto pS : v_old) {
367 
368  int next_level = pS->m_level;
369 
370  for(int nIdx=0;nIdx<pS->m_nNei;nIdx++) {
371 
372  unsigned int nextEdgeIdx = pS->m_vNei[nIdx];
373 
374  TrigFTF_GNN_Edge* pN = &(edgeStorage[nextEdgeIdx]);
375 
376  if(pS->m_level == pN->m_level) {
377  next_level = pS->m_level + 1;
378  v_new.push_back(pS);
379  break;
380  }
381  }
382 
383  pS->m_next = next_level;//proposal
384  }
385 
386  //update
387 
388  int nChanges = 0;
389 
390  for(auto pS : v_new) {
391  if(pS->m_next != pS->m_level) {
392  nChanges++;
393  pS->m_level = pS->m_next;
394  if(maxLevel < pS->m_level) maxLevel = pS->m_level;
395  }
396  }
397 
398  if(nChanges == 0) break;
399 
400 
401  v_old.swap(v_new);
402  v_new.clear();
403  }
404 
405  return maxLevel;
406 }
407 
TrigFTF_GNN_EtaBin
Definition: GNN_DataStorage.h:41
python.PyKernel.retrieve
def retrieve(aClass, aKey=None)
Definition: PyKernel.py:110
PixelID.h
This is an Identifier helper class for the Pixel subdetector. This class is a factory for creating co...
SeedingToolBase::m_layerGeometry
std::vector< TrigInDetSiLayer > m_layerGeometry
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:73
SeedingToolBase::m_matchBeforeCreate
BooleanProperty m_matchBeforeCreate
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:57
IRegSelTool.h
createLinkingScheme.iter
iter
Definition: createLinkingScheme.py:62
python.tests.PyTestsLib.finalize
def finalize(self)
_info( "content of StoreGate..." ) self.sg.dump()
Definition: PyTestsLib.py:50
TrigFTF_GNN_EtaBin::m_in
std::vector< std::vector< unsigned int > > m_in
Definition: GNN_DataStorage.h:73
ATH_MSG_FATAL
#define ATH_MSG_FATAL(x)
Definition: AthMsgStreamMacros.h:34
SCT_ID.h
This is an Identifier helper class for the SCT subdetector. This class is a factory for creating comp...
SeedingToolBase::initialize
virtual StatusCode initialize()
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.cxx:19
SeedingToolBase::m_pixelId
const PixelID * m_pixelId
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:47
TileDCSDataPlotter.max1
max1
Definition: TileDCSDataPlotter.py:886
StandaloneBunchgroupHandler.bg
bg
Definition: StandaloneBunchgroupHandler.py:241
ATH_MSG_INFO
#define ATH_MSG_INFO(x)
Definition: AthMsgStreamMacros.h:31
xAOD::deltaPhi
setSAddress setEtaMS setDirPhiMS setDirZMS setBarrelRadius setEndcapAlpha setEndcapRadius setInterceptInner setEtaMap setEtaBin setIsTgcFailure setDeltaPt deltaPhi
Definition: L2StandAloneMuon_v1.cxx:161
SeedingToolBase::buildTheGraph
std::pair< int, int > buildTheGraph(const IRoiDescriptor &, const std::unique_ptr< GNN_DataStorage > &, std::vector< GNN_Edge > &) const
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.cxx:93
initialize
void initialize()
Definition: run_EoverP.cxx:894
TrigFTF_GNN_Edge::m_vNei
unsigned int m_vNei[N_SEG_CONNS]
Definition: GNN_DataStorage.h:135
SeedingToolBase::m_nMaxEdges
IntegerProperty m_nMaxEdges
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:60
SeedingToolBase::m_sctId
const SCT_ID * m_sctId
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:46
SeedingToolBase::m_connector
std::unique_ptr< GNN_FasTrackConnector > m_connector
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:72
M_PI
#define M_PI
Definition: ActiveFraction.h:11
SeedingToolBase::m_filter_phi
BooleanProperty m_filter_phi
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:49
python.TurnDataReader.dr
dr
Definition: TurnDataReader.py:111
IRoiDescriptor::dzdrMinus
virtual double dzdrMinus() const =0
return the gradients
SeedingToolBase::m_mlLUT
std::vector< std::array< float, 5 > > m_mlLUT
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:75
SeedingToolBase::m_lutFile
StringProperty m_lutFile
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:63
AthenaPoolTestRead.sc
sc
Definition: AthenaPoolTestRead.py:27
AthCommonDataStore< AthCommonMsg< AlgTool > >::detStore
const ServiceHandle< StoreGateSvc > & detStore() const
The standard StoreGateSvc/DetectorStore Returns (kind of) a pointer to the StoreGateSvc.
Definition: AthCommonDataStore.h:95
IRoiDescriptor::dzdrPlus
virtual double dzdrPlus() const =0
N_SEG_CONNS
#define N_SEG_CONNS
Definition: GNN_DataStorage.h:14
AtlasDetectorID.h
This class provides an interface to generate or decode an identifier for the upper levels of the dete...
TrigFTF_GNN_EtaBin::empty
bool empty() const
Definition: GNN_DataStorage.h:57
SeedingToolBase::m_LRTmode
BooleanProperty m_LRTmode
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:51
TrigFTF_GNN_Edge
Definition: GNN_DataStorage.h:108
SeedingToolBase.h
TrigFTF_GNN_EtaBin::m_vPhiNodes
std::vector< std::pair< float, unsigned int > > m_vPhiNodes
Definition: GNN_DataStorage.h:72
TrigFTF_GNN_Edge::m_level
signed char m_level
Definition: GNN_DataStorage.h:130
SeedingToolBase::m_minPt
FloatProperty m_minPt
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:58
EL::StatusCode
::StatusCode StatusCode
StatusCode definition for legacy code.
Definition: PhysicsAnalysis/D3PDTools/EventLoop/EventLoop/StatusCode.h:22
IRoiDescriptor
Describes the API of the Region of Ineterest geometry.
Definition: IRoiDescriptor.h:23
ATH_MSG_DEBUG
#define ATH_MSG_DEBUG(x)
Definition: AthMsgStreamMacros.h:29
SeedingToolBase::m_atlasId
const AtlasDetectorID * m_atlasId
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:45
SeedingToolBase::finalize
virtual StatusCode finalize()
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.cxx:88
ATH_CHECK
#define ATH_CHECK
Definition: AthCheckMacros.h:40
hist_file_dump.f
f
Definition: hist_file_dump.py:140
GNN_TrackingFilter.h
MAX_SEG_PER_NODE
#define MAX_SEG_PER_NODE
Definition: GNN_DataStorage.h:13
TRT::Track::z0
@ z0
Definition: InnerDetector/InDetCalibEvent/TRT_CalibData/TRT_CalibData/TrackInfo.h:63
TrigFTF_GNN_DataStorage::getEtaBin
TrigFTF_GNN_EtaBin & getEtaBin(int idx)
Definition: GNN_DataStorage.h:94
SeedingToolBase::m_connectionFile
StringProperty m_connectionFile
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:62
TrigFTF_GNN_EtaBin::getMaxBinRadius
float getMaxBinRadius() const
Definition: GNN_DataStorage.h:67
SeedingToolBase::m_doubletFilterRZ
BooleanProperty m_doubletFilterRZ
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:55
SeedingToolBase::m_layerNumberTool
ToolHandle< ITrigL2LayerNumberTool > m_layerNumberTool
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:43
SeedingToolBase::m_useEtaBinning
BooleanProperty m_useEtaBinning
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:56
SeedingToolBase::m_geo
std::unique_ptr< const TrigFTF_GNN_Geometry > m_geo
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:74
PathResolver.h
SeedingToolBase::m_etaBinOverride
FloatProperty m_etaBinOverride
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:59
SeedingToolBase::m_phiSliceWidth
float m_phiSliceWidth
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:70
TrigFTF_GNN_Edge::m_nNei
unsigned char m_nNei
Definition: GNN_DataStorage.h:132
IRoiDescriptor::zedPlus
virtual double zedPlus() const =0
the zed and eta values at the most forward and most rear ends of the RoI
ATH_MSG_WARNING
#define ATH_MSG_WARNING(x)
Definition: AthMsgStreamMacros.h:32
PathResolver::find_file
static std::string find_file(const std::string &logical_file_name, const std::string &search_path)
Definition: PathResolver.cxx:183
TrigFTF_GNN_Edge::m_p
float m_p[3]
Definition: GNN_DataStorage.h:133
TauGNNUtils::Variables::Track::dPhi
bool dPhi(const xAOD::TauJet &tau, const xAOD::TauTrack &track, float &out)
Definition: TauGNNUtils.cxx:412
IRoiDescriptor::zedMinus
virtual double zedMinus() const =0
SeedingToolBase::m_useML
BooleanProperty m_useML
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:52
calibdata.copy
bool copy
Definition: calibdata.py:26
SeedingToolBase::m_useOldTunings
BooleanProperty m_useOldTunings
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:66
M_2PI
#define M_2PI
Definition: CaloGpuGeneral_fnc.cxx:11
TrigFTF_GNN_EtaBin::m_vn
std::vector< const TrigFTF_GNN_Node * > m_vn
Definition: GNN_DataStorage.h:71
SeedingToolBase::m_tau_ratio_cut
FloatProperty m_tau_ratio_cut
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:68
SeedingToolBase::runCCA
int runCCA(int, std::vector< GNN_Edge > &) const
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.cxx:340
SeedingToolBase::m_nMaxPhiSlice
UnsignedIntegerProperty m_nMaxPhiSlice
Definition: TrigInDetPattRecoTools/src/SeedingToolBase.h:54
TrigFTF_GNN_EtaBin::getMinBinRadius
float getMinBinRadius() const
Definition: GNN_DataStorage.h:63
TrigFTF_GNN_EtaBin::m_params
std::vector< std::array< float, 5 > > m_params
Definition: GNN_DataStorage.h:74