CMS 3D CMS Logo

Classes | Functions | Variables
phase1PixelTopology Namespace Reference

Classes

struct  AverageGeometry
 

Functions

constexpr uint16_t divu52 (uint16_t n)
 
constexpr uint8_t findLayer (uint32_t detId)
 
constexpr uint8_t findLayerFromCompact (uint32_t detId)
 
constexpr uint32_t findMaxModuleStride ()
 
constexpr bool isBigPixX (uint16_t px)
 
constexpr bool isBigPixY (uint16_t py)
 
constexpr bool isEdgeX (uint16_t px)
 
constexpr bool isEdgeY (uint16_t py)
 
constexpr uint16_t localX (uint16_t px)
 
constexpr uint16_t localY (uint16_t py)
 
template<int N, class Function >
constexpr auto map_to_array (Function f) -> std::array< typename std::result_of< Function(std::size_t)>::type, N >
 
template<class Function , std::size_t... Indices>
constexpr auto map_to_array_helper (Function f, std::index_sequence< Indices... >) -> std::array< typename std::result_of< Function(std::size_t)>::type, sizeof...(Indices)>
 
constexpr uint16_t toRocX (uint16_t px)
 
constexpr uint16_t toRocY (uint16_t py)
 
constexpr bool validateLayerIndex ()
 

Variables

constexpr uint16_t lastColInModule = numColsInModule - 1
 
constexpr uint16_t lastColInRoc = numColsInRoc - 1
 
constexpr uint16_t lastRowInModule = numRowsInModule - 1
 
constexpr uint16_t lastRowInRoc = numRowsInRoc - 1
 
constexpr std::array< uint8_t, layerIndexSizelayer = map_to_array<layerIndexSize>(findLayerFromCompact)
 
constexpr uint32_t layerIndexSize = numberOfModules / maxModuleStride
 
constexpr char const * layerName [numberOfLayers]
 
constexpr uint32_t layerStart [numberOfLayers+1]
 
constexpr uint32_t maxModuleStride = findMaxModuleStride()
 
constexpr uint32_t numberOfLaddersInBarrel = numberOfModulesInBarrel / 8
 
constexpr uint32_t numberOfLayers = 10
 
constexpr uint32_t numberOfModules = 1856
 
constexpr uint32_t numberOfModulesInBarrel = 1184
 
constexpr uint16_t numColsInModule = 8 * numColsInRoc
 
constexpr uint16_t numColsInRoc = 52
 
constexpr uint32_t numPixsInModule = uint32_t(numRowsInModule) * uint32_t(numColsInModule)
 
constexpr uint16_t numRowsInModule = 2 * numRowsInRoc
 
constexpr uint16_t numRowsInRoc = 80
 
constexpr int16_t xOffset = -81
 
constexpr int16_t yOffset = -54 * 4
 

Function Documentation

◆ divu52()

constexpr uint16_t phase1PixelTopology::divu52 ( uint16_t  n)
inlineconstexpr

Definition at line 115 of file phase1PixelTopology.h.

115  {
116  n = n >> 2;
117  uint16_t q = (n >> 1) + (n >> 4);
118  q = q + (q >> 4) + (q >> 5);
119  q = q >> 3;
120  uint16_t r = n - q * 13;
121  return q + ((r + 3) >> 4);
122  }

References dqmiodumpmetadata::n, submitPVResolutionJobs::q, and alignCSCRings::r.

Referenced by localY(), and toRocY().

◆ findLayer()

constexpr uint8_t phase1PixelTopology::findLayer ( uint32_t  detId)
constexpr

Definition at line 83 of file phase1PixelTopology.h.

83  {
84  for (uint8_t i = 0; i < std::size(layerStart); ++i)
85  if (detId < layerStart[i + 1])
86  return i;
87  return std::size(layerStart);
88  }

References mps_fire::i, layerStart, and findQualityFiles::size.

◆ findLayerFromCompact()

constexpr uint8_t phase1PixelTopology::findLayerFromCompact ( uint32_t  detId)
constexpr

Definition at line 90 of file phase1PixelTopology.h.

90  {
91  detId *= maxModuleStride;
92  for (uint8_t i = 0; i < std::size(layerStart); ++i)
93  if (detId < layerStart[i + 1])
94  return i;
95  return std::size(layerStart);
96  }

References mps_fire::i, layerStart, maxModuleStride, and findQualityFiles::size.

◆ findMaxModuleStride()

constexpr uint32_t phase1PixelTopology::findMaxModuleStride ( )
constexpr

Definition at line 64 of file phase1PixelTopology.h.

64  {
65  bool go = true;
66  int n = 2;
67  while (go) {
68  for (uint8_t i = 1; i < std::size(layerStart); ++i) {
69  if (layerStart[i] % n != 0) {
70  go = false;
71  break;
72  }
73  }
74  if (!go)
75  break;
76  n *= 2;
77  }
78  return n / 2;
79  }

References mps_fire::i, layerStart, dqmiodumpmetadata::n, and findQualityFiles::size.

◆ isBigPixX()

constexpr bool phase1PixelTopology::isBigPixX ( uint16_t  px)
inlineconstexpr

Definition at line 135 of file phase1PixelTopology.h.

135 { return (px == 79) | (px == 80); }

References multPhiCorr_741_25nsDY_cfi::px.

Referenced by pixelCPEforGPU::errorFromDB(), pixelCPEforGPU::errorFromSize(), and pixelCPEforGPU::position().

◆ isBigPixY()

constexpr bool phase1PixelTopology::isBigPixY ( uint16_t  py)
inlineconstexpr

Definition at line 137 of file phase1PixelTopology.h.

137  {
138  auto ly = toRocY(py);
139  return (ly == 0) | (ly == lastColInRoc);
140  }

References lastColInRoc, multPhiCorr_741_25nsDY_cfi::py, and toRocY().

Referenced by pixelCPEforGPU::errorFromDB(), pixelCPEforGPU::errorFromSize(), and pixelCPEforGPU::position().

◆ isEdgeX()

constexpr bool phase1PixelTopology::isEdgeX ( uint16_t  px)
inlineconstexpr

Definition at line 124 of file phase1PixelTopology.h.

124 { return (px == 0) | (px == lastRowInModule); }

References lastRowInModule, and multPhiCorr_741_25nsDY_cfi::px.

Referenced by pixelCPEforGPU::errorFromDB(), and pixelCPEforGPU::errorFromSize().

◆ isEdgeY()

constexpr bool phase1PixelTopology::isEdgeY ( uint16_t  py)
inlineconstexpr

Definition at line 126 of file phase1PixelTopology.h.

126 { return (py == 0) | (py == lastColInModule); }

References lastColInModule, and multPhiCorr_741_25nsDY_cfi::py.

Referenced by pixelCPEforGPU::errorFromDB(), and pixelCPEforGPU::errorFromSize().

◆ localX()

constexpr uint16_t phase1PixelTopology::localX ( uint16_t  px)
inlineconstexpr

◆ localY()

constexpr uint16_t phase1PixelTopology::localY ( uint16_t  py)
inlineconstexpr

◆ map_to_array()

template<int N, class Function >
constexpr auto phase1PixelTopology::map_to_array ( Function  f) -> std::array<typename std::result_of<Function(std::size_t)>::type, N>
constexpr

Definition at line 60 of file phase1PixelTopology.h.

60  {
61  return map_to_array_helper(f, std::make_index_sequence<N>{});
62  }

References f, and map_to_array_helper().

◆ map_to_array_helper()

template<class Function , std::size_t... Indices>
constexpr auto phase1PixelTopology::map_to_array_helper ( Function  f,
std::index_sequence< Indices... >   
) -> std::array<typename std::result_of<Function(std::size_t)>::type, sizeof...(Indices)>
constexpr

Definition at line 54 of file phase1PixelTopology.h.

55  {
56  return {{f(Indices)...}};
57  }

References f.

Referenced by map_to_array().

◆ toRocX()

constexpr uint16_t phase1PixelTopology::toRocX ( uint16_t  px)
inlineconstexpr

Definition at line 128 of file phase1PixelTopology.h.

128 { return (px < numRowsInRoc) ? px : px - numRowsInRoc; }

References numRowsInRoc, and multPhiCorr_741_25nsDY_cfi::px.

◆ toRocY()

constexpr uint16_t phase1PixelTopology::toRocY ( uint16_t  py)
inlineconstexpr

Definition at line 130 of file phase1PixelTopology.h.

130  {
131  auto roc = divu52(py);
132  return py - 52 * roc;
133  }

References divu52(), multPhiCorr_741_25nsDY_cfi::py, and PixelMapPlotter::roc.

Referenced by isBigPixY().

◆ validateLayerIndex()

constexpr bool phase1PixelTopology::validateLayerIndex ( )
constexpr

Definition at line 101 of file phase1PixelTopology.h.

101  {
102  bool res = true;
103  for (auto i = 0U; i < numberOfModules; ++i) {
104  auto j = i / maxModuleStride;
105  res &= (layer[j] < 10);
106  res &= (i >= layerStart[layer[j]]);
107  res &= (i < layerStart[layer[j] + 1]);
108  }
109  return res;
110  }

References mps_fire::i, dqmiolumiharvest::j, layer, layerStart, maxModuleStride, numberOfModules, and mitigatedMETSequence_cff::U.

Variable Documentation

◆ lastColInModule

constexpr uint16_t phase1PixelTopology::lastColInModule = numColsInModule - 1
constexpr

Definition at line 17 of file phase1PixelTopology.h.

Referenced by isEdgeY(), and pixelCPEforGPU::position().

◆ lastColInRoc

constexpr uint16_t phase1PixelTopology::lastColInRoc = numColsInRoc - 1
constexpr

Definition at line 12 of file phase1PixelTopology.h.

Referenced by isBigPixY().

◆ lastRowInModule

constexpr uint16_t phase1PixelTopology::lastRowInModule = numRowsInModule - 1
constexpr

Definition at line 16 of file phase1PixelTopology.h.

Referenced by isEdgeX(), and pixelCPEforGPU::position().

◆ lastRowInRoc

constexpr uint16_t phase1PixelTopology::lastRowInRoc = numRowsInRoc - 1
constexpr

Definition at line 11 of file phase1PixelTopology.h.

Referenced by localX().

◆ layer

constexpr std::array<uint8_t, layerIndexSize> phase1PixelTopology::layer = map_to_array<layerIndexSize>(findLayerFromCompact)
constexpr

Definition at line 99 of file phase1PixelTopology.h.

Referenced by CSCCFEBData::adcCounts(), CSCCFEBData::adcOverflow(), CSCAnodeData::add(), CSCCFEBData::add(), CSCAnodeData2007::add(), CSCComparatorData::add(), SiStripDetSummary::add(), CSCAnodeData2006::add(), TkHistoMap::add(), LayerHitMapCache::add(), CSCEventData::add(), GEMClusterProcessor::addCoincidenceClusters(), FWRecoGeometryESProducer::addCSCGeometry(), FWTGeoRecoGeometryESProducer::addCSCGeometry(), FWRecoGeometryESProducer::addDTGeometry(), FWTGeoRecoGeometryESProducer::addDTGeometry(), RPCWheelMap::addHit(), PreshowerHitMaker::addHit(), HcalHitMaker::addHit(), CSCAnodeData2006::addHit(), CSCSegAlgoTC::addHit(), CSCSegAlgoSK::addHit(), CSCSegAlgoRU::addHit(), trklet::TrackletCalculatorDisplaced::addLayerProj(), trklet::TrackletCalculatorBase::addLayerProj(), FWTGeoRecoGeometryESProducer::addPixelBarrelGeometry(), trklet::TrackletCalculatorDisplaced::addProjection(), trklet::TrackletCalculatorBase::addProjection(), fastsim::ParticleManager::addSecondaries(), GEMClusterProcessor::addSingleClusters(), IntermediateHitTriplets::RegionFiller::addTriplets(), CSCChamberMasker::ageDigis(), SiStripHitEffFromCalibTree::algoAnalyze(), algorithm(), ME0HitsValidation::analyze(), ME0RecHitsValidation::analyze(), CSCRecHit2DValidation::analyze(), CSCSegmentValidation::analyze(), ME0DigisValidation::analyze(), ME0SegmentsValidation::analyze(), CSCWireDigiValidation::analyze(), CSCComparatorDigiValidation::analyze(), CSCStripDigiValidation::analyze(), CSCAFEBThrAnalysis::analyze(), DTTPAnalyzer::analyze(), SiPixelDigiValid::analyze(), OuterTrackerMonitorTrackingParticles::analyze(), GEMEfficiencyAnalyzer::analyze(), SiPixelDigiSource::analyze(), DTTTrigCalibration::analyze(), CSCRecoBadChannelsAnalyzer::analyze(), DTEfficiencyTask::analyze(), PFCheckHitPattern::analyze(), HGCGeometryValidation::analyze(), DTResolutionAnalysisTask::analyze(), SiPixelHitEfficiencySource::analyze(), HGCalRecHitValidation::analyze(), GlobalDigisHistogrammer::analyze(), HGCalDigiValidation::analyze(), DTDigiReader::analyze(), PixelLumiDQM::analyze(), PixelBaryCentreAnalyzer::analyze(), PrimaryVertexValidation::analyze(), DTDigiTask::analyze(), OverlapValidation::analyze(), L1TrackObjectNtupleMaker::analyze(), L1MuonRecoTreeProducer::analyze(), PFAnalysis::analyze(), HGCalHitValidation::analyzeHGCalSimHit(), HGCalSimHitStudy::analyzeHits(), HGCalSimHitValidation::analyzeHits(), HcalHitValidation::analyzeLayer(), SiStripBadAPVandHotStripAlgorithmFromClusterOccupancy::AnalyzeOccupancy(), HGCalTBAnalyzer::analyzeRecHits(), HGCalTimingAnalyzer::analyzeSimHits(), HGCalTBAnalyzer::analyzeSimHits(), reco::HitPattern::appendTrackerHit(), reco::TrackBase::appendTrackerHitPattern(), HGCNumberingScheme::assignCell(), HGCalDDDConstants::assignCellTrap(), TrackerOfflineValidationSummary::associateModuleHistsWithTree(), PixelInactiveAreaFinder::badAdjecentDetsBarrel(), ME0NumberingScheme::baseNumberToUnitNumber(), GEMNumberingScheme::baseNumberToUnitNumber(), PixelBaryCentreAnalyzer::beginJob(), DTnoiseDBValidation::beginRun(), CSCComparatorData::bitValue(), SiPixelPhase1Analyzer::BookBarrelBins(), Phase1PixelMaps::bookBarrelBins(), DTEfficiencyTask::bookHistograms(), TICLTrackstersEdgesValidation::bookHistograms(), DTt0DBValidation::bookHistos(), DTEfficiencyTest::bookHistos(), Phase2TrackerMonitorDigi::bookLayerHistos(), Phase2TrackerValidateDigi::bookLayerHistos(), SiPixelPhase1ResidualsExtra::bookMEs(), RPCMonitorDigi::bookRegionME(), RPCMonitorDigi::bookWheelDiskME(), sipixelobjects::PixelROC::bpixLayerPhase1(), HGCalGeometryLoader::build(), ME0SegmentBuilder::build(), CSCRecHitDBuilder::build(), TrackerMap::build(), MuonRPCDetLayerGeometryBuilder::buildBarrelLayers(), CSCGeometryBuilder::buildChamber(), MuonRPCDetLayerGeometryBuilder::buildEndcapLayers(), MuonME0DetLayerGeometryBuilder::buildEndcapLayers(), MuonGEMDetLayerGeometryBuilder::buildEndcapLayers(), GEMEfficiencyAnalyzer::buildGEMLayers(), ME0GeometryBuilder::buildGeometry(), DTGeometryBuilderFromDDD::buildGeometry(), CmsMTDConstruction< FilteredView >::buildLayer(), ETLDetLayerGeometryBuilder::buildLayer(), MuonME0DetLayerGeometryBuilder::buildLayer(), MuonRPCDetLayerGeometryBuilder::buildLayer(), ME0GeometryBuilder::buildLayer(), DTGeometryBuilderFromDD4Hep::buildLayer(), DTGeometryBuilderFromDDD::buildLayer(), DTGeometryBuilderFromCondDB::buildLayer(), cms::DTGeometryBuilder::buildLayer(), ETLDetLayerGeometryBuilder::buildLayerNew(), MuonCSCDetLayerGeometryBuilder::buildLayers(), ETLDetLayerGeometryBuilder::buildLayers(), TrackerAlignmentLevelBuilder::buildPXBAlignmentLevels(), CSCSegAlgoST::buildSegments(), SiPixelClusterSource::buildStructure(), SiPixelDigiSource::buildStructure(), TrackerAlignmentLevelBuilder::buildTIBAlignmentLevels(), PixelTopologyMap::buildTopologyMaps(), HGCalTowerMap2DImpl::buildTowerMap2D(), SETFilter::buildTrajectoryMeasurements(), RPCDigiL1Link::bx(), TrackingParticleNumberOfLayers::calculate(), PixelRegions::calculateBPixID(), RPCStripsRing::calculateHwPlane(), HGCalImagingAlgo::calculateLocalDensity(), DTSegmentUpdator::calculateT0corr(), HGCalTriggerNtupleHGCTriggerCells::calibrate(), sistrip::MeasureLA::calibration_key(), HGCalDDDConstants::cellThickness(), GEMSuperChamber::chamber(), RPCNameHelper::chamberName(), RPCGeomServ::chambername(), RPCGeomServ::channelInChip(), CSCComparatorData::check(), PhiMemoryImage::check_input(), HitPairGeneratorFromLayerPairForPhotonConversion::checkBoundaries(), RPCDigiL1Link::checklayer(), GlobalTrackingRegion::checkRZ(), RectangularEtaPhiTrackingRegion::checkRZ(), HitPairGeneratorFromLayerPairForPhotonConversion::checkRZCompatibilityWithSeedTrack(), RectangularEtaPhiTrackingRegion::checkRZOld(), DTMapGenerator::checkWireExist(), CSCIndexer::chipIndex(), CSCIndexerBase::chipIndex(), RBXAndHPDCleaner::clean(), PhiMemoryImage::clear_bit(), MuonCkfTrajectoryBuilder::collectMeasurement(), ResidualRefitting::CollectTrackHits(), CSCComparatorData::comparatorDigis(), CSCSegAlgoShowering::compareProtoSegment(), CSCSegAlgoTC::compareProtoSegment(), CSCSegAlgoDF::compareProtoSegment(), CSCSegAlgoSK::compareProtoSegment(), CSCSegAlgoRU::compareProtoSegment(), OutInConversionSeedFinder::completeSeed(), InOutConversionSeedFinder::completeSeed(), DTRecHitSegmentResidual::compute(), DTLinearDriftAlgo::compute(), DTLinearDriftFromDBAlgo::compute(), DTNoDriftAlgo::compute(), HFShower::compute(), DTParametrizedDriftAlgo::compute(), DTCalibValidationFromMuons::compute(), DTCalibValidation::compute(), DTRecHitQuality::compute(), GlobalRecHitsAnalyzer::compute(), GlobalRecHitsProducer::compute(), RealisticHitToClusterAssociator::computeAssociation(), SiPixelUtility::computeHistoBin(), DTDigitizer::computeTime(), SiStripDetCabling::connectedNumber(), DDCmsMTDConstruction::construct(), DDHCalEndcapModuleAlgo::constructInsideModule(), DDHCalEndcapAlgo::constructInsideModule(), HCalEndcapModuleAlgo::constructInsideModule(), HCalEndcapAlgo::constructInsideModule(), DDHCalEndcapModuleAlgo::constructInsideModule0(), DDHCalEndcapAlgo::constructInsideModule0(), HCalEndcapModuleAlgo::constructInsideModule0(), HCalEndcapAlgo::constructInsideModule0(), RPCEMap::convert(), l1t::stage2::emtf::convert_GEM_location(), HGCalShowerShape::coreShowerLength(), CSCCondSegFit::correctTheCovX(), fastsim::SimplifiedGeometryFactory::createBarrelSimplifiedGeometry(), DTDigiToRaw::createFedBuffers(), fastsim::SimplifiedGeometryFactory::createForwardSimplifiedGeometry(), TrajectoryManager::createPSimHits(), fastsim::SimplifiedGeometryFactory::createSimplifiedGeometry(), TkHistoMap::createTkHistoMap(), fastsim::HelixTrajectory::crosses(), CSCAnodeData2006::CSCAnodeData2006(), CSCComparatorData::dataWord(), EcalDetailedTimeRecHitProducer::deltaTimeOfFlight(), CSCSegFit::derivativeMatrix(), SiStripDetCabling::detectedNumber(), CSCCrateMap::detId(), CSCReadoutMapping::detId(), CSCTriggerMapping::detId(), CSCIndexerPostls1::detIdFromChipIndex(), CSCIndexerStartup::detIdFromGasGainIndex(), CSCIndexerPostls1::detIdFromGasGainIndex(), CSCIndexerPostls1::detIdFromStripChannelIndex(), PixelRegions::detIdToPixelId(), SiStripBadComponentsDQMServiceReader::detIdToString(), HGCalTriggerGeometryV9Imp2::detIdWaferType(), HGCalTriggerGeometryV9Imp1::detIdWaferType(), PixelInactiveAreaFinder::detInfo(), ConvBremSeedProducer::detLayer(), TrajectoryManager::detLayer(), SiStripDetCabling::detNumber(), CSCCFEBData::digis(), DTDigiSyncTOFCorr::digitizerOffset(), HGCalDigiValidation::digiValidation(), CSCDigitizer::doAction(), CSCValidation::doAFEBTiming(), CSCOfflineMonitor::doBXMonitor(), CSCValidation::doGasGain(), tmtt::KFbase::doKF(), OutsideInMuonSeeder::doLayer(), DDEcalPreshowerAlgoTB::doLayers(), DDEcalPreshowerAlgo::doLayers(), CSCAFEBConnectAnalysis::done(), CSCAFEBThrAnalysis::done(), HFDarkening::dose(), CSCValidation::doTimeMonitoring(), DTNoiseAnalysisTest::dqmEndLuminosityBlock(), DTEfficiencyTest::dqmEndLuminosityBlock(), SiPixelStatusHarvester::dqmEndRun(), DTHitPairForFit::DTHitPairForFit(), DTNoiseCalibration::DTNoiseCalibration(), DTT0Calibration::DTT0Calibration(), DTT0CalibrationRMS::DTT0CalibrationRMS(), ticl::PatternRecognitionbyCLUE3D< TILES >::dumpClusters(), TkHistoMap::dumpInTkMap(), MuonPatternRecoDumper::dumpLayer(), TrackExtenderWithMTDT< TrackCollection >::dumpLayer(), ticl::PatternRecognitionbyCLUE3D< TILES >::dumpTiles(), HGCalShowerShape::eMax(), reco::HitPattern::encode(), TkAlCaSkimTreeMerger::endJob(), DTMapGenerator::endJob(), DTT0Correction::endJob(), AlignmentStats::endJob(), APVValidationPlots::endJob(), DTT0Calibration::endJob(), TrackerTreeGenerator::endJob(), tmtt::Histos::endJobAnalysis(), HcalHitRelabeller::energyWt(), CSCCFEBData::errorstat(), HITrackingRegionProducer::estimateMultiplicity(), RectangularEtaPhiTrackingRegion::estimator(), DDPixBarLayerAlgo::execute(), DDPixBarLayerUpgradeAlgo::execute(), DDTIBLayerAlgo::execute(), PulseArray::extend(), DTDigitizer::externalDelays(), HitQuadrupletGeneratorFromLayerPairForPhotonConversion::failCheckRZCompatibility(), MTDDetLayerMeasurements::fastMeasurements(), MuonDetLayerMeasurements::fastMeasurements(), ParticlePropagator::fieldMap(), HGCalTriggerNtupleHGCMulticlusters::fill(), HGCalTriggerNtupleHGCTriggerCells::fill(), MuonShowerDigiFiller::fill(), HcalTestAnalysis::fill(), TkHistoMap::fill(), SimG4HcalValidation::fill(), Phase1PixelMaps::fill(), TrackerMap::fill(), Phase1PixelMaps::fillBarrelBin(), SiPixelPhase1Analyzer::FillBarrelBinsAnalyze(), SiPixelPhase1Analyzer::FillBarrelBinsRemap(), TrackerRemapper::fillBarrelRemap(), HcalTB04Analysis::fillBuffer(), ME0ReDigiProducer::fillCentralTOFs(), SiPixelHitEfficiencySource::fillClusterProbability(), HGCalDigiValidation::fillDigiInfo(), PseudoBayesGrouping::FillDigisByLayer(), TrackerRemapper::fillEndcapRemap(), SiPixelDataQuality::fillGlobalQualityPlot(), HGCalRecHitValidation::fillHitsInfo(), tmtt::Histos::fillInputData(), HGCalTriggerGeometryHexLayerBasedImp1::fillInvalidTriggerCells(), HGCalTriggerGeometryV9Imp1::fillInvalidTriggerCells(), Phase2TrackerValidateDigi::fillITPixelBXInfo(), Phase2TrackerMonitorDigi::fillITPixelDigiHistos(), HGCalTriggerGeometryV9Imp2::fillMaps(), HGCalTriggerGeometryV9Imp1::fillMaps(), SiPixelPhase1ResidualsExtra::fillMEs(), CSCStripElectronicsSim::fillMissingLayer(), GlobalDigisProducer::fillMuon(), GlobalDigisAnalyzer::fillMuon(), GlobalRecHitsAnalyzer::fillMuon(), GlobalRecHitsProducer::fillMuon(), HGCalRecHitValidation::fillOccupancyMap(), HGCalDigiValidation::fillOccupancyMap(), HGCalSimHitValidation::fillOccupancyMap(), Phase2TrackerValidateDigi::fillOTBXInfo(), Phase2TrackerMonitorDigi::fillOTDigiHistos(), PixelCPEFast::fillParamsForGpu(), DeepCoreSeedGenerator::fillPixelMatrix(), QcdLowPtDQM::fillPixels(), CSCEfficiency::fillRechitsSegments_info(), Phase2TrackerValidateDigi::fillSimHitInfo(), CaloParticleDebugger::fillSimHits(), CaloTruthAccumulator::fillSimHits(), TrackerRemapper::fillStripRemap(), DTCompactMapWriter::fillTDCMap(), DTTimingExtractor::fillTiming(), HGCalHitCalibration::fillWithRecHits(), HcalTB04Analysis::finalAnalysis(), TrackerMap::find_layer(), HGCalImagingAlgo::findAndAssignClusters(), ticl::PatternRecognitionbyCLUE3D< TILES >::findAndAssignTracksters(), CosmicMuonTrajectoryBuilder::findBestMeasurements(), StandAloneMuonFilter::findBestMeasurements(), DTCalibValidation::findBestRecHit(), DTRecHitQuality::findBestRecHit(), GlobalRecHitsAnalyzer::findBestRecHit(), GlobalRecHitsProducer::findBestRecHit(), SETFilter::findChi2(), CSCAnodeData2007::findFrame(), MSLayersAtAngle::findLayer(), HcalDDDSimConstants::findLayer(), TkDetMap::findLayer(), InOutConversionSeedFinder::findSeeds(), SeedGeneratorFromL1TTracksEDProducer::findSeedsOnLayer(), TSGForOI::findSeedsOnLayer(), GEMEfficiencyAnalyzer::findStartingState(), MonitorTrackResidualsBase< pixel_or_strip >::findSubdetAndLayer(), CSCXonStrip_MatchGatti::findXOnStrip(), HGCalShowerShape::firstLayer(), CSCCondSegFit::fit(), DTSegmentUpdator::fit(), GEMCSCSegFit::fit2(), CSCSegAlgoRU::fit_r_phi(), CSCSimHitMatcher::fitHitsInChamber(), CSCSegFit::fitlsq(), GEMCSCSegFit::fitlsq(), TkHistoMap::folderDefinition(), PixelDataFormatter::formatRawData(), trackerDTC::Stub::formatTMTT(), sipixelobjects::FrameConversion::FrameConversion(), TotemT1Organization::fromObjectTypeToInt(), RPCPhiEff::fromRaw(), CSCIndexer::gasGainIndex(), CSCIndexerBase::gasGainIndex(), DTHVHandler::get(), DTT0::get(), DTHVStatus::get(), DTDeadFlag::get(), DTStatusFlag::get(), PhiMemoryImage::get_word(), CSCToAFEB::getAfebCh(), CSCToAFEB::getAfebPos(), TrackerMap::getAutomaticRange(), PropagateToMuon::getBestDet(), DTDeadFlag::getCellDead_HV(), DTDeadFlag::getCellDead_RO(), DTDeadFlag::getCellDead_TP(), DTDeadFlag::getCellDiscCat(), HGCalTriggerGeometryV9Imp1::getCellsFromTriggerCell(), HGCalTriggerGeometryV9Imp2::getCellsFromTriggerCell(), HGCalCoarseTriggerCellMapping::getCoarseTriggerCellId(), TkDetMap::getComponents(), HGCalCoarseTriggerCellMapping::getConstituentTriggerCells(), MuonAlignmentInputXML::getCSCnode(), L1TMuon::GeometryTranslator::getCSCSpecificPoint(), RealisticHitToClusterAssociator::getDecayLength(), HcalLayerDepthMap::getDepth(), TkDetMap::getDetFromBin(), TkHistoMap::getDetId(), PixelBarrelNameUpgrade::getDetId(), PixelBarrelName::getDetId(), HFNoseDetIdToModule::getDetIds(), HGCSiliconDetIdToModule::getDetIds(), getDetLayer(), GEMOfflineDQMBase::getDetOccXBin(), GEMDQMBase::getDetOccXBin(), TkDetMap::getDetsForLayer(), HGCSiliconDetIdToModule::getDetTriggerIds(), HGCalRadiationMap::getDoseValue(), MuonAlignmentInputXML::getDTnode(), reco::mlpf::getElementProperties(), HGCSD::getEnergyDeposit(), TkHistoMap::getEntries(), HGCalRadiationMap::getFluenceValue(), AngleConverter::getGlobalEta(), SimG4HcalValidation::getHcalScale(), DTTMax::getInfoLayer(), CSCWireHitSim::getIonizationClusters(), phase2tkutil::getITHistoId(), hgcal::RecHitTools::getLayer(), SiStripLAProfileBooker::getlayer(), CSCToAFEB::getLayer(), HcalLayerDepthMap::getLayerBack(), HcalDDDSimConstants::getLayerBack(), HcalLayerDepthMap::getLayerFront(), HcalDDDSimConstants::getLayerFront(), HitPairGeneratorFromLayerPairForPhotonConversion::getLayerRadius(), hgcal::RecHitTools::getLayerWithOffset(), HitPairGeneratorFromLayerPairForPhotonConversion::getLayerZ(), HGCalTriggerGeometryV9Imp1::getLinksInModule(), HGCalTriggerGeometryV9Imp2::getLinksInModule(), HGCNumberingScheme::getLocalCoords(), DTEfficiencyTest::getMEName(), TrackerMap::getmoduleCount(), HGCalTriggerGeometryV9Imp2::getModuleFromTriggerCell(), HGCalTriggerGeometryV9Imp1::getModuleSize(), HGCalTriggerGeometryV9Imp2::getModuleSize(), HGCalTriggerGeometryV9Imp1::getNeighborsFromTriggerCell(), TrajSeedMatcher::getNrValidLayersAlongTraj(), HGCalTriggerGeometryV9Imp1::getOrderedTriggerCellsFromModule(), HGCalTriggerGeometryV9Imp2::getOrderedTriggerCellsFromModule(), phase2tkutil::getOTHistoId(), HitPairGeneratorFromLayerPairForPhotonConversion::getPhiRange(), hgcal::RecHitTools::getPositionLayer(), AngleConverter::getProcessorPhi(), HGCalDDDConstants::getRadiusLayer(), ThirdHitPrediction::getRanges(), SiStripMiscalibrate::getRegionsFromDetId(), GlobalMuonRefitter::getRidOfSelectStationHits(), TrackerMap::getringCount(), RPCLBLinkMapHandler::getRPCDetId(), HcalDDDRecConstants::getRZ(), GEMEfficiencyAnalyzer::getStartingState(), SiStripFolderOrganizer::GetSubDetAndLayer(), SiStripFolderOrganizer::GetSubDetAndLayerThickness(), SiStripFolderOrganizer::getSubDetLayerFolderName(), TkDetMap::getSubDetLayerSide(), HGCalGeometry::getSummary(), SiStripApvSimulationParameters::getTIB(), SiStripApvSimulationParameters::getTOB(), reco::HitPattern::getTrackerLayerCase(), reco::HitPattern::getTrackerMonoStereo(), HGCalTriggerGeometryHexLayerBasedImp1::getTriggerCellFromCell(), HGCalTriggerGeometryV9Imp1::getTriggerCellFromCell(), HGCalTriggerGeometryV9Imp1::getTriggerCellsFromModule(), HGCalTriggerGeometryV9Imp2::getTriggerCellsFromModule(), HFNoseDetIdToModule::getTriggerDetIds(), SiStripMiscalibrate::getTruncatedRange(), HGCalDDDConstants::getTypeHex(), HGCalDDDConstants::getTypeTrap(), ESTBNumberingScheme::getUnitID(), EcalPreshowerNumberingScheme::getUnitID(), ZdcNumberingScheme::getUnitID(), HFNoseNumberingScheme::getUnitID(), HGCNumberingScheme::getUnitID(), HGCalNumberingScheme::getUnitID(), TkHistoMap::getValue(), CSCDriftSim::getWireHit(), HGCalDDDConstants::getXY(), LayerMeasurements::groupedMeasurements(), MTDDetLayerMeasurements::groupedMeasurements(), MuonDetLayerMeasurements::groupedMeasurements(), CSCSegAlgoTC::hasHitOnLayer(), ME0SegAlgoRU::hasHitOnLayer(), CSCSegAlgoDF::hasHitOnLayer(), CSCSegAlgoSK::hasHitOnLayer(), GE0SegAlgoRU::hasHitOnLayer(), CSCSegAlgoRU::hasHitOnLayer(), reco::HitPattern::hasValidHitInPixelLayer(), HGCalDDDConstants::HGCalDDDConstants(), CSCMake2DRecHit::hitFromStripAndWire(), GlobalTrackingRegion::hits(), SeedingLayerSetsBuilder::hits(), CosmicTrackingRegion::hits(), RectangularEtaPhiTrackingRegion::hits(), CosmicTrackingRegion::hits_(), MultiHitGeneratorFromChi2::hitSets(), PixelTripletNoTipGenerator::hitTriplets(), PixelTripletLowPtGenerator::hitTriplets(), PixelTripletLargeTipGenerator::hitTriplets(), PixelTripletHLTGenerator::hitTriplets(), DTSequentialCellNumber::id(), DTSequentialLayerNumber::id(), MuonSeedBuilder::IdentifyShowering(), MTDDetLayerGeometry::idToLayer(), MuonDetLayerGeometry::idToLayer(), PFHBHERecHitCreator::importRecHits(), PFPSRecHitCreator::importRecHits(), PFHFRecHitCreator::importRecHits(), PixelInactiveAreaFinder::inactiveAreas(), CSCSegAlgoTC::increaseProtoSegment(), CSCSegAlgoSK::increaseProtoSegment(), CSCSegAlgoRU::increaseProtoSegment(), CosmicMuonTrajectoryBuilder::incrementChamberCounters(), SETFilter::incrementChamberCounters(), StandAloneMuonFilter::incrementChamberCounters(), StandAloneMuonFilter::incrementCompatibleChamberCounters(), CSCAnodeData2007::index(), CSCAnodeData2006::index(), DTTMax::InfoLayer::InfoLayer(), MultipleScatteringParametrisation::init(), PFBadHcalPseudoClusterProducer::init(), TrackerMap::init(), InnerDeltaPhi::initBarrelLayer(), InnerDeltaPhi::initForwardLayer(), sipixelobjects::PixelROC::initFrameConversionPhase1(), PulseArray::initialize(), HGCalTriggerGeometryHexLayerBasedImp1::initialize(), HGCalTriggerGeometryV9Imp1::initialize(), HcalLayerDepthMap::initialize(), HGCalTriggerGeometryV9Imp2::initialize(), CSCOverlapsAlignmentAlgorithm::initialize(), ThirdHitRZPredictionBase::initLayer(), ThirdHitPrediction::initLayer(), trklet::MemoryBase::initLayerDisk(), trklet::ProcessBase::initLayerDisk(), InnerDeltaPhi::InnerDeltaPhi(), PFGeometry::innerRadius(), PFGeometry::innerZ(), fastsim::PairProduction::interact(), fastsim::EnergyLoss::interact(), fastsim::Bremsstrahlung::interact(), fastsim::MultipleScattering::interact(), fastsim::MuonBremsstrahlung::interact(), MaterialEffects::interact(), fastsim::TrackerSimHitProducer::interact(), fastsim::NuclearInteraction::interact(), fastsim::NuclearInteractionFTF::interact(), HGCalTriggerClusterInterpretationEM::interpret(), PixelDataFormatter::interpretRawData(), MagneticFieldMap::inTeslaZ(), Phase1PixelROCMaps::isBPixOuterLadder(), AlignmentPI::isBPixOuterLadder(), SiPixelPI::isBPixOuterLadder(), AngleConverter::isCSCCounterClockwise(), L1TMuon::GeometryTranslator::isCSCCounterClockwise(), TrajectoryAtInvalidHit::isDoubleSided(), HitEff::isDoubleSided(), ME0SegmentAlgorithm::isGoodToMerge(), CSCMake2DRecHit::isHitInFiducial(), CSCSegAlgoShowering::isHitNearSegment(), CSCSegAlgoDF::isHitNearSegment(), CSCSegAlgoRU::isHitNearSegment(), ME0SegmentsValidation::isMatched(), PulseArray::isOneShotHighAtBX(), hgcal::RecHitTools::isOnlySilicon(), TrackerMap::isRingStereo(), HGCalDDDConstants::isValidHex8(), HGCalDDDConstants::isValidTrap(), tmtt::KFbase::kalmanDeadLayers(), tmtt::KFbase::kalmanUpdate(), HGCalShowerShape::lastLayer(), Trajectory::lastLayer(), MSLayersKeeperX0Averaged::layer(), MSLayersKeeperX0DetLayer::layer(), LA_Filler_Fitter::layer_index(), AlignmentParameterSelector::layerDeselected(), OverlapValidation::layerFromId(), TrajSeedMatcher::layerHasValidHits(), CSCIndexer::layerIndex(), CSCIndexerBase::layerIndex(), LA_Filler_Fitter::layerLabel(), TrackerMap::layername(), SeedingLayerSetsBuilder::layerNamesInSets(), TrackerMap::layerno(), SeedingLayerSetsBuilder::layers(), HGCalTriggerGeometryV9Imp2::layerWithOffset(), HGCalTriggerGeometryHexLayerBasedImp1::layerWithOffset(), HGCalTriggerGeometryV9Imp1::layerWithOffset(), GEMCSCSegmentBuilder::LinkGEMRollsToCSCChamberIndex(), HGCalGeomParameters::loadGeometryHexagon(), HGCalGeomParameters::loadGeometryHexagon8(), TkHistoMap::loadTkHistoMap(), RPCtoDTTranslator::localXX(), HGCalDDDConstants::locateCell(), MagneticFieldMap::MagneticFieldMap(), EMTFSubsystemCollector::make_copad_gem(), PatternRecognition::make_zone_image(), HGCal3DClustering::makeClusters(), MuonDetLayerGeometry::makeDetLayerId(), OutInConversionSeedFinder::makeEstimator(), HcalHardcodeGeometryLoader::makeHBCells(), HcalHardcodeGeometryLoader::makeHECells(), HGCalDepthPreClusterer::makePreClusters(), HGCalRecHitSimpleAlgo::makeRecHit(), SeedingLayerSetsBuilder::makeSeedingLayerSetsHitsforFastSim(), TSGForOI::makeSeedsFromHits(), TSGForOIFromL2::makeSeedsFromHits(), TSGForOIFromL2::makeSeedsWithoutHits(), ticl::PatternRecognitionbyCLUE3D< TILES >::makeTracksters(), ticl::PatternRecognitionbyCA< TILES >::makeTracksters(), ConvBremSeedProducer::makeTrajectoryState(), TrajectoryManager::makeTrajectoryState(), HGCalDDDConstants::maskCell(), CSCStubMatcher::matchCLCTsToSimTrack(), MatchedHitRZCorrectionFromBending::MatchedHitRZCorrectionFromBending(), HGCalShowerShape::maxLayer(), LayerMeasurements::measurements(), MTDDetLayerMeasurements::measurements(), MuonDetLayerMeasurements::measurements(), SymmetricLayerFinder::mirror(), SymmetricLayerFinder::mirrorPartner(), SiPixelDigitizerAlgorithm::missCalibrate(), CSCGEMMatcher::mitigatedSlopeByConsistency(), InitialGrouping::mixChannels(), tmtt::KFbase::mkState(), fastsim::LayerNavigator::moveParticleToNextLayer(), MSLayer::MSLayer(), MultipleScatteringParametrisation::MultipleScatteringParametrisation(), MuonGeometrySanityCheckPoint::MuonGeometrySanityCheckPoint(), RPCGeomServ::name(), HGCalTowerMap2DImpl::newTowerMaps(), RBCProcessRPCDigis::next(), RBCProcessRPCSimDigis::next(), fastsim::HelixTrajectory::nextCrossingTimeC(), fastsim::StraightTrajectory::nextCrossingTimeC(), fastsim::Trajectory::nextCrossingTimeC(), fastsim::Geometry::nextLayer(), MaterialEffects::normalVector(), PulseArray::numberOfLayersAtBX(), reco::HitPattern::numberOfValidStripLayersWithMonoAndStereo(), reco::HitPattern::numberOfValidTECLayersWithMonoAndStereo(), reco::HitPattern::numberOfValidTIBLayersWithMonoAndStereo(), reco::HitPattern::numberOfValidTIDLayersWithMonoAndStereo(), reco::HitPattern::numberOfValidTOBLayersWithMonoAndStereo(), SimG4HcalValidation::nxNAnalysis(), DTTTrigBaseSync::offset(), DTTTrigSyncTOFCorr::offset(), DTTTrigSyncFromDB::offset(), PulseArray::oneShotAtBX(), DTSegmentCand::operator DTChamberRecSegment2D *(), TrackingLayer::operator!=(), ThirdHitRZPrediction< Propagator >::operator()(), PulseArray::operator()(), CheckHitPattern::operator()(), LayerHitMapCache::operator()(), TrackingLayer::operator<(), operator<<(), fastsim::operator<<(), TrackingLayer::operator==(), HGCal3DClustering::organizeByLayer(), PFGeometry::outerRadius(), PFGeometry::outerZ(), CSCCFEBData::overlappedSampleFlag(), trklet::TrackletCalculatorBase::overlapSeeding(), HGCalTriggerGeometryV9Imp2::packLayerModuleId(), HGCalTriggerGeometryV9Imp2::packLayerWaferId(), HGCalTriggerGeometryV9Imp1::packLayerWaferId(), ZdcNumberingScheme::packZdcIndex(), SiStripTrackerMapCreator::paintTkMapFromAlarm(), DDHCalEndcapAlgo::parameterLayer0(), HCalEndcapAlgo::parameterLayer0(), TTStubAlgorithm_official< T >::PatternHitCorrelation(), HGCalShowerShape::percentileLayer(), RPCMonitorDigi::performSourceOperation(), SiPixelStatusHarvester::perLayerRingAverage(), trklet::Globals::phiCorr(), DTTrigGeomUtils::phiRange(), DTLocalTriggerBaseTest::phiRange(), reco::HitPattern::pixelBarrelLayersNull(), reco::HitPattern::pixelBarrelLayersTotallyOffOrBad(), reco::HitPattern::pixelBarrelLayersWithMeasurement(), reco::HitPattern::pixelBarrelLayersWithoutMeasurement(), reco::HitPattern::pixelEndcapLayersNull(), reco::HitPattern::pixelEndcapLayersTotallyOffOrBad(), reco::HitPattern::pixelEndcapLayersWithMeasurement(), reco::HitPattern::pixelEndcapLayersWithoutMeasurement(), HIPplots::plotHitMap(), CSCSegmentValidation::plotResolution(), CSCWireDigiValidation::plotResolution(), CSCStripDigiValidation::plotResolution(), CSCRecHit2DValidation::plotResolution(), GlobalRecHitsAnalyzer::plotResolution(), GlobalRecHitsProducer::plotResolution(), DD4hep_TrackingMaterialPlotter::plotSegmentInLayer(), TrackingMaterialPlotter::plotSegmentInLayer(), HGCalImagingAlgo::populate(), HGCalCLUEAlgoT< TILE >::populate(), DDHGCalMixLayer::positionMix(), HGCalMixLayer::positionMix(), DDHGCalEEFileAlgo::positionSensitive(), DDHGCalSiliconModule::positionSensitive(), DDHGCalHEFileAlgo::positionSensitive(), HGCalEEFileAlgo::positionSensitive(), HGCalSiliconModule::positionSensitive(), HGCalHEFileAlgo::positionSensitive(), CSCChipSpeedCorrectionDBConditions::prefillDBChipSpeedCorrection(), CSCGasGainCorrectionDBConditions::prefillDBGasGainCorrection(), CtfSpecialSeedGenerator::preliminaryCheck(), CaloGeometryHelper::preshowerZPosition(), fastsim::Geometry::previousLayer(), MuonPath::primitive(), SiPixelDetSummary::print(), CheckHitPattern::print(), SiStripDetSummary::print(), PFCheckHitPattern::print(), TrackerMap::print(), SeedingLayerSetsHits::print(), VectorHitBuilderAlgorithmBase::printCluster(), SiStripQuality::printDetInfo(), MuonNavigationPrinter::printLayer(), ConversionSeedFinder::printLayer(), SiStripDetCabling::printSummary(), SiStripPI::printSummary(), TkDetMapESProducer::produce(), TICLLayerTileProducer::produce(), PFClusterTimeSelector::produce(), SiPixelDigisClustersFromSoA::produce(), DTRecHitProducer::produce(), TkAlCaOverlapTagger::produce(), cms::DigitizerFP420::produce(), HGCalTrackCollectionProducer::produce(), DTDigitizer::produce(), TkMSParameterizationBuilder::produce(), reco::CentralityProducer::produce(), CorrectedECALPFClusterProducer::produce(), MuonSimHitProducer::produce(), FastSimProducer::produce(), PixelClusterTagInfoProducer::produce(), CSCDCCUnpacker::produce(), CaloGeometryDBEP< T, U >::produceAligned(), EcalTrivialConditionRetriever::produceEcalAlignmentES(), reco::modules::TrackerTrackHitFilter::produceFromTrajectory(), HGCalIsoCalculator::produceHGCalIso(), SiStripRegionConnectivity::produceRegionCabling(), StandAloneMuonTrajectoryBuilder::propagateTheSeedTSOS(), ParticlePropagator::propagateToBoundSurface(), TrajectoryManager::propagateToLayer(), CSCSegAlgoShowering::pruneFromResidual(), CSCSegAlgoDF::pruneFromResidual(), PGlobalDigi::putMB1Digis(), PGlobalDigi::putMB2Digis(), PGlobalDigi::putMB3Digis(), PGlobalDigi::putMB4Digis(), SiStripApvSimulationParameters::putTIB(), SiStripApvSimulationParameters::putTOB(), HcalTestAnalysis::qieAnalysis(), TrackClassifier::qualityInformation(), MaterialEffects::radLengths(), CSCChannelMapperStartup::rawCSCDetId(), CSCChannelTranslator::rawCSCDetId(), RPCDigiL1Link::rawdetId(), CSCAnodeData2006::rawHit(), HGCalRadiationMap::readDosePars(), popcon::RPCEMapSourceHandler::readEMap1(), AsciiNeutronReader::readNextEvent(), HGCalSciNoiseMap::readSipmPars(), DTCalibValidationFromMuons::recHitDistFromWire(), DTCalibValidation::recHitDistFromWire(), DTRecHitQuality::recHitDistFromWire(), GlobalRecHitsAnalyzer::recHitDistFromWire(), GlobalRecHitsProducer::recHitDistFromWire(), DTCalibValidationFromMuons::recHitPosition(), DTCalibValidation::recHitPosition(), LayerMeasurements::recHits(), MTDDetLayerMeasurements::recHits(), MuonDetLayerMeasurements::recHits(), HGCalRecHitValidation::recHitValidation(), DTNoDriftAlgo::reconstruct(), DTRecHitBaseAlgo::reconstruct(), StandAloneMuonFilter::refit(), HcalHitRelabeller::relabel(), CSCSegAlgoTC::replaceHit(), CSCSegAlgoSK::replaceHit(), CSCSegAlgoRU::replaceHit(), HGCalRecHitWorkerSimple::run(), DTOccupancyTestML::runOccupancyTest(), CSCHitFromStripOnly::runStrip(), CSCHitFromWireOnly::runWire(), SiStripApvSimulationParameters::sampleTIB(), SiStripApvSimulationParameters::sampleTOB(), TrackerMap::save(), SiPixelPhase1Analyzer::SaveDetectorVertices(), TrackingMaterialAnalyser::saveLayerPlots(), DD4hep_TrackingMaterialAnalyser::saveLayerPlots(), TrackingMaterialAnalyser::saveParameters(), DD4hep_TrackingMaterialAnalyser::saveParameters(), DD4hep_TrackingMaterialAnalyser::saveXml(), TrackingMaterialAnalyser::saveXml(), CSCCFEBTimeSlice::scaControllerWord(), HcalTB04Analysis::scale(), HGCalSciNoiseMap::scaleByDose(), HGCalSciNoiseMap::scaleBySipmArea(), HGCalParameters::scintCells(), HGCalParameters::scintCellSize(), HGCalParameters::scintType(), ApeTreeCreateDefault::sectorBuilder(), ApeEstimator::sectorBuilder(), DTResidualCalibration::segmentToWireDistance(), HGCalConcentratorAutoEncoderImpl::select(), CosmicLayerPairs::selectTIBHit(), CosmicLayerPairs::selectTOBHit(), trackerDTC::SensorModule::SensorModule(), DTT0::set(), DTHVStatus::set(), DTDeadFlag::set(), DTStatusFlag::set(), PhiMemoryImage::set_bit(), PhiMemoryImage::set_word(), TkHistoMap::setBinContent(), DTStatusFlag::setCellDead(), DTDeadFlag::setCellDead_HV(), DTDeadFlag::setCellDead_RO(), DTDeadFlag::setCellDead_TP(), DTDeadFlag::setCellDiscCat(), DTStatusFlag::setCellFEMask(), DTStatusFlag::setCellNoHV(), DTStatusFlag::setCellNoise(), DTStatusFlag::setCellTDCMask(), DTStatusFlag::setCellTrigMask(), CSCCondSegFit::setChi2(), CSCSegFit::setChi2(), CSCCFEBTimeSlice::setControllerWord(), HGCScintSD::setDetUnitId(), HGCalSD::setDetUnitId(), HFNoseSD::setDetUnitId(), HGCSD::setDetUnitId(), DTHVStatus::setFlagA(), DTHVStatus::setFlagC(), DTHVStatus::setFlagS(), FWEventItemsManager::setFrom(), InitialGrouping::setInChannels(), CSCBaseElectronicsSim::setLayer(), SiStripFolderOrganizer::setLayerFolder(), DTPrimitive::setLayerId(), TkDetMap::setLayerMap(), RPCDigiL1Link::setLink(), MuonPath::setPrimitive(), ParticlePropagator::setPropagationConditions(), SiStripFolderOrganizer::setRingFolder(), TrackerMap::setText(), SiStripTrackerMapCreator::setTkMapFromHistogram(), PixelCPEGenericBase::setXYErrors(), RPCGeomServ::shortname(), CSCSegAlgoShowering::showerSeg(), FW3DViewGeometry::showHGCalEE(), FW3DViewGeometry::showHGCalHSc(), FW3DViewGeometry::showHGCalHSi(), HGCalShowerShape::sigmaEtaEtaMax(), HGCalShowerShape::sigmaPhiPhiMax(), HGCalShowerShape::sigmaRRMax(), HGCalShowerShape::sigmaRRMean(), DTRecHitQuality::simHitDistFromFE(), DTRecHitQuality::simHitDistFromWire(), GlobalRecHitsAnalyzer::simHitDistFromWire(), GlobalRecHitsProducer::simHitDistFromWire(), CSCSimHitMatcher::simHitsMeanWG(), CSCStripHitSim::simulate(), CSCWireHitSim::simulate(), CSCBaseElectronicsSim::simulate(), SiStripDetSummary::SiStripDetSummary(), GEMEfficiencyAnalyzer::skipLayer(), JetCoreMCtruthSeedGenerator::splittedClusterDirections(), DeepCoreSeedGenerator::splittedClusterDirections(), OutInConversionSeedFinder::startSeed(), CSCCFEBData::statusDigi(), tmtt::StubFEWindows::storedWindowSize(), hgcal::EGammaPCAHelper::storeRecHits(), ResidualRefitting::StoreTrackerRecHits(), RPCDigiL1Link::strip(), CSCIndexer::stripChannelIndex(), CSCIndexerBase::stripChannelIndex(), CSCCFEBData::stripDigis(), CSCEventData::stripDigis(), reco::HitPattern::stripTECLayersNull(), reco::HitPattern::stripTECLayersTotallyOffOrBad(), reco::HitPattern::stripTECLayersWithMeasurement(), reco::HitPattern::stripTECLayersWithoutMeasurement(), reco::HitPattern::stripTIBLayersNull(), reco::HitPattern::stripTIBLayersTotallyOffOrBad(), reco::HitPattern::stripTIBLayersWithMeasurement(), reco::HitPattern::stripTIBLayersWithoutMeasurement(), reco::HitPattern::stripTIDLayersNull(), reco::HitPattern::stripTIDLayersTotallyOffOrBad(), reco::HitPattern::stripTIDLayersWithMeasurement(), reco::HitPattern::stripTIDLayersWithoutMeasurement(), reco::HitPattern::stripTOBLayersNull(), reco::HitPattern::stripTOBLayersTotallyOffOrBad(), reco::HitPattern::stripTOBLayersWithMeasurement(), reco::HitPattern::stripTOBLayersWithoutMeasurement(), SiPixelStatusHarvester::substructure(), PhiMemoryImage::test_bit(), MagneticFieldMap::theFieldBarrelHisto(), MagneticFieldMap::theFieldEndcapHisto(), DTTrigGeomUtils::thetaRange(), ThirdHitCorrection::ThirdHitCorrection(), ThirdHitRZPredictionBase::ThirdHitRZPredictionBase(), MatchedHitRZCorrectionFromBending::tibMatchedHitZFixup(), HGCalTileIndex::tileIndex(), HGCalDDDConstants::tileType(), HcalTestAnalysis::timeOfFlight(), HcalTB04Analysis::timeOfFlight(), EcalTimeMapDigitizer::timeOfFlight(), CSCCFEBTimeSlice::timeSample(), PFLayer::toCaloID(), TrackTransformerForGlobalCosmicMuons::TrackerKeep(), TrackerMap::TrackerMap(), HGVHistoProducerAlgo::tracksters_to_CaloParticles(), CosmicMuonTrajectoryBuilder::trajectories(), TrajectorySeedProducer::TrajectorySeedProducer(), HGCalClusteringImpl::triggerCellReshuffling(), HGCalTriggerGeometryHexLayerBasedImp1::triggerLayer(), HGCalTriggerGeometryV9Imp1::triggerLayer(), HGCalTriggerGeometryV9Imp2::triggerLayer(), CSCSegAlgoDF::tryAddingHitsToSegment(), CSCSegAlgoSK::tryAddingHitsToSegment(), CSCSegAlgoTC::tryAddingHitsToSegment(), CSCSegAlgoRU::tryAddingHitsToSegment(), SiStripDetCabling::undetectedNumber(), MkFitGeometry::uniqueIdInLayer(), HcalNumberingFromPS::unitID(), HGCalTriggerGeometryV9Imp1::unpackLayerWaferId(), ZdcNumberingScheme::unpackZdcIndex(), CosmicMuonTrajectoryBuilder::unusedHits(), MSLayersAtAngle::update(), HcalTestAnalysis::update(), SimG4HcalValidation::update(), SimG4HGCalValidation::update(), HcalTB02Analysis::update(), SeedingLayerSetsBuilder::updateEventSetup(), FW3DViewBase::updateHGCalVisibility(), DTSegmentUpdator::updateHits(), PixelInactiveAreaFinder::updatePixelDets(), ValidateGeometry::validateCSCLayerGeometry(), ValidateGeometry::validateDTLayerGeometry(), validateLayerIndex(), HGCalDDDConstants::waferFromPosition(), HGCalWaferIndex::waferIndex(), HGCalDDDConstants::waferIndex(), HGCalDDDConstants::wafers(), HGCalDDDConstants::waferType(), HGCalDDDConstants::waferTypeRotation(), HGCalDDDConstants::waferVirtual(), CSCAnodeData::wireDigis(), CSCAnodeData2007::wireDigis(), CSCAnodeData2006::wireDigis(), CSCEventData::wireDigis(), sistrip::EnsembleCalibrationLA::write_ensembles_text(), CSCComparatorData::zero(), CSCStubMatcher::zpositionOfLayer(), and TrackerMap::~TrackerMap().

◆ layerIndexSize

constexpr uint32_t phase1PixelTopology::layerIndexSize = numberOfModules / maxModuleStride
constexpr

Definition at line 98 of file phase1PixelTopology.h.

◆ layerName

constexpr char const* phase1PixelTopology::layerName[numberOfLayers]
constexpr

◆ layerStart

constexpr uint32_t phase1PixelTopology::layerStart[numberOfLayers+1]
constexpr

◆ maxModuleStride

constexpr uint32_t phase1PixelTopology::maxModuleStride = findMaxModuleStride()
constexpr

◆ numberOfLaddersInBarrel

constexpr uint32_t phase1PixelTopology::numberOfLaddersInBarrel = numberOfModulesInBarrel / 8
constexpr

Definition at line 51 of file phase1PixelTopology.h.

Referenced by PixelCPEFast::fillParamsForGpu().

◆ numberOfLayers

constexpr uint32_t phase1PixelTopology::numberOfLayers = 10
constexpr

◆ numberOfModules

constexpr uint32_t phase1PixelTopology::numberOfModules = 1856
constexpr

Definition at line 24 of file phase1PixelTopology.h.

Referenced by validateLayerIndex().

◆ numberOfModulesInBarrel

constexpr uint32_t phase1PixelTopology::numberOfModulesInBarrel = 1184
constexpr

Definition at line 50 of file phase1PixelTopology.h.

Referenced by PixelCPEFast::fillParamsForGpu().

◆ numColsInModule

constexpr uint16_t phase1PixelTopology::numColsInModule = 8 * numColsInRoc
constexpr

Definition at line 15 of file phase1PixelTopology.h.

◆ numColsInRoc

constexpr uint16_t phase1PixelTopology::numColsInRoc = 52
constexpr

◆ numPixsInModule

constexpr uint32_t phase1PixelTopology::numPixsInModule = uint32_t(numRowsInModule) * uint32_t(numColsInModule)
constexpr

Definition at line 22 of file phase1PixelTopology.h.

◆ numRowsInModule

constexpr uint16_t phase1PixelTopology::numRowsInModule = 2 * numRowsInRoc
constexpr

Definition at line 14 of file phase1PixelTopology.h.

◆ numRowsInRoc

constexpr uint16_t phase1PixelTopology::numRowsInRoc = 80
constexpr

◆ xOffset

constexpr int16_t phase1PixelTopology::xOffset = -81
constexpr

◆ yOffset

constexpr int16_t phase1PixelTopology::yOffset = -54 * 4
constexpr
mps_fire.i
i
Definition: mps_fire.py:428
dqmiodumpmetadata.n
n
Definition: dqmiodumpmetadata.py:28
f
double f[11][100]
Definition: MuScleFitUtils.cc:78
phase1PixelTopology::lastColInModule
constexpr uint16_t lastColInModule
Definition: phase1PixelTopology.h:17
multPhiCorr_741_25nsDY_cfi.py
py
Definition: multPhiCorr_741_25nsDY_cfi.py:12
phase1PixelTopology::toRocY
constexpr uint16_t toRocY(uint16_t py)
Definition: phase1PixelTopology.h:130
phase1PixelTopology::numRowsInRoc
constexpr uint16_t numRowsInRoc
Definition: phase1PixelTopology.h:9
phase1PixelTopology::lastRowInModule
constexpr uint16_t lastRowInModule
Definition: phase1PixelTopology.h:16
Indices
Indices
Definition: EdmEventSize.cc:28
phase1PixelTopology::numberOfModules
constexpr uint32_t numberOfModules
Definition: phase1PixelTopology.h:24
phase1PixelTopology::lastColInRoc
constexpr uint16_t lastColInRoc
Definition: phase1PixelTopology.h:12
mitigatedMETSequence_cff.U
U
Definition: mitigatedMETSequence_cff.py:36
phase1PixelTopology::layer
constexpr std::array< uint8_t, layerIndexSize > layer
Definition: phase1PixelTopology.h:99
phase1PixelTopology::map_to_array_helper
constexpr auto map_to_array_helper(Function f, std::index_sequence< Indices... >) -> std::array< typename std::result_of< Function(std::size_t)>::type, sizeof...(Indices)>
Definition: phase1PixelTopology.h:54
phase1PixelTopology::lastRowInRoc
constexpr uint16_t lastRowInRoc
Definition: phase1PixelTopology.h:11
submitPVResolutionJobs.q
q
Definition: submitPVResolutionJobs.py:84
res
Definition: Electron.h:6
phase1PixelTopology::maxModuleStride
constexpr uint32_t maxModuleStride
Definition: phase1PixelTopology.h:81
alignCSCRings.r
r
Definition: alignCSCRings.py:93
multPhiCorr_741_25nsDY_cfi.px
px
Definition: multPhiCorr_741_25nsDY_cfi.py:10
edm::shift
static unsigned const int shift
Definition: LuminosityBlockID.cc:7
PixelMapPlotter.roc
roc
Definition: PixelMapPlotter.py:498
phase1PixelTopology::layerStart
constexpr uint32_t layerStart[numberOfLayers+1]
Definition: phase1PixelTopology.h:26
dqmiolumiharvest.j
j
Definition: dqmiolumiharvest.py:66
findQualityFiles.size
size
Write out results.
Definition: findQualityFiles.py:443
phase1PixelTopology::divu52
constexpr uint16_t divu52(uint16_t n)
Definition: phase1PixelTopology.h:115