CMS 3D CMS Logo

Namespaces | Classes | Typedefs | Functions | Variables
cms::cuda Namespace Reference

Namespaces

 allocator
 
 detail
 
 device
 
 host
 
 impl
 

Classes

class  AtomicPairCounter
 
class  bad_alloc
 
class  ContextState
 
class  ESProduct
 
class  EventCache
 
class  HistoContainer
 
class  HostAllocator
 
struct  LaunchParameters
 
class  LogAbsolute
 
class  LogError
 
class  LogImportant
 
class  LogInfo
 
class  LogPrint
 
class  LogProblem
 
class  LogSystem
 
class  LogVerbatim
 
class  LogWarning
 
class  MessageLogger
 
class  Product
 
class  ProductBase
 
class  ScopedContextAcquire
 
class  ScopedContextAnalyze
 
class  ScopedContextProduce
 
class  ScopedContextTask
 
class  ScopedSetDevice
 
struct  SimpleVector
 
class  StreamCache
 
class  VecArray
 

Typedefs

template<typename I , uint32_t MAXONES, uint32_t MAXMANYS>
using OneToManyAssoc = HistoContainer< uint32_t, MAXONES, MAXMANYS, sizeof(uint32_t) *8, I, 1 >
 
using SharedEventPtr = std::shared_ptr< std::remove_pointer_t< cudaEvent_t > >
 
using SharedStreamPtr = std::shared_ptr< std::remove_pointer_t< cudaStream_t > >
 

Functions

template<typename Histo , typename T >
 __attribute__ ((always_inline)) void countFromVector(Histo *__restrict__ h
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t Func __attribute__ ((always_inline)) void forEachInBins(Hist const &hist
 
template<typename Histo >
 __attribute__ ((always_inline)) void launchZero(Histo *__restrict__ h
 
void abortOnCudaError (const char *file, int line, const char *cmd, const char *error, const char *message, const char *description=nullptr)
 
void * allocate_device (int dev, size_t nbytes, cudaStream_t stream)
 
void * allocate_host (size_t nbytes, cudaStream_t stream)
 
 assert (be >=bs)
 
int chooseDevice (edm::StreamID id)
 
template<typename T >
void copyAsync (cms::cuda::device::unique_ptr< T[]> &dst, const std::vector< T, cms::cuda::HostAllocator< T >> &src, cudaStream_t stream)
 
template<typename T >
void copyAsync (device::unique_ptr< T > &dst, const host::unique_ptr< T > &src, cudaStream_t stream)
 
template<typename T >
void copyAsync (device::unique_ptr< T[]> &dst, const host::unique_ptr< T[]> &src, size_t nelements, cudaStream_t stream)
 
template<typename T >
void copyAsync (edm::propagate_const_array< cms::cuda::device::unique_ptr< T[]>> &dst, const std::vector< T, cms::cuda::HostAllocator< T >> &src, cudaStream_t stream)
 
template<typename T >
void copyAsync (host::unique_ptr< T > &dst, const device::unique_ptr< T > &src, cudaStream_t stream)
 
template<typename T >
void copyAsync (host::unique_ptr< T[]> &dst, const device::unique_ptr< T[]> &src, size_t nelements, cudaStream_t stream)
 
bool cudaCheck_ (const char *file, int line, const char *cmd, cudaError_t result, const char *description=nullptr)
 
bool cudaCheck_ (const char *file, int line, const char *cmd, CUresult result, const char *description=nullptr)
 
int currentDevice ()
 
allocator::GpuCachedBytes deviceAllocatorStatus ()
 
int deviceCount ()
 
bool eventWorkHasCompleted (cudaEvent_t event)
 
 for (auto pj=hist.begin(bs);pj< hist.end(be);++pj)
 
 for (int i=first, nt=offsets[nh];i< nt;i+=gridDim.x *blockDim.x)
 
void free_device (int device, void *ptr)
 
void free_host (void *ptr)
 
EventCachegetEventCache ()
 
StreamCachegetStreamCache ()
 
template<typename F , typename... Args>
std::enable_if_t< std::is_void< std::result_of_t< F &&(Args &&...)> >::valuelaunch (F *kernel, LaunchParameters config, Args &&... args)
 
void launch (void(*kernel)(), LaunchParameters config)
 
template<typename F , typename... Args>
std::enable_if_t< std::is_void< std::result_of_t< F &&(Args &&...)> >::valuelaunch_cooperative (F *kernel, LaunchParameters config, Args &&... args)
 
void launch_cooperative (void(*kernel)(), LaunchParameters config)
 
template<typename T , typename... Args>
device::impl::make_device_unique_selector< T >::bounded_array make_device_unique (Args &&...)=delete
 
template<typename T >
device::impl::make_device_unique_selector< T >::non_array make_device_unique (cudaStream_t stream)
 
template<typename T >
device::impl::make_device_unique_selector< T >::unbounded_array make_device_unique (size_t n, cudaStream_t stream)
 
template<typename T , typename... Args>
device::impl::make_device_unique_selector< T >::bounded_array make_device_unique_uninitialized (Args &&...)=delete
 
template<typename T >
device::impl::make_device_unique_selector< T >::non_array make_device_unique_uninitialized (cudaStream_t stream)
 
template<typename T >
device::impl::make_device_unique_selector< T >::unbounded_array make_device_unique_uninitialized (size_t n, cudaStream_t stream)
 
template<typename T , typename... Args>
host::noncached::impl::make_host_unique_selector< T >::bounded_array make_host_noncached_unique (Args &&...)=delete
 
template<typename T >
host::noncached::impl::make_host_unique_selector< T >::unbounded_array make_host_noncached_unique (size_t n, unsigned int flags=cudaHostAllocDefault)
 
template<typename T >
host::noncached::impl::make_host_unique_selector< T >::non_array make_host_noncached_unique (unsigned int flags=cudaHostAllocDefault)
 
template<typename T , typename... Args>
host::impl::make_host_unique_selector< T >::bounded_array make_host_unique (Args &&...)=delete
 
template<typename T >
host::impl::make_host_unique_selector< T >::non_array make_host_unique (cudaStream_t stream)
 
template<typename T >
host::impl::make_host_unique_selector< T >::unbounded_array make_host_unique (size_t n, cudaStream_t stream)
 
template<typename T , typename... Args>
host::impl::make_host_unique_selector< T >::bounded_array make_host_unique_uninitialized (Args &&...)=delete
 
template<typename T >
host::impl::make_host_unique_selector< T >::non_array make_host_unique_uninitialized (cudaStream_t stream)
 
template<typename T >
host::impl::make_host_unique_selector< T >::unbounded_array make_host_unique_uninitialized (size_t n, cudaStream_t stream)
 
template<class T >
SimpleVector< Tmake_SimpleVector (int capacity, T *data)
 
template<class T >
SimpleVector< T > * make_SimpleVector (SimpleVector< T > *mem, int capacity, T *data)
 
template<typename T >
void memsetAsync (device::unique_ptr< T > &ptr, T value, cudaStream_t stream)
 
template<typename T >
void memsetAsync (device::unique_ptr< T[]> &ptr, int value, size_t nelements, cudaStream_t stream)
 
int numberOfDevices ()
 

Variables

int be = std::min(int(Hist::nbins() - 1), bs + n)
 
 bs = std::max(0, bs - n)
 
VT * co
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t Func V int Func func
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t Func V int n
 
uint32_t nh
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int nthreads
 
uint32_t const T *__restrict__ const uint32_t *__restrict__ offsets
 
VT uint32_t size
 
cudaStream_t stream
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t totSize
 
uint32_t const T *__restrict__ v
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t V
 
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t Func V value
 
V V wmax
 
V wmin
 

Typedef Documentation

◆ OneToManyAssoc

template<typename I , uint32_t MAXONES, uint32_t MAXMANYS>
using cms::cuda::OneToManyAssoc = typedef HistoContainer<uint32_t, MAXONES, MAXMANYS, sizeof(uint32_t) * 8, I, 1>

Definition at line 318 of file HistoContainer.h.

◆ SharedEventPtr

using cms::cuda::SharedEventPtr = typedef std::shared_ptr<std::remove_pointer_t<cudaEvent_t> >

Definition at line 14 of file SharedEventPtr.h.

◆ SharedStreamPtr

using cms::cuda::SharedStreamPtr = typedef std::shared_ptr<std::remove_pointer_t<cudaStream_t> >

Definition at line 14 of file SharedStreamPtr.h.

Function Documentation

◆ __attribute__() [1/3]

template<typename Histo , typename T >
cms::cuda::__attribute__ ( (always_inline)  )
inline

◆ __attribute__() [2/3]

cms::cuda::__attribute__ ( (always_inline)  ) const &
inline

◆ __attribute__() [3/3]

template<typename Histo >
cms::cuda::__attribute__ ( (always_inline)  )
inline

◆ abortOnCudaError()

void cms::cuda::abortOnCudaError ( const char *  file,
int  line,
const char *  cmd,
const char *  error,
const char *  message,
const char *  description = nullptr 
)
inline

Definition at line 19 of file cudaCheck.h.

24  {
25  std::ostringstream out;
26  out << "\n";
27  out << file << ", line " << line << ":\n";
28  out << "cudaCheck(" << cmd << ");\n";
29  out << error << ": " << message << "\n";
30  if (description)
31  out << description << "\n";
32  throw std::runtime_error(out.str());
33  }

References mps_setup::cmd, edmLumisInFiles::description, relativeConstraints::error, FrontierConditions_GlobalTag_cff::file, mps_splice::line, and MillePedeFileConverter_cfg::out.

Referenced by cudaCheck_().

◆ allocate_device()

void * cms::cuda::allocate_device ( int  dev,
size_t  nbytes,
cudaStream_t  stream 
)

Definition at line 16 of file allocate_device.cc.

16  {
17  void *ptr = nullptr;
18  if constexpr (allocator::useCaching) {
19  if (UNLIKELY(nbytes > maxAllocationSize)) {
20  throw std::runtime_error("Tried to allocate " + std::to_string(nbytes) +
21  " bytes, but the allocator maximum is " + std::to_string(maxAllocationSize));
22  }
23  cudaCheck(allocator::getCachingDeviceAllocator().DeviceAllocate(dev, &ptr, nbytes, stream));
24  } else {
25  ScopedSetDevice setDeviceForThisScope(dev);
26  cudaCheck(cudaMalloc(&ptr, nbytes));
27  }
28  return ptr;
29  }

References cudaCheck, cms::cuda::allocator::getCachingDeviceAllocator(), stream, UNLIKELY, and cms::cuda::allocator::useCaching.

Referenced by make_device_unique(), and make_device_unique_uninitialized().

◆ allocate_host()

void * cms::cuda::allocate_host ( size_t  nbytes,
cudaStream_t  stream 
)

Definition at line 15 of file allocate_host.cc.

15  {
16  void *ptr = nullptr;
17  if constexpr (allocator::useCaching) {
18  if (UNLIKELY(nbytes > maxAllocationSize)) {
19  throw std::runtime_error("Tried to allocate " + std::to_string(nbytes) +
20  " bytes, but the allocator maximum is " + std::to_string(maxAllocationSize));
21  }
22  cudaCheck(allocator::getCachingHostAllocator().HostAllocate(&ptr, nbytes, stream));
23  } else {
24  cudaCheck(cudaMallocHost(&ptr, nbytes));
25  }
26  return ptr;
27  }

References cudaCheck, cms::cuda::allocator::getCachingHostAllocator(), stream, UNLIKELY, and cms::cuda::allocator::useCaching.

Referenced by make_host_unique(), and make_host_unique_uninitialized().

◆ assert()

cms::cuda::assert ( be >=  bs)

Referenced by cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::__attribute__(), edm::Trie< T >::_addEntry(), optutl::VariableMapCont::_checkKey(), CMSTopTagger::_find_min_mass(), optutl::CommandLineParser::_getSectionFiles(), optutl::CommandLineParser::_runVariableCommandFromString(), optutl::CommandLineParser::_setVariableFromString(), hltrigreport::Accumulate::accumulate(), npstat::HistoND< Numeric, Axis >::accumulateBinsInBox(), RecoTrackAccumulator::accumulateEvent(), cms::SiPixelDigitizer::accumulatePixelHits(), SiStripDigitizer::accumulateStripHits(), CSCCFEBData::add(), HcalSiPMHitResponse::add(), CSCComparatorData::add(), FWConfigurationManager::add(), TH1Store::add(), edm::eventsetup::EventSetupProvider::add(), edm::eventsetup::EventSetupRecordProvider::add(), edm::eventsetup::EventSetupRecordImpl::add(), hitfit::Fourvec_Event::add(), fftjetcms::add_Grid2d_data(), edm::Principal::addAliasedProduct(), FWDigitSetProxyBuilder::addBoxSetToProduct(), edm::RootOutputTree::addBranch(), edm::RootTree::addBranch(), CSCDMBHeader2005::addCFEB(), CSCDMBHeader2013::addCFEB(), CalibrationXML::addChild(), trigger::TriggerEvent::addCollections(), addElements(), TAPD::addEntry(), trklet::TrackDerTable::addEntry(), edm::IndexIntoFile::addEntry(), ViewerParameterGUI::addFrameToContainer(), trklet::MatchEngine::addInput(), trklet::ProjectionRouter::addInput(), trklet::TrackletEngine::addInput(), trklet::TripletEngine::addInput(), trklet::FitTrack::addInput(), trklet::TrackletCalculator::addInput(), trklet::PurgeDuplicate::addInput(), trklet::TrackletEngineDisplaced::addInput(), trklet::MatchCalculator::addInput(), trklet::TrackletCalculatorDisplaced::addInput(), trklet::MatchProcessor::addInput(), trklet::TrackletProcessor::addInput(), trklet::VMRouter::addInput(), edm::ProductRegistry::addLabelAlias(), OMTFinput::addLayerHit(), trklet::TrackletCalculatorDisplaced::addLayerProj(), trklet::TrackletCalculatorBase::addLayerProj(), trklet::Tracklet::addMatch(), trklet::Tracklet::addMatchDisk(), HLTPerformanceInfo::addModuleToPath(), reco::PFRecHit::addNeighbour(), trigger::TriggerRefsCollections::addObjects(), trklet::MatchEngine::addOutput(), trklet::ProjectionRouter::addOutput(), trklet::TrackletEngine::addOutput(), trklet::FitTrack::addOutput(), trklet::TripletEngine::addOutput(), trklet::TrackletCalculator::addOutput(), trklet::PurgeDuplicate::addOutput(), trklet::TrackletEngineDisplaced::addOutput(), trklet::MatchCalculator::addOutput(), trklet::TrackletCalculatorDisplaced::addOutput(), trklet::TrackletProcessor::addOutput(), trklet::MatchProcessor::addOutput(), trklet::VMRouter::addOutput(), trklet::TrackletCalculator::addOutputProjection(), trklet::TrackletCalculatorDisplaced::addOutputProjection(), trklet::TrackletProcessor::addOutputProjection(), HcalAmplifier::addPedestals(), trklet::DTC::addphi(), trklet::Cabling::addphi(), edm::ProductRegistry::addProduct(), edm::Principal::addProduct_(), trklet::TrackletProjectionsMemory::addProj(), trklet::TrackletCalculatorDisplaced::addProjection(), trklet::TrackletCalculatorBase::addProjection(), trklet::TrackletCalculatorDisplaced::addProjectionDisk(), trklet::TrackletCalculatorBase::addProjectionDisk(), trklet::VarInv::addr_to_ival(), jetCollectionTools.RecoJetAdder::addRecoJetCollection(), MuonCSCChamberResidual::addResidual(), pos::PixelTKFECConfig::addressFromTKFECID(), HcalTriggerPrimitiveAlgo::addSignal(), FWFromTEveCaloDataSelector::addSliceSelector(), trklet::InputLinkMemory::addStub(), trklet::Sector::addStub(), edm::Principal::addSwitchAliasProduct(), edm::Principal::addSwitchProducerProduct(), FWEventItemsManager::addTo(), FWEveView::addTo(), npstat::HistoND< Numeric, Axis >::addToBinContents(), npstat::HistoND< Numeric, Axis >::addToOverflows(), npstat::ArrayND< Num1, Len1, Dim1 >::addToProjection(), npstat::HistoND< Numeric, Axis >::addToProjection(), edm::WorkerManager::addToUnscheduledWorkers(), CSCPairResidualsConstraint::addTrack(), trklet::VMProjectionsMemory::addTracklet(), IntermediateHitTriplets::RegionFiller::addTriplets(), FWModelContextMenuHandler::addViewEntry(), trklet::VMStubsTEMemory::addVMStub(), edm::UnscheduledCallProducer::addWorker(), FFTSimpleScalingAdjuster< MyJet, Adjustable >::adjust(), FFTUncertaintyAdjuster< MyJet, Adjustable >::adjust(), FFTScalingAdjusterWithUncertainty< MyJet, Adjustable >::adjust(), trklet::VarAdjustK::adjust(), edm::PrincipalCache::adjustEventsToNewProductRegistry(), edm::Principal::adjustIndexesAfterProductRegistryAddition(), InputFile::advance(), edm::IndexIntoFile::IndexIntoFileItrImpl::advanceToNextLumiOrRun(), TrackPropagation::algebraicSymMatrix55ToG4ErrorTrajErr(), LumiDetails::algoNames(), algorithm(), HcalGeometry::alignmentBarEndForIndexLocal(), HcalGeometry::alignmentOuterIndexLocal(), CaloTowerGeometry::alignmentTransformIndexLocal(), ZdcGeometry::alignmentTransformIndexLocal(), CastorGeometry::alignmentTransformIndexLocal(), EcalPreshowerGeometry::alignmentTransformIndexLocal(), EcalEndcapGeometry::alignmentTransformIndexLocal(), HcalGeometry::alignmentTransformIndexLocal(), EcalBarrelGeometry::alignmentTransformIndexLocal(), npstat::HistoND< Numeric, Axis >::allBinCenters(), CaloSubdetectorGeometry::allocateCorners(), CaloSubdetectorGeometry::allocatePar(), SiStripThreshold::allThresholds(), trklet::DiskResidual::alpha(), trklet::Tracklet::alphadisk(), CastorAmplifier::amplify(), ESElectronicsSimFast::analogToDigital(), ZHistogrammer::analyze(), ZMCHistogrammer::analyze(), PlaybackRawDataProvider::analyze(), SiPixelPhase1TrackClustersV::analyze(), TriggerSummaryAnalyzerAOD::analyze(), HcalPulseContainmentTest::analyze(), BufferedBoostIODBWriter::analyze(), L1TDEMON::analyze(), L1TdeStage2CaloLayer1::analyze(), HLTEventAnalyzerAOD::analyze(), HLTEventAnalyzerRAW::analyze(), TrackingRecoMaterialAnalyser::analyze(), EcalPerEvtLaserAnalyzer::analyze(), DrellYanValidation::analyze(), EcalABAnalyzer::analyze(), EcalTestPulseAnalyzer::analyze(), EcalLaserAnalyzer2::analyze(), HGCalHitCalibration::analyze(), FFTJetCorrectorDBWriter::analyze(), EcalLaserAnalyzer::analyze(), METTester::analyze(), SiPhase2OuterTrackerLorentzAngleWriter::analyze(), HcalLutAnalyzer::analyze(), PixelLumiDQM::analyze(), FFTJetPileupAnalyzer::analyze(), JetAnalyzer_HeavyIons::analyze(), HLTriggerJSONMonitoring::analyze(), L1TriggerJSONMonitoring::analyze(), MuonGeometrySanityCheck::analyze(), METAnalyzer::analyze(), PFAnalysis::analyze(), PrimaryVertexAnalyzer4PUSlimmed::analyze(), SiStripTrackingRecHitsValid::analyze(), EcalSelectiveReadoutValidation::analyzeEB(), HcalTriggerPrimitiveAlgo::analyzeHF(), HcalTriggerPrimitiveAlgo::analyzeHF2016(), HcalTriggerPrimitiveAlgo::analyzeHFQIE10(), PixelClusterShapeExtractor::analyzeRecTracks(), HLTEventAnalyzerAOD::analyzeTrigger(), HLTEventAnalyzerRAW::analyzeTrigger(), CSCConditions::anodeBXoffset(), pos::PixelPortCardConfig::AOHBiasAddressFromAOHNumber(), pos::PixelPortCardConfig::AOHGainAddressFromAOHNumber(), pos::PixelPortCardConfig::AOHGainStringFromAOHNumber(), PhotonFix::aPhi(), edm::HistoryAppender::appendToProcessHistory(), CSCAlignmentCorrections::applyAlignment(), edm::ContainerMask< T >::applyOrTo(), areaInfo::areaInfo(), edm::TypeWithDict::arrayDimension(), edm::TypeWithDict::arrayLength(), npstat::Private::ArrayMapper< Num1, Len1, Dim1, Num2, Len2, Dim2 >::ArrayMapper(), npstat::ArrayND< Num1, Len1, Dim1 >::ArrayND(), npstat::ArrayRange::ArrayRange(), FWCaloDataHistProxyBuilder::assertCaloDataSlice(), FWHFTowerProxyBuilderBase::assertCaloDataSlice(), FWHGTowerProxyBuilderBase::assertCaloDataSlice(), pat::eventhypothesis::Looper< T >::assertOk(), EZMgrFL< T >::assign(), EZArrayFL< GlobalPoint >::assign(), DTTFBitArray< N >::assign(), BitArray< 9 >::assign(), asSMatrix(), PFAnalysis::associateClusterToSimCluster(), PFAlgo::associatePSClusters(), fwlite::EventContainer::atEnd(), FWStringParameterSetter::attach(), FWBoolParameterSetter::attach(), FWDoubleParameterSetter::attach(), FWLongParameterSetter::attach(), FWEnumParameterSetter::attach(), npstat::Private::axesOfASlice(), MEEBGeom::barrel(), trklet::TrackletCalculatorBase::barrelSeeding(), Basic2DGenericPFlowPositionCalc::Basic2DGenericPFlowPositionCalc(), EcalClusterLazyToolsBase::BasicClusterTime(), Json::BatchAllocator< AllocatedType, objectPerAllocation >::BatchAllocator(), edm::RootOutputFile::beginInputFile(), gen::Pythia6Gun::beginLuminosityBlock(), cms::Phase2TrackerDigitizer::beginLuminosityBlock(), edm::test::TestProcessor::beginLuminosityBlock(), L1Muon2RecoTreeProducer::beginRun(), L1MuonRecoTreeProducer::beginRun(), DQMEDAnalyzer::beginStream(), edm::Schedule::beginStream(), trklet::bendencode(), cond::auth::Cipher::bf_process_alloc(), npstat::HistoND< Numeric, Axis >::binBox(), npstat::HistoND< Numeric, Axis >::binCenter(), trklet::FPGAWord::bits(), pos::PixelROCName::blade(), pos::PixelModuleName::blade(), GctFormatTranslateV35::blockToGctInternEmCand(), GctFormatTranslateV38::blockToGctInternEmCand(), GctFormatTranslateV35::blockToGctJetCandsAndCounts(), GctFormatTranslateV38::blockToGctJetCandsAndCounts(), GctFormatTranslateMCLegacy::blockToGctJetCandsAndCounts(), GctFormatTranslateV35::blockToRctCaloRegions(), GctFormatTranslateV38::blockToRctCaloRegions(), GctFormatTranslateV35::blockToRctEmCand(), GctFormatTranslateV38::blockToRctEmCand(), GctFormatTranslateMCLegacy::blockToRctEmCand(), HistogramManager::book(), L1TDEMON::bookHistograms(), BeamMonitor::bookHistograms(), FakeBeamMonitor::bookHistograms(), HLTBTagPerformanceAnalyzer::bookHistograms(), TrackingMonitor::bookHistograms(), dqm::implementation::IBooker::bookME(), MVAJetPuId::bookReader(), PrimaryVertexValidation::bookResidualsHistogram(), dqm::implementation::DQMStore::bookTransaction(), optutl::VariableMapCont::boolValue(), edm::BranchTypeToAuxBranchName(), edm::BranchTypeToAuxiliaryBranchName(), edm::BranchTypeToBranchEntryInfoBranchName(), edm::BranchTypeToInfoTreeName(), edm::BranchTypeToMetaDataTreeName(), edm::BranchTypeToProductProvenanceBranchName(), edm::BranchTypeToProductStatusBranchName(), edm::BranchTypeToProductTreeName(), BTagSFProducer::BTagSFProducer(), FastTimeGeometryLoader::build(), HGCalGeometryLoader::build(), MTDGeomBuilderFromGeometricTimingDet::build(), TrackerGeomBuilderFromGeometricDet::build(), CSCGeometryBuilder::build(), FWSimpleProxyBuilderTemplate< TrajectorySeed >::build(), KDTreeLinkerAlgo< reco::PFRecHit const * >::build(), PFClusterFromHGCalMultiCluster::buildClusters(), npstat::ArrayND< Num1, Len1, Dim1 >::buildFromShapePtr(), XMLConfigReader::buildGP(), MuonCSCDetLayerGeometryBuilder::buildLayer(), ETLDetLayerGeometryBuilder::buildLayer(), DTGeometryBuilderFromCondDB::buildLayer(), ETLDetLayerGeometryBuilder::buildLayerNew(), HDetIdAssociator::buildMap(), DetIdAssociator::buildMap(), pos::PixelCalibConfiguration::buildObjectsDependingOnTheNameTranslation(), pos::PixelCalibConfiguration::buildROCAndModuleLists(), pos::PixelCalibConfiguration::buildROCAndModuleListsFromROCSet(), pos::PixelNameTranslation::buildROCsFromFEDChannel(), npstat::ArrayND< Num1, Len1, Dim1 >::buildStrides(), DTGeometryBuilderFromCondDB::buildSuperLayer(), BaseCkfTrajectoryBuilder::buildTrajectories(), FWSimpleProxyBuilderTemplate< TrajectorySeed >::buildViewType(), edm::TypeWithDict::byName(), HBHEHitMap::byTowers(), trklet::Cabling::Cabling(), DoublePadeDelay< ODE1, ODE2, DelayTimeModel1, DelayTimeModel2 >::calc(), HIPAlignmentAlgorithm::calcAPE(), calcSampleName(), trklet::Tracklet::calcSeedIndex(), ThirdOrderDelayODE::calculate(), PadeTableODE::calculate(), trklet::TrackDerTable::calculateDerivatives(), edm::ParameterSet::calculateID(), CSCPairResidualsConstraint::calculatePhi(), ElectronEnergyCalibratorRun2::calibrate(), PhotonEnergyCalibratorRun2::calibrate(), SiPixelGainCalibrationForHLTService::calibrate(), SiPixelGainCalibrationServiceBase::calibrate(), CaloCellCrossing::CaloCellCrossing(), cast_to_L1TMuonBarrelParams(), cast_to_L1TMuonGlobalParams(), cast_to_L1TMuonGlobalParams_PUBLIC(), BoostedJetONNXJetTagsProducer::center_norm_pad(), CSCDMBHeader2005::cfebAvailable(), CSCDMBHeader2013::cfebAvailable(), CSCConditions::chamberTimingCorrection(), FWModelChangeManager::changed(), FWViewManagerBase::changeManager(), edm::SoATuple< edm::EDConsumerBase::TokenLookupInfo, bool, edm::EDConsumerBase::LabelPlacement, edm::KindOfType >::changeSize(), pos::PixelNameTranslation::ChannelFromFEDChannel(), pos::PixelCalibConfiguration::channelList(), edm::PrintEventSetupDataRetrieval::check(), l1t::EndCapParamsHelper::check_write(), l1t::PrescalesVetosFractHelper::check_write(), l1t::PrescalesVetosHelper::check_write(), l1t::GlobalParamsHelper::check_write(), CSCEventData::checkALCTClasses(), pos::PixelConfigurationVerifier::checkChannelEnable(), TPedValues::checkEntries(), edm::eventsetup::EventSetupProvider::checkESProducerSharing(), EcalScDetId::checkHashedIndexMap(), SiPixelTemplate2D::checkIllegalIndex(), DeepTauId::checkInputs(), edm::RunHelperBase::checkLumiConsistency(), CaloCellGeometry::checkParmPtr(), MuonDetCleaner< T1, T2 >::checkrecHit(), FWGeometryTableManager::checkRegionOfInterest(), edm::WorkerInPath::checkResultsOfRunWorker(), edm::RunHelperBase::checkRunConsistency(), edm::SetRunHelper::checkRunConsistency(), edm::SetRunForEachLumiHelper::checkRunConsistency(), edm::FirstLuminosityBlockForEachRunHelper::checkRunConsistency(), edm::RootOutputTree::checkSplitLevelsAndBasketSizes(), pos::PixelROCDACSettings::checkTag(), GlobalTrackingRegion::checkTracks(), CosmicTrackingRegion::checkTracks(), RectangularEtaPhiTrackingRegion::checkTracks(), edm::RootTree::checkTriggerCacheImpl(), ThirdHitPredictionFromInvLine::chi2(), SymmetryFit::chi2_element(), SiPixelTemplate::chi2xavg(), SiPixelTemplate::chi2xavgc2m(), SiPixelTemplate::chi2xmin(), SiPixelTemplate::chi2xminc2m(), SiPixelTemplate::chi2yavg(), SiPixelTemplate::chi2yavgc2m(), SiPixelTemplate::chi2ymin(), SiPixelTemplate::chi2yminc2m(), CSCConditions::chipCorrection(), FWModelContextMenuHandler::chosenItem(), cms::CkfTrackCandidateMakerBase::CkfTrackCandidateMakerBase(), PixelTrackCleanerWrapper::clean(), TrajectoryCleaner::clean(), FastTrajectoryCleaner::clean(), ctfseeding::HitExtractorSTRP::cleanedOfClusters(), EcalClusterPUCleaningTools::CleanedSuperCluster(), PixelTrackCleaner::cleanTracks(), dqm::implementation::DQMStore::cleanupLumi(), sistrip::RawToDigiUnpacker::cleanupWorkVectors(), npstat::clearBuffer(), edm::clearLoggedErrorsSummary(), edm::ViewBase::clone(), pos::PixelConfigList::clone(), TrackingRecHit::clone_(), helper::GsfElectronCollectionStoreManager::cloneAndStore(), TrackingRecHit::cloneSH_(), File::close(), npstat::ArrayND< Num1, Len1, Dim1 >::closest(), npstat::HistoND< Numeric, Axis >::closestBin(), MTDThresholdClusterizer::clusterize(), PixelThresholdClusterizer::clusterizeDetUnitT(), helper::ClusterStorer::ClusterHitRecord< SiStripRecHit2D::ClusterRef >rekey(), Model::CMSLinkDeleteOptOs(), CastorCoderFactory::coder(), HcalCoderFactory::coder(), pos::PixelCalibConfiguration::colCounter(), FWViewManagerBase::colorManager(), NamedCandCombinerBase::combine(), CandCombinerBase< OutputCollection, Cloner::CandPtr >::combine(), edm::EventSelector::combine(), SimplePlan1RechitCombiner::combineAuxInfo(), optutl::CommandLineParser::CommandLineParser(), jsoncollector::FastMonitor::commit(), CSCComparatorData::comparatorDigis(), pos::PixelHdwAddress::compare(), compareAlignments(), DEcompare< T >::CompareCollections(), DTGeometryValidate::compareShape(), GEMGeometryValidate::compareShape(), RPCGeometryValidate::compareShape(), ME0GeometryValidate::compareShape(), CSCGeometryValidate::compareShape(), ValidateGeometry::compareShape(), LowPtClusterShapeSeedComparitor::compatible(), PixelClusterShapeSeedComparitor::compatible(), PixelClusterShapeSeedComparitor::compatibleHit(), BasicSingleTrajectoryState::components(), PFMEtSignInterfaceBase::compResolution(), GsfCombinedMaterialEffectsUpdator::compute(), evf::compute_crc(), EcalDccWeightBuilder::computeAllWeights(), SiPixelErrorEstimation::computeAnglesFromDetPosition(), AlignmentPI::TkAlBarycenters::computeBarycenters(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), MuonDTSeedFromRecHits::computeMean(), pos::PixelConfigFile::configurationDataExists(), edm::DataManagingProductResolver::connectTo(), IntermediateHitTriplets::RegionLayerSets::const_iterator::const_iterator(), hitfit::Constraint::Constraint(), CSCGEMMotherboard::constructLCTsGEM(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::consumesInfo(), edm::stream::EDAnalyzerAdaptorBase::consumesInfo(), evf::EvFDaqDirector::contactFileBroker(), edm::ContainerMask< T >::ContainerMask(), edm::contains(), npstat::ArrayND< Num1, Len1, Dim1 >::contractLoop(), fw2dpf::convert(), CaloTowersCreationAlgo::convert(), edm::convert_handle(), convertFile(), npstat::convertHistoToDensity(), npstat::ArrayND< Num1, Len1, Dim1 >::convertLinearIndex(), npstat::ArrayND< Num1, Len1, Dim1 >::convertToLastDimCdf(), fftjetcms::copy_Grid2d_data(), PixelThresholdClusterizer::copy_to_buffer(), npstat::copyBuffer(), DDExpandedNode::copyno(), edm::ProductRegistry::copyProduct(), l1t::Stage1Layer2EtSumAlgorithmImpHW::cordicToMETPhi(), l1t::Stage1Layer2EtSumAlgorithmImpHI::cordicToMETPhi(), FWTextTreeCellRenderer::coreIcondir(), FWCheckBoxIcon::coreIcondir(), coreIcondir(), AutocorrelationAnalyzer::correlation(), reco::tau::countMatches(), AutocorrelationAnalyzer::covariance(), MuonResidualsFitter::covarianceElement(), pos::PixelFEDConfig::crateFromFEDNumber(), pos::PixelTKFECConfig::crateFromTKFECID(), edm::SharedResourcesRegistry::createAcquirer(), CellularAutomaton::createAndConnectCells(), PFAlgo::createCandidatesECAL(), PFAlgo::createCandidatesHCAL(), PFAlgo::createCandidatesHCALUnlinked(), PFAlgo::createCandidatesHF(), FlatHexagon::createCorners(), TruncatedPyramid::createCorners(), FlatTrd::createCorners(), sistrip::RawToDigiUnpacker::createDigis(), LegacyIOHelper::createDirectoryIfNeededAndCd(), edm::service::RandomNumberGeneratorService::createEnginesInVector(), FWViewManagerBase::createInstanceOf(), edm::eventsetup::DataProxyProvider::DataProxyContainer::createKeyedProxies(), FWModelContextMenuHandler::createModelContext(), ESDigitizer::createNoisyList(), HcalDbASCIIIO::createObject(), TGeoFromDddService::createShape(), FWGUIManager::createView(), CSCConditions::crossTalk(), CSCConditions::crosstalkIntercept(), CSCConditions::crosstalkSlope(), MEEEGeom::crystal(), MEEEGeom::crystal_in_sc(), CSCBaseElectronicsSim::CSCBaseElectronicsSim(), edm::soa::Table< Args >::CtrFillerFromContainers::ctrFiller(), cond::service::PoolDBOutputService::currentTime(), ThirdHitPredictionFromInvLine::curvature(), FWEventItem::data(), edmNew::DetSet< T >::data(), FWTableViewTableManager::dataChanged(), cms::cuda::ESProduct< T >::dataForCurrentDeviceAsync(), edm::eventsetup::ESRecordsToProxyIndices::dataKeysInRecord(), MaterialBudgetData::dataPerStep(), CSCComparatorData::dataWord(), DTTFBitArray< N >::dataWord(), BitArray< 9 >::dataWord(), cmsHarvester::dbs_check_dataset_spread(), cmsHarvester::dbs_resolve_cmssw_version(), cmsHarvester::dbs_resolve_dataset_name(), cmsHarvester::dbs_resolve_datatype(), cmsHarvester::dbs_resolve_globaltag(), cmsHarvester::dbs_resolve_number_of_events(), cmsHarvester::dbs_resolve_runs(), MEEEGeom::dcc(), ME::dccAndSide(), MEEBGeom::dccFromSm(), MEEEGeom::dccFromSm(), ParticleDecayDrawer::decay(), EcalDumpRaw::decode(), edm::decode(), MEEEGeom::dee(), DeepCombinedONNXJetTagsProducer::DeepCombinedONNXJetTagsProducer(), edm::ProductProvenanceRetriever::deepCopy(), DeepDoubleXONNXJetTagsProducer::DeepDoubleXONNXJetTagsProducer(), DeepFlavourONNXJetTagsProducer::DeepFlavourONNXJetTagsProducer(), DeepVertexONNXJetTagsProducer::DeepVertexONNXJetTagsProducer(), spu::def(), HBHEDarkening::degradation(), edm::Principal::deleteProduct(), edm::SubProcess::deleteRunFromCache(), EcalDetailedTimeRecHitProducer::deltaTimeOfFlight(), fftjetcms::densePeakTreeFromStorable(), fftjetcms::densePeakTreeToStorable(), ProcessCallGraph::depends(), PhysicsTools::VarProcessor::deriv(), jsoncollector::JSONSerializer::deserialize(), FFTJetProducer::determineGriddedConstituents(), FFTJetProducer::determinePileup(), ClusterShape::determineShape(), FFTJetProducer::determineVectorConstituents(), HcalGeometry::detIdFromBarrelAlignmentIndex(), EcalTrigTowerDetId::detIdFromDenseIndex(), HcalGeometry::detIdFromEndcapAlignmentIndex(), HcalGeometry::detIdFromForwardAlignmentIndex(), HcalGeometry::detIdFromLocalAlignmentIndex(), HcalGeometry::detIdFromOuterAlignmentIndex(), CaloTDigitizer< Traits, runHelper >::detIds(), MuonGeometrySanityCheckPoint::detName(), PixelCPEBase::detParam(), edm::DetSetRefVector< T, C >::DetSetRefVector(), edmNew::dstvdetails::DetSetVectorTrans::DetSetVectorTrans(), FWDigitSetProxyBuilder::digitSet(), CmsShowModelPopup::disconnectAll(), reco::DiscretizedEnergyFlow::DiscretizedEnergyFlow(), fftjetcms::FFTJetInterface::discretizeEnergyFlow(), pos::PixelROCName::disk(), pos::PixelModuleName::disk(), DiskSectorBounds::DiskSectorBounds(), trklet::TrackletCalculatorBase::diskSeeding(), npstat::HistoND< Numeric, Axis >::dispatch(), edm::distinct(), SiLinearChargeDivider::divide(), MuonAlignmentInputXML::do_setposition(), edm::stream::EDFilterAdaptorBase::doAcquire(), edm::stream::EDProducerAdaptorBase::doAcquire(), doBZ2Compression(), edm::stream::EDFilterAdaptorBase::doEvent(), edm::stream::EDProducerAdaptorBase::doEvent(), edm::stream::EDAnalyzerAdaptorBase::doEvent(), lhef::domToLines(), edm::IDGeneratorSourceBase< PuttableSourceBase >::doReadEvent(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::doRegisterThinnedAssociations(), FWHFTowerSliceSelector::doSelect(), FWHGTowerSliceSelector::doSelect(), FWFromTEveCaloDataSelector::doSelect(), l1t::Stage1Layer2EtSumAlgorithmImpHW::doSumAndMET(), l1t::Stage1Layer2EtSumAlgorithmImpHI::doSumAndMET(), HitPairGeneratorFromLayerPair::doublets(), optutl::VariableMapCont::doubleValue(), optutl::VariableMapCont::doubleVector(), FWHFTowerSliceSelector::doUnselect(), FWHGTowerSliceSelector::doUnselect(), FWFromTEveCaloDataSelector::doUnselect(), FWLiteJobMetadataManager::doUpdate(), FWFFMetadataManager::doUpdate(), FWStringParameterSetter::doUpdate(), FWBoolParameterSetter::doUpdate(), FWLongParameterSetter::doUpdate(), FWDoubleParameterSetter::doUpdate(), FWEnumParameterSetter::doUpdate(), Pythia8::PowhegHooksBB4L::doVetoProcessLevel(), edm::Worker::doWork(), doZlibCompression(), DQMAnalyzer::DQMAnalyzer(), MEGeom::drawHist(), trklet::Cabling::dtc(), trklet::DTCLink::DTCLink(), edmNew::DetSetVector< T >::FastFiller::dummy(), edmNew::DetSetVector< T >::TSFastFiller::dummy(), ProvenanceDumper::dumpEventFilteringParameterSets_(), dumpFiles(), GeometryInfoDump::dumpInfo(), File::duplicate(), EcalCoder::EcalCoder(), EcalEleCalibLooper::EcalEleCalibLooper(), ME::ecalRegion(), EcalTimeMapDigitizer::EcalTimeMapDigitizer(), EDMtoMEConverter::EDMtoMEConverter(), EcalSelectiveReadout::eeRuInterest(), EgammaTowerIsolation::EgammaTowerIsolation(), EcalSimRawData::elec2GeomNum(), ElectronAnalyzer::ElectronAnalyzer(), edm::FileIndex::Element::Element(), PFAlgo::elementLoop(), EmDQMReco::EmDQMReco(), edm::ProcessBlock::emplaceImpl(), edm::LuminosityBlock::emplaceImpl(), edm::Run::emplaceImpl(), edm::Event::emplaceImpl(), EcalCoder::encode(), edm::encode(), CordicXilinx::encodeAngle(), encodeFile(), FWModelChangeManager::endChanges(), lhef::LHEReader::XMLHandler::endElement(), EcalMatacqAnalyzer::endJob(), TestCUDAAnalyzerGPU::endJob(), EcalPerEvtLaserAnalyzer::endJob(), EcalLaserAnalyzer2::endJob(), EcalLaserAnalyzer::endJob(), BuildTrackerMapPlugin::endJob(), edm::Schedule::endStream(), dqm::implementation::DQMStore::enterLumi(), edm::RootTree::entryNumberForIndex(), edm::ParameterSet::eraseOrSetUntrackedParameterSet(), edm::ParameterSet::eraseSimpleParameter(), CSCPairResidualsConstraint::error(), ThirdHitPredictionFromInvLine::errorCurvature(), MuonResidualsFitter::errorerror(), KfComponentsHolder::errors(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::esGetTokenIndicesVector(), edm::stream::EDAnalyzerAdaptorBase::esGetTokenIndicesVector(), edm::EDConsumerBase::esGetTokenIndicesVector(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::esGetTokenRecordIndicesVector(), edm::stream::EDAnalyzerAdaptorBase::esGetTokenRecordIndicesVector(), edm::EDConsumerBase::esGetTokenRecordIndicesVector(), ESHitResponse::ESHitResponse(), edm::Worker::esPrefetchAsync(), PhotonFix::etaC(), fftjetcms::EtaDependentPileup::EtaDependentPileup(), PhotonFix::etaM(), PhotonFix::etaS(), EcalEleCalibLooper::etaShifter(), FlatHexagon::etaSpan(), FlatTrd::etaSpan(), l1t::CorrCondition::evaluateCondition(), l1t::CorrWithOverlapRemovalCondition::evaluateCondition(), trklet::TrackletEventProcessor::event(), edm::test::TestProcessor::event(), EventMsgBuilder::EventMsgBuilder(), edm::EventPrincipal::EventPrincipal(), edm::EventRange::EventRange(), EveService::EveService(), npstat::HistoND< Numeric, Axis >::examine(), trklet::MatchEngine::execute(), trklet::TrackletEngine::execute(), trklet::TripletEngine::execute(), trklet::TrackletEngineDisplaced::execute(), trklet::MatchCalculator::execute(), trklet::MatchProcessor::execute(), trklet::TrackletProcessor::execute(), DDCutTubsFromPoints::execute(), trklet::FitTrack::execute(), trklet::VMRouter::execute(), DDEcalEndcapAlgo::execute(), HistogramManager::executeExtend(), HistogramManager::executeGroupBy(), HistogramManager::executeHarvesting(), HistogramManager::executePerEventHarvesting(), npstat::BoxND< unsigned >::expand(), npstat::ArrayND< Num1, Len1, Dim1 >::exportSlice(), npstat::ArrayND< Num1, Len1, Dim1 >::exportSubrange(), LayerHitMapCache::SimpleCache::extend(), GeometryInterface::extract(), DDI::ExtrudedPolygon::ExtrudedPolygon(), EZArrayFL< GlobalPoint >::EZArrayFL(), EZMgrFL< T >::EZMgrFL(), edm::RootOutputTree::fastCloneTTree(), fastjetarea_(), fastjetconstituents_(), fastjetdmerge_(), fastjetdmergemax_(), SiPixelGenError::fbin(), SiPixelTemplate::fbin(), HcalBaseSignalGenerator::fC2pe(), HFSimParameters::fCtoGeV(), CastorSimParameters::fCtoGeV(), HcalSimParameters::fCtoGeV(), HPDIonFeedbackSim::fCtoGeV(), pos::PixelFECConfig::FECSlotFromVMEBaseAddress(), pos::PixelCalibConfiguration::fedCardsAndChannels(), pos::PixelNameTranslation::FEDChannelExist(), pos::PixelFEDConfig::FEDNumberFromCrateAndVMEBaseAddress(), FedRawDataInputSource::FedRawDataInputSource(), l1tpf_calo::SimpleCaloLinkerBase::fetch(), l1tpf_calo::SingleCaloClusterer::fetchCells(), FFTSpecificScaleCalculator< MyJet, Adjustable >::FFTSpecificScaleCalculator(), edm::RootInputFileSequence::fileBranchIDListHelper(), gs::fileDirname(), edm::RootInputFileSequence::fileProductRegistry(), gs::fileTail(), PFJetMonitor::fill(), GenericBenchmark::fill(), OffsetAnalyzerDQM::Plot1D::fill(), HistogramManager::fill(), PFCandidateMonitor::fill(), PFCandidateManager::fill(), PFJetAnalyzerDQM::Plot1DInBin::fill(), MELaserPrim::fill(), PFJetAnalyzerDQM::Plot1DInBinVariable::fill(), PixelRegions::PixelRegionContainers::fill(), npstat::HistoND< Numeric, Axis >::fill(), OffsetAnalyzerDQM::PlotProfile::fill2D(), CaloCleaner< T >::fill_correction_map(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), CollectionMerger< T1, T2 >::fill_output_obj(), edm::RootOutputFile::fillBranches(), PVValHelper::fillByIndex(), npstat::HistoND< Numeric, Axis >::fillC(), FWHFTowerProxyBuilderBase::fillCaloData(), FWHGTowerProxyBuilderBase::fillCaloData(), InOutConversionSeedFinder::fillClusterSeeds(), EcalUncalibRecHitProducer::fillDescriptions(), MTDCPEBase::fillDetParams(), PixelCPEBase::fillDetParams(), gainCalibHelper::gainCalibPI::fillDiffAndRatio(), SiStripDaqInfo::fillDummyStatus(), SiStripDcsInfo::fillDummyStatus(), pat::PATElectronProducer::fillElectron(), edm::RootFile::fillEventHistory(), edm::IndexIntoFile::fillEventNumbersOrEntries(), FedRawDataInputSource::fillFEDRawDataCollection(), MELaserPrim::fillHistograms(), TrackerValidationVariables::fillHitQuantities(), fwlite::EntryFinder::fillIndex(), edm::RootFile::fillIndexIntoFile(), HistogramManager::fillInternal(), edm::fillLooper(), EcalElectronicsMapper::fillMaps(), pos::PixelPortCardConfig::fillNameToAddress(), MuonAlignmentFromReference::fillNtuple(), Phase2StripCPE::fillParam(), StripCPE::fillParams(), edm::fillPathSummary(), FastTimerServiceClient::fillPathSummaryPlots(), ClusterShapeHitFilter::fillPixelData(), FastTimerServiceClient::fillPlotsVsLumi(), FWTGeoRecoGeometry::Info::fillPoints(), FWRecoGeometryESProducer::fillPoints(), edm::fillProcessHistoryBranch(), CSCHitFromStripOnly::fillPulseHeights(), edm::IndexIntoFile::fillRunOrLumiIndexes(), CaloParticleDebugger::fillSimHits(), SiStripDcsInfo::fillStatus(), ClusterShapeHitFilter::fillStripData(), trklet::TrackDerTable::fillTable(), SimpleFlatTableProducer< T >::fillTable(), TrackerValidationVariables::fillTrackQuantities(), edm::WrapperBase::fillView(), HGCalHitCalibration::fillWithRecHits(), edm::StreamSchedule::fillWorkers(), PFJetFilter::filter(), BadGlobalMuonTagger::filter(), HLTPathSelector::filter(), ElectronRegressionEnergyProducer::filter(), L1TGlobalPrescaler::filter(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::find(), edm::DetSetVector< TotemRPLocalTrack::FittedRecHit >::find(), edm::DetSetRefVector< T, C >::find(), l1tpf_calo::Phase1GridBase::find_cell(), find_element_ref(), findBestMatchingLepton(), IRPCDigitizer::findDet(), RPCDigitizer::findDet(), cms::DDDetector::findElement(), edm::FileIndex::findEventEntryPosition(), edm::IndexIntoFile::findEventPosition(), pat::PATGenCandsFromSimTracksProducer::findGeantMother(), edm::EventSetupRecordIntervalFinder::findIntervalFor(), CSCBaseValidation::findLayer(), CSCDigitizer::findLayer(), edm::IndexIntoFile::findLumiPosition(), SiPixelInformationExtractor::findNoisyPixels(), edm::findOrAssert(), dqm::implementation::DQMStore::findOrRecycle(), MultipleCompare::FindParents(), edm::FileIndex::findPosition(), edm::IndexIntoFile::findPosition(), edm::Principal::findProductByTag(), pat::PATGenCandsFromSimTracksProducer::findRef(), GenParticlesHelper::findSisters(), CellularAutomaton::findTriplets(), trklet::Tracklet::finervm(), trklet::Tracklet::finezvm(), edm::StreamSchedule::finishedPaths(), pos::PixelDACScanRange::first(), pat::eventhypothesis::Looper< T >::first(), PFJetIDSelectionFunctor::firstDataCuts(), pos::PixelNameTranslation::firstHdwAddress(), cms::DDFilteredView::firstSibling(), KinematicConstrainedVertexFitterT< nTrk, nConstraint >::fit(), PulseShapeFitOOTPileupCorrection::fit(), hitfit::Top_Fit::fit(), hitfit::Chisq_Constrainer::fit(), hitfit::Fit_Result_Vec::Fit_Result_Vec(), MuonAlignmentFromReference::fitAndAlign(), GsfTrajectoryFitter::fitOne(), KFTrajectoryFitter::fitOne(), MuonResidualsFitter::fix(), edm::BranchIDListHelper::fixBranchListIndexes(), MuonResidualsFitter::fixed(), edm::ProvenanceAdaptor::fixProcessHistory(), File::flush(), DQMService::flushStandalone(), for(), reco::FormulaEvaluator::FormulaEvaluator(), trklet::DiskProjection::fpgafinervm(), trklet::LayerProjection::fpgafinezvm(), trklet::LayerProjection::fpgaphiproj(), trklet::DiskProjection::fpgaphiproj(), trklet::Tracklet::fpgaphiproj(), trklet::LayerProjection::fpgaphiprojder(), trklet::DiskProjection::fpgaphiprojder(), trklet::Tracklet::fpgaphiprojder(), trklet::Tracklet::fpgaphiprojderdisk(), trklet::Tracklet::fpgaphiprojdisk(), trklet::LayerProjection::fpgaphiprojvm(), trklet::DiskProjection::fpgaphiprojvm(), trklet::LayerResidual::fpgaphiresid(), trklet::DiskResidual::fpgaphiresid(), trklet::Tracklet::fpgaphiresid(), trklet::Tracklet::fpgaphiresiddisk(), trklet::DiskProjection::fpgarbin1projvm(), trklet::DiskProjection::fpgarbin2projvm(), trklet::DiskProjection::fpgarproj(), trklet::DiskProjection::fpgarprojder(), trklet::Tracklet::fpgarprojderdisk(), trklet::Tracklet::fpgarprojdisk(), trklet::DiskProjection::fpgarprojvm(), trklet::DiskResidual::fpgarresid(), trklet::Tracklet::fpgarresiddisk(), trklet::LayerResidual::fpgastubid(), trklet::DiskResidual::fpgastubid(), trklet::LayerProjection::fpgazbin1projvm(), trklet::LayerProjection::fpgazbin2projvm(), trklet::LayerProjection::fpgazproj(), trklet::Tracklet::fpgazproj(), trklet::LayerProjection::fpgazprojder(), trklet::Tracklet::fpgazprojder(), trklet::LayerProjection::fpgazprojvm(), trklet::LayerResidual::fpgazresid(), trklet::Tracklet::fpgazresid(), EcalSelectiveReadoutValidation::frame2Energy(), edm::FreshErrorsExist(), edm::Guid::fromBinary(), edm::Guid::fromString(), FsmwModeFinder3d::FsmwModeFinder3d(), trklet::Tracklet::fullmatchdiskstr(), trklet::FullMatchMemory::FullMatchMemory(), trklet::Tracklet::fullmatchstr(), FWCustomIconsButton::FWCustomIconsButton(), edm::FwdPtr< T >::FwdPtr(), edm::FwdRef< reco::GenJetCollection >::FwdRef(), FWFFHelper::FWFFHelper(), FWGUIManager::FWGUIManager(), FWSelectionManager::FWSelectionManager(), FWFileEntry::fwTreeCache(), TrackPropagation::g4ErrorTrajErrToAlgebraicSymMatrix55(), CSCConditions::gain(), CSCConditions::gasGainCorrection(), GBRForestsAndConstants::GBRForestsAndConstants(), GEMStripTopology::GEMStripTopology(), GeneralBinFinderInZforGeometricSearchDet< float >::GeneralBinFinderInZforGeometricSearchDet(), pat::PATGenCandsFromSimTracksProducer::generatorRef_(), EcalHitResponse::geometry(), RemoteFile::get(), edm::test::ProcessBlock::get(), edm::test::Run::get(), edm::test::Event::get(), edm::test::LuminosityBlock::get(), fwlite::Record::get(), fwlite::EventSetup::get(), edm::serviceregistry::ServicesManager::get(), SiPixelClusterShapeCache::get(), pos::PixelConfigFile::get(), dqm::implementation::IGetter::get(), hitfit::Pair_Table::get_pair(), trainingvars::get_var_pset(), getABABOutputStream(), pos::PixelTKFECConfig::getAddress(), CaloGeometryDBEP< T, U >::getAlignGlobal(), SiPixelLayoutParser::getAllLayouts(), edm::getAnyPtr(), pos::PixelPortCardConfig::getAOHGain(), trklet::Tracklet::getBendIndex(), MEGeom::getBoundary(), MEEEGeom::getBoundary(), edm::PrincipalGetAdapter::getBranchDescription(), fwlite::EventContainer::getBranchNameFor(), fwlite::DataGetterHelper::getByBranchDescription(), fwlite::EventContainer::getByLabel(), edm::Principal::getByLabel(), edm::Principal::getByToken(), MEChannel::getChannel(), pos::PixelNameTranslation::getChannelForROC(), pos::PixelNameTranslation::getChannelFromHdwAddress(), pos::PixelNameTranslation::getChannelsOnModule(), HcalGeometry::getClosestCell(), matrixSaver::getConcreteMatrixVector(), JetMatchingTools::getConstituentHits(), npstat::BoxNDScanner< Numeric >::getCoords(), npstat::LinInterpolatedTableND< Numeric, Axis >::getCoords(), CaloCellGeometry::getCorners(), pos::PixelFEDConfig::getCrate(), pos::PixelTKFECConfig::getCrate(), L1TMuon::GeometryTranslator::getCSCSpecificPoint(), CSCTriggerPrimitivesReader::getCSCType(), pos::PixelROCDACSettings::getDac(), TAPDPulse::getDelta(), EcalTBHodoscopeGeometryLoaderFromDDD::getDetIdForDDDNode(), pos::PixelPortCardConfig::getdeviceAddress(), pos::PixelPortCardConfig::getdeviceAddressForSetting(), pos::PixelPortCardConfig::getdeviceValues(), pos::PixelPortCardConfig::getdeviceValuesForAddress(), SiStripLayoutParser::getDocument(), EcalElectronicsMapping::getEcalScDetId(), edm::Principal::getExistingProduct(), pos::PixelCalibConfiguration::getFECCrates(), pos::PixelCalibConfiguration::getFEDCrates(), pos::PixelFEDConfig::getFEDNumber(), pos::PixelDetectorConfig::getFEDs(), pos::PixelDetectorConfig::getFEDsAndChannels(), pos::PixelCalibConfiguration::getFEDsAndChannels(), getFlagStream(), dqm::impl::MonitorElement::getFloatValue(), edm::eventsetup::EventSetupRecordImpl::getFromProxy(), edm::eventsetup::EventSetupRecordImpl::getFromProxyAfterPrefetch(), L1TMuon::GeometryTranslator::getGEMSpecificPoint(), FWGeometryTableViewManager::getGeoMangeur(), MEEEGeom::getGraphBoundary(), edm::eventsetup::EventSetupRecord::getHandleImpl(), pos::PixelNameTranslation::getHdwAddress(), MEGeom::getHist(), SiPixelTemplate2D::getid(), edm::eventsetup::EventSetupRecordImpl::getImplementation(), trklet::TrackDerTable::getIndex(), npstat::ArrayNDScanner::getIndex(), npstat::BoxNDScanner< Numeric >::getIndex(), edm::ELseverityLevel::getInputStr(), MELaserPrim::getInt(), EcalTrivialConditionRetriever::getIntercalibConstantsFromConfiguration(), EcalTrivialConditionRetriever::getIntercalibErrorsFromConfiguration(), dqm::impl::MonitorElement::getIntValue(), trklet::Tracklet::getISeed(), edm::Principal::getIt(), trklet::Tracklet::getITC(), edm::Ptr< reco::Muon >::getItem_(), FWHGCalMultiClusterSliceSelector::getItemEntryEtaPhi(), FWPFCandidateTowerSliceSelector::getItemEntryEtaPhi(), FWCaloTowerSliceSelector::getItemEntryEtaPhi(), OMTFinput::getLayerData(), reco::tau::RecoTauVertexAssociator::getLeadCand(), MEChannel::getListOfChannels(), trklet::VMRouterTable::getLookup(), edm::Principal::getManyByType(), BTagPerformance::GetMap(), matrixSaver::getMatrix(), matrixSaver::getMatrixVector(), L1TMuon::GeometryTranslator::getME0SpecificPoint(), jsoncollector::FastMonitor::getMergedIntJForLumi(), npstat::BoxND< unsigned >::getMidpoint(), HLTPerformanceInfo::getModuleOnPath(), edm::ELseverityLevel::getName(), SiStripGainFromAsciiFile::getNewObject(), FedRawDataInputSource::getNextEvent(), evf::EvFDaqDirector::getNextFromFileBroker(), edm::RootPrimaryFileSequence::getNextItemType(), trigger::TriggerRefsCollections::getObjects(), CandMCMatchTableProducer::getParentHadronFlag(), pos::PixelConfigFile::getPath(), XMLConfigReader::getPatternsVersion(), trklet::VMStubsTEMemory::getPhiRange(), HcalSiPMnonlinearity::getPixelsFired(), DeepTauId::getPredictionsV2(), heppy::TriggerBitChecker::getprescale(), edm::Event::getProcessParameterSet(), edm::refcore::getProduct_(), edm::PtrVectorBase::getProduct_(), edm::PrincipalGetAdapter::getProductID(), edm::RefCore::getProductPtr(), edm::ParameterSet::getPSetForUpdate(), edm::ParameterSet::getPSetVectorForUpdate(), dqm::impl::MonitorElement::getQReport(), TAPDPulse::getRatio(), MuonDetCleaner< T1, T2 >::getRawDetId(), PerformancePayloadFromTFormula::getResult(), pos::PixelNameTranslation::getROCsFromFEDChannel(), L1TMuon::GeometryTranslator::getRPCSpecificPoint(), EcalLaserAnalyzer2::getShapes(), FWTrackResidualDetailView::getSignedResidual(), PrimaryVertexAnalyzer4PUSlimmed::getSimPVs(), hgcal::RecHitTools::getSiThickIndex(), ClusterShapeHitFilter::getSizes(), EcalSimRawData::getSrfs(), cms::DDFilteredView::getString(), dqm::impl::MonitorElement::getStringValue(), trklet::VMStubsMEMemory::getStubBin(), trklet::Tracklet::getStubIDs(), EgammaTowerIsolation::getSum(), CaloTowerGeometry::getSummary(), CaloSubdetectorGeometry::getSummary(), HcalGeometry::getSummary(), edm::ELseverityLevel::getSymbol(), ViewerParameterGUI::getTabContainer(), dqm::impl::MonitorElement::getTH1D(), dqm::impl::MonitorElement::getTH1F(), dqm::impl::MonitorElement::getTH1S(), dqm::impl::MonitorElement::getTH2D(), dqm::impl::MonitorElement::getTH2F(), dqm::impl::MonitorElement::getTH2S(), dqm::impl::MonitorElement::getTH3F(), edm::Principal::getThinnedKeyFrom(), edm::Principal::getThinnedProduct(), edm::Principal::getThinnedProducts(), EcalTrivialConditionRetriever::getTimeCalibConstantsFromConfiguration(), EcalTrivialConditionRetriever::getTimeCalibErrorsFromConfiguration(), pos::PixelCalibConfiguration::getTKFECCrates(), pos::PixelTKFECConfig::getTKFECID(), EcalSelectiveReadout::getTowerInterest(), dqm::impl::MonitorElement::getTProfile(), dqm::impl::MonitorElement::getTProfile2D(), trklet::Tracklet::getTrack(), FlatHexagon::getTransform(), TruncatedPyramid::getTransform(), FlatTrd::getTransform(), CaloCellGeometry::getTransform(), pos::PixelTKFECConfig::getType(), CastorNumberingScheme::getUnitID(), MELaserPrim::getVal(), edm::ELseverityLevel::getVarName(), pos::PixelAliasList::getVersion(), pos::PixelFEDConfig::getVMEBaseAddress(), trklet::VMStubsMEMemory::getVMStubMEBin(), heppy::PdfWeightProducerTool::getWeights(), EcalTrivialConditionRetriever::getWeightsFromConfiguration(), CaloSubdetectorTopology::getWindow(), CSCDriftSim::getWireHit(), DTTFBitArray< N >::getWord(), BitArray< 9 >::getWord(), MEEBGeom::globalCoord(), edm::GlobalSchedule::GlobalSchedule(), CachingSeedCleanerBySharedInput::good(), edm::RootPrimaryFileSequence::goToEvent(), evf::EvFDaqDirector::grabNextJsonFile(), grid1d_t(), edm::shared_memory::WriteBuffer::growBuffer(), GsfBetheHeitlerUpdator::GsfBetheHeitlerUpdator(), GsfElectronDataAnalyzer::GsfElectronDataAnalyzer(), CmsShowMainBase::guiManager(), edm::Handle< GenericObject >::Handle(), XrdAdaptor::RequestManager::handle(), edm::Handle< FWGenericObject >::Handle(), edm::HandleBase::HandleBase(), edm::friendlyname::handleTemplateArguments(), hitfit::Objpair::has_constraint(), FWItemAccessorFactory::hasMemberTVirtualCollectionProxy(), HBHELinearMap::HBHELinearMap(), HcalChannelProperties::HcalChannelProperties(), HcalSiPM::HcalSiPM(), HcalSiPMnonlinearity::HcalSiPMnonlinearity(), hcalSubdetectorName(), helicityAngle(), pos::PixelModuleName::HF(), pos::PixelROCName::HF(), HcalTrigTowerGeometry::hfTowerEtaSize(), reco::HGCalMultiCluster::HGCalMultiCluster(), Comparator::Histo(), cms::DDFilteredView::history(), MuonChamberResidual::hitlayer(), CombinedHitQuadrupletGeneratorForPhotonConversion::hitPairs(), CombinedHitPairGeneratorForPhotonConversion::hitPairs(), MuonChamberResidual::hitposition(), HITrackClusterRemover::HITrackClusterRemover(), MuonChamberResidual::hitresid(), ctfseeding::HitExtractorPIX::hits(), CosmicTrackingRegion::hits_(), SimCluster::hits_and_energies(), MultiHitGeneratorFromChi2::hitSets(), PixelTripletLargeTipGenerator::hitTriplets(), PixelTripletHLTGenerator::hitTriplets(), edm::HLTPathStatus::HLTPathStatus(), trigger::HLTPrescaleTable::HLTPrescaleTable(), gen::hwrgen_(), trklet::DiskResidual::ialpha(), trklet::Tracklet::ialphadisk(), l1tpf_calo::Phase1GridBase::imove(), PFHFRecHitCreator::importRecHits(), EcalSRCondTools::importSrpConfigFile(), npstat::ArrayND< Num1, Len1, Dim1 >::importSubrange(), HSCPHLTFilter::IncreasedTreshold(), HSCPValidator::IncreasedTreshold(), CSCAnodeData2007::index(), CSCAnodeData2006::index(), fireworks::expression::indexFromNewFormatToOldFormat(), SiTrivialInduceChargeOnStrips::induceVector(), spu::inf(), trklet::LayerProjection::init(), triggerExpression::PathReader::init(), trklet::DiskProjection::init(), TPNPulse::init(), trklet::DiskResidual::init(), trklet::LayerResidual::init(), trklet::VMRouterPhiCorrTable::init(), TMom::init(), TAPDPulse::init(), trklet::TrackletEventProcessor::init(), SiPixelConfigWriter::init(), SiStripConfigWriter::init(), TShapeAnalysis::init(), MELaserPrim::init(), edm::EventProcessor::init(), DataProxyWrapper< ExDwarfListRcd, cond::persistency::KeyList >::initConcurrentIOVs(), LogicTool< GenLogic >::initialise(), PhotonFix::initialiseGeometry(), PhotonFix::initialiseParameters(), reco::tau::xclean::CrossCleanPiZeros< PtrIter >::initialize(), JetResolution::initialize(), DDCutTubsFromPoints::initialize(), RawEventFileWriterForBU::initialize(), ElectronEnergyRegressionEvaluate::initialize(), EGammaMvaEleEstimatorCSA14::initialize(), TStorageFactoryFile::Initialize(), EGammaMvaEleEstimator::initialize(), reco::tau::xclean::CrossCleanPtrs< PtrIter >::initialize(), npstat::ArrayNDScanner::initialize(), npstat::BoxNDScanner< Numeric >::initialize(), reco::isodeposit::OtherJetConstituentsDeltaRVeto::initialize(), PixelUnpackingRegions::initialize(), XrdAdaptor::RequestManager::initialize(), PreMixingSiStripWorker::initializeEvent(), SiStripDigitizer::initializeEvent(), cms::SiPixelDigitizer::initializeEvent(), edm::IndexIntoFile::IndexIntoFileItrImpl::initializeLumi(), edm::IndexIntoFile::IndexIntoFileItrNoSort::initializeLumi_(), edm::IndexIntoFile::IndexIntoFileItrSorted::initializeLumi_(), EcalPreshowerGeometry::initializeParms(), dqm::implementation::DQMStore::initLumi(), CandMatcherBase< C1, C2 >::initMaps(), InitMsgBuilder::InitMsgBuilder(), HGCalShowerShapeHelper::initPerObject(), edm::RootInputFileSequence::initTheFile(), trklet::InputLinkMemory::InputLinkMemory(), trklet::DTCLink::inRange(), edm::PrincipalCache::insert(), edm::eventsetup::DataProxyProvider::KeyedProxies::insert(), edm::RootOutputFile::insertAncestors(), edm::RootTree::insertEntryForIndex(), optutl::VariableMapCont::integerValue(), optutl::VariableMapCont::integerVector(), SiPixelTemplate2D::interpolate(), SiPixelTemplate::interpolate(), npstat::ArrayND< Num1, Len1, Dim1 >::interpolate3(), npstat::interpolateHistoND(), npstat::ArrayND< Num1, Len1, Dim1 >::interpolateLoop(), l1t::Interval< TimeType, PayloadType >::Interval(), RectangularEtaPhiTrackingRegion::intToUseMeasurementTracker(), edm::ParameterSet::invalidateRegistration(), trklet::TrackDerTable::invert(), npstat::LinInterpolatedTableND< Numeric, Axis >::invert1DResponse(), edm::FunctionWithDict::invoke(), InvRingCalib::InvRingCalib(), edm::serviceregistry::ServicesManager::isAvailable(), pos::PixelCalibConfiguration::iScan(), TrackCleaner::isCompatible(), npstat::ArrayRange::isCompatible(), npstat::ArrayND< Num1, Len1, Dim1 >::isCompatible(), MTDRingForwardDoubleLayer::isCrack(), MuRingForwardDoubleLayer::isCrack(), GenParticlesHelper::isDirect(), edm::RootFile::isDuplicateEvent(), CSCPairResidualsConstraint::isFiducial(), PFMuonAlgo::isGlobalLooseMuon(), PFMuonAlgo::isGlobalTightMuon(), CSCAnodeDataFrame2006::isHit(), CSCAnodeDataFrame2007::isHit(), FWEventItem::isInBack(), FWEventItem::isInFront(), PFMuonAlgo::isIsolatedMuon(), PFMuonAlgo::isLooseMuon(), PFMuonAlgo::isMuon(), edm::EventSetupRecordIntervalFinder::isNonconcurrentAndIOVNeedsUpdate(), edm::Wrapper< math::XYZVectorD >::isProductEqual_(), FFTJetPFPileupCleaner::isRemovable(), npstat::ArrayND< Num1, Len1, Dim1 >::isShapeCompatible(), PFElecTkProducer::isSharingEcalEnergyWithEgSC(), trklet::L1TStub::isTilted(), PFMuonAlgo::isTrackerTightMuon(), npstat::LinInterpolatedTableND< Numeric, Axis >::isWithinLimits(), FWSelectionManager::itemChanged(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::itemsMayGet(), edm::stream::EDAnalyzerAdaptorBase::itemsMayGet(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::itemsToGet(), edm::stream::EDAnalyzerAdaptorBase::itemsToGet(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::itemsToGetFrom(), edm::stream::EDAnalyzerAdaptorBase::itemsToGetFrom(), FFTJetProducer::iterateJetReconstruction(), hitfit::Lepjets_Event::jet(), fftjetcms::JetConvergenceDistance::JetConvergenceDistance(), fftjetcms::JetToPeakDistance::JetToPeakDistance(), TempTrajectory::join(), cmsutils::bqueue< TrajectoryMeasurement >::join(), npstat::ArrayND< Num1, Len1, Dim1 >::jointMemSliceScan(), KDTreeLinkerTrackHcal::KDTreeLinkerTrackHcal(), edm::one::OutputModuleBase::keepThisBranch(), edm::global::OutputModuleBase::keepThisBranch(), edm::limited::OutputModuleBase::keepThisBranch(), edm::eventsetup::DataProxyProvider::DataProxyContainer::keyedProxies(), L1DummyProducer::L1DummyProducer(), L1EmulBias::L1EmulBias(), L1ScalersClient::L1ScalersClient(), L1TMuonBarrelParamsAllPublic::L1TMuonBarrelParamsAllPublic(), pos::PixelModuleName::ladder(), pos::PixelROCName::ladder(), pos::PixelDACScanRange::last(), pos::PixelModuleName::layer(), pos::PixelROCName::layer(), TrackerMap::layerno(), dqm::implementation::DQMStore::leaveLumi(), hitfit::Lepjets_Event::lep(), edm::lessThan(), pos::PixelFEDTestDAC::levelEncoder(), npstat::Private::lind_invert1DSlice(), npstat::ArrayND< Num1, Len1, Dim1 >::linearFill(), npstat::ArrayND< Num1, Len1, Dim1 >::linearIndex(), npstat::Interval< Numeric >::linearMap(), npstat::LinInterpolatedTableND< Numeric, Axis >::LinInterpolatedTableND(), trklet::TrackletCalculatorDisplaced::LLLSeeding(), MEEEGeom::lmmodFromLmr(), ME::lmr(), MEEEGeom::lmr(), L1MuDTPtaLut::load(), L1MuDTPhiLut::load(), MagneticFieldGrid::load(), L1TMuonBarrelParamsHelper::load_phi(), L1TMuonBarrelParamsHelper::load_pt(), GeometryInterface::loadFromTopology(), fftjetcms::FFTJetInterface::loadInputCollection(), MEEBGeom::localCoord(), PreshowerStrip::localCorners(), IdealZDCTrapezoid::localCorners(), IdealObliquePrism::localCorners(), IdealZPrism::localCorners(), IdealCastorTrapezoid::localCorners(), FlatHexagon::localCorners(), TruncatedPyramid::localCorners(), FlatTrd::localCorners(), egammaTools::localEcalClusterCoordsEB(), egammaTools::localEcalClusterCoordsEE(), GEMStripTopology::localError(), gs::localFileURI(), GEMStripTopology::localPitch(), PixelCPEClusterRepair::localPosition(), PixelCPETemplateReco::localPosition(), GEMStripTopology::localStripLength(), edm::service::ELoutput::log(), edm::LoggedErrorsOnlySummary(), edm::LoggedErrorsSummary(), MELaserPrim::logicId(), trklet::VMRouterTable::lookup(), trklet::VMRouterTable::lookupdisk(), trklet::VMRouterTable::lookupinner(), trklet::VMRouterTable::lookupinneroverlap(), trklet::VMRouterTable::lookupinnerThird(), trklet::VMRouterPhiCorrTable::lookupPhiCorr(), fftjetcms::LookupTable2d::LookupTable2d(), npstat::ArrayRange::lowerLimits(), edm::InputSource::luminosityBlock(), main(), make_array(), DeepFlavourONNXJetTagsProducer::make_inputs(), DeepCombinedONNXJetTagsProducer::make_inputs(), DeepVertexONNXJetTagsProducer::make_inputs(), DeepDoubleXONNXJetTagsProducer::make_inputs(), ZdcHardcodeGeometryLoader::makeCell(), HcalDbHardcode::makeHardcodeMap(), makeHelper(), Multi5x5BremRecoveryClusterAlgo::makeIslandSuperClusters(), DQMTTreeIO::TreeReaderBase::makeKey(), edm::eventsetup::ProxyArgumentFactoryTemplate< ProxyType, CallbackType >::makeProxy(), EgammaHLTValidationUtils::makePSetForEgammaGenericFilter(), EgammaHLTValidationUtils::makePSetForElectronGenericFilter(), SimplePlan1RechitCombiner::makeRechit(), CosmicSeedCreator::makeSeed(), FWParameterSetterBase::makeSetterFor(), npstat::makeShape(), trklet::Tracklet::makeTrack(), ticl::PatternRecognitionbyCA< TILES >::makeTracksters(), cms::DDDetector::manager(), FFTEtaLogPtConeRadiusMapper< MyJet, Adjustable >::map(), L2RecoScaleCalculator::mapFFTJet(), L2ResScaleCalculator::mapFFTJet(), FFTGenericScaleCalculator::mapFFTJet(), L2AbsScaleCalculator::mapFFTJet(), edm::DaqProvenanceHelper::mapProcessHistoryID(), npstat::ArrayND< Num1, Len1, Dim1 >::marginalize(), npstat::ArrayND< Num1, Len1, Dim1 >::marginalizeInnerLoop(), mayown_ptr< T, N >::markOwn(), hitfit::Fourvec_Constrainer::mass_constraint(), trklet::Tracklet::match(), TrackerCleaner< T >::match_rechit_type(), trklet::MatchProcessor::matchCalculator(), trklet::Tracklet::matchdisk(), cms::DDFilteredView::matchPath(), trklet::MatchProcessor::MatchProcessor(), edm::TypeWithDict::maximumIndex(), AutocorrelationAnalyzer::mean(), FastTimerService::Measurement::measure_and_accumulate(), FastTimerService::Measurement::measure_and_store(), KfComponentsHolder::measuredErrors(), KfComponentsHolder::measuredParams(), GEMStripTopology::measurementError(), TotemNumberMerger::Merge(), edm::PrincipalCache::merge(), DAClusterizerInZ_vect::merge(), DAClusterizerInZT_vect::merge(), jsoncollector::DataPoint::mergeAndRetrieveValue(), jsoncollector::DataPoint::mergeAndSerialize(), edm::RunAuxiliary::mergeAuxiliary(), edm::LuminosityBlockAuxiliary::mergeAuxiliary(), trklet::MatchCalculator::mergeMatches(), edm::DataManagingProductResolver::mergeProduct(), MonitorElementCollection::mergeProduct(), edm::Wrapper< math::XYZVectorD >::mergeProduct_(), edm::service::MessageLoggerDefaults::MessageLoggerDefaults(), FWInteractionList::modelChanges(), FWProxyBuilderBase::modelChanges(), FWItemRandomAccessorBase::modelType(), pos::PixelModuleName::module(), pos::PixelROCName::module(), pos::PixelCalibConfiguration::moduleList(), edm::EarlyDeleteHelper::moduleRan(), edm::stream::ProducingModuleAdaptorBase< EDProducerBase >::modulesWhoseProductsAreConsumed(), edm::stream::EDAnalyzerAdaptorBase::modulesWhoseProductsAreConsumed(), PFECALHashNavigator::move(), FWEventItem::moveToBack(), FWEventItem::moveToFront(), FWEventItem::moveToLayer(), InputFile::moveToPreviousChunk(), MTDGeometry::MTDGeometry(), npstat::ArrayND< Num1, Len1, Dim1 >::multiMirror(), MuonPathAnalyzerPerSL::MuonPathAnalyzerPerSL(), MuonResiduals1DOFFitter_FCN(), MuonResiduals5DOFFitter_FCN(), MuonResiduals6DOFFitter_FCN(), MuonResiduals6DOFrphiFitter_FCN(), MuonResidualsAngleFitter_FCN(), MuonResidualsBfieldAngleFitter_FCN(), MuonResidualsFromTrack::MuonResidualsFromTrack(), MuonResidualsPositionFitter_FCN(), MVAJetPuIdProducer::MVAJetPuIdProducer(), StorageAccount::nameForToken(), MuonResidualsTwoBin::ndata(), pos::PixelPortCardConfig::new_PLL_CTR2_value(), CaloTowerGeometry::newCell(), ZdcGeometry::newCell(), CastorGeometry::newCell(), HcalDDDGeometry::newCellImpl(), HcalGeometry::newCellImpl(), FWModelChangeManager::newItemSlot(), L1CaloHcalScaleConfigOnlineProd::newObject(), CSCChamberDataItr::next(), pos::PixelCalibConfiguration::nextFECState(), FWLayoutBuilder::nextHints(), edm::InputSource::nextItemType(), NavigationSchool::nextLayers(), cms::DDFilteredView::nextSibling(), cms::DDFilteredView::nodeCopyNoAt(), cms::DDFilteredView::nodeNameAt(), CSCConditions::noiseMatrix(), CSCConditions::noiseMatrixElements(), MuonResidualsPositionFitter::npar(), MuonResidualsAngleFitter::npar(), MuonResiduals1DOFFitter::npar(), MuonResidualsBfieldAngleFitter::npar(), MuonResidualsTwoBin::npar(), MuonResiduals6DOFrphiFitter::npar(), MuonResiduals5DOFFitter::npar(), MuonResiduals6DOFFitter::npar(), pos::PixelCalibConfiguration::nROC(), trklet::VMStubsMEMemory::nStubsBin(), hitfit::Fourvec_Event::nu(), AlignmentMonitorMuonSystemMap1D::num02d(), MuonGeometrySanityCheckPoint::number(), MuonAlignmentFromReference::number(), edm::eventsetup::NumberOfConcurrentIOVs::numberOfConcurrentIOVs(), funct::Numerical< n >::Numerical(), pos::PixelCalibConfiguration::numROCsCalibratedOnChannel(), hitfit::Fourvec_Event::obj(), reco::parser::ExpressionVar::objToDouble(), MEChannel::oneLine(), MEChannel::oneWord(), DQMNet::onMessage(), DQMNet::onPeerConnect(), DQMNet::onPeerData(), File::open(), XrdFile::open(), dqm::implementation::DQMStore::open(), FWDetailViewManager::openDetailViewFor(), LowPassFilterTiming::operator()(), ZMuMuOverlap::operator()(), CordicXilinx::operator()(), modules::ZHLTMatchFilter::operator()(), reco::parser::CutSetter::operator()(), reco::parser::MethodArgumentSetter::operator()(), reco::tau::RecoTauElectronRejectionPlugin::operator()(), FsmwModeFinder3d::operator()(), PositionAtECalEntranceComputer::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), ZGoldenFilter::operator()(), npstat::MultivariateFunctorScanner< IndexMapper >::operator()(), CorrectedMETProducer_namespace::CorrectedMETFactoryT< T >::operator()(), TrackCollectionCloner::Producer::operator()(), L1MuGMTMatrix< bool >::operator()(), npstat::Private::ArrayMapper< Num1, Len1, Dim1, Num2, Len2, Dim2 >::operator()(), LayerHitMapCache::operator()(), npstat::LinInterpolatedTableND< Numeric, Axis >::operator()(), edmNew::DetSetVector< T >::FindForDetSetVector::operator()(), CSCDDUDataItr::operator*(), fwlite::EventContainer::operator++(), pat::eventhypothesis::Looper< T >::operator++(), L1MuGMTMatrix< bool >::operator+=(), l1tpf_calo::GridData< PreCluster >::operator+=(), FastTimerService::ResourcesPerProcess::operator+=(), FastTimerService::ResourcesPerJob::operator+=(), pat::eventhypothesis::Looper< T >::operator--(), DDValue::operator<(), operator<<(), DTTFBitArray< N >::operator<<=(), BitArray< 9 >::operator<<=(), L1MuGMTMatrix< bool >::operator=(), edmNew::dstvdetails::DetSetVectorTrans::operator=(), l1tpf_calo::GridData< PreCluster >::operator=(), hitfit::Row_Vector::operator=(), BitArray< 9 >::operator=(), DTTFBitArray< N >::operator=(), DDValue::operator==(), npstat::ArrayND< Num1, Len1, Dim1 >::operator==(), operator>>(), DTTFBitArray< N >::operator>>=(), BitArray< 9 >::operator>>=(), hitfit::Fit_Results::operator[](), CSCAnalogSignal::operator[](), hitfit::Fit_Result_Vec::operator[](), trklet::FitTrack::orderedMatches(), edm::OrphanHandleBase::OrphanHandleBase(), OuterHitPhiPrediction::OuterHitPhiPrediction(), edm::overlaps(), trklet::TrackletCalculatorBase::overlapSeeding(), PTrajectoryStateOnDet::Pack::Pack(), ReadRepacker::packInternal(), pos::PixelROCName::panel(), pos::PixelModuleName::panel(), JetResolution::parameter(), cms::DDFilteredView::parameters(), edm::ParameterSetEntry::ParameterSetEntry(), edm::parameterTypeEnumToString(), KfComponentsHolder::params(), EcalHitResponse::params(), DDLParser::parse(), parse_int(), parseHBHEMethod2Description(), fwlite::EventContainer::parser(), parseSubdetector(), MiscalibReaderFromXML::parseXMLMiscalibFile(), trklet::VMStubsTEMemory::passbend(), edm::SystemTimeKeeper::pathTiming(), reco::tau::PATTauDiscriminationByMVAIsolationRun2::PATTauDiscriminationByMVAIsolationRun2(), CSCConditions::pedestal(), CSCConditions::pedestalSigma(), trklet::CircularBuffer< trklet::ProjectionTemp >::peek(), QualityTester::performTests(), PFAlgo::PFAlgo(), PFLinker::PFLinker(), PFRecoTauDiscriminationByIsolationMVA2::PFRecoTauDiscriminationByIsolationMVA2(), reco::tau::PFRecoTauDiscriminationByMVAIsolationRun2::PFRecoTauDiscriminationByMVAIsolationRun2(), MahiFit::phase1Apply(), l1tpf_calo::Phase1GridBase::Phase1GridBase(), PhotonFix::phiC(), PhotonFix::phiM(), trklet::DiskProjection::phiproj(), trklet::LayerProjection::phiproj(), trklet::Tracklet::phiproj(), trklet::LayerProjection::phiprojapprox(), trklet::DiskProjection::phiprojapprox(), trklet::Tracklet::phiprojapprox(), trklet::Tracklet::phiprojapproxdisk(), trklet::LayerProjection::phiprojder(), trklet::DiskProjection::phiprojder(), trklet::Tracklet::phiprojder(), trklet::LayerProjection::phiprojderapprox(), trklet::DiskProjection::phiprojderapprox(), trklet::Tracklet::phiprojderapprox(), trklet::Tracklet::phiprojderapproxdisk(), trklet::Tracklet::phiprojderdisk(), trklet::Tracklet::phiprojdisk(), trklet::Tracklet::phiprojvm(), trklet::LayerResidual::phiresid(), trklet::DiskResidual::phiresid(), trklet::Tracklet::phiresid(), trklet::LayerResidual::phiresidapprox(), trklet::DiskResidual::phiresidapprox(), trklet::Tracklet::phiresidapprox(), trklet::Tracklet::phiresidapproxdisk(), trklet::Tracklet::phiresiddisk(), PhotonFix::phiS(), FlatHexagon::phiSpan(), FlatTrd::phiSpan(), HcalSimParameters::photoelectronsToAnalog(), PickEvents::PickEvents(), pos::PixelCalibConfiguration::PixelCalibConfiguration(), pos::PixelDACScanRange::PixelDACScanRange(), pos::PixelDACSettings::PixelDACSettings(), pos::PixelDetectorConfig::PixelDetectorConfig(), pos::PixelFEDTestDAC::PixelFEDTestDAC(), pos::PixelLowVoltageMap::PixelLowVoltageMap(), pos::PixelMaskAllPixels::PixelMaskAllPixels(), pos::PixelMaxVsf::PixelMaxVsf(), pos::PixelNameTranslation::PixelNameTranslation(), pos::PixelPortCardConfig::PixelPortCardConfig(), pos::PixelPortcardMap::PixelPortcardMap(), HcalSimParameters::pixels(), pos::PixelTBMChannel::PixelTBMChannel(), pos::PixelTBMSettings::PixelTBMSettings(), SiPixelTemplateReco::PixelTempReco1D(), SiPixelTemplateSplit::PixelTempSplit(), Phase2TrackerDigi::pixelToChannel(), pos::PixelTrimAllPixels::PixelTrimAllPixels(), pos::PixelROCName::plaquet(), MuonResiduals1DOFFitter::plot(), MuonResiduals6DOFrphiFitter::plot(), MuonResiduals5DOFFitter::plot(), MuonResiduals6DOFFitter::plot(), mayown_ptr< T, N >::pointer(), cmsutils::bqueue< TrajectoryMeasurement >::pop_back(), edm::ParameterSet::popParameterSet(), edm::service::popStack(), edm::ParameterSet::popVParameterSet(), File::position(), XrdFile::position(), FWFFService::postBeginJob(), edm::postIndexIntoFilePrintEventLists(), edm::service::RandomNumberGeneratorService::preallocate(), ProcessCallGraph::preBeginJob(), mxnet::cpp::Predictor::predict(), edm::service::MessageLogger::preEvent(), edm::eventsetup::preferEverything(), edm::Principal::prefetchAsync(), edm::eventsetup::CallbackProxy< CallbackT, RecordT, DataT >::prefetchAsyncImpl(), edm::eventsetup::DataProxyTemplate< RecordT, DataT >::prefetchAsyncImpl(), CSCChamberTimeCorrectionsValues::prefill(), CSCChipSpeedCorrectionDBConditions::prefillDBChipSpeedCorrection(), CSCGasGainCorrectionDBConditions::prefillDBGasGainCorrection(), NVProfilerService::preModuleBeginStream(), NVProfilerService::preModuleEndStream(), NVProfilerService::preModuleEvent(), NVProfilerService::preModuleEventAcquire(), NVProfilerService::preModuleEventPrefetching(), NVProfilerService::preModuleStreamBeginLumi(), NVProfilerService::preModuleStreamBeginRun(), NVProfilerService::preModuleStreamEndLumi(), NVProfilerService::preModuleStreamEndRun(), ConfigBuilder.ConfigBuilder::prepare_L1(), FWTrackResidualDetailView::prepareData(), fireworks::prepareTrack(), edm::Worker::prePrefetchSelectionAsync(), HLTPrescaleProvider::prescaleSet(), edm::IndexIntoFile::IndexIntoFileItrNoSort::previousEventRange(), edm::IndexIntoFile::IndexIntoFileItrImpl::previousLumiWithEvents(), edm::Principal::Principal(), CommandLine::print(), trklet::VarAdjustK::print(), trklet::VarAdjustKR::print(), trklet::VarParam::print(), trklet::VarDef::print(), trklet::VarAdd::print(), trklet::VarSubtract::print(), trklet::VarNounits::print(), trklet::VarShiftround::print(), trklet::VarShift::print(), trklet::VarNeg::print(), trklet::VarTimesC::print(), trklet::VarMult::print(), trklet::VarDSPPostadd::print(), trklet::VarInv::print(), trklet::VarCut::print(), trklet::VarFlag::print(), trklet::VarBase::print_step(), ParticleTreeDrawer::printDecay(), PFCandidateChecker::printElementsInBlocks(), edm::printEventLists(), edm::printEventsInLumis(), EcalSelectiveReadoutProducer::printSrFlags(), SeedClusterRemoverPhase2::process(), RecHitProcessor::process(), SeedClusterRemover::process(), HLTTrackClusterRemoverNew::process(), HITrackClusterRemover::process(), PFAlgo::processBlock(), DDLPgonGenerator::processElement(), edm::EventProcessor::processLumis(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), MuonAlignmentFromReference::processMuonResidualsFromTrack(), MultiTrackSelector::processMVA(), HIMultiTrackSelector::processMVA(), edm::Schedule::processOneEventAsync(), edm::Schedule::processOneStreamAsync(), TICLLayerTileProducer::produce(), RegressionEnergyPatElectronProducer::produce(), CandidateTriggerObjectProducer::produce(), MVAJetPuIdProducer::produce(), pat::GenJetFlavourInfoPreserver::produce(), reco::modulesNew::Matcher< C1, C2, S, D >::produce(), SiPixelClusterShapeCacheProducer::produce(), EcalDetailedTimeRecHitProducer::produce(), Phase2TrackerClusterizer::produce(), DeepFlavourONNXJetTagsProducer::produce(), NoPileUpPFMEtProducer::produce(), TopBottomClusterInfoProducer::produce(), DeepVertexONNXJetTagsProducer::produce(), DeepCombinedONNXJetTagsProducer::produce(), TrackListMerger::produce(), DeepDoubleXONNXJetTagsProducer::produce(), SeedClusterRemoverPhase2::produce(), SeedClusterRemover::produce(), PFEGammaProducer::produce(), HLTMuonTrackSelector::produce(), PFProducer::produce(), SiPixelRawToDigi::produce(), MuonDetCleaner< T1, T2 >::produce(), TrackMVAClassifierBase::produce(), BoostedJetONNXJetTagsProducer::produce(), MinMETProducerT< T >::produce(), L1EmulBias::produce(), HITrackClusterRemover::produce(), PFSimParticleProducer::produce(), BoostedTauSeedsProducer::produce(), SourceCardTextToRctDigi::produce(), HiFJRhoFlowModulationProducer::produce(), DeDxEstimatorProducer::produce(), reco::modules::TrackFullCloneSelectorBase< Selector >::produce(), pat::PATTriggerProducer::produce(), HFPreReconstructor::produce(), reco::PhysObjectMatcher< C1, C2, S, D, Q >::produce(), CSCOverlapsTrackPreparation::produce(), FastTrackDeDxProducer::produce(), cms::CosmicTrackFinder::produce(), FFTJetPatRecoProducer::produce(), pat::PATMuonProducer::produce(), TotemDAQMappingESSourceXML::produce(), PileupJetIdProducer::produce(), FFTJetProducer::produce(), SiStripClusterizerFromRaw::produce(), CaloGeometryDBEP< T, U >::produceAligned(), CaloGeometryEP< T, D >::produceAligned(), cms::CkfTrackCandidateMakerBase::produceBase(), CTPPSPixelDAQMappingESSourceXML::produceCTPPSPixelAnalysisMask(), CTPPSPixelDAQMappingESSourceXML::produceCTPPSPixelDAQMapping(), edm::ProducedProductResolver::ProducedProductResolver(), HcalAlignmentEP::produceHcalAli(), edm::ProductProvenanceRetriever::ProductProvenanceRetriever(), trklet::DiskProjection::projdisk(), npstat::ArrayND< Num1, Len1, Dim1 >::project(), ProjectedSiStripRecHit2D::ProjectedSiStripRecHit2D(), KfComponentsHolder::projection(), npstat::ArrayND< Num1, Len1, Dim1 >::projectLoop(), npstat::ArrayND< Num1, Len1, Dim1 >::projectLoop2(), KfComponentsHolder::projFunc(), trklet::LayerProjection::projlayer(), edm::VParameterSetEntry::psetInVector(), DAClusterizerInZ_vect::purge(), DAClusterizerInZT_vect::purge(), edm::SerialTaskQueueChain::push(), hitfit::Fit_Results::push(), TempTrajectory::push(), MonitorElementCollection::push_back(), edm::RangeMap< det_id_type, edm::OwnVector< B > >::put(), edm::EventPrincipal::put(), MagneticFieldGrid::putCoordGetInd(), MEtoEDMConverter::putData(), edm::ProcessBlock::putImpl(), edm::LuminosityBlock::putImpl(), edm::Run::putImpl(), edm::Event::putImpl(), MagneticFieldGrid::putIndGetCoord(), KfTrackProducerBase::putInEvt(), dqm::implementation::DQMStore::putME(), edm::EventPrincipal::putOnRead(), edm::Principal::putOrMerge(), dqm::implementation::NavigatorBase::pwd(), SiPixelGenError::qbin(), SiPixelTemplate::qbin(), SiPixelTemplate::qbin_dist(), SiPixelTemplate::qmin(), QualityTester::QualityTester(), npstat::ArrayRange::rangeLength(), trklet::Tracklet::rbin1projvm(), trklet::Tracklet::rbin2projvm(), trklet::CircularBuffer< trklet::ProjectionTemp >::read(), File::read(), edm::StreamerInputSource::read(), DTTFBitArray< N >::read(), BitArray< 9 >::read(), edm::EventProcessor::readAndMergeLumi(), edm::EventProcessor::readAndMergeRun(), TStorageFactoryFile::ReadBuffersSync(), lhef::StorageInputStream::readBytes(), gs::readCompressedStringArchive(), XMLConfigReader::readConfig(), pos::PixelFEDCard::readDBROCLevels(), pos::PixelFEDCard::readDBTBMLevels(), l1t::XmlConfigParser::readDOMFromFile(), l1t::XmlConfigParser::readDOMFromString(), edm::RootInputFileSequence::readEvent(), edm::InputSource::readEvent(), edm::RootFile::readEvent(), edm::RawInputSource::readEvent_(), LH5Source::readEvent_(), LHESource::readEvent_(), LmfSource::readEventWithinFile(), pos::PixelConfigList::readfile(), pos::PixelAliasList::readfile(), edm::InputSource::readFile(), edm::RootPrimaryFileSequence::readFile_(), DQMRootSource::readFile_(), l1tpf_impl::readFromFile(), LocalFileSystem::readFSTypes(), edm::EventProcessor::readLuminosityBlock(), edm::RootInputFileSequence::readLuminosityBlock_(), edm::RootFile::readLuminosityBlock_(), edm::RawInputSource::readLuminosityBlockAuxiliary_(), edm::RootInputFileSequence::readLuminosityBlockAuxiliary_(), edm::RootFile::readLuminosityBlockAuxiliary_(), MuonResiduals6DOFrphiFitter::readNtuple(), MuonResiduals5DOFFitter::readNtuple(), MuonResiduals6DOFFitter::readNtuple(), edm::RootEmbeddedFileSequence::readOneEvent(), edm::RootEmbeddedFileSequence::readOneRandom(), edm::RootEmbeddedFileSequence::readOneRandomWithID(), edm::RootEmbeddedFileSequence::readOneSequential(), edm::RootEmbeddedFileSequence::readOneSequentialWithID(), edm::RootEmbeddedFileSequence::readOneSpecified(), GsfBetheHeitlerUpdator::readParameters(), XMLConfigReader::readPatterns(), edm::OldProvenanceReader::readProvenance(), edm::EventProcessor::readRun(), edm::RootInputFileSequence::readRun_(), edm::RootFile::readRun_(), edm::RawInputSource::readRunAuxiliary_(), edm::RootInputFileSequence::readRunAuxiliary_(), edm::RootFile::readRunAuxiliary_(), EnergyScaleCorrection_class::ReadSmearingFromFile(), gs::readStringArchive(), FedRawDataInputSource::readSupervisor(), Model::readSystemDescription(), IOInput::readv(), IOChannel::readv(), DavixFile::readv(), DCacheFile::readv(), XrdFile::readv(), EndcapPiZeroDiscriminatorAlgo::readWeightFile(), FedRawDataInputSource::readWorker(), npstat::Private::rebinAxes(), BaseCkfTrajectoryBuilder::rebuildTrajectories(), KDTreeLinkerAlgo< reco::PFRecHit const * >::recBuild(), TkPhase2OTMeasurementDet::recHits(), TkPixelMeasurementDet::recHits(), edm::Principal::recombine(), PFAlgo::reconstructCluster(), fwlite::Record::Record(), reco::tau::RecoTauVertexAssociator::RecoTauVertexAssociator(), PFAlgo::recoTracksNotHCAL(), edm::ProcessHistoryRegistry::reducedProcessHistoryID(), edm::InputSource::reducedProcessHistoryID(), MiniFloatConverter::ReduceMantissaToNbitsRounding::ReduceMantissaToNbitsRounding(), ME::regionAndSector(), edm::ESProxyFactoryProducer::registerFactoryWithKey(), jsoncollector::FastMonitor::registerGlobalMonitorable(), edmplugin::PluginFactoryBase::registerPMaker(), edm::detail::registerProperSelectionInfo(), jsoncollector::FastMonitor::registerStreamMonitorableUIntVec(), jsoncollector::FastMonitor::registerStreamMonitorableUIntVecAtomic(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVar(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVarV2(), ElectronEnergyRegressionEvaluate::regressionValueNoTrkVar(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVar(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVarV2(), ME::regTree(), helper::ClusterStorer::ClusterHitRecord< ClusterRefType >::rekey(), Json::BatchAllocator< AllocatedType, objectPerAllocation >::release(), dqm::impl::MonitorElement::release(), DQMNet::releaseFromWait(), FFTJetProducer::removeFakePreclusters(), FWEventItemsManager::removeItem(), edm::maker::ModuleHolderT< T >::replaceModuleFor(), npstat::rescanArray(), ViewerParameterGUI::reset(), pat::eventhypothesis::Looper< T >::reset(), edm::WaitingTaskList::reset(), edm::StreamerInputSource::resetAfterEndRun(), fwlite::Record::resetCaches(), resetColors(), edm::service::RandomNumberGeneratorService::resetEngineSeeds(), edm::EventSetupRecordIntervalFinder::resetInterval(), SiStripCertificationInfo::resetSiStripCertificationMEs(), MuonResidualsTwoBin::residualsModel(), File::resize(), JetResolution::resolution(), edm::UnscheduledProductResolver::resolveProduct_(), edm::NoProcessProductResolver::resolveProduct_(), npstat::BoxND< unsigned >::restore(), npstat::ArrayND< Num1, Len1, Dim1 >::restore(), edm::service::RandomNumberGeneratorService::restoreFromCache(), HEPTopTaggerV2::result(), edm::IDGeneratorSourceBase< PuttableSourceBase >::retreatToPrevious(), edm::ReusableObjectHolder< edm::ESProductHost >::ReusableObjectHolder(), IMACalibBlock::riempiMtr(), IMACalibBlock::riempiVtr(), pos::PixelDACSettings::rocIsDisabled(), pos::PixelCalibConfiguration::rocList(), pos::PixelROCName::rocname(), pos::PixelNameTranslation::ROCNameFromFEDChannelROC(), pos::PixelCalibConfiguration::ROCNumberOnChannelAmongThoseCalibrated(), edm::RootEmbeddedFileSequence::RootEmbeddedFileSequence(), edm::RootFile::RootFile(), npstat::ArrayND< Num1, Len1, Dim1 >::rotate(), hitfit::Row_Vector::Row_Vector(), pos::PixelCalibConfiguration::rowCounter(), trklet::LayerProjection::rproj(), trklet::DiskProjection::rproj(), trklet::Tracklet::rproj(), trklet::DiskProjection::rprojapprox(), trklet::Tracklet::rprojapproxdisk(), trklet::DiskProjection::rprojder(), trklet::DiskProjection::rprojderapprox(), trklet::Tracklet::rprojderapproxdisk(), trklet::Tracklet::rprojderdisk(), trklet::Tracklet::rprojdisk(), trklet::DiskResidual::rresid(), trklet::DiskResidual::rresidapprox(), trklet::Tracklet::rresidapproxdisk(), trklet::Tracklet::rresiddisk(), trklet::LayerResidual::rstub(), trklet::Tracklet::rstub(), ESDigitizer::run(), HitTripletGenerator::run(), HitPairGenerator::run(), EcalTDigitizer< ESDigitizerTraits >::run(), cms::Ort::ONNXRuntime::run(), SiPixelClusterProducer::run(), ConstantStepOdeSolver::run(), CaloTDigitizer< Traits, runHelper >::run(), cms::SiPixelRecHitConverter::run(), QIE8Simulator::run(), edm::InputSource::run(), edm::Worker::runAcquireAfterAsyncPrefetch(), edm::service::ThreadSafeLogMessageLoggerScribe::runCommand(), edm::Worker::runModule(), edm::Worker::runModuleAfterAsyncPrefetch(), EcalSelectiveReadout::runSelectiveReadout0(), QCriterion::runTest(), DQMFileSaver::saveForOffline(), DeepTauId::saveInputs(), matrixSaver::saveMatrix(), matrixSaver::saveMatrixVector(), MEEEGeom::sc(), hitfit::scalar(), npstat::HistoND< Numeric, Axis >::scaleBinContents(), npstat::ArrayND< Num1, Len1, Dim1 >::scaleBySliceLoop(), npstat::HistoND< Numeric, Axis >::scaleOverflows(), FWCaloRecHitDigitSetProxyBuilder::scaleProduct(), pos::PixelCalibConfiguration::scanCounter(), pos::PixelCalibConfiguration::scanROC(), pos::PixelCalibConfiguration::scanValue(), pos::PixelModuleName::sec(), pos::PixelROCName::sec(), HLTL1TSeed::seedsL1TriggerObjectMaps(), MuonHitsChamberResidual::segment_fit(), ME0TriggerPseudoBuilder::segmentConversion(), pf2pat::PtMinPFCandidateSelectorDefinition::select(), FWModelExpressionSelector::select(), FWTableView::selectCollection(), MuonResidualsFitter::selectPeakResiduals(), MuonResidualsFitter::selectPeakResiduals_simple(), MuonAlignmentFromReference::selectResidualsPeaks(), FFTJetProducer::selectTreeNodes(), CSCTMBTrailer::selfTest(), CSCAnodeData2007::selfTest(), MTDSectorForwardDoubleLayer::selfTest(), CSCAnodeData2006::selfTest(), MuRingForwardDoubleLayer::selfTest(), MTDRingForwardDoubleLayer::selfTest(), CSCComparatorData::selfTest(), CSCStripElectronicsSim::selfTest(), CSCTMBHeader::selfTest(), CSCEventData::selfTest(), CSCALCTHeader::selfTest(), ViewerParameterGUI::separator(), jsoncollector::JSONSerializer::serialize(), edm::StreamSerializer::serializeEvent(), edm::SerialTaskQueue::SerialTaskQueue(), trklet::FPGAWord::set(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), L1MuGMTMatrix< bool >::set(), TAPD::set2DAPDoAPD0Cut(), TAPD::set2DAPDoAPD1Cut(), TAPD::set2DCut(), TAPD::set2DTimeCut(), mxnet::cpp::Predictor::set_input_shapes(), TShapeAnalysis::set_nch(), hitfit::Fourvec_Event::set_obj_p(), pos::PixelHdwAddress::setAddress(), pos::PixelPortCardConfig::setAOHGain(), edm::eventsetup::DataProxyProvider::setAppendToDataLabel(), trklet::Tracklet::setBendIndex(), trklet::VMStubsTEMemory::setbendtable(), MEGeom::setBinGlobalHist(), FWViewManagerBase::setChangeManager(), pos::PixelFEDCard::setChannel(), reco::tau::setChargedHadronP4(), FWViewManagerBase::setColorManager(), ROOT::Math::Transform3DPJ::SetComponents(), dqm::implementation::NavigatorBase::setCurrentFolder(), TAPD::setCut(), TMom::setCut(), pos::PixelROCDACSettings::setDac(), pos::PixelDACScanRange::setDACChannel(), FWItemRandomAccessorBase::setData(), FWItemSingleAccessor::setData(), FWItemTVirtualCollectionProxyAccessor::setData(), pos::PixelPortCardConfig::setDataBaseAOHGain(), CSCDCCHeader::setDAV(), HcalSimParameters::setDbService(), ESDigitizer::setDetIds(), EcalSampleMask::setEcalSampleMaskRecordEB(), EcalSampleMask::setEcalSampleMaskRecordEE(), CSCEventData::setEventInformation(), FWConfigurationManager::setFrom(), FWCompositeParameter::setFrom(), FWConfigurableParameterizable::setFrom(), FWLegoViewBase::setFrom(), FWEventItemsManager::setFrom(), FWEveView::setFrom(), FWTableView::setFrom(), FWTableViewManager::setFrom(), CmsShowNavigator::setFrom(), FWGUIManager::setFrom(), ESDigitizer::setGain(), EcalLaserAnalyzer2::setGeomEB(), EcalLaserAnalyzer::setGeomEB(), EcalLaserAnalyzer2::setGeomEE(), EcalLaserAnalyzer::setGeomEE(), ConstantStepOdeSolver::setHistory(), pos::PixelROCName::setIdBPix(), pos::PixelROCName::setIdFPix(), QIE8Simulator::setInitialConditions(), MELaserPrim::setInt(), edm::eventsetup::DependentRecordIntervalFinder::setIntervalFor(), CSCCFEBData::setL1A(), AbsElectronicODERHS::setLeadingParameters(), reco::PFBlock::setLink(), reco::PFDisplacedVertexCandidate::setLink(), PVValHelper::histodetails::setMap(), pos::PixelROCMaskBits::setMask(), HcalSiPM::setNCells(), ticl::TracksterP4FromTrackAndPCA::setP4(), ThirdOrderDelayODE::setParameters(), PadeTableODE::setParameters(), edm::ProcessConfiguration::setParameterSetID(), edm::RootTree::setPresence(), MahiFit::setPulseShapeTemplate(), FFTJetPFPileupCleaner::setRemovalBit(), FRDStreamSource::setRunAndEventInfo(), edm::EventPrincipal::setRunAndLumiNumber(), MuonTrackDT13ChamberResidual::setSegmentResidual(), MuonTrackDT2ChamberResidual::setSegmentResidual(), InterpolatedPulse< 1500U >::setShape(), FWColumnLabelCellRenderer::setSortOrder(), CaloGeometry::setSubdetGeometry(), pos::PixelTBMSettings::setTBMGenericValue(), edm::IndexIntoFile::IndexIntoFileItrNoSort::setToLastEventInRange(), edm::IndexIntoFile::IndexIntoFileItrSorted::setToLastEventInRange(), trklet::Tracklet::setTrackletIndex(), pos::PixelROCTrimBits::setTrim(), KfComponentsHolder::setup(), FWPathsPopup::setup(), PhotonFix::setup(), fireworks::setupAddElement(), FWProxyBuilderBase::setupElement(), HiFJGridEmptyAreaCalculator::setupGrid(), HiFJGridEmptyAreaCalculator::setupGridJet(), edm::UnscheduledProductResolver::setupUnscheduled(), MELaserPrim::setVal(), EmDQM::SetVarsFromPSet(), FWTabularWidget::setWidthOfTextInColumns(), EcalPreshowerGeometry::setzPlanes(), EcalHitResponse::shape(), cms::DDFilteredView::shape(), npstat::Private::shapeOfASlice(), FTLTrackingRecHit< ObjRef >::sharesInput(), npstat::BoxND< unsigned >::shift(), FWGUIEventFilter::show(), FWModelContextMenuHandler::showSelectedModelContext(), HcalSimParameters::signalShape(), SimHitShifter::SimHitShifter(), L1DummyProducer::SimpleDigi(), TkStripMeasurementDet::simpleRecHits(), CSCGasCollisions::simulate(), SiPixelDigiSource::SiPixelDigiSource(), HcalSimParameters::sipmCrossTalk(), HcalSimParameters::sipmDarkCurrentuA(), HcalSimParameters::sipmNonlinearity(), SiStripClusterizerFromRaw::SiStripClusterizerFromRaw(), File::size(), RecoIdealGeometry::size(), pat::eventhypothesis::Looper< T >::skip(), edm::RootEmbeddedFileSequence::skipEntries(), edm::RootPrimaryFileSequence::skipEvents(), ctfseeding::HitExtractorSTRP::skipThis(), edm::RootInputFileSequence::skipToItem(), edm::RootInputFileSequence::skipToItemInNewFile(), funct::Slave< F >::Slave(), SeedingLayerSetsHits::SeedingLayerSet::slice(), npstat::ArrayND< Num1, Len1, Dim1 >::sliceShape(), l1t::slidingWindowJetFinder(), MEEBGeom::sm(), MEEBGeom::smFromDcc(), MEEBGeom::smName(), MEEEGeom::smName(), ME::smName(), jsoncollector::DataPoint::snap(), jsoncollector::DataPoint::snapStreamAtomic(), npstat::LinInterpolatedTableND< Numeric, Axis >::solveForRatioArg(), edm::IndexIntoFile::SortedRunOrLumiItr::SortedRunOrLumiItr(), edm::IndexIntoFile::sortEventEntries(), edm::IndexIntoFile::sortEvents(), OMTFSorter::sortSingleResult(), fftjetcms::sparsePeakTreeFromStorable(), fftjetcms::sparsePeakTreeToStorable(), TrackingMaterialAnalyser::split(), DD4hep_TrackingMaterialAnalyser::split(), DAClusterizerInZ_vect::split(), DAClusterizerInZT_vect::split(), XrdAdaptor::RequestManager::splitClientRequest(), edm::service::ConcurrentModuleTimer::start(), evf::EvFBuildingThrottle::start(), evf::FastMonitoringThread::start(), DQMRootOutputModule::startEndFile(), FWFFLooper::startingNewLoop(), edm::RootTree::startTraining(), pos::PixelROCStatus::statusName(), pos::PixelDACScanRange::step(), edm::service::ConcurrentModuleTimer::stop(), evf::EvFBuildingThrottle::stop(), evf::FastMonitoringThread::stop(), trklet::CircularBuffer< trklet::ProjectionTemp >::store(), sistrip::MeasureLA::store_calibrations(), reco::PFCandidate::storeRefInfo(), edm::StreamSchedule::StreamSchedule(), StringToEnumValue(), optutl::VariableMapCont::stringValue(), optutl::VariableMapCont::stringVector(), edm::stripNamespace(), edm::stripTemplate(), trklet::Stub::Stub(), trklet::LayerResidual::stubptr(), trklet::DiskResidual::stubptr(), trklet::Tracklet::stubptr(), npstat::ArrayND< Num1, Len1, Dim1 >::subtractFromProjection(), BuildTrackerMapPlugin::subtractMap(), suffix_matches(), magneticfield::BaseVolumeHandle::surface(), edmNew::dstvdetails::DetSetVectorTrans::swap(), edm::Wrapper< math::XYZVectorD >::swapProduct_(), dqm::impl::MonitorElement::switchData(), fwlite::Record::syncTo(), SiPixelTemplate::temperrors(), edm::TypeWithDict::templateArgumentAt(), edm::TypeWithDict::templateName(), TPedValues::terminate(), edm::test::TestProcessor::testBeginLuminosityBlockImpl(), edm::test::TestProcessor::testBeginRunImpl(), DTSegtoRPC::thePoints(), CSCSegtoRPC::thePoints(), HiFJGridEmptyAreaCalculator::tileIndexEta(), HiFJGridEmptyAreaCalculator::tileIndexEtaJet(), HiFJGridEmptyAreaCalculator::tileIndexPhi(), EcalHitResponse::timeOfFlight(), EcalTimeMapDigitizer::timeOfFlight(), CSCCFEBTimeSlice::timeSample(), CSCCFEBData::timeSlice(), TkOfflineVariables::TkOfflineVariables(), TkRadialStripTopology::TkRadialStripTopology(), ClusterShapeTrajectoryFilter::toBeContinued(), fwlite::EventContainer::toBegin(), edm::VParameterSetEntry::toDigest(), HeterogeneousSoA< T >::toHostAsync(), edm::VParameterSetEntry::toString(), MatcherByPullsAlgorithm::track(), TrackAndHCALLinker::TrackAndHCALLinker(), TrackerGeometry::TrackerGeometry(), TrackerInteractionGeometry::TrackerInteractionGeometry(), trklet::FitTrack::trackFitChisq(), trklet::Tracklet::Tracklet(), trklet::TrackletCalculator::TrackletCalculator(), trklet::TrackletCalculatorDisplaced::TrackletCalculatorDisplaced(), trklet::TrackletProcessor::TrackletProcessor(), trklet::TrackletProjectionsMemory::TrackletProjectionsMemory(), trklet::Tracklet::trackletprojstr(), trklet::Tracklet::trackletprojstrD(), jsoncollector::DataPoint::trackMonitorable(), TrackMVAClassifierBase::TrackMVAClassifierBase(), OutInConversionTrackFinder::tracks(), edm::RootTree::trainCache(), KFTrajectorySmoother::trajectory(), SiStripMonitorTrack::trajectoryStudy(), edm::StreamerInputSource::EventPrincipalHolder::transitionIndex_(), cms::DDFilteredView::translation(), npstat::transposeBuffer(), DQMTTreeIO::TreeObjectReader< T >::TreeObjectReader(), DQMTTreeIO::TreeSimpleReader< T >::TreeSimpleReader(), DQMTTreeIO::TreeStringReader::TreeStringReader(), edm::service::ThreadSafeLogMessageLoggerScribe::triggerStatisticsSummaries(), PATStringObjectFunction::tryEval(), PATStringCutObjectSelector::tryEval(), edm::NoProcessProductResolver::tryPrefetchResolverAsync(), edm::RefCore::tryToGetProductPtr(), edmNew::DetSetVector< T >::TSFastFiller::TSFastFiller(), l1t::TwelveByTwelveFinder(), two_joined_lines(), l1t::TwoByTwoFinder(), MuonResidualsTwoBin::type(), pos::PixelTKFECConfig::typeFromTKFECID(), edm::PtrVectorBase::typeInfo(), edm::service::MessageLogger::unEstablishModule(), FWLayoutBuilder::unindent(), RctRawToDigi::unpackCTP7(), FWSelectionManager::unselect(), FWDialogBuilder::untabs(), PrintMaterialBudgetInfo::update(), fwlite::RecordWriter::update(), KinematicConstrainedVertexUpdatorT< nTrk, nConstraint >::update(), HcaluLUTTPGCoder::update(), StMeasurementDetSet::update(), DAClusterizerInZ_vect::update(), DAClusterizerInZT_vect::update(), edmNew::DetSetVector< T >::update(), edm::ParameterSetEntry::updateID(), DDI::Specific::updateLogicalPart(), edm::EDConsumerBase::updateLookup(), edm::ESProducer::updateLookup(), fwlite::internal::BranchMapReaderStrategyV8::updateMap(), DQMNet::updateMask(), MeasurementTrackerEventProducer::updatePixels(), FWPSetTableManager::updateSchedule(), MeasurementTrackerEventProducer::updateStrips(), npstat::ArrayRange::upperLimits(), pos::PixelFEDCard::useChannel(), EcalSampleMask::useSample(), EcalSampleMask::useSampleEB(), EcalSampleMask::useSampleEE(), edm::eventsetup::DataProxyProvider::DataProxyContainer::usingRecordWithKey(), V0Validator::V0Couple::V0Couple(), CaloTowerTopology::valid(), HcalTopology::valid(), edm::Entry::validate(), edm::ParameterDescription< std::vector< ParameterSet > >::validate_(), edm::AllowedLabelsDescription< std::vector< ParameterSet > >::validateAllowedLabel_(), ValidateGeometry::validateCaloGeometry(), ValidateGeometry::validateCSCLayerGeometry(), DTGeometryValidate::validateDTLayerGeometry(), ValidateGeometry::validateDTLayerGeometry(), edm::RootFile::validateFile(), validateList(), edm::ParameterWildcard< std::vector< ParameterSet > >::validatePSetVector(), ValidateGeometry::validateRPCGeometry(), ValidateGeometry::validateStripTopology(), ObjectValidator::validHit(), trklet::Tracklet::validProj(), trklet::Tracklet::validProjDisk(), trklet::Tracklet::validResid(), CSCPairResidualsConstraint::value(), pos::PixelDACScanRange::value(), MuonResidualsFitter::value(), npstat::ArrayND< Num1, Len1, Dim1 >::value(), npstat::ArrayND< Num1, Len1, Dim1 >::valueAt(), trklet::VarAdjustK::VarAdjustK(), trklet::VarAdjustKR::VarAdjustKR(), SiPixelTemplate::vavilov2_pars(), SiPixelTemplate::vavilov_pars(), DAClusterizerInZ_vect::verify(), DAClusterizerInZT_vect::verify(), npstat::ArrayND< Num1, Len1, Dim1 >::verifyBufferSliceCompatibility(), npstat::ArrayND< Num1, Len1, Dim1 >::verifyProjectionCompatibility(), npstat::ArrayND< Num1, Len1, Dim1 >::verifySliceCompatibility(), FWLayoutBuilder::verticalFrame(), pos::PixelFEDConfig::VMEBaseAddressFromFEDNumber(), trklet::Tracklet::vmstrlayer(), DDI::Polycone::volume(), cms::DDFilteredView::volume(), edm::VParameterSetEntry::VParameterSetEntry(), HEPTopTaggerV2Structure::W1(), HEPTopTaggerV2Structure::W2(), muonisolation::IsolatorByNominalEfficiency::weightedSum(), muonisolation::IsolatorByDeposit::weightedSum(), CSCBadCFEBTimeSlice::word(), ProvenanceDumper::work_(), edm::WorkerT< T >::WorkerT(), cms::DDDetector::world(), cms::DDDetector::worldVolume(), File::write(), XrdFile::write(), RawEventOutputModuleForBU< Consumer >::write(), WriteESAlignments::writeAlignments(), GctFormatTranslateMCLegacy::writeAllRctCaloRegionBlock(), pos::PixelPortCardConfig::writeASCII(), pos::PixelGlobalDelay25::writeASCII(), pos::PixelTrimCommon::writeASCII(), pos::PixelTKFECConfig::writeASCII(), pos::PixelFEDConfig::writeASCII(), pos::PixelPortcardMap::writeASCII(), pos::PixelTrimCommon::writeBinary(), edm::RootOutputFile::writeBranchIDListRegistry(), MuonAlignmentOutputXML::writeComponents(), gs::writeCompressedStringArchive(), pos::PixelConfigList::writefile(), edm::RootOutputFile::writeFileFormatVersion(), edm::RootOutputFile::writeFileIdentifier(), edm::RootOutputFile::writeIndexIntoFile(), DQMRootOutputModule::writeLuminosityBlock(), edm::RootOutputFile::writeOne(), edm::RootOutputFile::writeProductDependencies(), edm::RootOutputFile::writeProductDescriptionRegistry(), GctFormatTranslateMCLegacy::writeRctEmCandBlocks(), DQMRootOutputModule::writeRun(), edm::SubProcess::writeRunAsync(), edm::RootOutputFile::writeStoredMergeableRunProductMetadata(), gs::writeStringArchive(), edm::RootOutputFile::writeThinnedAssociationsHelper(), l1tpf_impl::writeToFile(), IOOutput::writev(), IOChannel::writev(), trklet::VMStubsTEMemory::writeVMBendTable(), trklet::TETableBase::writeVMTable(), pos::PixelPortCardConfig::writeXML(), pos::PixelDetectorConfig::writeXML(), pos::PixelNameTranslation::writeXML(), pos::PixelDetectorConfig::writeXMLHeader(), SiPixelTemplate::xavg(), SiPixelTemplate::xavgc2m(), PhotonFix::xC(), SiPixelTemplate::xflcorr(), SiPixelTemplate::xgsig(), SiPixelTemplate::xgx0(), PhotonFix::xM(), IOInput::xread(), IOInput::xreadv(), SiPixelTemplate::xrms(), SiPixelTemplate::xrmsc2m(), PhotonFix::xS(), SiPixelTemplate::xsigma2(), xtalFromiEtaiPhi(), SiPixelTemplate::xtemp(), SiPixelTemplate::xtemp3d_int(), IOOutput::xwritev(), SiPixelTemplate2D::xysigma2(), PhotonFix::xZ(), SiPixelTemplate::yavg(), SiPixelTemplate::yavgc2m(), PhotonFix::yC(), SiPixelTemplate::yflcorr(), SiPixelTemplate::ygsig(), SiPixelTemplate::ygx0(), PhotonFix::yM(), SiPixelTemplate::yrms(), SiPixelTemplate::yrmsc2m(), PhotonFix::yS(), SiPixelTemplate::ysigma2(), SiPixelTemplate::ytemp(), SiPixelTemplate::ytemp3d_int(), PhotonFix::yZ(), trklet::Tracklet::zbin1projvm(), trklet::Tracklet::zbin2projvm(), zMCLeptonDaughters(), DAClusterizerInZT_vect::zorder(), trklet::DiskProjection::zproj(), trklet::LayerProjection::zproj(), trklet::Tracklet::zproj(), trklet::LayerProjection::zprojapprox(), trklet::Tracklet::zprojapprox(), trklet::LayerProjection::zprojder(), trklet::Tracklet::zprojder(), trklet::LayerProjection::zprojderapprox(), trklet::Tracklet::zprojderapprox(), trklet::Tracklet::zprojvm(), trklet::LayerResidual::zresid(), trklet::Tracklet::zresid(), trklet::LayerResidual::zresidapprox(), trklet::Tracklet::zresidapprox(), trklet::DiskResidual::zstub(), trklet::Tracklet::zstubdisk(), edmNew::DetSetVector< T >::FastFiller::~FastFiller(), combinedConstraintHelpers::Place< DIM >::~Place(), TrackCollectionCloner::Producer::~Producer(), edm::ReusableObjectHolder< edm::ESProductHost >::~ReusableObjectHolder(), and edmNew::DetSetVector< T >::TSFastFiller::~TSFastFiller().

◆ chooseDevice()

int cms::cuda::chooseDevice ( edm::StreamID  id)

Definition at line 8 of file chooseDevice.cc.

8  {
9  edm::Service<CUDAService> cudaService;
10  if (not cudaService->enabled()) {
11  cms::Exception ex("CUDAError");
12  ex << "Unable to choose current device because CUDAService is disabled. If CUDAService was not explicitly\n"
13  "disabled in the configuration, the probable cause is that there is no GPU or there is some problem\n"
14  "in the CUDA runtime or drivers.";
15  ex.addContext("Calling cms::cuda::chooseDevice()");
16  throw ex;
17  }
18 
19  // For startes we "statically" assign the device based on
20  // edm::Stream number. This is suboptimal if the number of
21  // edm::Streams is not a multiple of the number of CUDA devices
22  // (and even then there is no load balancing).
23  //
24  // TODO: improve the "assignment" logic
25  return id % cudaService->numberOfDevices();
26  }

References cms::Exception::addContext(), CUDAService::enabled(), and CUDAService::numberOfDevices().

◆ copyAsync() [1/6]

template<typename T >
void cms::cuda::copyAsync ( cms::cuda::device::unique_ptr< T[]> &  dst,
const std::vector< T, cms::cuda::HostAllocator< T >> &  src,
cudaStream_t  stream 
)
inline

Definition at line 72 of file copyAsync.h.

74  {
75  cudaCheck(cudaMemcpyAsync(dst.get(), src.data(), src.size() * sizeof(T), cudaMemcpyHostToDevice, stream));
76  }

References cudaCheck, math::cholesky::dst, TrackRefitter_38T_cff::src, and stream.

◆ copyAsync() [2/6]

template<typename T >
void cms::cuda::copyAsync ( device::unique_ptr< T > &  dst,
const host::unique_ptr< T > &  src,
cudaStream_t  stream 
)
inline

Definition at line 20 of file copyAsync.h.

20  {
21  // Shouldn't compile for array types because of sizeof(T), but
22  // let's add an assert with a more helpful message
23  static_assert(std::is_array<T>::value == false,
24  "For array types, use the other overload with the size parameter");
25  cudaCheck(cudaMemcpyAsync(dst.get(), src.get(), sizeof(T), cudaMemcpyHostToDevice, stream));
26  }

References cudaCheck, math::cholesky::dst, TrackRefitter_38T_cff::src, stream, and relativeConstraints::value.

Referenced by BeamSpotToCUDA::produce().

◆ copyAsync() [3/6]

template<typename T >
void cms::cuda::copyAsync ( device::unique_ptr< T[]> &  dst,
const host::unique_ptr< T[]> &  src,
size_t  nelements,
cudaStream_t  stream 
)
inline

Definition at line 47 of file copyAsync.h.

50  {
51  cudaCheck(cudaMemcpyAsync(dst.get(), src.get(), nelements * sizeof(T), cudaMemcpyHostToDevice, stream));
52  }

References cudaCheck, math::cholesky::dst, TrackRefitter_38T_cff::src, and stream.

◆ copyAsync() [4/6]

template<typename T >
void cms::cuda::copyAsync ( edm::propagate_const_array< cms::cuda::device::unique_ptr< T[]>> &  dst,
const std::vector< T, cms::cuda::HostAllocator< T >> &  src,
cudaStream_t  stream 
)
inline

Definition at line 80 of file copyAsync.h.

82  {
83  cudaCheck(cudaMemcpyAsync(
84  get_underlying(dst).get(), src.data(), src.size() * sizeof(T), cudaMemcpyHostToDevice, stream));
85  }

References cudaCheck, math::cholesky::dst, get, edm::get_underlying(), TrackRefitter_38T_cff::src, and stream.

◆ copyAsync() [5/6]

template<typename T >
void cms::cuda::copyAsync ( host::unique_ptr< T > &  dst,
const device::unique_ptr< T > &  src,
cudaStream_t  stream 
)
inline

Definition at line 38 of file copyAsync.h.

38  {
39  static_assert(std::is_array<T>::value == false,
40  "For array types, use the other overload with the size parameter");
41  cudaCheck(cudaMemcpyAsync(dst.get(), src.get(), sizeof(T), cudaMemcpyDeviceToHost, stream));
42  }

References cudaCheck, math::cholesky::dst, TrackRefitter_38T_cff::src, stream, and relativeConstraints::value.

◆ copyAsync() [6/6]

template<typename T >
void cms::cuda::copyAsync ( host::unique_ptr< T[]> &  dst,
const device::unique_ptr< T[]> &  src,
size_t  nelements,
cudaStream_t  stream 
)
inline

Definition at line 63 of file copyAsync.h.

66  {
67  cudaCheck(cudaMemcpyAsync(dst.get(), src.get(), nelements * sizeof(T), cudaMemcpyDeviceToHost, stream));
68  }

References cudaCheck, math::cholesky::dst, TrackRefitter_38T_cff::src, and stream.

◆ cudaCheck_() [1/2]

bool cms::cuda::cudaCheck_ ( const char *  file,
int  line,
const char *  cmd,
cudaError_t  result,
const char *  description = nullptr 
)
inline

Definition at line 48 of file cudaCheck.h.

49  {
50  if (LIKELY(result == cudaSuccess))
51  return true;
52 
53  const char* error = cudaGetErrorName(result);
54  const char* message = cudaGetErrorString(result);
56  return false;
57  }

References abortOnCudaError(), mps_setup::cmd, edmLumisInFiles::description, relativeConstraints::error, FrontierConditions_GlobalTag_cff::file, LIKELY, mps_splice::line, and mps_fire::result.

◆ cudaCheck_() [2/2]

bool cms::cuda::cudaCheck_ ( const char *  file,
int  line,
const char *  cmd,
CUresult  result,
const char *  description = nullptr 
)
inline

Definition at line 35 of file cudaCheck.h.

36  {
37  if (LIKELY(result == CUDA_SUCCESS))
38  return true;
39 
40  const char* error;
41  const char* message;
42  cuGetErrorName(result, &error);
43  cuGetErrorString(result, &message);
45  return false;
46  }

References abortOnCudaError(), mps_setup::cmd, edmLumisInFiles::description, relativeConstraints::error, FrontierConditions_GlobalTag_cff::file, LIKELY, mps_splice::line, and mps_fire::result.

◆ currentDevice()

int cms::cuda::currentDevice ( )
inline

◆ deviceAllocatorStatus()

allocator::GpuCachedBytes cms::cuda::deviceAllocatorStatus ( )

◆ deviceCount()

int cms::cuda::deviceCount ( )
inline

Definition at line 10 of file deviceCount.h.

10  {
11  int ndevices;
12  cudaCheck(cudaGetDeviceCount(&ndevices));
13  return ndevices;
14  }

References cudaCheck.

Referenced by cms::cuda::StreamCache::clear(), cms::cuda::EventCache::clear(), and cms::cuda::allocator::minCachedBytes().

◆ eventWorkHasCompleted()

bool cms::cuda::eventWorkHasCompleted ( cudaEvent_t  event)
inline

Returns true if the work captured by the event (=queued to the CUDA stream at the point of cudaEventRecord()) has completed.

Returns false if any captured work is incomplete.

In case of errors, throws an exception.

Definition at line 18 of file eventWorkHasCompleted.h.

18  {
19  const auto ret = cudaEventQuery(event);
20  if (ret == cudaSuccess) {
21  return true;
22  } else if (ret == cudaErrorNotReady) {
23  return false;
24  }
25  // leave error case handling to cudaCheck
26  cudaCheck(ret);
27  return false; // to keep compiler happy
28  }

References cudaCheck, and runTheMatrix::ret.

Referenced by cms::cuda::ESProduct< T >::dataForCurrentDeviceAsync(), cms::cuda::EventCache::get(), and cms::cuda::ProductBase::isAvailable().

◆ for() [1/2]

cms::cuda::for ( )

Definition at line 129 of file HistoContainer.h.

129  {
130  func(*pj);
131  }

References func.

◆ for() [2/2]

cms::cuda::for ( int  i = first)

Definition at line 27 of file HistoContainer.h.

27  {
28  auto off = cuda_std::upper_bound(offsets, offsets + nh + 1, i);
29  assert((*off) > 0);
30  int32_t ih = off - offsets - 1;
31  assert(ih >= 0);
32  assert(ih < int(nh));
33  (*h).count(v[i], ih);
34  }

References assert(), mps_fire::i, nh, offsets, cuda_std::upper_bound(), and v.

Referenced by SiStripAPVRestorer::abnormalBaselineInspect(), DumpFWRecoGeometry::analyze(), HGCalImagingAlgo::calculateDistanceToHigher(), spr::cGenSimInfo(), LHCInfo::cloneFill(), CandCombinerBase< OutputCollection, Cloner::CandPtr >::combine(), GsfBetheHeitlerUpdator::correctWeights(), CSCOfflineMonitor::doEfficiencies(), CSCValidation::doEfficiencies(), CSCValidation::doGasGain(), CSCValidation::doPedestalNoise(), CSCOfflineMonitor::doStripDigis(), CSCValidation::doStripDigis(), CSCOfflineMonitor::doWireDigis(), CSCValidation::doWireDigis(), SiPixelStatusHarvester::dqmEndRun(), InvRingCalib::endOfLoop(), SiStripBadAPVAlgorithmFromClusterOccupancy::extractBadAPVs(), NtupleManager::FillFitParameters(), CSCEfficiency::fillStrips_info(), HLTCTPPSLocalTrackFilter::filter(), ecaldqm::binning::getBinningEcal_(), HcalLutManager_test::getLutSetFromFile_test(), HcalDDDSimConstants::initialize(), FWGeometry::initMap(), InputTagDistributor::inputTag(), SiPixelTemplate::interpolate(), SiStripFedCablingFakeESSource::make(), LayerClusterAssociatorByEnergyScoreImpl::makeConnections(), HcalFlexiHardcodeGeometryLoader::makeHECells(), operator<<(), operator>>(), SiPixelTemplateReco::PixelTempReco1D(), SiPixelTemplateReco2D::PixelTempReco2D(), SiPixelGenError::postInit(), SiPixelTemplate::postInit(), SiPixelTemplate2D::pushfile(), TPedValues::TPedValues(), DAClusterizerInZ_vect::vertices(), DAClusterizerInZT_vect::vertices(), EcalPedOffset::~EcalPedOffset(), SiStripLAProfileBooker::~SiStripLAProfileBooker(), and StraightTrackAlignment::~StraightTrackAlignment().

◆ free_device()

void cms::cuda::free_device ( int  device,
void *  ptr 
)

Definition at line 31 of file allocate_device.cc.

31  {
32  if constexpr (allocator::useCaching) {
33  cudaCheck(allocator::getCachingDeviceAllocator().DeviceFree(device, ptr));
34  } else {
35  ScopedSetDevice setDeviceForThisScope(device);
36  cudaCheck(cudaFree(ptr));
37  }
38  }

References cudaCheck, cms::cuda::allocator::getCachingDeviceAllocator(), and cms::cuda::allocator::useCaching.

Referenced by cms::cuda::device::impl::DeviceDeleter::operator()().

◆ free_host()

void cms::cuda::free_host ( void *  ptr)

Definition at line 29 of file allocate_host.cc.

29  {
30  if constexpr (allocator::useCaching) {
32  } else {
33  cudaCheck(cudaFreeHost(ptr));
34  }
35  }

References cudaCheck, cms::cuda::allocator::getCachingHostAllocator(), and cms::cuda::allocator::useCaching.

Referenced by cms::cuda::host::impl::HostDeleter::operator()().

◆ getEventCache()

EventCache & cms::cuda::getEventCache ( )

Definition at line 64 of file EventCache.cc.

64  {
65  // the public interface is thread safe
66  CMS_THREAD_SAFE static EventCache cache;
67  return cache;
68  }

References utilities::cache(), and CMS_THREAD_SAFE.

Referenced by CUDAService::CUDAService(), cms::cuda::ESProduct< T >::ESProduct(), and CUDAService::~CUDAService().

◆ getStreamCache()

StreamCache & cms::cuda::getStreamCache ( )

Definition at line 39 of file StreamCache.cc.

39  {
40  // the public interface is thread safe
41  CMS_THREAD_SAFE static StreamCache cache;
42  return cache;
43  }

References utilities::cache(), and CMS_THREAD_SAFE.

Referenced by CUDAService::CUDAService(), TestCUDAAnalyzerGPU::endJob(), cms::cuda::impl::ScopedContextBase::ScopedContextBase(), TestCUDAAnalyzerGPU::TestCUDAAnalyzerGPU(), and CUDAService::~CUDAService().

◆ launch() [1/2]

template<typename F , typename... Args>
std::enable_if_t<std::is_void<std::result_of_t<F && (Args && ...)> >::value> cms::cuda::launch ( F kernel,
LaunchParameters  config,
Args &&...  args 
)

Definition at line 107 of file launch.h.

107  {
108  using function_type = detail::kernel_traits<F>;
109  typename function_type::argument_type_tuple args_copy(args...);
110 
111  constexpr auto size = function_type::arguments_size;
112  void const* pointers[size];
113 
114  detail::pointer_setter<size>()(pointers, args_copy);
115  cudaCheck(cudaLaunchKernel(
116  (const void*)kernel, config.gridDim, config.blockDim, (void**)pointers, config.sharedMem, config.stream));
117  }

References writedatasetfile::args, cudaCheck, and size.

◆ launch() [2/2]

void cms::cuda::launch ( void(*)()  kernel,
LaunchParameters  config 
)
inline

Definition at line 96 of file launch.h.

96  {
97  cudaCheck(cudaLaunchKernel(
98  (const void*)kernel, config.gridDim, config.blockDim, nullptr, config.sharedMem, config.stream));
99  }

References cudaCheck.

◆ launch_cooperative() [1/2]

template<typename F , typename... Args>
std::enable_if_t<std::is_void<std::result_of_t<F && (Args && ...)> >::value> cms::cuda::launch_cooperative ( F kernel,
LaunchParameters  config,
Args &&...  args 
)

Definition at line 132 of file launch.h.

132  {
133  using function_type = detail::kernel_traits<F>;
134  typename function_type::argument_type_tuple args_copy(args...);
135 
136  constexpr auto size = function_type::arguments_size;
137  void const* pointers[size];
138 
139  detail::pointer_setter<size>()(pointers, args_copy);
140  cudaCheck(cudaLaunchCooperativeKernel(
141  (const void*)kernel, config.gridDim, config.blockDim, (void**)pointers, config.sharedMem, config.stream));
142  }

References writedatasetfile::args, cudaCheck, and size.

◆ launch_cooperative() [2/2]

void cms::cuda::launch_cooperative ( void(*)()  kernel,
LaunchParameters  config 
)
inline

Definition at line 121 of file launch.h.

121  {
122  cudaCheck(cudaLaunchCooperativeKernel(
123  (const void*)kernel, config.gridDim, config.blockDim, nullptr, config.sharedMem, config.stream));
124  }

References cudaCheck.

◆ make_device_unique() [1/3]

template<typename T , typename... Args>
device::impl::make_device_unique_selector<T>::bounded_array cms::cuda::make_device_unique ( Args &&  ...)
delete

◆ make_device_unique() [2/3]

template<typename T >
device::impl::make_device_unique_selector<T>::non_array cms::cuda::make_device_unique ( cudaStream_t  stream)

Definition at line 52 of file device_unique_ptr.h.

52  {
54  "Allocating with non-trivial constructor on the device memory is not supported");
55  int dev = currentDevice();
56  void *mem = allocate_device(dev, sizeof(T), stream);
57  return typename device::impl::make_device_unique_selector<T>::non_array{reinterpret_cast<T *>(mem),
58  device::impl::DeviceDeleter{dev}};
59  }

References allocate_device(), currentDevice(), mem, stream, and relativeConstraints::value.

◆ make_device_unique() [3/3]

template<typename T >
device::impl::make_device_unique_selector<T>::unbounded_array cms::cuda::make_device_unique ( size_t  n,
cudaStream_t  stream 
)

Definition at line 62 of file device_unique_ptr.h.

63  {
64  using element_type = typename std::remove_extent<T>::type;
66  "Allocating with non-trivial constructor on the device memory is not supported");
67  int dev = currentDevice();
68  void *mem = allocate_device(dev, n * sizeof(element_type), stream);
69  return typename device::impl::make_device_unique_selector<T>::unbounded_array{
70  reinterpret_cast<element_type *>(mem), device::impl::DeviceDeleter{dev}};
71  }

References allocate_device(), currentDevice(), mem, n, stream, and relativeConstraints::value.

◆ make_device_unique_uninitialized() [1/3]

template<typename T , typename... Args>
device::impl::make_device_unique_selector<T>::bounded_array cms::cuda::make_device_unique_uninitialized ( Args &&  ...)
delete

◆ make_device_unique_uninitialized() [2/3]

template<typename T >
device::impl::make_device_unique_selector<T>::non_array cms::cuda::make_device_unique_uninitialized ( cudaStream_t  stream)

Definition at line 78 of file device_unique_ptr.h.

79  {
80  int dev = currentDevice();
81  void *mem = allocate_device(dev, sizeof(T), stream);
82  return typename device::impl::make_device_unique_selector<T>::non_array{reinterpret_cast<T *>(mem),
83  device::impl::DeviceDeleter{dev}};
84  }

References allocate_device(), currentDevice(), mem, and stream.

◆ make_device_unique_uninitialized() [3/3]

template<typename T >
device::impl::make_device_unique_selector<T>::unbounded_array cms::cuda::make_device_unique_uninitialized ( size_t  n,
cudaStream_t  stream 
)

Definition at line 87 of file device_unique_ptr.h.

88  {
89  using element_type = typename std::remove_extent<T>::type;
90  int dev = currentDevice();
91  void *mem = allocate_device(dev, n * sizeof(element_type), stream);
92  return typename device::impl::make_device_unique_selector<T>::unbounded_array{
93  reinterpret_cast<element_type *>(mem), device::impl::DeviceDeleter{dev}};
94  }

References allocate_device(), currentDevice(), mem, n, and stream.

◆ make_host_noncached_unique() [1/3]

template<typename T , typename... Args>
host::noncached::impl::make_host_unique_selector<T>::bounded_array cms::cuda::make_host_noncached_unique ( Args &&  ...)
delete

◆ make_host_noncached_unique() [2/3]

template<typename T >
host::noncached::impl::make_host_unique_selector<T>::unbounded_array cms::cuda::make_host_noncached_unique ( size_t  n,
unsigned int  flags = cudaHostAllocDefault 
)

Definition at line 57 of file host_noncached_unique_ptr.h.

58  {
59  using element_type = typename std::remove_extent<T>::type;
61  "Allocating with non-trivial constructor on the pinned host memory is not supported");
62  void *mem;
63  cudaCheck(cudaHostAlloc(&mem, n * sizeof(element_type), flags));
64  return typename host::noncached::impl::make_host_unique_selector<T>::unbounded_array(
65  reinterpret_cast<element_type *>(mem));
66  }

References cudaCheck, HLT_FULL_cff::flags, mem, n, and relativeConstraints::value.

◆ make_host_noncached_unique() [3/3]

template<typename T >
host::noncached::impl::make_host_unique_selector<T>::non_array cms::cuda::make_host_noncached_unique ( unsigned int  flags = cudaHostAllocDefault)

The difference wrt. make_host_unique is that these do not cache, so they should not be called per-event.

Definition at line 47 of file host_noncached_unique_ptr.h.

48  {
50  "Allocating with non-trivial constructor on the pinned host memory is not supported");
51  void *mem;
52  cudaCheck(cudaHostAlloc(&mem, sizeof(T), flags));
53  return typename host::noncached::impl::make_host_unique_selector<T>::non_array(reinterpret_cast<T *>(mem));
54  }

References cudaCheck, HLT_FULL_cff::flags, mem, and relativeConstraints::value.

◆ make_host_unique() [1/3]

template<typename T , typename... Args>
host::impl::make_host_unique_selector<T>::bounded_array cms::cuda::make_host_unique ( Args &&  ...)
delete

◆ make_host_unique() [2/3]

template<typename T >
host::impl::make_host_unique_selector<T>::non_array cms::cuda::make_host_unique ( cudaStream_t  stream)

Definition at line 41 of file host_unique_ptr.h.

41  {
43  "Allocating with non-trivial constructor on the pinned host memory is not supported");
44  void *mem = allocate_host(sizeof(T), stream);
45  return typename host::impl::make_host_unique_selector<T>::non_array{reinterpret_cast<T *>(mem)};
46  }

References allocate_host(), mem, stream, and relativeConstraints::value.

◆ make_host_unique() [3/3]

template<typename T >
host::impl::make_host_unique_selector<T>::unbounded_array cms::cuda::make_host_unique ( size_t  n,
cudaStream_t  stream 
)

Definition at line 49 of file host_unique_ptr.h.

49  {
50  using element_type = typename std::remove_extent<T>::type;
52  "Allocating with non-trivial constructor on the pinned host memory is not supported");
53  void *mem = allocate_host(n * sizeof(element_type), stream);
54  return typename host::impl::make_host_unique_selector<T>::unbounded_array{reinterpret_cast<element_type *>(mem)};
55  }

References allocate_host(), mem, n, stream, and relativeConstraints::value.

◆ make_host_unique_uninitialized() [1/3]

template<typename T , typename... Args>
host::impl::make_host_unique_selector<T>::bounded_array cms::cuda::make_host_unique_uninitialized ( Args &&  ...)
delete

◆ make_host_unique_uninitialized() [2/3]

template<typename T >
host::impl::make_host_unique_selector<T>::non_array cms::cuda::make_host_unique_uninitialized ( cudaStream_t  stream)

Definition at line 62 of file host_unique_ptr.h.

62  {
63  void *mem = allocate_host(sizeof(T), stream);
64  return typename host::impl::make_host_unique_selector<T>::non_array{reinterpret_cast<T *>(mem)};
65  }

References allocate_host(), mem, and stream.

◆ make_host_unique_uninitialized() [3/3]

template<typename T >
host::impl::make_host_unique_selector<T>::unbounded_array cms::cuda::make_host_unique_uninitialized ( size_t  n,
cudaStream_t  stream 
)

Definition at line 68 of file host_unique_ptr.h.

69  {
70  using element_type = typename std::remove_extent<T>::type;
71  void *mem = allocate_host(n * sizeof(element_type), stream);
72  return typename host::impl::make_host_unique_selector<T>::unbounded_array{reinterpret_cast<element_type *>(mem)};
73  }

References allocate_host(), mem, n, and stream.

◆ make_SimpleVector() [1/2]

template<class T >
SimpleVector<T> cms::cuda::make_SimpleVector ( int  capacity,
T data 
)

Definition at line 124 of file SimpleVector.h.

124  {
125  SimpleVector<T> ret;
126  ret.construct(capacity, data);
127  return ret;
128  }

References data, and runTheMatrix::ret.

◆ make_SimpleVector() [2/2]

template<class T >
SimpleVector<T>* cms::cuda::make_SimpleVector ( SimpleVector< T > *  mem,
int  capacity,
T data 
)

Definition at line 132 of file SimpleVector.h.

132  {
133  auto ret = new (mem) SimpleVector<T>();
134  ret->construct(capacity, data);
135  return ret;
136  }

References data, mem, and runTheMatrix::ret.

◆ memsetAsync() [1/2]

template<typename T >
void cms::cuda::memsetAsync ( device::unique_ptr< T > &  ptr,
T  value,
cudaStream_t  stream 
)
inline

Definition at line 12 of file memsetAsync.h.

12  {
13  // Shouldn't compile for array types because of sizeof(T), but
14  // let's add an assert with a more helpful message
15  static_assert(std::is_array<T>::value == false,
16  "For array types, use the other overload with the size parameter");
17  cudaCheck(cudaMemsetAsync(ptr.get(), value, sizeof(T), stream));
18  }

References cudaCheck, stream, relativeConstraints::value, and value.

◆ memsetAsync() [2/2]

template<typename T >
void cms::cuda::memsetAsync ( device::unique_ptr< T[]> &  ptr,
int  value,
size_t  nelements,
cudaStream_t  stream 
)
inline

The type of value is int because of cudaMemsetAsync() takes it as an int. Note that cudaMemsetAsync() sets the value of each byte to value. This may lead to unexpected results if sizeof(T) > 1 and value != 0.

Definition at line 27 of file memsetAsync.h.

27  {
28  cudaCheck(cudaMemsetAsync(ptr.get(), value, nelements * sizeof(T), stream));
29  }

References cudaCheck, stream, and value.

◆ numberOfDevices()

int cms::cuda::numberOfDevices ( )

Definition at line 6 of file numberOfDevices.cc.

6  {
8  return cs->enabled() ? cs->numberOfDevices() : 0;
9  }

References fwrapper::cs.

Referenced by cms::cuda::allocator::minCachedBytes().

Variable Documentation

◆ be

auto cms::cuda::be = std::min(int(Hist::nbins() - 1), bs + n)

◆ bs

cms::cuda::bs = std::max(0, bs - n)

Definition at line 127 of file HistoContainer.h.

Referenced by OutputMagneticFieldDDToDDL::addToSolStore(), OutputDDToDDL::addToSolStore(), ElectronGeneralAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), MuonMiniAOD::analyze(), RecoMuonValidator::analyze(), ElectronMcFakeValidator::analyze(), EfficiencyAnalyzer::analyze(), MuonKinVsEtaAnalyzer::analyze(), DiMuonHistograms::analyze(), ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), DQMAnalyzer::analyze(), TriggerMatchMonitor::analyze(), TrackBuildingAnalyzer::analyze(), tadqm::TrackAnalyzer::analyze(), MuonRecoOneHLT::analyze(), AnotherBeamSpotAnalyzer::analyze(), BSvsPVAnalyzer::analyze(), V0Monitor::analyze(), TrackingMonitor::analyze(), MuonTrackValidator::analyze(), TrackerDpgAnalysis::analyze(), TrackingNtuple::analyze(), TrackGenAssociatorByChi2Impl::associateGenToReco(), TrackGenAssociatorByChi2Impl::associateRecoToGen(), TrackAssociatorByChi2Impl::associateRecoToSim(), TrackAssociatorByChi2Impl::associateSimToReco(), bitset_utilities::bitsetToChar(), bitsetToVector(), MTDTopologyBuilder::build(), PixelTopologyBuilder::build(), StripTopologyBuilder::build(), FWBeamSpotProxyBuilder::build(), FWConvTrackHitsDetailView::build(), FWTauProxyBuilderBase::buildBaseTau(), DAFTrackProducerAlgorithm::buildTrack(), TrackExtenderWithMTDT< TrackCollection >::buildTrack(), L1GtVmeWriterCore::calculateAddress(), L1GtVmeWriterCore::calculateJetsAddress(), TrackerSeedCleaner::clean(), ReferenceTrajectory::construct(), SiStripDigitizerAlgorithm::digitize(), VertexCompatibleWithBeam::distanceToBeam(), MultiTrackValidatorGenPs::dqmAnalyze(), MultiTrackValidator::dqmAnalyze(), TEveEllipsoidProjectedGL::DrawRhoZ(), TEveEllipsoidProjectedGL::drawRhoZAxis(), BeamSpotAnalyzer::endLuminosityBlock(), AlcaBeamSpotProducer::endLuminosityBlockProduce(), DTGeometryParsFromDD::extractParameters(), DTGeometryBuilderFromDDD::extractParameters(), BeamSpotHistogramMaker::fill(), BSvsPVHistogramMaker::fill(), BPHWriteSpecificDecay::fill(), TrackToTrackComparisonHists::fill_generic_tracks_histos(), TrackToTrackComparisonHists::fill_matching_tracks_histos(), TrackingNtuple::fillBeamSpot(), TrackExtenderWithMTDT< TrackCollection >::fillMatchingHits(), GsfTrackProducerBase::fillMode(), TrackingNtuple::fillSeeds(), TrackingNtuple::fillTrackingParticles(), TrackingNtuple::fillTracks(), QcdUeDQM::fillVtxPlots(), BsJpsiPhiFilter::filter(), pat::PATSingleVertexSelector::filter_(), DivisiveVertexFinder::findVertexesAlt(), BeamMonitor::FitAndFill(), BeamMonitorBx::FitAndFill(), FakeBeamMonitor::FitAndFill(), BPHDecayVertex::fitVertex(), HcalLutManager::get_brickSet_from_oracle(), OnlineMetaDataRawToDigi::getBeamSpot(), TrackGenAssociatorByChi2Impl::getChi2(), TrackAssociatorByChi2Impl::getChi2(), DAFTrackProducer::getFromEvt(), edm::DataMixingPileupCopy::getPileupInfo(), NuclearTrackCorrector::getTrackFromTrajectory(), TrackProducerWithSCAssociation::getTransient(), TrackProducer::getTransient(), SusyDQM< Mu, Ele, Jet, Met >::goodSusyElectron(), SusyDQM< Mu, Ele, Jet, Met >::goodSusyMuon(), DDG4SolidConverter::intersection(), OniaVtxReProducer::makeVertices(), CosmicParametersDefinerForTP::momentum(), ParametersDefinerForTP::momentum(), VertexCompatibleWithBeam::operator()(), egammaisolation::EgammaTrackSelector::operator()(), CosmicTrackingParticleSelector::operator()(), VertexBeamspotOrigins::origins(), bitset_utilities::printWords(), EgammaHLTPixelMatchElectronAlgo::process(), TrackRefitter::produce(), GsfTrackRefitter::produce(), GsfTrackProducer::produce(), TrackProducer::produce(), TrackProducerWithSCAssociation::produce(), DAFTrackProducer::produce(), L2TauPixelTrackMatch::produce(), L2TauPixelIsoTagProducer::produce(), VertexCompositeCandidateCollectionSelector::produce(), AlCaGammaJetProducer::produce(), PATTracksToPackedCandidates::produce(), PixelVertexProducer::produce(), Onia2MuMuPAT::produce(), BeamSpotToCUDA::produce(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::produce(), TemplatedSecondaryVertexProducer< IPTI, VTX >::produce(), TrackExtenderWithMTDT< TrackCollection >::produce(), PreMixingSiPixelWorker::put(), PreMixingSiStripWorker::put(), GsfTrackProducerBase::putInEvt(), MuonTrackingRegionBuilder::region(), GlobalTrackingRegionProducerFromBeamSpot::regions(), TrackingRegionsFromBeamSpotAndL2Tau::regions(), GlobalTrackingRegionWithVerticesProducer::regions(), HITrackingRegionForPrimaryVtxProducer::regions(), CandidateSeededTrackingRegionsProducer::regions(), PointSeededTrackingRegionsProducer::regions(), EgammaHLTPixelMatchElectronAlgo::run(), DAFTrackProducerAlgorithm::runWithCandidate(), pixeltemp::Cluster1DMerger< reco::Track >::setBeamSpot(), RecoTracktoTP::SetBeamSpot(), TPtoRecoTrack::SetBeamSpot(), pixeltemp::DivisiveClusterizer1D< reco::Track >::setBeamSpot(), TtDilepEvtSolution::setBestSol(), GsfElectronAlgo::setCutBasedPreselectionFlag(), TrackAlgoCompareUtil::SetTrackingParticleD0Dz(), DDErrorDetection::so(), DDG4SolidConverter::subtraction(), MultiTrackValidator::tpParametersAndSelection(), track_associator::trackAssociationChi2(), reco::trackingParametersAtClosestApproachToBeamSpot(), QcdUeDQM::trackSelection(), TrackExtenderWithMTDT< TrackCollection >::tryBTLLayers(), TrackExtenderWithMTDT< TrackCollection >::tryETLLayers(), DDG4SolidConverter::unionsolid(), CosmicParametersDefinerForTP::vertex(), ParametersDefinerForTP::vertex(), BPHDecayVertex::vertex(), BSvsPVHistogramMaker::x(), and BSvsPVHistogramMaker::y().

◆ co

VT* cms::cuda::co

◆ func

V V const Func & cms::cuda::func
Initial value:
{

Definition at line 124 of file HistoContainer.h.

Referenced by for(), and cms::cuda::impl::ScopedContextHolderHelper::pushNextTask().

◆ n

cudaStream_t T uint32_t const T* __restrict__ const uint32_t* __restrict__ uint32_t int cudaStream_t Func V int cms::cuda::n

◆ nh

cudaStream_t T uint32_t cms::cuda::nh

◆ nthreads

cudaStream_t T uint32_t const T* __restrict__ const uint32_t* __restrict__ uint32_t int cms::cuda::nthreads

Definition at line 92 of file HistoContainer.h.

Referenced by addFiles().

◆ offsets

cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ cms::cuda::offsets
Initial value:

Definition at line 25 of file HistoContainer.h.

Referenced by for().

◆ size

VT uint32_t cms::cuda::size

Definition at line 46 of file prefixScan.h.

Referenced by launch(), and launch_cooperative().

◆ stream

cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t cms::cuda::stream

Definition at line 57 of file HistoContainer.h.

Referenced by dqmstorepb::ROOTFilePB_Histo::_InternalSerialize(), dqmstorepb::ROOTFilePB::_InternalSerialize(), allocate_device(), allocate_host(), HLTrigReport::analyze(), HLTriggerJSONMonitoring::analyze(), L1TriggerJSONMonitoring::analyze(), BeamSpotCUDA::BeamSpotCUDA(), BTagDifferentialPlot::bookHisto(), dqm::RamdiskMonitor::bookHistograms(), EtaPtBin::buildDescriptionString(), DQMStoreStats::calcIgProfDump(), edm::StreamSerializer::compressBufferLZMA(), copyAsync(), LzmaFile::DecodeAll(), LzmaFile::DecodeBuffer(), DTOccupancyClusterBuilder::drawClusters(), HLTrigReport::endRun(), cms::cuda::impl::ScopedContextHolderHelper::enqueueCallback(), fillPathSummary(), edm::SystemTimeKeeper::fillTriggerTimingReport(), SiStripDetVOffTkMapPlotter::formatIOV(), SiStripDetVOffTrendPlotter::formatIOV(), cms::cuda::StreamCache::get(), getABDCCOutputStream(), evf::EvFDaqDirector::getDatFilePath(), evf::EvFDaqDirector::getInitFilePath(), evf::EvFDaqDirector::getMergedDatChecksumFilePath(), evf::EvFDaqDirector::getMergedDatFilePath(), evf::EvFDaqDirector::getMergedProtocolBufferHistogramFilePath(), evf::EvFDaqDirector::getMergedRootHistogramFilePath(), evf::EvFDaqDirector::getOpenDatFilePath(), evf::EvFDaqDirector::getOpenInitFilePath(), evf::EvFDaqDirector::getOpenOutputJsonFilePath(), evf::EvFDaqDirector::getOpenProtocolBufferHistogramFilePath(), evf::EvFDaqDirector::getOpenRootHistogramFilePath(), evf::EvFDaqDirector::getOutputJsonFilePath(), evf::EvFDaqDirector::getProtocolBufferHistogramFilePath(), evf::EvFDaqDirector::getRootHistogramFilePath(), evf::EvFDaqDirector::getStreamDestinations(), evf::EvFDaqDirector::getStreamMergeType(), HLTrigReport::globalEndLuminosityBlock(), HeterogeneousSoAImpl< T, Traits >::HeterogeneousSoAImpl(), HLTMuonTrackMassFilter::hltFilter(), HLTMuonTrackMassFilter::HLTMuonTrackMassFilter(), fffnaming::initFileNameWithInstance(), fffnaming::initFileNameWithPid(), l1t::MicroGMTLUT::initialize(), CSCComparatorCodeLUT::initialize(), LookInStream_LookRead(), LookInStream_Read(), LookInStream_Read2(), LookInStream_SeekTo(), l1t::LUT::LUT(), make_device_unique(), cms::cudacompat::GPUTraits::make_device_unique(), cms::cudacompat::HostTraits::make_device_unique(), make_device_unique_uninitialized(), make_host_unique(), cms::cudacompat::GPUTraits::make_host_unique(), cms::cudacompat::HostTraits::make_host_unique(), make_host_unique_uninitialized(), cms::cudacompat::GPUTraits::make_unique(), cms::cudacompat::HostTraits::make_unique(), memsetAsync(), hcaldqm::hashfunctions::name_TChannel(), L1GtPsbSetupConfigOnlineProd::numberFromString(), LzmaFile::Open(), cms::cuda::StreamCache::Deleter::operator()(), operator<<(), reco::operator<<(), edm::ParentContext::ParentContext(), FastTimerService::postEvent(), FastTimerService::postModuleEvent(), FastTimerService::postModuleEventAcquire(), FastTimerService::postPathEvent(), FastTimerService::postSourceEvent(), edm::service::MessageLogger::preModuleEvent(), FastTimerService::preModuleEvent(), edm::service::MessageLogger::preModuleEventAcquire(), FastTimerService::preModuleEventAcquire(), edm::service::MessageLogger::preModuleStreamBeginLumi(), edm::service::MessageLogger::preModuleStreamBeginRun(), edm::service::MessageLogger::preModuleStreamEndLumi(), edm::service::MessageLogger::preModuleStreamEndRun(), FastTimerService::prePathEvent(), edm::service::MessageLogger::prePathEvent(), FastTimerService::preSourceEvent(), PhysicsTGraphPayload::print(), PFMETAlgorithmMVA::print(), reco::PFRecoTauChargedHadron::print(), reco::HitPattern::print(), reco::HitPattern::printHitPattern(), QuarkoniaTrackSelector::produce(), trackerDTC::DTC::produce(), L1RCTOmdsFedVectorProducer::produce(), fffnaming::protocolBufferHistogramFileNameWithInstance(), fffnaming::protocolBufferHistogramFileNameWithPid(), QuarkoniaTrackSelector::QuarkoniaTrackSelector(), CSCComparatorCodeLUT::read(), l1t::LUT::read(), RunInfoRead::readData(), CSCComparatorCodeLUT::readHeader(), l1t::LUT::readHeader_(), EnergyScaleCorrection::readScalesFromFile(), fffnaming::rootHistogramFileNameWithInstance(), fffnaming::rootHistogramFileNameWithPid(), TestCUDAProducerGPUKernel::runAlgo(), SeqInStream_Read(), SeqInStream_Read2(), SeqInStream_ReadByte(), cms::cuda::ContextState::set(), trackerDTC::DTC::split(), HLTriggerJSONMonitoring::streamBeginLuminosityBlock(), L1TriggerJSONMonitoring::streamBeginLuminosityBlock(), HLTConfigData::streamContent(), HLTConfigProvider::streamContent(), HLTriggerJSONMonitoring::streamEndLuminosityBlockSummary(), L1TriggerJSONMonitoring::streamEndLuminosityBlockSummary(), fffnaming::streamerDataChecksumFileNameWithInstance(), fffnaming::streamerDataFileNameWithInstance(), fffnaming::streamerDataFileNameWithPid(), fffnaming::streamerJsonFileNameWithInstance(), fffnaming::streamerJsonFileNameWithPid(), HLTConfigData::streamIndex(), HLTConfigProvider::streamIndex(), HLTConfigData::streamName(), HLTConfigProvider::streamName(), edm::SystemTimeKeeper::SystemTimeKeeper(), HeterogeneousSoA< T >::toHostAsync(), HeterogeneousSoAImpl< T, Traits >::toHostAsync(), edm::StreamerInputSource::uncompressBufferLZMA(), edm::service::MessageLogger::unEstablishModule(), CSCComparatorCodeLUT::write(), and l1t::LUT::write().

◆ totSize

cudaStream_t T uint32_t const T* __restrict__ const uint32_t* __restrict__ uint32_t cms::cuda::totSize

◆ v

cudaStream_t T uint32_t const T *__restrict__ cms::cuda::v

◆ V

cudaStream_t T uint32_t const T* __restrict__ const uint32_t* __restrict__ uint32_t int cudaStream_t cms::cuda::V

◆ value

cudaStream_t T uint32_t const T* __restrict__ const uint32_t* __restrict__ uint32_t int cudaStream_t Func V cms::cuda::value

Definition at line 124 of file HistoContainer.h.

Referenced by memsetAsync().

◆ wmax

V V cms::cuda::wmax

◆ wmin

V cms::cuda::wmin

Definition at line 136 of file HistoContainer.h.

Referenced by HGCalDDDConstants::HGCalDDDConstants().

runTheMatrix.ret
ret
prodAgent to be discontinued
Definition: runTheMatrix.py:373
writedatasetfile.args
args
Definition: writedatasetfile.py:18
mps_setup.cmd
list cmd
Definition: mps_setup.py:244
mps_fire.i
i
Definition: mps_fire.py:428
dqmiodumpmetadata.n
n
Definition: dqmiodumpmetadata.py:28
cms::cuda::allocator::useCaching
constexpr bool useCaching
Definition: getCachingDeviceAllocator.h:14
fwrapper::cs
unique_ptr< ClusterSequence > cs
Definition: fastjetfortran_madfks.cc:47
edmLumisInFiles.description
description
Definition: edmLumisInFiles.py:11
cms::cuda::stream
cudaStream_t stream
Definition: HistoContainer.h:57
cms::cuda::assert
assert(be >=bs)
mem
uint16_t mem[nChs][nEvts]
Definition: recycleTccEmu.cc:13
relativeConstraints.error
error
Definition: relativeConstraints.py:53
dqmdumpme.first
first
Definition: dqmdumpme.py:55
notcub::CachingDeviceAllocator::CacheStatus
GpuCachedBytes CacheStatus() const
Definition: CachingDeviceAllocator.h:753
CUDAService::numberOfDevices
int numberOfDevices() const
Definition: CUDAService.h:24
cms::cuda::allocate_host
void * allocate_host(size_t nbytes, cudaStream_t stream)
Definition: allocate_host.cc:15
config
Definition: config.py:1
UNLIKELY
#define UNLIKELY(x)
Definition: Likely.h:21
cms::cuda::bs
bs
Definition: HistoContainer.h:127
cuda_std::upper_bound
__host__ constexpr __device__ RandomIt upper_bound(RandomIt first, RandomIt last, const T &value, Compare comp={})
Definition: cudastdAlgorithm.h:45
cms::cuda::func
cudaStream_t T uint32_t const T *__restrict__ const uint32_t *__restrict__ uint32_t int cudaStream_t Func V int Func func
Definition: HistoContainer.h:124
cms::cuda::nh
uint32_t nh
Definition: HistoContainer.h:23
CMS_THREAD_SAFE
#define CMS_THREAD_SAFE
Definition: thread_safety_macros.h:4
utilities.cache
def cache(function)
Definition: utilities.py:3
cms::cuda::currentDevice
int currentDevice()
Definition: currentDevice.h:10
TrackRefitter_38T_cff.src
src
Definition: TrackRefitter_38T_cff.py:24
cms::cudacompat::blockDim
const dim3 blockDim
Definition: cudaCompat.h:25
gainCalibHelper::gainCalibPI::type
type
Definition: SiPixelGainCalibHelper.h:39
edm::get_underlying
constexpr T & get_underlying(propagate_const< T > &)
Definition: propagate_const.h:103
edm::Service
Definition: Service.h:30
FrontierConditions_GlobalTag_cff.file
file
Definition: FrontierConditions_GlobalTag_cff.py:13
cms::cudacompat::dim3::x
uint32_t x
Definition: cudaCompat.h:21
value
Definition: value.py:1
cms::cudacompat::threadIdx
const dim3 threadIdx
Definition: cudaCompat.h:24
get
#define get
newFWLiteAna.bin
bin
Definition: newFWLiteAna.py:161
CUDAService::enabled
bool enabled() const
Definition: CUDAService.h:22
cudaCheck
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:62
cms::cuda::allocator::getCachingHostAllocator
notcub::CachingHostAllocator & getCachingHostAllocator()
Definition: getCachingHostAllocator.h:14
cms::cuda::offsets
uint32_t const T *__restrict__ const uint32_t *__restrict__ offsets
Definition: HistoContainer.h:25
T
long double T
Definition: Basic3DVectorLD.h:48
LIKELY
#define LIKELY(x)
Definition: Likely.h:20
relativeConstraints.value
value
Definition: relativeConstraints.py:53
data
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:79
cms::cuda::abortOnCudaError
void abortOnCudaError(const char *file, int line, const char *cmd, const char *error, const char *message, const char *description=nullptr)
Definition: cudaCheck.h:19
cms::cuda::allocate_device
void * allocate_device(int dev, size_t nbytes, cudaStream_t stream)
Definition: allocate_device.cc:16
MillePedeFileConverter_cfg.out
out
Definition: MillePedeFileConverter_cfg.py:31
mps_fire.result
result
Definition: mps_fire.py:311
cms::Exception
Definition: Exception.h:70
math::cholesky::dst
M2 & dst
Definition: choleskyInversion.h:158
event
Definition: event.py:1
HLT_FULL_cff.flags
flags
Definition: HLT_FULL_cff.py:13150
mps_splice.line
line
Definition: mps_splice.py:76
cms::cuda::v
uint32_t const T *__restrict__ v
Definition: HistoContainer.h:23
findQualityFiles.size
size
Write out results.
Definition: findQualityFiles.py:443
cms::cuda::allocator::getCachingDeviceAllocator
notcub::CachingDeviceAllocator & getCachingDeviceAllocator()
Definition: getCachingDeviceAllocator.h:45
cms::cudacompat::blockIdx
thread_local dim3 blockIdx
Definition: cudaCompat.cc:5