ATLAS Offline Software
Public Member Functions | Static Public Member Functions | Protected Member Functions | Protected Attributes | Private Member Functions | Private Attributes | List of all members
CaloTTMgrDetDescrCnv Class Reference

This class is a converter for the CaloTTDescrManager which is stored in the detector store. More...

#include <CaloTTMgrDetDescrCnv.h>

Inheritance diagram for CaloTTMgrDetDescrCnv:
Collaboration diagram for CaloTTMgrDetDescrCnv:

Public Member Functions

virtual long int repSvcType () const override
 
virtual StatusCode initialize () override
 
virtual StatusCode finalize () override
 
virtual StatusCode createObj (IOpaqueAddress *pAddr, DataObject *&pObj) override
 
 CaloTTMgrDetDescrCnv (ISvcLocator *svcloc)
 
virtual StatusCode fillObjRefs (IOpaqueAddress *pAddr, DataObject *pObj)
 
virtual StatusCode createRep (DataObject *pObj, IOpaqueAddress *&pAddr)
 
virtual StatusCode fillRepRefs (IOpaqueAddress *pAddr, DataObject *pObj)
 
const ServiceHandle< StoreGateSvc > & detStore () const
 Handle to DetectorStore. More...
 
void addTrack (TIDA::Track *t)
 
const std::vector< TIDA::Track * > & tracks () const
 
void clear ()
 
void selectTracks (const TrigInDetTrackCollection *trigtracks)
 
void selectTracks (const Rec::TrackParticleContainer *trigtracks)
 
void selectTracks (const Analysis::MuonContainer *muontracks)
 
bool msgLvl (const MSG::Level lvl) const
 Test the output level. More...
 
MsgStream & msg () const
 The standard message stream. More...
 
MsgStream & msg (const MSG::Level lvl) const
 The standard message stream. More...
 
void setLevel (MSG::Level lvl)
 Change the current logging level. More...
 

Static Public Member Functions

static long storageType ()
 
static const CLIDclassID ()
 

Protected Member Functions

double phiCorr (double phi)
 
void ipCorr (double d0, double z0, double &d0c, double &z0c, double phi0, double eta, double pt)
 

Protected Attributes

double m_beamX
 
double m_beamY
 
double m_beamZ
 
std::vector< TIDA::Track * > m_tracks
 

Private Member Functions

void initMessaging () const
 Initialize our message level and MessageSvc. More...
 

Private Attributes

ServiceHandle< StoreGateSvcm_detStore
 
std::string m_nm
 Message source name. More...
 
boost::thread_specific_ptr< MsgStream > m_msg_tls
 MsgStream instance (a std::cout like with print-out levels) More...
 
std::atomic< IMessageSvc * > m_imsg { nullptr }
 MessageSvc pointer. More...
 
std::atomic< MSG::Level > m_lvl { MSG::NIL }
 Current logging level. More...
 
std::atomic_flag m_initialized ATLAS_THREAD_SAFE = ATOMIC_FLAG_INIT
 Messaging initialized (initMessaging) More...
 

Detailed Description

This class is a converter for the CaloTTDescrManager which is stored in the detector store.

This class derives from DetDescrConverter which is a converter of the DetDescrCnvSvc. This converter creates a manager object and adds descriptors and detector elements to the manager. This objects are either created or accessed from the detector store.

Warning
The hadronic part of the FCAL calorimeter calorimeter is constructed with 4 channels in eta. These 4 channels actually correspond to 2 channels in eta FOR EACH of the hadronic samplings, i.e. FCAL2 and FCAL3. Therefore the geometry of these channels is wrong.

Definition at line 33 of file CaloTTMgrDetDescrCnv.h.

Constructor & Destructor Documentation

◆ CaloTTMgrDetDescrCnv()

CaloTTMgrDetDescrCnv::CaloTTMgrDetDescrCnv ( ISvcLocator *  svcloc)

Definition at line 300 of file CaloTTMgrDetDescrCnv.cxx.

Member Function Documentation

◆ addTrack()

void Converter::addTrack ( TIDA::Track t)
inlineinherited

Definition at line 45 of file Converter.h.

45  {
46  m_tracks.push_back(t);
47  }

◆ classID()

const CLID & CaloTTMgrDetDescrCnv::classID ( )
static

Definition at line 295 of file CaloTTMgrDetDescrCnv.cxx.

295  {
297 }

◆ clear()

void Converter::clear ( )
inlineinherited

Definition at line 53 of file Converter.h.

53 {m_tracks.clear();}

◆ createObj()

StatusCode CaloTTMgrDetDescrCnv::createObj ( IOpaqueAddress *  pAddr,
DataObject *&  pObj 
)
overridevirtual

Implements DetDescrConverter.

Definition at line 78 of file CaloTTMgrDetDescrCnv.cxx.

79 {
80  ATH_MSG_INFO("in createObj: creating a CaloTTDescrManager object in the detector store");
81 
82  // Create a new CaloTTDescrManager
83  CaloTTDescrManager* caloTTMgr = new CaloTTDescrManager();
84 
85  // Pass a pointer to the container to the Persistency service by reference.
86  pObj = SG::asStorable(caloTTMgr);
87 
88  // Get idhelper from detector store and add to mgr
89  //const DataHandle<CaloLVL1_ID> lvl1_id;
90  const CaloLVL1_ID* lvl1_id = nullptr;
91  ATH_CHECK(detStore()->retrieve(lvl1_id, "CaloLVL1_ID"));
92  caloTTMgr->set_helper(lvl1_id);
93  ATH_MSG_INFO("Set CaloLVL1_ID helper in CaloTTMgr ");
94 
95  // Get CaloDetDescrManager from condition store
96  // to build geometry of trigger towers
97  //
98  // NB! The information retrieved from the CaloDetDescrManager is NOT sensitive
99  // to Calo alignment changes. Hence, it is OK to write CaloTTDescrManager
100  // into DetStore
101  SG::ReadCondHandleKey<CaloDetDescrManager> caloMgrKey {"CaloDetDescrManager"};
102  ATH_CHECK(caloMgrKey.initialize());
103  SG::ReadCondHandle<CaloDetDescrManager> caloMgrHandle{caloMgrKey};
104  const CaloDetDescrManager* caloMgr = *caloMgrHandle;
105 
106  SmartIF<IToolSvc> toolSvc{service("ToolSvc")};
107  ATH_CHECK(toolSvc.isValid());
108 
109  CaloTriggerTowerService* ttSvc{nullptr};
110  ATH_CHECK(toolSvc->retrieveTool("CaloTriggerTowerService",ttSvc));
111 
112  // Initialize the caloTT mgr
113  // We protect here in case this has been initialized elsewhere
114 
115  if (!caloTTMgr->is_initialized()) {
116 
117  ATH_MSG_DEBUG("Initializing CaloTTMgr from values in CaloTTMgrDetDescrCnv");
118 
119  int numberOfIdRegions=0;
120  int numberOfDescrRegions=0;
121  int nEmb=0;
122  int nEmec=0;
123  int nHec=0;
124  int nFcal=0;
125 
126  // Initialize the manager ...
127  const CaloLVL1_ID* lvl1_helper = lvl1_id;
128 
129  std::vector<Identifier>::const_iterator itId = lvl1_id->region_begin();
130  std::vector<Identifier>::const_iterator itIdEnd = lvl1_id->region_end();
131 
132  for(; itId!=itIdEnd;++itId){
133  Identifier regId = *itId;
134  ++numberOfIdRegions;
135  int posNeg = lvl1_helper->pos_neg_z(regId);
136  // int sampling = lvl1_helper->sampling(regId);
137  int region = lvl1_helper->region(regId);
138  int halfNphi = (lvl1_helper->phi_max(regId)+1)/2;
139  int nLay = lvl1_helper->layer_max(regId)+1;
140 
141  // create Descriptors for both LAr and Tile
142  CaloTTDescriptor* calo_descriptor = new CaloTTDescriptor() ;
143  calo_descriptor->set(regId);
144 
145  if( 0 == region ) {
146  // calo_descriptor->set(0. ,2.5,0.1,-M_PI,M_PI,M_PI/halfNphi,posNeg,nLay);
147  calo_descriptor->set(0. ,2.5,0.1,0.,2.*M_PI,M_PI/halfNphi,posNeg,nLay);
148  } else if( 1 == region ) {
149  // calo_descriptor->set(2.5,3.1,0.2,-M_PI,M_PI,M_PI/halfNphi,posNeg,nLay);
150  calo_descriptor->set(2.5,3.1,0.2,0.,2.*M_PI,M_PI/halfNphi,posNeg,nLay);
151  } else if( 2 == region ) {
152  // calo_descriptor->set(3.1,3.2,0.1,-M_PI,M_PI,M_PI/halfNphi,posNeg,nLay);
153  calo_descriptor->set(3.1,3.2,0.1,0.,2.*M_PI,M_PI/halfNphi,posNeg,nLay);
154  } else if( 3 == region ) {
155  // calo_descriptor->set(3.2,4.9,0.4,-M_PI,M_PI,M_PI/halfNphi,posNeg,nLay);
156  calo_descriptor->set(3.2,4.9,0.4,0.,2.*M_PI,M_PI/halfNphi,posNeg,nLay);
157  }
158 
159  // Initialize
160  caloTTMgr->add(calo_descriptor);
161 
162  // now, create CaloTTDescrRegions for LAr only
163  // Loop on TTs of this region and create CaloTTDescrRegion's (equiv. to cell's CaloDDE for TT)
164  int maxEta=calo_descriptor->nEta();
165  for(int iEta=0;iEta<maxEta;++iEta) {
166 
167  int maxPhi=calo_descriptor->nPhi();
168  for(int iPhi=0;iPhi<maxPhi;++iPhi) {
169 
170  Identifier TTid = lvl1_helper->tower_id(regId,iEta,iPhi);
171  if(!lvl1_helper->is_tile(TTid)) {
172 
173  int maxLay=calo_descriptor->nLay();
174  for(int iLay=0;iLay<maxLay;++iLay) {
175 
176  Identifier layId = lvl1_helper->layer_id(TTid,iLay);
177  bool isFCAL(0), isEC(0);
178  if(lvl1_helper->is_fcal(layId)) {
179  isFCAL=true;
180  }
181  else if(lvl1_helper->is_emec(layId) || lvl1_helper->is_hec(layId)) {
182  isEC=true;
183  }
184  if (this->msgLvl(MSG::DEBUG)) {
185  if(lvl1_helper->is_emb(layId) || lvl1_helper->is_barrel_end(layId) ) {
186  ++nEmb;
187  ATH_MSG_DEBUG(" Found EMB TT " << lvl1_helper->show_to_string(layId));
188  }
189  else if(lvl1_helper->is_emec(layId)) {
190  ++nEmec;
191  ATH_MSG_DEBUG(" Found EMEC TT " << lvl1_helper->show_to_string(layId));
192  }
193  else if(lvl1_helper->is_hec(layId)) {
194  ++nHec;
195  ATH_MSG_DEBUG(" Found HEC TT " << lvl1_helper->show_to_string(layId));
196  }
197  else { // FCAL
198  ++nFcal;
199  ATH_MSG_DEBUG(" Found FCAL TT " << lvl1_helper->show_to_string(layId));
200  }
201  }
202 
203  double dEta=calo_descriptor->deta();
204  double eta=calo_descriptor->eta_min()+(iEta+0.5)*dEta;
205  eta*=calo_descriptor->sign_eta();
206 
207  double dPhi=calo_descriptor->dphi();
208  // beware of the -pi,pi convention
209  // fixed thanks to Denis Damazio when integrating LArRegionSelector
210  // float orig=-M_PI;
211  float orig=0.;
212  double phi=calo_descriptor->phiMin() + (iPhi+0.5)*dPhi + orig;
213  if(phi>=M_PI) {phi-=2.*M_PI;}
214  if(phi<-M_PI) {phi+=2.*M_PI;}
215 
216 
217  float rhoMin=99999.;
218  float rhoMax=0.;
219  float zMin=99999.;
220  float zMax=-99999.;
221 
222  //int atlas_tb=0;
223  std::vector<Identifier> vec = ttSvc->createCellIDvecLayer(layId);
224 
225  if(vec.size() > 0) {
226  numberOfDescrRegions++;
227  std::vector<Identifier>::const_iterator it = vec.begin();
228  std::vector<Identifier>::const_iterator it_end = vec.end();
229  for(;it!=it_end;++it) {
230  Identifier offId = (*it);
231  const CaloDetDescrElement* caloDDE =
232  caloMgr->get_element(offId);
233  double rho =caloDDE->r_raw();
234  double cDrho=caloDDE->dr();
235  double z =caloDDE->z_raw();
236  double cDz =caloDDE->dz();
237 
238  if( (rho-cDrho/2.)<rhoMin ) {rhoMin=std::max(rho-cDrho/2.,0.);}
239  if( (rho+cDrho/2.)>rhoMax ) {rhoMax=rho+cDrho/2.;}
240  if( (z-cDz/2.)<zMin ) {zMin=z-cDz/2.;}
241  if( (z+cDz/2.)>zMax ) {zMax=z+cDz/2.;}
242  } // end loop on vector elements
243 
244 
245  CaloTTDescrRegion* tt_region = new CaloTTDescrRegion(layId,calo_descriptor);
246  if(isFCAL) {
247  // FIX ME !?
248  tt_region->set_cylindric(eta,phi,(zMax+zMin)/2.);
249  tt_region->set_cylindric_size(dEta,dPhi,fabs(zMax-zMin));
250  } else if(isEC) {
251  tt_region->set_cylindric(eta,phi,(zMax+zMin)/2.);
252  tt_region->set_cylindric_size(dEta,dPhi,fabs(zMax-zMin));
253  } else {
254  tt_region->set_spherical(eta,phi,(rhoMax+rhoMin)/2.);
255  tt_region->set_spherical_size(dEta,dPhi,fabs(rhoMax-rhoMin));
256  }
257 
258  caloTTMgr->add(tt_region);
259 
260  } // end condition of vec size
261  else {
262  ATH_MSG_DEBUG(" Found no cell for TT " << lvl1_helper->show_to_string(layId));
263  }
264  } // end loop on layers
265  } // end condition against tile
266  } // end loop on phi
267  } // end loop on eta
268  } // end loop on descr_regions
269 
270  // Set to initialized state only if descriptors have been found
271  if (caloTTMgr->calo_descriptors_size () > 0) caloTTMgr->initialize();
272 
273  ATH_MSG_INFO(" Initialized CaloTTMgr, number of descr regions is " << numberOfDescrRegions);
274  ATH_MSG_DEBUG(" including "
275  << nEmb << " Em Barrel "
276  << nEmec << " Em EC "
277  << nHec << " HEC "
278  << nFcal << " FCAL ");
279  ATH_MSG_DEBUG(" number of helper regions= " << numberOfIdRegions);
280  } // end of condition !is_initialized()
281 
282  return StatusCode::SUCCESS;
283 }

◆ createRep()

StatusCode DetDescrConverter::createRep ( DataObject *  pObj,
IOpaqueAddress *&  pAddr 
)
virtualinherited

Definition at line 20 of file DetDescrConverter.cxx.

21  {
22  return StatusCode::SUCCESS;
23 }

◆ detStore()

const ServiceHandle<StoreGateSvc>& DetDescrConverter::detStore ( ) const
inlineinherited

Handle to DetectorStore.

Definition at line 33 of file DetDescrConverter.h.

33 { return m_detStore; }

◆ fillObjRefs()

StatusCode DetDescrConverter::fillObjRefs ( IOpaqueAddress *  pAddr,
DataObject *  pObj 
)
virtualinherited

Definition at line 15 of file DetDescrConverter.cxx.

16  {
17  return StatusCode::SUCCESS;
18 }

◆ fillRepRefs()

StatusCode DetDescrConverter::fillRepRefs ( IOpaqueAddress *  pAddr,
DataObject *  pObj 
)
virtualinherited

Definition at line 25 of file DetDescrConverter.cxx.

26  {
27  return StatusCode::SUCCESS;
28 }

◆ finalize()

StatusCode CaloTTMgrDetDescrCnv::finalize ( )
overridevirtual

Definition at line 69 of file CaloTTMgrDetDescrCnv.cxx.

70 {
71  ATH_MSG_DEBUG("in finalize");
72  return StatusCode::SUCCESS;
73 }

◆ initialize()

StatusCode CaloTTMgrDetDescrCnv::initialize ( )
overridevirtual

Definition at line 42 of file CaloTTMgrDetDescrCnv.cxx.

43 {
44  ATH_MSG_DEBUG("in initialize");
45  // First call parent init
47 
48  // The following is an attempt to "bootstrap" the loading of a
49  // proxy for CaloTTDescrManager into the detector store. However,
50  // CaloTTMgrDetDescrCnv::initialize is NOT called by the conversion
51  // service. So for the moment, this cannot be use. Instead the
52  // DetDescrCnvSvc must do the bootstrap from a parameter list.
53 
54 
55 // // Add CaloTTDescrManager proxy as entry point to the detector store
56 // // - this is ONLY needed for the manager of each system
57 // sc = addToDetStore(classID(), "CaloTTDescrManager");
58 // if (sc.isFailure()) {
59 // log << MSG::FATAL << "Unable to add proxy for CaloTTDescrManager to the Detector Store!" << endmsg;
60 // return StatusCode::FAILURE;
61 // } else {}
62 
63  return StatusCode::SUCCESS;
64 }

◆ initMessaging()

void AthMessaging::initMessaging ( ) const
privateinherited

Initialize our message level and MessageSvc.

This method should only be called once.

Definition at line 39 of file AthMessaging.cxx.

40 {
42  m_lvl = m_imsg ?
43  static_cast<MSG::Level>( m_imsg.load()->outputLevel(m_nm) ) :
44  MSG::INFO;
45 }

◆ ipCorr()

void Converter::ipCorr ( double  d0,
double  z0,
double &  d0c,
double &  z0c,
double  phi0,
double  eta,
double  pt 
)
inlineprotectedinherited

Definition at line 257 of file Converter.h.

257  {
258 
259  double sn = sin(phi0);
260  double cs = cos(phi0);
261  double sd0 = (d0 != 0 ? d0/fabs(d0) : 1);
262  double spt = (pt != 0 ? pt/fabs(pt) : 1);
263 
264  if (fabs(pt) >= 1*CLHEP::TeV) {
265 
266  d0c = d0 + m_beamX*sn - m_beamY*cs;
267 
268  } else {
269 
270  double rc = fabs(pt)*15.0/(9.0*1.042);
271 
272  double xc = (fabs(d0)-spt*sd0*rc)*cos(phi0+M_PI/2*sd0) - m_beamX;
273  double yc = (fabs(d0)-spt*sd0*rc)*sin(phi0+M_PI/2*sd0) - m_beamY;
274 
275  double newphi;
276  double xd01,yd01,xd02,yd02;
277 
278  if (xc == 0) {
279  xd01 = 0; yd01 = rc+yc;
280  xd02 = 0; yd02 = -rc+yc;
281  } else {
282  xd01 = xc+yc/xc*yc+sqrt(pow((xc+yc/xc*yc),2)-xc*xc-yc*yc+rc*rc); yd01 = yc/xc*xd01;
283  xd02 = xc+yc/xc*yc-sqrt(pow((xc+yc/xc*yc),2)-xc*xc-yc*yc+rc*rc); yd02 = yc/xc*xd02;
284  }
285 
286  double r1 = sqrt(xd01*xd01+yd01*yd01);
287  double r2 = sqrt(xd02*xd02+yd02*yd02);
288 
289  double phiV;
290 
291  if (r1 < r2)
292  phiV = atan2(yd01,xd01);
293  else
294  phiV = atan2(yd02,xd02);
295 
296  double phi1 = phiCorr(phiV+M_PI/2);
297  double phi2 = phiCorr(phiV-M_PI/2);
298 
299  if (fabs(phiCorr(phi1-phi0))<=fabs(phiCorr(phi2-phi0)))
300  newphi = phi1;
301  else
302  newphi = phi2;
303 
304  d0c = fabs(sqrt(xc*xc+yc*yc)-rc)*sin(phiV-newphi);
305 
306  double theta=2*atan2(exp(-eta),1);
307  double theta_save=theta;
308  theta = theta - (1+spt)/2*M_PI;
309  if (theta>0) theta = theta_save;
310 
311  double deltaz0= -spt*rc/tan(theta)*phiCorr(phiCorr(newphi)-phiCorr(phi0));
312  z0c = z0 + deltaz0;
313 
314  }
315  }

◆ msg() [1/2]

MsgStream & AthMessaging::msg ( ) const
inlineinherited

The standard message stream.

Returns a reference to the default message stream May not be invoked before sysInitialize() has been invoked.

Definition at line 164 of file AthMessaging.h.

165 {
166  MsgStream* ms = m_msg_tls.get();
167  if (!ms) {
168  if (!m_initialized.test_and_set()) initMessaging();
169  ms = new MsgStream(m_imsg,m_nm);
170  m_msg_tls.reset( ms );
171  }
172 
173  ms->setLevel (m_lvl);
174  return *ms;
175 }

◆ msg() [2/2]

MsgStream & AthMessaging::msg ( const MSG::Level  lvl) const
inlineinherited

The standard message stream.

Returns a reference to the default message stream May not be invoked before sysInitialize() has been invoked.

Definition at line 179 of file AthMessaging.h.

180 { return msg() << lvl; }

◆ msgLvl()

bool AthMessaging::msgLvl ( const MSG::Level  lvl) const
inlineinherited

Test the output level.

Parameters
lvlThe message level to test against
Returns
boolean Indicating if messages at given level will be printed
Return values
trueMessages at level "lvl" will be printed

Definition at line 151 of file AthMessaging.h.

152 {
153  if (!m_initialized.test_and_set()) initMessaging();
154  if (m_lvl <= lvl) {
155  msg() << lvl;
156  return true;
157  } else {
158  return false;
159  }
160 }

◆ phiCorr()

double Converter::phiCorr ( double  phi)
inlineprotectedinherited

Definition at line 248 of file Converter.h.

248  {
249 
250  if (phi < -TMath::Pi()) phi += 2*TMath::Pi();
251  if (phi > TMath::Pi()) phi -= 2*TMath::Pi();
252 
253  return phi;
254  }

◆ repSvcType()

long int CaloTTMgrDetDescrCnv::repSvcType ( ) const
overridevirtual

Definition at line 36 of file CaloTTMgrDetDescrCnv.cxx.

37 {
38  return (storageType());
39 }

◆ selectTracks() [1/3]

void Converter::selectTracks ( const Analysis::MuonContainer muontracks)
inlineinherited

Definition at line 177 of file Converter.h.

177  {
178 
179  static int hpmap[20] = { 0, 1, 2, 7, 8, 9, 3, 4, 5, 6, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19 };
180 
181  Analysis::MuonContainer::const_iterator muonitr = muontracks->begin();
182  Analysis::MuonContainer::const_iterator muonend = muontracks->end();
183 
184  while(muonitr!=muonend) {
185 
186  bool hasInDet = (*muonitr)->hasInDetTrackParticle();
187  const Rec::TrackParticle *trackitr=NULL;
188  if(hasInDet) trackitr=(*muonitr)->inDetTrackParticle();
189  muonitr++;
190  if(!hasInDet) continue;
191 
192  const Trk::MeasuredPerigee* measPer = trackitr->measuredPerigee();
193 
194  CLHEP::HepVector perigeeParams = measPer->parameters();
195  double pT = measPer->pT();
196  double eta = measPer->eta();
197  double phi = perigeeParams[Trk::phi0];
198  double z0 = perigeeParams[Trk::z0];
199  double d0 = perigeeParams[Trk::d0];
200  //double theta = perigeeParams[Trk::theta];
201 
202  double deta = 1;
203  double dphi = 1;
204  double dz0 = 1;
205  double dd0 = 1;
206  double dpT = 1;
207 
208  // Check number of hits
209  // NB: a spacepoint is two offline "hits", so a pixel spacepoint is really
210  // 2 "hits" and an offline SCT "hit" is really a 1D cluster, so two intersetcting
211  // stereo clusters making a spacepoint are two "hits"
212  const Trk::TrackSummary *summary = trackitr->trackSummary();
213  int nBlayerHits = 2*summary->get(Trk::numberOfBLayerHits);
215  int nSctHits = summary->get(Trk::numberOfSCTHits);
216  int nStrawHits = summary->get(Trk::numberOfTRTHits);
217  int nTrHits = summary->get(Trk::numberOfTRTHighThresholdHits);
218 
219  int nSiHits = nPixelHits + nSctHits;
220 
221  const Trk::FitQuality *quality = trackitr->fitQuality();
222  double chi2 = quality->chiSquared();
223  double dof = quality->quality->numberDoF();
224 
225  unsigned bitmap = 0;
226 
227  for ( int ih=0 ; ih<20 ; ih++ ) {
228  if ( summary->isHit(Trk::DetectorType(ih)) ) bitmap |= ( 1<<hpmap[ih] );
229  }
230 
231  // Shift d0 and z0 according to beam position
232  ipCorr(d0, z0, d0, z0, phi, eta, pT);
233 
234  // Create and save Track
235  TIDA::Track* t = new TIDA::Track(eta, phi, z0, d0, pT, chi2, dof,
236  deta, dphi, dz0, dd0, dpT,
237  nBlayerHits, nPixelHits, nSctHits, nSiHits,
238  nStrawHits, nTrHits, bitmap, 0,
239  -1) ;
240 
241  addTrack(t);
242  }
243 
244  }

◆ selectTracks() [2/3]

void Converter::selectTracks ( const Rec::TrackParticleContainer trigtracks)
inlineinherited

Definition at line 111 of file Converter.h.

111  {
112 
113  Rec::TrackParticleContainer::const_iterator trackitr = trigtracks->begin();
114  Rec::TrackParticleContainer::const_iterator trackend = trigtracks->end();
115 
116  static int hpmap[20] = { 0, 1, 2, 7, 8, 9, 3, 4, 5, 6, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19 };
117 
118  while ( trackitr!=trackend ) {
119 
120  const Trk::MeasuredPerigee* measPer = (*trackitr)->measuredPerigee();
121 
122  CLHEP::HepVector perigeeParams = measPer->parameters();
123  double pT = measPer->pT();
124  double eta = measPer->eta();
125  double phi = perigeeParams[Trk::phi0];
126  double z0 = perigeeParams[Trk::z0];
127  double d0 = perigeeParams[Trk::d0];
128  //double theta = perigeeParams[Trk::theta];
129 
130  double deta = 1;
131  double dphi = 1;
132  double dz0 = 1;
133  double dd0 = 1;
134  double dpT = 1;
135 
136  // Check number of hits
137  // NB: a spacepoint is two offline "hits", so a pixel spacepoint is really
138  // 2 "hits" and an offline SCT "hit" is really a 1D cluster, so two intersetcting
139  // stereo clusters making a spacepoint are two "hits"
140  const Trk::TrackSummary *summary = (*trackitr)->trackSummary();
141  int nBlayerHits = 2*summary->get(Trk::numberOfBLayerHits);
143  int nSctHits = summary->get(Trk::numberOfSCTHits);
144  int nStrawHits = summary->get(Trk::numberOfTRTHits);
145  int nTrHits = summary->get(Trk::numberOfTRTHighThresholdHits);
146  int nSiHits = nPixelHits + nSctHits;
147  bool expectBL = false; // Not stored for Rec::TrackParticle
148 
149  const Trk::FitQuality *quality = (*trackitr)->fitQuality();
150  double chi2 = quality->chiSquared();
151  double dof = quality->numberDoF();
152 
153  unsigned bitmap = 0;
154 
155  for ( int ih=0 ; ih<20 ; ih++ ) {
156  if ( summary->isHit(Trk::DetectorType(ih)) ) bitmap |= ( 1<<hpmap[ih] );
157  }
158 
159  // Shift d0 and z0 according to beam position
160  ipCorr(d0, z0, d0, z0, phi, eta, pT);
161 
162  // Create and save Track
163  TIDA::Track* t = new TIDA::Track(eta, phi, z0, d0, pT, chi2, dof,
164  deta, dphi, dz0, dd0, dpT,
165  nBlayerHits, nPixelHits, nSctHits, nSiHits,
166  nStrawHits, nTrHits, bitmap, 0,
167  -1,
168  expectBL) ;
169 
170  addTrack(t);
171  trackitr++;
172  }
173 
174  }

◆ selectTracks() [3/3]

void Converter::selectTracks ( const TrigInDetTrackCollection trigtracks)
inlineinherited

Definition at line 56 of file Converter.h.

56  {
57 
58  TrigInDetTrackCollection::const_iterator trackitr = trigtracks->begin();
59  TrigInDetTrackCollection::const_iterator trackend = trigtracks->end();
60 
61  while ( trackitr!=trackend ) {
62 
63  double eta = (*trackitr)->param()->eta();
64  double phi = (*trackitr)->param()->phi0();
65  double z0 = (*trackitr)->param()->z0();
66  double pT = (*trackitr)->param()->pT();
67  double d0 = (*trackitr)->param()->a0();
68  //double theta = 2*atan2(exp(-(*trackitr)->param()->eta()),1);
69 
70  double deta = (*trackitr)->param()->eeta();
71  double dphi = (*trackitr)->param()->ephi0();
72  double dz0 = (*trackitr)->param()->ez0();
73  double dpT = (*trackitr)->param()->epT();
74  double dd0 = (*trackitr)->param()->ea0();
75 
76  int algoid = (*trackitr)->algorithmId();
77 
78  int nBlayerHits = ((*trackitr)->HitPattern() & 0x1);
79  int nPixelHits = 2*(*trackitr)->NPixelSpacePoints(); // NB: for comparison with offline
80  int nSctHits = 2*(*trackitr)->NSCT_SpacePoints(); // a spacepoint is 2 "hits"
81  int nStrawHits = (*trackitr)->NStrawHits();
82  int nTrHits = (*trackitr)->NTRHits();
83 
84  int nSiHits = nPixelHits + nSctHits;
85  bool expectBL = false; //not available with TrigInDetTrack
86 
87  unsigned hitPattern = (*trackitr)->HitPattern();
88  unsigned multiPattern = 0;
89 
90  double chi2 = (*trackitr)->chi2();
91  double dof = 0;
92 
93  // Shift d0 and z0 according to beam position
94  ipCorr(d0, z0, d0, z0, phi, eta, pT);
95 
96  // Create and save Track
97  TIDA::Track* t = new TIDA::Track(eta, phi, z0, d0, pT, chi2, dof,
98  deta, dphi, dz0, dd0, dpT,
99  nBlayerHits, nPixelHits, nSctHits, nSiHits,
100  nStrawHits, nTrHits, hitPattern, multiPattern,
101  algoid,
102  expectBL ) ;
103 
104  addTrack(t);
105  trackitr++;
106  }
107  }

◆ setLevel()

void AthMessaging::setLevel ( MSG::Level  lvl)
inherited

Change the current logging level.

Use this rather than msg().setLevel() for proper operation with MT.

Definition at line 28 of file AthMessaging.cxx.

29 {
30  m_lvl = lvl;
31 }

◆ storageType()

long CaloTTMgrDetDescrCnv::storageType ( )
static

Definition at line 288 of file CaloTTMgrDetDescrCnv.cxx.

289 {
290  return DetDescr_StorageType;
291 }

◆ tracks()

const std::vector<TIDA::Track*>& Converter::tracks ( ) const
inlineinherited

Definition at line 50 of file Converter.h.

50 {return m_tracks;}

Member Data Documentation

◆ ATLAS_THREAD_SAFE

std::atomic_flag m_initialized AthMessaging::ATLAS_THREAD_SAFE = ATOMIC_FLAG_INIT
mutableprivateinherited

Messaging initialized (initMessaging)

Definition at line 141 of file AthMessaging.h.

◆ m_beamX

double Converter::m_beamX
protectedinherited

Definition at line 320 of file Converter.h.

◆ m_beamY

double Converter::m_beamY
protectedinherited

Definition at line 320 of file Converter.h.

◆ m_beamZ

double Converter::m_beamZ
protectedinherited

Definition at line 320 of file Converter.h.

◆ m_detStore

ServiceHandle<StoreGateSvc> DetDescrConverter::m_detStore
privateinherited

Definition at line 42 of file DetDescrConverter.h.

◆ m_imsg

std::atomic<IMessageSvc*> AthMessaging::m_imsg { nullptr }
mutableprivateinherited

MessageSvc pointer.

Definition at line 135 of file AthMessaging.h.

◆ m_lvl

std::atomic<MSG::Level> AthMessaging::m_lvl { MSG::NIL }
mutableprivateinherited

Current logging level.

Definition at line 138 of file AthMessaging.h.

◆ m_msg_tls

boost::thread_specific_ptr<MsgStream> AthMessaging::m_msg_tls
mutableprivateinherited

MsgStream instance (a std::cout like with print-out levels)

Definition at line 132 of file AthMessaging.h.

◆ m_nm

std::string AthMessaging::m_nm
privateinherited

Message source name.

Definition at line 129 of file AthMessaging.h.

◆ m_tracks

std::vector<TIDA::Track*> Converter::m_tracks
protectedinherited

Definition at line 321 of file Converter.h.


The documentation for this class was generated from the following files:
python.PyKernel.retrieve
def retrieve(aClass, aKey=None)
Definition: PyKernel.py:110
AthMessaging::m_lvl
std::atomic< MSG::Level > m_lvl
Current logging level.
Definition: AthMessaging.h:138
Trk::numberOfPixelHits
@ numberOfPixelHits
number of pixel layers on track with absence of hits
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:57
CalculateHighPtTerm.pT
pT
Definition: ICHEP2016/CalculateHighPtTerm.py:57
Converter::ipCorr
void ipCorr(double d0, double z0, double &d0c, double &z0c, double phi0, double eta, double pt)
Definition: Converter.h:257
DataModel_detail::const_iterator
Const iterator class for DataVector/DataList.
Definition: DVLIterator.h:82
CaloLVL1_ID::layer_max
int layer_max(const Identifier regId) const
max value of phi index (-999 == failure)
Definition: CaloLVL1_ID.cxx:516
Trk::numberOfTRTHighThresholdHits
@ numberOfTRTHighThresholdHits
total number of TRT hits which pass the high threshold
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:87
CaloTTDescriptor::phiMin
float phiMin() const
descriptor parameter: min value of phi
Definition: CaloTTDescriptor.h:156
CaloTTDescrManager::is_initialized
bool is_initialized(void) const
Definition: CaloTTDescrManager.cxx:100
Converter::m_beamY
double m_beamY
Definition: Converter.h:320
max
#define max(a, b)
Definition: cfImp.cxx:41
phi
Scalar phi() const
phi method
Definition: AmgMatrixBasePlugin.h:67
SG::ReadCondHandle
Definition: ReadCondHandle.h:44
ATH_MSG_INFO
#define ATH_MSG_INFO(x)
Definition: AthMsgStreamMacros.h:31
DetDescr_StorageType
const long DetDescr_StorageType
Definition: DetDescrCnvSvc.cxx:20
CaloLVL1_ID::is_fcal
bool is_fcal(const Identifier id) const
Test wether given tower or layer is part of the FCAL.
Definition: CaloLVL1_ID.h:710
eta
Scalar eta() const
pseudorapidity method
Definition: AmgMatrixBasePlugin.h:83
Trk::ParametersT
Dummy class used to allow special convertors to be called for surfaces owned by a detector element.
Definition: EMErrorDetail.h:25
CaloTTDescriptor::eta_min
float eta_min() const
descriptor parameter: min value of abs(eta)
Definition: CaloTTDescriptor.h:148
CaloLVL1_ID::phi_max
int phi_max(const Identifier regId) const
min value of phi index (-999 == failure)
Definition: CaloLVL1_ID.cxx:495
initialize
void initialize()
Definition: run_EoverP.cxx:894
InDetAccessor::phi0
@ phi0
Definition: InDetAccessor.h:33
CaloTTDescrManager::calo_descriptors_size
calo_descr_size calo_descriptors_size(void) const
Total number of descriptors.
Definition: CaloTTDescrManager.cxx:81
CaloTriggerTowerService
Tool providing the mapping of the online and offline TriggerTower identifiers as well as the TT-cells...
Definition: CaloTriggerTowerService.h:50
CaloDetDescrElement
This class groups all DetDescr information related to a CaloCell. Provides a generic interface for al...
Definition: Calorimeter/CaloDetDescr/CaloDetDescr/CaloDetDescrElement.h:66
theta
Scalar theta() const
theta method
Definition: AmgMatrixBasePlugin.h:75
conifer::pow
constexpr int pow(int x)
Definition: conifer.h:20
xAOD::JetInput::Track
@ Track
Definition: JetContainerInfo.h:61
CaloDetDescrManager_Base::get_element
const CaloDetDescrElement * get_element(const Identifier &cellId) const
get element by its identifier
Definition: CaloDetDescrManager.cxx:159
CaloDetDescrElement::dr
float dr() const
cell dr
Definition: Calorimeter/CaloDetDescr/CaloDetDescr/CaloDetDescrElement.h:360
Trk::TrackParticleBase::trackSummary
const TrackSummary * trackSummary() const
accessor function for TrackSummary.
Definition: TrackParticleBase.h:247
skel.it
it
Definition: skel.GENtoEVGEN.py:396
CaloLVL1_ID::is_emec
bool is_emec(const Identifier id) const
Test wether given tower or layer is part of the EM end-cap.
Definition: CaloLVL1_ID.h:696
test_pyathena.pt
pt
Definition: test_pyathena.py:11
M_PI
#define M_PI
Definition: ActiveFraction.h:11
Trk::z0
@ z0
Definition: ParamDefs.h:64
CaloLVL1_ID::region
int region(const Identifier id) const
return region according to :
Definition: CaloLVL1_ID.h:647
SG::asStorable
DataObject * asStorable(T *pObject)
Definition: StorableConversions.h:158
CaloLVL1_ID::is_barrel_end
bool is_barrel_end(const Identifier id) const
Test wether given tower or layer is part of the EM barrel END.
Definition: CaloLVL1_ID.h:690
python.SystemOfUnits.TeV
int TeV
Definition: SystemOfUnits.py:158
vec
std::vector< size_t > vec
Definition: CombinationsGeneratorTest.cxx:12
read_hist_ntuple.t
t
Definition: read_hist_ntuple.py:5
drawFromPickle.cos
cos
Definition: drawFromPickle.py:36
MCP::ScaleSmearParam::r2
@ r2
drawFromPickle.exp
exp
Definition: drawFromPickle.py:36
AthMessaging::m_imsg
std::atomic< IMessageSvc * > m_imsg
MessageSvc pointer.
Definition: AthMessaging.h:135
DetDescrConverter::detStore
const ServiceHandle< StoreGateSvc > & detStore() const
Handle to DetectorStore.
Definition: DetDescrConverter.h:33
python.SystemOfUnits.ms
int ms
Definition: SystemOfUnits.py:132
IDTPM::nPixelHits
float nPixelHits(const U &p)
Definition: TrackParametersHelper.h:326
Athena::getMessageSvc
IMessageSvc * getMessageSvc(bool quiet=false)
Definition: getMessageSvc.cxx:20
CaloTTDescrRegion::set_spherical
void set_spherical(double eta, double phi, double rho)
set coordinates of the Det Descr region – pseudo spherical system; eta is signed, rho is unsigned
Definition: CaloTTDescrRegion.cxx:28
PUfitVar::maxEta
constexpr float maxEta
Definition: GepMETPufitAlg.cxx:13
Trk::numberOfBLayerHits
@ numberOfBLayerHits
these are the hits in the 0th pixel layer?
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:51
CaloLVL1_ID::is_hec
bool is_hec(const Identifier id) const
Test wether given tower or layer is part of the HEC.
Definition: CaloLVL1_ID.h:703
Converter::phiCorr
double phiCorr(double phi)
Definition: Converter.h:248
CaloLVL1_ID::region_end
id_iterator region_end() const
end iterator over regions
Definition: CaloLVL1_ID.h:585
CaloDetDescrElement::dz
float dz() const
cell dz
Definition: Calorimeter/CaloDetDescr/CaloDetDescr/CaloDetDescrElement.h:379
CaloLVL1_ID::layer_id
Identifier layer_id(int pos_neg_z, int sampling, int region, int eta, int phi, int layer) const
build a layer identifier
Definition: CaloLVL1_ID.h:530
DetDescrConverter::m_detStore
ServiceHandle< StoreGateSvc > m_detStore
Definition: DetDescrConverter.h:42
ClassID_traits::ID
static const CLID & ID()
the CLID of T
Definition: Control/AthenaKernel/AthenaKernel/ClassID_traits.h:50
CaloTTMgrDetDescrCnv::storageType
static long storageType()
Definition: CaloTTMgrDetDescrCnv.cxx:288
TrigConf::MSGTC::Level
Level
Definition: Trigger/TrigConfiguration/TrigConfBase/TrigConfBase/MsgStream.h:21
AthMessaging::msgLvl
bool msgLvl(const MSG::Level lvl) const
Test the output level.
Definition: AthMessaging.h:151
CaloTTDescrManager::set_helper
void set_helper(const CaloLVL1_ID *id_helper)
set the helper used to decode the TT offline identifiers
Definition: CaloTTDescrManager.cxx:121
CaloLVL1_ID::region_begin
id_iterator region_begin() const
begin iterator over regions
Definition: CaloLVL1_ID.h:579
z
#define z
Converter::m_beamX
double m_beamX
Definition: Converter.h:320
Trk::numberOfSCTHits
@ numberOfSCTHits
number of SCT holes
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:71
ATH_MSG_DEBUG
#define ATH_MSG_DEBUG(x)
Definition: AthMsgStreamMacros.h:29
DetDescrConverter::DetDescrConverter
DetDescrConverter(const CLID &myCLID, ISvcLocator *svcloc, const char *name=nullptr)
Definition: DetDescrConverter.cxx:34
TauGNNUtils::Variables::Track::dPhi
bool dPhi(const xAOD::TauJet &tau, const xAOD::TauTrack &track, double &out)
Definition: TauGNNUtils.cxx:538
ClassID_traits
Default, invalid implementation of ClassID_traits.
Definition: Control/AthenaKernel/AthenaKernel/ClassID_traits.h:40
Trk::TrackParticleBase::fitQuality
const FitQuality * fitQuality() const
accessor function for FitQuality.
Definition: TrackParticleBase.h:259
chi2
double chi2(TH1 *h0, TH1 *h1)
Definition: comparitor.cxx:522
CaloTTDescrRegion::set_cylindric_size
void set_cylindric_size(double deta, double dphi, double dz)
set size of the Det Descr region – pseudo cylindrical system; eta is signed, z as well (same sign)
Definition: CaloTTDescrRegion.cxx:86
TRT::Track::d0
@ d0
Definition: InnerDetector/InDetCalibEvent/TRT_CalibData/TRT_CalibData/TrackInfo.h:62
ATH_CHECK
#define ATH_CHECK
Definition: AthCheckMacros.h:40
CaloLVL1_ID::is_emb
bool is_emb(const Identifier id) const
Test wether given tower or layer is part of the EM barrel.
Definition: CaloLVL1_ID.h:684
drawFromPickle.tan
tan
Definition: drawFromPickle.py:36
Trk::FitQuality
Class to represent and store fit qualities from track reconstruction in terms of and number of degre...
Definition: FitQuality.h:97
TRT::Track::z0
@ z0
Definition: InnerDetector/InDetCalibEvent/TRT_CalibData/TRT_CalibData/TrackInfo.h:63
CaloTTDescriptor::deta
float deta() const
descriptor parameter: eta granularity
Definition: CaloTTDescriptor.h:164
AthMessaging::msg
MsgStream & msg() const
The standard message stream.
Definition: AthMessaging.h:164
Converter::addTrack
void addTrack(TIDA::Track *t)
Definition: Converter.h:45
Trk::numberOfTRTHits
@ numberOfTRTHits
number of TRT outliers
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:79
CaloLVL1_ID
Helper class for offline TT identifiers.
Definition: CaloLVL1_ID.h:66
CaloTTDescrRegion::set_cylindric
void set_cylindric(double eta, double phi, double z)
set coordinates of the Det Descr region – pseudo cylindrical system; eta is signed,...
Definition: CaloTTDescrRegion.cxx:70
Trk::TrackSummary
A summary of the information contained by a track.
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:287
Trk::d0
@ d0
Definition: ParamDefs.h:63
CaloTTDescriptor::nPhi
short nPhi() const
descriptor parameter: number of phi bins
Definition: CaloTTDescriptor.h:176
CaloTTDescrRegion::set_spherical_size
void set_spherical_size(double deta, double dphi, double drho)
set size of the Det Descr region – pseudo spherical system; eta is signed, rho is unsigned
Definition: CaloTTDescrRegion.cxx:44
xAOD::EgammaHelpers::isFCAL
bool isFCAL(const xAOD::CaloCluster *cluster)
return true if the cluster (or the majority of its energy) is in the FCAL0
Definition: EgammaxAODHelpers.cxx:46
CaloTTDescriptor::sign_eta
int sign_eta() const
descriptor parameter: sign of eta (+-1)
Definition: CaloTTDescriptor.h:144
CaloDetDescrElement::z_raw
float z_raw() const
cell z_raw
Definition: Calorimeter/CaloDetDescr/CaloDetDescr/CaloDetDescrElement.h:373
Rec::TrackParticle
Definition: Reconstruction/Particle/Particle/TrackParticle.h:47
CaloTTDescriptor::set
void set(const Identifier &id)
set internal data member m_id (which is unused.
Definition: CaloTTDescriptor.h:131
Rec::TrackParticle::measuredPerigee
const Trk::Perigee * measuredPerigee() const
Accessor method for Perigee.
Definition: Reconstruction/Particle/Particle/TrackParticle.h:180
Trk::iPhi
@ iPhi
Definition: ParamDefs.h:47
CaloLVL1_ID::pos_neg_z
int pos_neg_z(const Identifier id) const
return pos_neg_z according to :
Definition: CaloLVL1_ID.h:635
CaloDetDescrElement::r_raw
float r_raw() const
cell r_raw
Definition: Calorimeter/CaloDetDescr/CaloDetDescr/CaloDetDescrElement.h:354
DataVector::end
const_iterator end() const noexcept
Return a const_iterator pointing past the end of the collection.
SG::ReadCondHandleKey< CaloDetDescrManager >
CaloTTDescrManager::add
void add(CaloTTDescrRegion *region)
Insertion in the vector of Det Descr regions (== Trigger Towers)
Definition: CaloTTDescrManager.cxx:107
Trk::DetectorType
DetectorType
enumerates the various detector types currently accessible from the isHit() method.
Definition: Tracking/TrkEvent/TrkTrackSummary/TrkTrackSummary/TrackSummary.h:231
CaloDetDescrManager
This class provides the client interface for accessing the detector description information common to...
Definition: CaloDetDescrManager.h:473
AtlasDetectorID::show_to_string
std::string show_to_string(Identifier id, const IdContext *context=0, char sep='.') const
or provide the printout in string form
Definition: AtlasDetectorID.cxx:574
AthMessaging::m_nm
std::string m_nm
Message source name.
Definition: AthMessaging.h:129
DEBUG
#define DEBUG
Definition: page_access.h:11
TIDA::Track
Definition: Trigger/TrigAnalysis/TrigInDetAnalysis/TrigInDetAnalysis/Track.h:26
CaloTTDescrRegion
This class provides an interface to the geometrical description of the Calorimeter Trigger Towers.
Definition: CaloTTDescrRegion.h:48
Trk::FitQuality::chiSquared
double chiSquared() const
returns the of the overall track fit
Definition: FitQuality.h:56
CaloTTDescriptor::dphi
float dphi() const
descriptor parameter: phi granularity
Definition: CaloTTDescriptor.h:168
CaloTTDescrManager
This class is used to build the CaloTTDescriptors and CaloTTDetDescrRegions carrying the geometry inf...
Definition: CaloTTDescrManager.h:70
Trk::FitQuality::numberDoF
int numberDoF() const
returns the number of degrees of freedom of the overall track or vertex fit as integer
Definition: FitQuality.h:60
AthMessaging::initMessaging
void initMessaging() const
Initialize our message level and MessageSvc.
Definition: AthMessaging.cxx:39
drawFromPickle.sin
sin
Definition: drawFromPickle.py:36
CaloTTDescrManager::initialize
void initialize(void)
dummy.
Definition: CaloTTDescrManager.cxx:94
MCP::ScaleSmearParam::r1
@ r1
AthMessaging::m_msg_tls
boost::thread_specific_ptr< MsgStream > m_msg_tls
MsgStream instance (a std::cout like with print-out levels)
Definition: AthMessaging.h:132
CaloTTDescriptor
This class holds the Calorimeter TriggerTower geometrical description
Definition: CaloTTDescriptor.h:30
TauGNNUtils::Variables::Track::dEta
bool dEta(const xAOD::TauJet &tau, const xAOD::TauTrack &track, double &out)
Definition: TauGNNUtils.cxx:527
CaloLVL1_ID::tower_id
Identifier tower_id(int pos_neg_z, int sampling, int region, int eta, int phi) const
build a tower identifier
Definition: CaloLVL1_ID.h:429
xAOD::iEta
setScale setgFexType iEta
Definition: gFexJetRoI_v1.cxx:74
CaloLVL1_ID::is_tile
bool is_tile(const Identifier id) const
Test wether given tower or layer is part of the Tile Calorimeter.
Definition: CaloLVL1_ID.h:672
Converter::m_tracks
std::vector< TIDA::Track * > m_tracks
Definition: Converter.h:321
CaloTTDescriptor::nEta
short nEta() const
descriptor parameter: number of eta bins
Definition: CaloTTDescriptor.h:172
Trk::phi0
@ phi0
Definition: ParamDefs.h:65
CaloTTDescriptor::nLay
short nLay() const
descriptor parameter: number of layers
Definition: CaloTTDescriptor.h:180
fitman.rho
rho
Definition: fitman.py:532
IDTPM::nSiHits
float nSiHits(const U &p)
Definition: TrackParametersHelper.h:399
python.trfValidateRootFile.rc
rc
Definition: trfValidateRootFile.py:349
DataVector::begin
const_iterator begin() const noexcept
Return a const_iterator pointing at the beginning of the collection.
python.LArCondContChannels.posNeg
posNeg
Definition: LArCondContChannels.py:659
Identifier
Definition: IdentifierFieldParser.cxx:14
SCT_Monitoring::summary
@ summary
Definition: SCT_MonitoringNumbers.h:65