#include <EcalBarrelGeometry.h>
Definition at line 17 of file EcalBarrelGeometry.h.
Definition at line 28 of file EcalBarrelGeometry.h.
Definition at line 29 of file EcalBarrelGeometry.h.
Reimplemented from CaloSubdetectorGeometry.
Definition at line 23 of file EcalBarrelGeometry.h.
typedef std::vector<TruncatedPyramid> EcalBarrelGeometry::CellVec |
Definition at line 21 of file EcalBarrelGeometry.h.
typedef EBDetId EcalBarrelGeometry::DetIdType |
Definition at line 38 of file EcalBarrelGeometry.h.
Definition at line 27 of file EcalBarrelGeometry.h.
Definition at line 36 of file EcalBarrelGeometry.h.
Definition at line 32 of file EcalBarrelGeometry.h.
Definition at line 30 of file EcalBarrelGeometry.h.
Definition at line 24 of file EcalBarrelGeometry.h.
Definition at line 25 of file EcalBarrelGeometry.h.
typedef std::vector<OrderedListOfEEDetId*> EcalBarrelGeometry::VecOrdListEEDetIdPtr |
Definition at line 34 of file EcalBarrelGeometry.h.
anonymous enum |
Definition at line 40 of file EcalBarrelGeometry.h.
anonymous enum |
Definition at line 42 of file EcalBarrelGeometry.h.
{ k_NumberOfShapes = 17 } ;
anonymous enum |
Definition at line 44 of file EcalBarrelGeometry.h.
{ k_NumberOfParametersPerShape = 11 } ;
EcalBarrelGeometry::EcalBarrelGeometry | ( | ) |
Definition at line 20 of file EcalBarrelGeometry.cc.
References _EtaBaskets.
: _nnxtalEta ( 85 ) , _nnxtalPhi ( 360 ) , _PhiBaskets ( 18 ) , m_borderMgr ( 0 ), m_borderPtrVec ( 0 ) , m_radius ( -1. ), m_cellVec ( k_NumberOfCellsForCorners ) { const int neba[] = {25,45,65,85} ; _EtaBaskets = std::vector<int>( &neba[0], &neba[3] ) ; }
EcalBarrelGeometry::~EcalBarrelGeometry | ( | ) | [virtual] |
Definition at line 34 of file EcalBarrelGeometry.cc.
References m_borderMgr, and m_borderPtrVec.
{ delete m_borderPtrVec ; delete m_borderMgr ; }
unsigned int EcalBarrelGeometry::alignmentTransformIndexGlobal | ( | const DetId & | id | ) | [static] |
Definition at line 60 of file EcalBarrelGeometry.cc.
References DetId::Ecal.
{ return (unsigned int)DetId::Ecal - 1 ; }
unsigned int EcalBarrelGeometry::alignmentTransformIndexLocal | ( | const DetId & | id | ) | [static] |
Definition at line 42 of file EcalBarrelGeometry.cc.
References getHLTprescales::index, CaloGenericDetId::isEB(), and ecalpyutils::ism().
{ const CaloGenericDetId gid ( id ) ; assert( gid.isEB() ) ; unsigned int index ( EBDetId(id).ism() - 1 ) ; return index ; }
CCGFloat EcalBarrelGeometry::avgRadiusXYFrontFaceCenter | ( | ) | const |
Definition at line 471 of file EcalBarrelGeometry.cc.
References cellGeomPtr(), CaloCellGeometry::getPosition(), i, m_cellVec, m_radius, and pos.
{ if( 0 > m_radius ) { CCGFloat sum ( 0 ) ; for( uint32_t i ( 0 ) ; i != m_cellVec.size() ; ++i ) { const CaloCellGeometry* cell ( cellGeomPtr(i) ) ; if( 0 != cell ) { const GlobalPoint& pos ( cell->getPosition() ) ; sum += pos.perp() ; } } m_radius = sum/m_cellVec.size() ; } return m_radius ; }
const CaloCellGeometry * EcalBarrelGeometry::cellGeomPtr | ( | uint32_t | index | ) | const [protected, virtual] |
Implements CaloSubdetectorGeometry.
Definition at line 491 of file EcalBarrelGeometry.cc.
References m_cellVec, and CaloCellGeometry::param().
Referenced by avgRadiusXYFrontFaceCenter().
{ const CaloCellGeometry* cell ( &m_cellVec[ index ] ) ; return ( m_cellVec.size() < index || 0 == cell->param() ? 0 : cell ) ; }
static std::string EcalBarrelGeometry::dbString | ( | ) | [inline, static] |
Definition at line 46 of file EcalBarrelGeometry.h.
{ return "PEcalBarrelRcd" ; }
DetId EcalBarrelGeometry::detIdFromLocalAlignmentIndex | ( | unsigned int | iLoc | ) | [static] |
Definition at line 54 of file EcalBarrelGeometry.cc.
References EBDetId::SMCRYSTALMODE.
Referenced by FakeCaloAlignmentEP::produceEBAli(), and TestCaloAlignmentEP::produceEBAli().
{ return EBDetId( iLoc + 1, 1, EBDetId::SMCRYSTALMODE ) ; }
int EcalBarrelGeometry::getBasketSizeInPhi | ( | ) | const [inline] |
Definition at line 61 of file EcalBarrelGeometry.h.
References _PhiBaskets.
Referenced by ClusterShapeAlgo::Calculate_BarrelBasketEnergyFraction().
{ return _PhiBaskets ; }
CaloSubdetectorGeometry::DetIdSet EcalBarrelGeometry::getCells | ( | const GlobalPoint & | r, |
double | dR | ||
) | const [virtual] |
Get a list of all cells within a dR of the given cell.
The default implementation makes a loop over all cell geometries. Cleverer implementations are suggested to use rough conversions between eta/phi and ieta/iphi and test on the boundaries.
Reimplemented from CaloSubdetectorGeometry.
Definition at line 293 of file EcalBarrelGeometry.cc.
References abs, Geom::deltaR2(), eta(), PV3DBase< T, PVType, FrameType >::eta(), CaloSubdetectorGeometry::getGeometry(), CaloCellGeometry::getPosition(), errorMatrix2Lands_multiChannel::id, M_PI, EBDetId::MAX_IETA, EBDetId::MAX_IPHI, convertSQLiteXML::ok, AlCaHLTBitMon_ParallelJobs::p, PV3DBase< T, PVType, FrameType >::phi(), phi, pileupReCalc_HLTpaths::scale, and PV3DBase< T, PVType, FrameType >::z().
{ static const int maxphi ( EBDetId::MAX_IPHI ) ; static const int maxeta ( EBDetId::MAX_IETA ) ; CaloSubdetectorGeometry::DetIdSet dis; // this is the return object if( 0.000001 < dR ) { if( dR > M_PI/2. ) // this version needs "small" dR { dis = CaloSubdetectorGeometry::getCells( r, dR ) ; // base class version } else { const double dR2 ( dR*dR ) ; const double reta ( r.eta() ) ; const double rz ( r.z() ) ; const double rphi ( r.phi() ) ; const double lowEta ( reta - dR ) ; const double highEta ( reta + dR ) ; if( highEta > -1.5 && lowEta < 1.5 ) // in barrel { const double scale ( maxphi/(2*M_PI) ) ; // angle to index const int ieta_center ( int( reta*scale + ((rz<0)?(-1):(1))) ) ; const double phi ( rphi<0 ? rphi + 2*M_PI : rphi ) ; const int iphi_center ( int( phi*scale + 11. ) ) ; // phi=-9.4deg is iphi=1 const double fr ( dR*scale ) ; // # crystal widths in dR const double frp ( 1.08*fr + 1. ) ; // conservatively above fr const double frm ( 0.92*fr - 1. ) ; // conservatively below fr const int idr ( (int)frp ) ; // integerize const int idr2p ( (int)(frp*frp) ) ; const int idr2m ( frm > 0 ? int(frm*frm) : 0 ) ; for( int de ( -idr ) ; de <= idr ; ++de ) // over eta limits { int ieta ( de + ieta_center ) ; if( std::abs(ieta) <= maxeta && ieta != 0 ) // eta is in EB { const int de2 ( de*de ) ; for( int dp ( -idr ) ; dp <= idr ; ++dp ) // over phi limits { const int irange2 ( dp*dp + de2 ) ; if( irange2 <= idr2p ) // cut off corners that must be too far away { const int iphi ( ( iphi_center + dp + maxphi - 1 )%maxphi + 1 ) ; if( iphi != 0 ) { const EBDetId id ( ieta, iphi ) ; bool ok ( irange2 < idr2m ) ; // no more calculation necessary if inside this radius if( !ok ) // if not ok, then we have to test this cell for being inside cone { const CaloCellGeometry* cell ( getGeometry( id ) ); if( 0 != cell ) { const GlobalPoint& p ( cell->getPosition() ) ; const double eta ( p.eta() ) ; const double phi ( p.phi() ) ; ok = ( reco::deltaR2( eta, phi, reta, rphi ) < dR2 ) ; } } if( ok ) dis.insert( id ) ; } } } } } } } } return dis; }
DetId EcalBarrelGeometry::getClosestCell | ( | const GlobalPoint & | r | ) | const [virtual] |
Reimplemented from CaloSubdetectorGeometry.
Definition at line 66 of file EcalBarrelGeometry.cc.
References _nnxtalPhi, funct::A, newFWLiteAna::bin, funct::C, alignCSCRings::e, eta(), PV3DBase< T, PVType, FrameType >::eta(), EBDetId::ETAPHIMODE, CaloSubdetectorGeometry::getGeometry(), CaloCellGeometry::getPosition(), i, EBDetId::ieta(), EBDetId::iphi(), M_PI, EBDetId::MAX_IPHI, EBDetId::MIN_IPHI, PV3DBase< T, PVType, FrameType >::phi(), point, CaloSubdetectorGeometry::present(), errorMatrix2Lands_multiChannel::start, PV3DBase< T, PVType, FrameType >::x(), x, PV3DBase< T, PVType, FrameType >::y(), detailsBasic3DVector::y, PV3DBase< T, PVType, FrameType >::z(), and z.
Referenced by spr::chargeIsolationEcal(), CaloGeometryHelper::getClosestCell(), and spr::propagateCALO().
{ // z is the easy one int leverx = 1; int levery = 1; CCGFloat pointz = r.z(); int zbin=1; if(pointz<0) zbin=-1; // Now find the closest eta CCGFloat pointeta = r.eta(); // double eta; CCGFloat deta=999.; int etabin=1; int guessed_eta = (int)( fabs(pointeta) / 0.0174)+1; int guessed_eta_begin = guessed_eta-1; int guessed_eta_end = guessed_eta+1; if (guessed_eta_begin < 1) guessed_eta_begin = 1; if (guessed_eta_end > 85) guessed_eta_end = 85; for(int bin=guessed_eta_begin; bin<= guessed_eta_end; bin++) { try { if (!present(EBDetId(zbin*bin,1,EBDetId::ETAPHIMODE))) continue; CCGFloat eta = getGeometry(EBDetId(zbin*bin,1,EBDetId::ETAPHIMODE))->getPosition().eta(); if(fabs(pointeta-eta)<deta) { deta=fabs(pointeta-eta); etabin=bin; } else break; } catch ( cms::Exception &e ) { } } // Now the closest phi. always same number of phi bins(!?) const CCGFloat twopi = M_PI+M_PI; // 10 degree tilt const CCGFloat tilt=twopi/36.; CCGFloat pointphi = r.phi()+tilt; // put phi in correct range (0->2pi) if(pointphi > twopi) pointphi -= twopi; if(pointphi < 0) pointphi += twopi; //calculate phi bin, distinguish + and - eta int phibin = static_cast<int>(pointphi / (twopi/_nnxtalPhi)) + 1; // if(point.z()<0.0) // { // phibin = nxtalPhi/2 - 1 - phibin; // if(phibin<0) // phibin += nxtalPhi; // } try { EBDetId myCell(zbin*etabin,phibin,EBDetId::ETAPHIMODE); if (!present(myCell)) return DetId(0); Pt3D A; Pt3D B; Pt3D C; Pt3D point(r.x(),r.y(),r.z()); // D.K. : equation of plane : AA*x+BB*y+CC*z+DD=0; // finding equation for each edge // Since the point can lie between crystals, it is necessary to keep track of the movements // to avoid infinite loops std::vector<CCGFloat> history; history.resize(4,0.); // // stop movement in eta direction when closest cell was found (point between crystals) int start = 1; int counter = 0; // Moving until find closest crystal in eta and phi directions (leverx and levery) while (leverx==1 || levery == 1) { leverx = 0; levery = 0; const CaloCellGeometry::CornersVec& corners ( getGeometry(myCell)->getCorners() ) ; std::vector<CCGFloat> SS; // compute the distance of the point with respect of the 4 crystal lateral planes for (short i=0; i < 4 ; ++i) { A = Pt3D(corners[i%4].x(),corners[i%4].y(),corners[i%4].z()); B = Pt3D(corners[(i+1)%4].x(),corners[(i+1)%4].y(),corners[(i+1)%4].z()); C = Pt3D(corners[4+(i+1)%4].x(),corners[4+(i+1)%4].y(),corners[4+(i+1)%4].z()); Pl3D plane(A,B,C); plane.normalize(); CCGFloat distance = plane.distance(point); if(plane.d()>0.) distance=-distance; if (corners[0].z()<0.) distance=-distance; SS.push_back(distance); } // SS's - normals // check position of the point with respect to opposite side of crystal // if SS's have opposite sign, the point lies inside that crystal if ( ( SS[0]>0.&&SS[2]>0. )||( SS[0]<0.&&SS[2]<0. ) ) { levery = 1; if ( history[0]>0. && history[2]>0. && SS[0]<0 && SS[2]<0 && (fabs(SS[0])+fabs(SS[2]))> (fabs(history[0])+fabs(history[2]))) levery = 0 ; if ( history[0]<0. && history[2]<0. && SS[0]>0 && SS[2]>0 && (fabs(SS[0])+fabs(SS[2]))> (fabs(history[0])+fabs(history[2]))) levery = 0 ; if (SS[0]>0. ) { EBDetId nextPoint; if (myCell.iphi()==EBDetId::MIN_IPHI) nextPoint=EBDetId(myCell.ieta(),EBDetId::MAX_IPHI); else nextPoint=EBDetId(myCell.ieta(),myCell.iphi()-1); if (present(nextPoint)) myCell=nextPoint; else levery=0; } else { EBDetId nextPoint; if (myCell.iphi()==EBDetId::MAX_IPHI) nextPoint=EBDetId(myCell.ieta(),EBDetId::MIN_IPHI); else nextPoint=EBDetId(myCell.ieta(),myCell.iphi()+1); if (present(nextPoint)) myCell=nextPoint; else levery=0; } } if ( ( ( SS[1]>0.&&SS[3]>0. )||( SS[1]<0.&&SS[3]<0. )) && start==1 ) { leverx = 1; if ( history[1]>0. && history[3]>0. && SS[1]<0 && SS[3]<0 && (fabs(SS[1])+fabs(SS[3]))> (fabs(history[1])+fabs(history[3])) ) { leverx = 0; start = 0; } if ( history[1]<0. && history[3]<0. && SS[1]>0 && SS[3]>0 && (fabs(SS[1])+fabs(SS[3]))> (fabs(history[1])+fabs(history[3])) ) { leverx = 0; start = 0; } if (SS[1]>0.) { EBDetId nextPoint; if (myCell.ieta()==-1) nextPoint=EBDetId (1,myCell.iphi()); else { int nieta= myCell.ieta()+1; if(nieta==86) nieta=85; nextPoint=EBDetId(nieta,myCell.iphi()); } if (present(nextPoint)) myCell = nextPoint; else leverx = 0; } else { EBDetId nextPoint; if (myCell.ieta()==1) nextPoint=EBDetId(-1,myCell.iphi()); else { int nieta=myCell.ieta()-1; if(nieta==-86) nieta=-85; nextPoint=EBDetId(nieta,myCell.iphi()); } if (present(nextPoint)) myCell = nextPoint; else leverx = 0; } } // Update the history. If the point lies between crystals, the closest one // is returned history =SS; counter++; if (counter == 10) { leverx=0; levery=0; } } // D.K. if point lies netween cells, take a closest cell. return DetId(myCell); } catch ( cms::Exception &e ) { return DetId(0); } }
const EcalBarrelGeometry::OrderedListOfEEDetId * EcalBarrelGeometry::getClosestEndcapCells | ( | EBDetId | id | ) | const |
Definition at line 376 of file EcalBarrelGeometry.cc.
References i, EEDetId::idOuterRing(), EEDetId::iquadrant(), EEDetId::ix(), EEDetId::iy(), gen::k, m_borderMgr, m_borderPtrVec, and EEDetId::validDetId().
Referenced by spr::simpleMove(), and PFRecHitProducerECAL::stdsimplemove().
{ OrderedListOfEEDetId* ptr ( 0 ) ; if( 0 != id.rawId() ) { const int iPhi ( id.iphi() ) ; const int iz ( id.ieta()>0 ? 1 : -1 ) ; const EEDetId eeid ( EEDetId::idOuterRing( iPhi, iz ) ) ; // const int ix ( eeid.ix() ) ; // const int iy ( eeid.iy() ) ; const int iq ( eeid.iquadrant() ) ; const int xout ( 1==iq || 4==iq ? 1 : -1 ) ; const int yout ( 1==iq || 2==iq ? 1 : -1 ) ; if( 0 == m_borderMgr ) { m_borderMgr = new EZMgrFL<EEDetId>( 720*9, 9 ) ; } if( 0 == m_borderPtrVec ) { m_borderPtrVec = new VecOrdListEEDetIdPtr() ; m_borderPtrVec->reserve( 720 ) ; for( unsigned int i ( 0 ) ; i != 720 ; ++i ) { const int kz ( 360>i ? -1 : 1 ) ; const EEDetId eeid ( EEDetId::idOuterRing( i%360+1, kz ) ) ; const int jx ( eeid.ix() ) ; const int jy ( eeid.iy() ) ; OrderedListOfEEDetId& olist ( *new OrderedListOfEEDetId( m_borderMgr ) ); int il ( 0 ) ; for( unsigned int k ( 1 ) ; k <= 25 ; ++k ) { const int kx ( 1==k || 2==k || 3==k || 12==k || 13==k ? 0 : ( 4==k || 6==k || 8==k || 15==k || 20==k ? 1 : ( 5==k || 7==k || 9==k || 16==k || 19==k ? -1 : ( 10==k || 14==k || 21==k || 22==k || 25==k ? 2 : -2 )))) ; const int ky ( 1==k || 4==k || 5==k || 10==k || 11==k ? 0 : ( 2==k || 6==k || 7==k || 14==k || 17==k ? 1 : ( 3==k || 8==k || 9==k || 18==k || 21==k ? -1 : ( 12==k || 15==k || 16==k || 22==k || 23==k ? 2 : -2 )))) ; if( 8>=il && EEDetId::validDetId( jx + kx*xout , jy + ky*yout , kz ) ) { olist[il++]=EEDetId( jx + kx*xout , jy + ky*yout , kz ) ; } } m_borderPtrVec->push_back( &olist ) ; } } ptr = (*m_borderPtrVec)[ iPhi - 1 + ( 0>iz ? 0 : 360 ) ] ; } return ptr ; }
const std::vector<int>& EcalBarrelGeometry::getEtaBaskets | ( | ) | const [inline] |
Definition at line 59 of file EcalBarrelGeometry.h.
References _EtaBaskets.
Referenced by ClusterShapeAlgo::Calculate_BarrelBasketEnergyFraction().
{ return _EtaBaskets ; }
int EcalBarrelGeometry::getNumXtalsEtaDirection | ( | ) | const [inline] |
int EcalBarrelGeometry::getNumXtalsPhiDirection | ( | ) | const [inline] |
static std::string EcalBarrelGeometry::hitString | ( | ) | [inline, static] |
Definition at line 81 of file EcalBarrelGeometry.h.
{ return "EcalHitsEB" ; }
void EcalBarrelGeometry::localCorners | ( | Pt3DVec & | lc, |
const CCGFloat * | pv, | ||
unsigned int | i, | ||
Pt3D & | ref | ||
) | [static] |
Definition at line 438 of file EcalBarrelGeometry.cc.
References EBDetId::kSizeForDenseIndexing, TruncatedPyramid::localCornersReflection(), and TruncatedPyramid::localCornersSwap().
{ const bool negz ( EBDetId::kSizeForDenseIndexing/2 > i ) ; const bool odd ( 1 == i%2 ) ; if( ( ( negz && !odd ) || ( !negz && odd ) ) ) { TruncatedPyramid::localCornersReflection( lc, pv, ref ) ; } else { TruncatedPyramid::localCornersSwap( lc, pv, ref ) ; } }
void EcalBarrelGeometry::newCell | ( | const GlobalPoint & | f1, |
const GlobalPoint & | f2, | ||
const GlobalPoint & | f3, | ||
const CCGFloat * | parm, | ||
const DetId & | detId | ||
) | [virtual] |
Implements CaloSubdetectorGeometry.
Definition at line 458 of file EcalBarrelGeometry.cc.
References CaloSubdetectorGeometry::cornersMgr(), m_cellVec, and CaloSubdetectorGeometry::m_validIds.
{ const unsigned int cellIndex ( EBDetId( detId ).denseIndex() ) ; m_cellVec[ cellIndex ] = TruncatedPyramid( cornersMgr(), f1, f2, f3, parm ) ; m_validIds.push_back( detId ) ; }
static unsigned int EcalBarrelGeometry::numberOfAlignments | ( | ) | [inline, static] |
Definition at line 85 of file EcalBarrelGeometry.h.
Referenced by FakeCaloAlignmentEP::produceEBAli(), and TestCaloAlignmentEP::produceEBAli().
{ return 36 ; }
virtual unsigned int EcalBarrelGeometry::numberOfParametersPerShape | ( | ) | const [inline, virtual] |
Reimplemented from CaloSubdetectorGeometry.
Definition at line 49 of file EcalBarrelGeometry.h.
References k_NumberOfParametersPerShape.
{ return k_NumberOfParametersPerShape ; }
virtual unsigned int EcalBarrelGeometry::numberOfShapes | ( | ) | const [inline, virtual] |
Reimplemented from CaloSubdetectorGeometry.
Definition at line 48 of file EcalBarrelGeometry.h.
References k_NumberOfShapes.
{ return k_NumberOfShapes ; }
static std::string EcalBarrelGeometry::producerTag | ( | ) | [inline, static] |
Definition at line 83 of file EcalBarrelGeometry.h.
Referenced by PCaloGeometryBuilder::beginRun(), and CaloGeometryBuilder::produceAligned().
{ return "EcalBarrel" ; }
void EcalBarrelGeometry::setBasketSizeInPhi | ( | const int & | PhiBaskets | ) | [inline] |
Definition at line 69 of file EcalBarrelGeometry.h.
References _PhiBaskets.
{ _PhiBaskets=PhiBaskets ; }
void EcalBarrelGeometry::setEtaBaskets | ( | const std::vector< int > & | EtaBaskets | ) | [inline] |
Definition at line 67 of file EcalBarrelGeometry.h.
References _EtaBaskets.
{ _EtaBaskets=EtaBaskets ; }
void EcalBarrelGeometry::setNumXtalsEtaDirection | ( | const int & | nnxtalEta | ) | [inline] |
Definition at line 65 of file EcalBarrelGeometry.h.
References _nnxtalEta.
{ _nnxtalEta=nnxtalEta ; }
void EcalBarrelGeometry::setNumXtalsPhiDirection | ( | const int & | nnxtalPhi | ) | [inline] |
Definition at line 63 of file EcalBarrelGeometry.h.
References _nnxtalPhi.
{ _nnxtalPhi=nnxtalPhi ; }
std::vector<int> EcalBarrelGeometry::_EtaBaskets [private] |
size of the baskets in the eta direction. This is needed to find out whether two adjacent crystals lie in the same basked ('module') or not (e.g. this can be used for correcting cluster energies etc.)
Definition at line 119 of file EcalBarrelGeometry.h.
Referenced by EcalBarrelGeometry(), getEtaBaskets(), and setEtaBaskets().
int EcalBarrelGeometry::_nnxtalEta [private] |
number of crystals in eta direction
Definition at line 110 of file EcalBarrelGeometry.h.
Referenced by getNumXtalsEtaDirection(), and setNumXtalsEtaDirection().
int EcalBarrelGeometry::_nnxtalPhi [private] |
number of crystals in phi direction
Definition at line 113 of file EcalBarrelGeometry.h.
Referenced by getClosestCell(), getNumXtalsPhiDirection(), and setNumXtalsPhiDirection().
int EcalBarrelGeometry::_PhiBaskets [private] |
size of one basket in phi
Definition at line 122 of file EcalBarrelGeometry.h.
Referenced by getBasketSizeInPhi(), and setBasketSizeInPhi().
EZMgrFL<EEDetId>* EcalBarrelGeometry::m_borderMgr [mutable, private] |
Definition at line 124 of file EcalBarrelGeometry.h.
Referenced by getClosestEndcapCells(), and ~EcalBarrelGeometry().
VecOrdListEEDetIdPtr* EcalBarrelGeometry::m_borderPtrVec [mutable, private] |
Definition at line 126 of file EcalBarrelGeometry.h.
Referenced by getClosestEndcapCells(), and ~EcalBarrelGeometry().
CellVec EcalBarrelGeometry::m_cellVec [private] |
Definition at line 130 of file EcalBarrelGeometry.h.
Referenced by avgRadiusXYFrontFaceCenter(), cellGeomPtr(), and newCell().
CCGFloat EcalBarrelGeometry::m_radius [mutable, private] |
Definition at line 128 of file EcalBarrelGeometry.h.
Referenced by avgRadiusXYFrontFaceCenter().