CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Groups Pages
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  FlexiStorage
 
class  FlexiStorage< I,-1 >
 
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  OneToManyAssoc
 
struct  OneToManyAssocView
 
class  Product
 
class  ProductBase
 
class  ScopedContextAcquire
 
class  ScopedContextAnalyze
 
class  ScopedContextProduce
 
class  ScopedContextTask
 
class  ScopedSetDevice
 
struct  SimpleVector
 
class  StreamCache
 
class  VecArray
 

Typedefs

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
 
template<typename Assoc >
 __attribute__ ((always_inline)) void zeroAndInit(OneToManyAssocView< Assoc > view)
 
template<typename VT , typename T >
__host__ __device__ __attribute__ ((always_inline)) void blockPrefixScan(VT const *ci
 
template<typename Hist , typename V , typename Func >
__host__ __device__ __attribute__ ((always_inline)) void forEachInWindow(Hist const &hist
 
void abortOnCudaError (const char *file, int line, const char *cmd, const char *error, const char *message, std::string_view description=std::string_view())
 
void abortOnNvmlError (const char *file, int line, const char *cmd, const char *error, const char *message, std::string_view description=std::string_view())
 
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 (device::unique_ptr< T > &dst, const host::unique_ptr< 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 (device::unique_ptr< T[]> &dst, const host::unique_ptr< T[]> &src, size_t nelements, 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)
 
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 (edm::propagate_const_array< cms::cuda::device::unique_ptr< T[]>> &dst, const std::vector< T, cms::cuda::HostAllocator< T >> &src, cudaStream_t stream)
 
bool cudaCheck_ (const char *file, int line, const char *cmd, CUresult result, std::string_view description=std::string_view())
 
bool cudaCheck_ (const char *file, int line, const char *cmd, cudaError_t result, std::string_view description=std::string_view())
 
int currentDevice ()
 
allocator::GpuCachedBytes deviceAllocatorStatus ()
 
int deviceCount ()
 
bool eventWorkHasCompleted (cudaEvent_t event)
 
 for (int i=first, nt=offsets[nh];i< nt;i+=gridDim.x *blockDim.x)
 
 for (auto pj=hist.begin(bs);pj< hist.end(be);++pj)
 
void free_device (int device, void *ptr)
 
void free_host (void *ptr)
 
EventCachegetEventCache ()
 
StreamCachegetStreamCache ()
 
void launch (void(*kernel)(), LaunchParameters config)
 
template<typename F , typename... Args>
std::enable_if_t< std::is_void
< std::result_of_t< F &&(Args &&...)>
>::value
launch (F *kernel, LaunchParameters config, Args &&...args)
 
void launch_cooperative (void(*kernel)(), LaunchParameters config)
 
template<typename F , typename... Args>
std::enable_if_t< std::is_void
< std::result_of_t< F &&(Args &&...)>
>::value
launch_cooperative (F *kernel, LaunchParameters config, Args &&...args)
 
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 (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>
device::impl::make_device_unique_selector
< T >::bounded_array 
make_device_unique_uninitialized (Args &&...)=delete
 
template<typename T >
host::noncached::impl::make_host_unique_selector
< T >::non_array 
make_host_noncached_unique (unsigned int flags=cudaHostAllocDefault)
 
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 , typename... Args>
host::noncached::impl::make_host_unique_selector
< T >::bounded_array 
make_host_noncached_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 (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<typename T , typename... Args>
host::impl::make_host_unique_selector
< T >::bounded_array 
make_host_unique_uninitialized (Args &&...)=delete
 
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 ()
 
bool nvmlCheck_ (const char *file, int line, const char *cmd, nvmlReturn_t result, std::string_view description=std::string_view())
 

Variables

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

Typedef Documentation

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

Definition at line 14 of file SharedEventPtr.h.

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

Definition at line 14 of file SharedStreamPtr.h.

Function Documentation

template<typename Histo , typename T >
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t Func __host__ __device__ cms::cuda::__attribute__ ( (always_inline)  )
inline
template<typename Assoc >
cms::cuda::__attribute__ ( (always_inline)  )
inline

Definition at line 36 of file OneToManyAssoc.h.

References cms::cudacompat::__syncthreads(), assert(), cms::cuda::OneToManyAssocView< Assoc >::assoc, cms::cudacompat::blockDim, cms::cudacompat::blockIdx, first, cms::cudacompat::gridDim, h, mps_fire::i, nt, and cms::cudacompat::threadIdx.

36  {
37  auto h = view.assoc;
38  assert(1 == gridDim.x);
39  assert(0 == blockIdx.x);
40 
41  int first = threadIdx.x;
42 
43  if (0 == first) {
44  h->psws = 0;
45  h->initStorage(view);
46  }
47  __syncthreads();
48  for (int i = first, nt = h->totOnes(); i < nt; i += blockDim.x) {
49  h->off[i] = 0;
50  }
51  }
const dim3 threadIdx
Definition: cudaCompat.h:29
const dim3 gridDim
Definition: cudaCompat.h:33
const dim3 blockDim
Definition: cudaCompat.h:30
assert(be >=bs)
const dim3 blockIdx
Definition: cudaCompat.h:32
int nt
Definition: AMPTWrapper.h:42
void __syncthreads()
Definition: cudaCompat.h:108
The Signals That Services Can Subscribe To This is based on ActivityRegistry h
Helper function to determine trigger accepts.
Definition: Activities.doc:4
template<typename VT , typename T >
__host__ __device__ cms::cuda::__attribute__ ( (always_inline)  ) const
inline
template<typename Hist , typename V , typename Func >
__host__ __device__ cms::cuda::__attribute__ ( (always_inline)  ) const
inline
void cms::cuda::abortOnCudaError ( const char *  file,
int  line,
const char *  cmd,
const char *  error,
const char *  message,
std::string_view  description = std::string_view() 
)
inline

Definition at line 21 of file cudaCheck.h.

References getPayloadData::description, and submitPVResolutionJobs::out.

Referenced by cudaCheck_().

26  {
27  std::ostringstream out;
28  out << "\n";
29  out << file << ", line " << line << ":\n";
30  out << "cudaCheck(" << cmd << ");\n";
31  out << error << ": " << message << "\n";
32  if (!description.empty())
33  out << description << "\n";
34  throw std::runtime_error(out.str());
35  }
list cmd
Definition: mps_setup.py:244
void cms::cuda::abortOnNvmlError ( const char *  file,
int  line,
const char *  cmd,
const char *  error,
const char *  message,
std::string_view  description = std::string_view() 
)
inline

Definition at line 20 of file nvmlCheck.h.

References getPayloadData::description, and submitPVResolutionJobs::out.

Referenced by nvmlCheck_().

25  {
26  std::ostringstream out;
27  out << "\n";
28  out << file << ", line " << line << ":\n";
29  out << "nvmlCheck(" << cmd << ");\n";
30  out << error << ": " << message << "\n";
31  if (!description.empty())
32  out << description << "\n";
33  throw std::runtime_error(out.str());
34  }
list cmd
Definition: mps_setup.py:244
void * cms::cuda::allocate_device ( int  dev,
size_t  nbytes,
cudaStream_t  stream 
)

Definition at line 16 of file allocate_device.cc.

References cudaCheck, cms::cuda::allocator::getCachingDeviceAllocator(), cond::impl::to_string(), UNLIKELY, and cms::cuda::allocator::useCaching.

Referenced by make_device_unique(), and make_device_unique_uninitialized().

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  }
std::string to_string(const V &value)
Definition: OMSAccess.h:71
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr bool useCaching
notcub::CachingDeviceAllocator & getCachingDeviceAllocator()
#define UNLIKELY(x)
Definition: Likely.h:21
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
void * cms::cuda::allocate_host ( size_t  nbytes,
cudaStream_t  stream 
)

Definition at line 15 of file allocate_host.cc.

References cudaCheck, cms::cuda::allocator::getCachingHostAllocator(), cond::impl::to_string(), UNLIKELY, and cms::cuda::allocator::useCaching.

Referenced by make_host_unique(), and make_host_unique_uninitialized().

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  }
std::string to_string(const V &value)
Definition: OMSAccess.h:71
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
notcub::CachingHostAllocator & getCachingHostAllocator()
constexpr bool useCaching
#define UNLIKELY(x)
Definition: Likely.h:21
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
cms::cuda::assert ( be >=  bs)

Referenced by gpuPixelRecHits::__attribute__(), __attribute__(), 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(), HcalDigisProducerGPU::acquire(), SiPixelRawToClusterCUDA::acquire(), 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::ProjectionRouter::addInput(), trklet::MatchEngine::addInput(), trklet::TrackletEngine::addInput(), trklet::TripletEngine::addInput(), trklet::FitTrack::addInput(), trklet::InputRouter::addInput(), trklet::PurgeDuplicate::addInput(), trklet::TrackletEngineDisplaced::addInput(), trklet::TrackletCalculator::addInput(), trklet::MatchCalculator::addInput(), trklet::TrackletCalculatorDisplaced::addInput(), trklet::MatchProcessor::addInput(), trklet::TrackletProcessor::addInput(), trklet::VMRouterCM::addInput(), trklet::VMRouter::addInput(), L1HPSPFTauBuilder::addL1PFCandidates(), edm::ProductRegistry::addLabelAlias(), OMTFinput::addLayerHit(), trklet::TrackletCalculatorDisplaced::addLayerProj(), trklet::TrackletCalculatorBase::addLayerProj(), trklet::Tracklet::addMatch(), HLTPerformanceInfo::addModuleToPath(), reco::PFRecHit::addNeighbour(), trigger::TriggerRefsCollections::addObjects(), trklet::ProjectionRouter::addOutput(), trklet::MatchEngine::addOutput(), trklet::FitTrack::addOutput(), trklet::TrackletEngine::addOutput(), trklet::TripletEngine::addOutput(), trklet::InputRouter::addOutput(), trklet::PurgeDuplicate::addOutput(), trklet::TrackletEngineDisplaced::addOutput(), trklet::TrackletCalculator::addOutput(), trklet::MatchCalculator::addOutput(), trklet::TrackletCalculatorDisplaced::addOutput(), trklet::MatchProcessor::addOutput(), trklet::TrackletProcessor::addOutput(), trklet::VMRouterCM::addOutput(), trklet::VMRouter::addOutput(), trklet::TrackletCalculator::addOutputProjection(), trklet::TrackletCalculatorDisplaced::addOutputProjection(), trklet::TrackletProcessor::addOutputProjection(), HcalAmplifier::addPedestals(), 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::Sector::addStub(), edm::Principal::addSwitchAliasProduct(), edm::Principal::addSwitchProducerProduct(), FWEventItemsManager::addTo(), FWEveView::addTo(), npstat::HistoND< Numeric, Axis >::addToBinContents(), npstat::HistoND< Numeric, Axis >::addToOverflows(), npstat::ArrayND< Numeric, StackLen, StackDim >::addToProjection(), npstat::HistoND< Numeric, Axis >::addToProjection(), edm::WorkerManager::addToUnscheduledWorkers(), CSCPairResidualsConstraint::addTrack(), trklet::VMProjectionsMemory::addTracklet(), IntermediateHitTriplets::RegionFiller::addTriplets(), HcalTriggerPrimitiveAlgo::addUpgradeTDCFG(), 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(), SiStripGainsPCLHarvester::algoComputeMPVandGain(), 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(), HelixFitOnGPU::allocateOnGPU(), CAHitNtupletGeneratorKernels< TTraits >::allocateOnGPU(), CaloSubdetectorGeometry::allocatePar(), SiStripThreshold::allThresholds(), CastorAmplifier::amplify(), ESElectronicsSimFast::analogToDigital(), PlaybackRawDataProvider::analyze(), TriggerSummaryAnalyzerAOD::analyze(), HcalPulseContainmentTest::analyze(), PixelTrackDumpCUDA::analyze(), BufferedBoostIODBWriter::analyze(), L1TDEMON::analyze(), L1TdeStage2CaloLayer1::analyze(), HLTEventAnalyzerAOD::analyze(), HLTEventAnalyzerRAW::analyze(), TrackingRecoMaterialAnalyser::analyze(), HeterogeneousHGCalRecHitsValidator::analyze(), DrellYanValidation::analyze(), EcalABAnalyzer::analyze(), EcalPerEvtLaserAnalyzer::analyze(), EcalTestPulseAnalyzer::analyze(), FFTJetCorrectorDBWriter::analyze(), HGCalHitCalibration::analyze(), METTester::analyze(), SiPhase2OuterTrackerLorentzAngleWriter::analyze(), HcalLutAnalyzer::analyze(), EcalLaserAnalyzer::analyze(), EcalLaserAnalyzer2::analyze(), PixelLumiDQM::analyze(), FFTJetPileupAnalyzer::analyze(), JetAnalyzer_HeavyIons::analyze(), HLTriggerJSONMonitoring::analyze(), L1TriggerJSONMonitoring::analyze(), MuonGeometrySanityCheck::analyze(), METAnalyzer::analyze(), PrimaryVertexAnalyzer4PUSlimmed::analyze(), PFAnalysis::analyze(), l1tVertexFinder::VertexNTupler::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(), edm::HistoryAppender::appendToProcessHistory(), CSCAlignmentCorrections::applyAlignment(), edm::ContainerMask< T >::applyOrTo(), areaInfo::areaInfo(), edm::TypeWithDict::arrayDimension(), edm::TypeWithDict::arrayLength(), npstat::ArrayND< Numeric, StackLen, StackDim >::ArrayND(), npstat::ArrayRange::ArrayRange(), FWCaloDataHistProxyBuilder::assertCaloDataSlice(), FWHGTowerProxyBuilderBase::assertCaloDataSlice(), FWHFTowerProxyBuilderBase::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(), mkfit::axis_base< R, I, M, N >::axis_base(), MEEBGeom::barrel(), trklet::TrackletCalculatorBase::barrelSeeding(), Basic2DGenericPFlowPositionCalc::Basic2DGenericPFlowPositionCalc(), EcalClusterLazyToolsBase::BasicClusterTime(), Json::BatchAllocator< AllocatedType, objectPerAllocation >::BatchAllocator(), edm::RootOutputFile::beginInputFile(), FRDOutputModule::beginLuminosityBlock(), gen::Pythia6Gun::beginLuminosityBlock(), edm::test::TestProcessor::beginLuminosityBlock(), mkfit::LayerOfHits::beginRegistrationOfHits(), L1Muon2RecoTreeProducer::beginRun(), L1MuonRecoTreeProducer::beginRun(), DQMEDAnalyzer::beginStream(), edm::Schedule::beginStream(), trklet::Settings::bendcut(), trklet::Settings::benddecode(), 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(), FakeBeamMonitor::bookHistograms(), BeamMonitor::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(), KDTreeLinkerAlgo< DATA, DIM >::build(), FWProxyBuilderBase::build(), PFClusterFromHGCalTrackster::buildClusters(), CAHitNtupletGeneratorKernels< TTraits >::buildDoublets(), npstat::ArrayND< Numeric, StackLen, StackDim >::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< Numeric, StackLen, StackDim >::buildStrides(), DTGeometryBuilderFromCondDB::buildSuperLayer(), trklet::TrackletConfigBuilder::buildTC(), BaseCkfTrajectoryBuilder::buildTrajectories(), FWProxyBuilderBase::buildViewType(), edm::TypeWithDict::byName(), HBHEHitMap::byTowers(), HIPAlignmentAlgorithm::calcAPE(), calcSampleName(), 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(), edm::checkForModuleDependencyCorrectness(), 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(), TrackingRecHit::clone_(), helper::GsfElectronCollectionStoreManager::cloneAndStore(), TrackingRecHit::cloneSH_(), edm::storage::File::close(), edm::storage::StatisticsSenderService::closedFile(), npstat::ArrayND< Numeric, StackLen, StackDim >::closest(), npstat::HistoND< Numeric, Axis >::closestBin(), MTDThresholdClusterizer::clusterize(), PixelThresholdClusterizerForBricked::clusterizeDetUnitT(), PixelThresholdClusterizer::clusterizeDetUnitT(), helper::ClusterStorer::ClusterHitRecord< SiStripRecHit2D::ClusterRef >rekey(), Model::CMSLinkDeleteOptOs(), CastorCoderFactory::coder(), HcalCoderFactory::coder(), pos::PixelCalibConfiguration::colCounter(), FWViewManagerBase::colorManager(), NamedCandCombinerBase::combine(), CandCombinerBase< OutputCollection, CandPtr >::combine(), edm::EventSelector::combine(), SimplePlan1RechitCombiner::combineAuxInfo(), optutl::CommandLineParser::CommandLineParser(), jsoncollector::FastMonitor::commit(), mkfit::CombCandidate::compactifyHitStorageForBestCand(), 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(), DQMBarycenter::TkAlBarycenters::computeBarycenters(), AlignmentPI::TkAlBarycenters::computeBarycenters(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), MuonDTSeedFromRecHits::computeMean(), pat::MuonMvaIDEstimator::computeMVAID(), edm::DataManagingProductResolver::connectTo(), IntermediateHitTriplets::RegionLayerSets::const_iterator::const_iterator(), hitfit::Constraint::Constraint(), edm::stream::ProducingModuleAdaptorBase< T >::consumesInfo(), edm::stream::EDAnalyzerAdaptorBase::consumesInfo(), evf::EvFDaqDirector::contactFileBroker(), edm::ContainerMask< T >::ContainerMask(), edm::contains(), PSFitter::HybridMinimizer::Contour(), npstat::ArrayND< Numeric, StackLen, StackDim >::contractLoop(), fw2dpf::convert(), CaloTowersCreationAlgo::convert(), edm::convert_handle(), convertFile(), npstat::convertHistoToDensity(), npstat::ArrayND< Numeric, StackLen, StackDim >::convertLinearIndex(), npstat::ArrayND< Numeric, StackLen, StackDim >::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::PixelFECConfig::crateFromFECNumber(), 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(), 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< HcalGainWidthsGPU::Product >::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(), trklet::Tracklet::diskstubstr(), 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::IDGeneratorSourceBase< PuttableSourceBase >::doReadEventWithDelayedReader(), edm::stream::ProducingModuleAdaptorBase< T >::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(), doZlibCompression(), DQMAnalyzer::DQMAnalyzer(), MEGeom::drawHist(), edm::RootFile::dropOnInputAndReorder(), edm::ProcessBlockHelper::dropProcessesAndReorderStoredImpl(), trklet::Settings::dtcLayers(), edmNew::DetSetVector< T >::FastFiller::dummy(), edmNew::DetSetVector< T >::TSFastFiller::dummy(), ProvenanceDumper::dumpEventFilteringParameterSets_(), dumpFiles(), GeometryInfoDump::dumpInfo(), edm::storage::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(), edm::ELseverityLevel::ELseverityLevel(), 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(), EcalLaserAnalyzer::endJob(), EcalLaserAnalyzer2::endJob(), BuildTrackerMapPlugin::endJob(), edm::Worker::endJob(), edm::Schedule::endStream(), dqm::implementation::DQMStore::enterLumi(), edm::RootTree::entryNumberForIndex(), edm::ParameterSet::eraseOrSetUntrackedParameterSet(), edm::ParameterSet::eraseSimpleParameter(), reco::tau::eratio(), CSCPairResidualsConstraint::error(), ThirdHitPredictionFromInvLine::errorCurvature(), MuonResidualsFitter::errorerror(), KfComponentsHolder::errors(), PSFitter::HybridMinimizer::Errors(), edm::stream::ProducingModuleAdaptorBase< T >::esGetTokenIndicesVector(), edm::stream::EDAnalyzerAdaptorBase::esGetTokenIndicesVector(), edm::EDConsumerBase::esGetTokenIndicesVector(), edm::stream::ProducingModuleAdaptorBase< T >::esGetTokenRecordIndicesVector(), edm::stream::EDAnalyzerAdaptorBase::esGetTokenRecordIndicesVector(), edm::EDConsumerBase::esGetTokenRecordIndicesVector(), ESHitResponse::ESHitResponse(), edm::EDLooperBase::esPrefetchAsync(), edm::Worker::esPrefetchAsync(), fftjetcms::EtaDependentPileup::EtaDependentPileup(), EcalEleCalibLooper::etaShifter(), FlatHexagon::etaSpan(), FlatTrd::etaSpan(), l1t::CorrCondition::evaluateCondition(), l1t::CorrWithOverlapRemovalCondition::evaluateCondition(), edm::test::TestProcessor::event(), EventMsgBuilder::EventMsgBuilder(), edm::EventPrincipal::EventPrincipal(), edm::EventRange::EventRange(), edm::eventsetup::EventSetupRecord::getHandleImpl< edm::ESHandle, fwliteeswriter::DummyType, fwliteeswriter::FWLWEventSetupRecord >(), edm::eventsetup::EventSetupRecordImpl::getImplementation< fwliteeswriter::DummyType >(), EveService::EveService(), npstat::HistoND< Numeric, Axis >::examine(), trklet::MatchEngine::execute(), trklet::TrackletEngine::execute(), trklet::TripletEngine::execute(), trklet::InputRouter::execute(), trklet::TrackletEngineDisplaced::execute(), trklet::MatchCalculator::execute(), trklet::MatchProcessor::execute(), trklet::TrackletProcessor::execute(), DDCutTubsFromPoints::execute(), trklet::FitTrack::execute(), trklet::VMRouterCM::execute(), trklet::VMRouter::execute(), DDEcalEndcapAlgo::execute(), HistogramManager::executeExtend(), HistogramManager::executeGroupBy(), HistogramManager::executeHarvesting(), HistogramManager::executePerEventHarvesting(), npstat::BoxND< Numeric >::expand(), mkfit::MkBuilder::export_best_comb_cands(), npstat::ArrayND< Numeric >::exportSlice(), npstat::ArrayND< Numeric, StackLen, StackDim >::exportSubrange(), LayerHitMapCache::SimpleCache::extend(), timestudy::ExternalWorkSleepingProducer::ExternalWorkSleepingProducer(), 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(), BeamSpotPI::DisplayParametersDiff< PayloadType, nIOVs, ntags >::fill(), gainCalibHelper::SiPixelGainCalibrationValuesComparisonPerRegion< isBarrel, myType, nIOVs, ntags, PayloadType >::fill(), gainCalibHelper::SiPixelGainCalibDiffAndRatioBase< myType, nIOVs, ntags, PayloadType >::fill(), gainCalibHelper::SiPixelGainCalibrationByRegionComparisonBase< myType, PayloadType, nIOVs, ntags >::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(), edm::OutputProcessBlockHelper::fillCacheIndices(), FWHFTowerProxyBuilderBase::fillCaloData(), FWHGTowerProxyBuilderBase::fillCaloData(), InOutConversionSeedFinder::fillClusterSeeds(), EcalUncalibRecHitProducer::fillDescriptions(), PixelCPEBase::fillDetParams(), gainCalibHelper::gainCalibPI::fillDiffAndRatio(), SiStripDaqInfo::fillDummyStatus(), SiStripDcsInfo::fillDummyStatus(), pat::PATElectronProducer::fillElectron(), edm::RootFile::fillEventHistory(), edm::IndexIntoFile::fillEventNumbersOrEntries(), FedRawDataInputSource::fillFEDRawDataCollection(), edm::ProcessBlockHelper::fillFromPrimaryInputWhenNotEmpty(), 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(), PixelCPEFast::fillParamsForGpu(), edm::fillPathSummary(), FastTimerServiceClient::fillPathSummaryPlots(), ClusterShapeHitFilter::fillPixelData(), FastTimerServiceClient::fillPlotsVsLumi(), FWTGeoRecoGeometry::Info::fillPoints(), FWRecoGeometryESProducer::fillPoints(), edm::RootInputFileSequence::fillProcessBlockHelper_(), edm::RootFile::fillProcessBlockHelper_(), 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(), BadGlobalMuonTagger::filter(), HLTPathSelector::filter(), PFJetFilter::filter(), ElectronRegressionEnergyProducer::filter(), L1TGlobalPrescaler::filter(), mkfit::MkBuilder::filter_comb_cands(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::find(), edm::DetSetVector< T >::find(), edm::DetSetRefVector< T, C >::find(), l1tpf_calo::Phase1GridBase::find_cell(), mkfit::MkBuilder::find_tracks_in_layers(), mkfit::MkBuilder::find_tracks_load_seeds(), mkfit::MkBuilder::find_tracks_load_seeds_BH(), 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(), mkfit::MkBuilder::findTracksBestHit(), mkfit::MkBuilder::findTracksStandard(), CellularAutomaton::findTriplets(), 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(), edm::storage::File::flush(), DQMService::flushStandalone(), for(), for(), reco::FormulaEvaluator::FormulaEvaluator(), trklet::Projection::fpgafinephivm(), trklet::Projection::fpgafinerzvm(), trklet::Projection::fpgaphiproj(), trklet::Projection::fpgaphiprojder(), trklet::Residual::fpgaphiresid(), trklet::Projection::fpgarzbin1projvm(), trklet::Projection::fpgarzbin2projvm(), trklet::Projection::fpgarzproj(), trklet::Projection::fpgarzprojder(), trklet::Residual::fpgarzresid(), trklet::Residual::fpgastubid(), EcalSelectiveReadoutValidation::frame2Energy(), edm::FreshErrorsExist(), EcalLaserCondTools::from_hdf_to_db(), 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(), edm::storage::RemoteFile::get(), edm::test::ProcessBlock::get(), edm::test::Run::get(), edm::test::Event::get(), edm::test::LuminosityBlock::get(), fwlite::Record::get(), edm::serviceregistry::ServicesManager::get(), fwlite::EventSetup::get(), SiPixelClusterShapeCache::get(), dqm::implementation::IGetter::get(), hitfit::Pair_Table::get_pair(), trainingvars::get_var_pset(), getABABOutputStream(), pos::PixelTKFECConfig::getAddress(), CaloGeometryDBEP< T, U >::getAlignGlobal(), SiPixelLayoutParser::getAllLayouts(), pos::PixelPortCardConfig::getAOHGain(), 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(), ROOT::Math::Transform3DPJ::GetComponents(), matrixSaver::getConcreteMatrixVector(), JetMatchingTools::getConstituentHits(), npstat::LinInterpolatedTableND< Numeric, Axis >::getCoords(), CaloCellGeometry::getCorners(), pos::PixelFECConfig::getCrate(), pos::PixelTKFECConfig::getCrate(), pos::PixelFEDConfig::getCrate(), L1TMuon::GeometryTranslator::getCSCSpecificPoint(), 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::PixelFECConfig::getFECNumber(), 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(), edm::messagelogger::ELseverityLevel::getInputStr(), MELaserPrim::getInt(), EcalTrivialConditionRetriever::getIntercalibConstantsFromConfiguration(), EcalTrivialConditionRetriever::getIntercalibErrorsFromConfiguration(), dqm::impl::MonitorElement::getIntValue(), trklet::Tracklet::getISeed(), edm::Principal::getIt(), trklet::Tracklet::getITC(), edm::Ptr< T >::getItem_(), FWHGCalMultiClusterSliceSelector::getItemEntryEtaPhi(), FWPFCandidateTowerSliceSelector::getItemEntryEtaPhi(), FWCaloTowerSliceSelector::getItemEntryEtaPhi(), OMTFinput::getLayerData(), reco::tau::RecoTauVertexAssociator::getLeadCand(), MEChannel::getListOfChannels(), edm::Principal::getManyByType(), BTagPerformance::GetMap(), matrixSaver::getMatrix(), matrixSaver::getMatrixVector(), L1TMuon::GeometryTranslator::getME0SpecificPoint(), jsoncollector::FastMonitor::getMergedIntJForLumi(), npstat::BoxND< Numeric >::getMidpoint(), PSFitter::HybridMinimizer::GetMinosError(), HLTPerformanceInfo::getModuleOnPath(), edm::messagelogger::ELseverityLevel::getName(), edm::ELseverityLevel::getName(), SiStripGainFromAsciiFile::getNewObject(), FedRawDataInputSource::getNextEvent(), evf::EvFDaqDirector::getNextFromFileBroker(), edm::RootPrimaryFileSequence::getNextItemType(), trigger::TriggerRefsCollections::getObjects(), CandMCMatchTableProducer::getParentHadronFlag(), XMLConfigReader::getPatternsVersion(), SiPixelGainForHLTonGPU::getPedAndGain(), 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(), pixelgpudetails::SiPixelRawToClusterGPUKernel::getResults(), pos::PixelNameTranslation::getROCsFromFEDChannel(), L1TMuon::GeometryTranslator::getRPCSpecificPoint(), EcalLaserAnalyzer2::getShapes(), FWTrackResidualDetailView::getSignedResidual(), PrimaryVertexAnalyzer4PUSlimmed::getSimPVs(), Primary4DVertexValidation::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::messagelogger::ELseverityLevel::getSymbol(), ViewerParameterGUI::getTabContainer(), dqm::impl::MonitorElement::getTH1D(), dqm::impl::MonitorElement::getTH1F(), dqm::impl::MonitorElement::getTH1I(), dqm::impl::MonitorElement::getTH1S(), dqm::impl::MonitorElement::getTH2D(), dqm::impl::MonitorElement::getTH2F(), dqm::impl::MonitorElement::getTH2I(), 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::messagelogger::ELseverityLevel::getVarName(), pos::PixelFECConfig::getVMEBaseAddress(), pos::PixelFEDConfig::getVMEBaseAddress(), trklet::TrackletLUT::getVMRLookup(), 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(), edm::Handle< FWGenericObject >::Handle(), XrdAdaptor::RequestManager::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::ilog2(), l1tpf_calo::Phase1GridBase::imove(), PFHFRecHitCreator::importRecHits(), EcalSRCondTools::importSrpConfigFile(), npstat::ArrayND< Numeric, StackLen, StackDim >::importSubrange(), GeneralTracksImporter::importToBlock(), pflow::importers::TrackFromParentImporter< Collection, Adaptor >::importToBlock(), CSCAnodeData2007::index(), CSCAnodeData2006::index(), fireworks::expression::indexFromNewFormatToOldFormat(), edm::IndexIntoFile::IndexIntoFileItrEntryOrder::IndexIntoFileItrEntryOrder(), SiTrivialInduceChargeOnStrips::induceVector(), spu::inf(), trklet::Projection::init(), triggerExpression::PathReader::init(), TPNPulse::init(), trklet::Residual::init(), trklet::MatchEngineUnit::init(), TMom::init(), trklet::TrackletEventProcessor::init(), TAPDPulse::init(), SiPixelConfigWriter::init(), SiStripConfigWriter::init(), TShapeAnalysis::init(), trklet::TrackletEngineUnit::init(), MELaserPrim::init(), edm::EventProcessor::init(), DataProxyWrapper< ExDwarfListRcd, cond::persistency::KeyList >::initConcurrentIOVs(), LogicTool< GenLogic >::initialise(), reco::tau::xclean::CrossCleanPiZeros< PtrIter >::initialize(), JetResolution::initialize(), DDCutTubsFromPoints::initialize(), RawEventFileWriterForBU::initialize(), ElectronEnergyRegressionEvaluate::initialize(), EGammaMvaEleEstimatorCSA14::initialize(), EGammaMvaEleEstimator::initialize(), TStorageFactoryFile::Initialize(), reco::tau::xclean::CrossCleanPtrs< PtrIter >::initialize(), npstat::ArrayNDScanner::initialize(), reco::isodeposit::OtherJetConstituentsDeltaRVeto::initialize(), PixelUnpackingRegions::initialize(), XrdAdaptor::RequestManager::initialize(), PreMixingSiStripWorker::initializeEvent(), cms::SiPixelDigitizer::initializeEvent(), cms::Phase2TrackerDigitizer::initializeEvent(), SiStripDigitizer::initializeEvent(), edm::RootFile::initializeFirstProcessBlockEntry(), edm::ProcessBlockHelper::initializeFromPrimaryInput(), edm::IndexIntoFile::IndexIntoFileItrImpl::initializeLumi(), edm::IndexIntoFile::IndexIntoFileItrNoSort::initializeLumi_(), edm::IndexIntoFile::IndexIntoFileItrSorted::initializeLumi_(), edm::IndexIntoFile::IndexIntoFileItrEntryOrder::initializeLumi_(), EcalPreshowerGeometry::initializeParms(), dqm::implementation::DQMStore::initLumi(), InitMsgBuilder::InitMsgBuilder(), edm::RootInputFileSequence::initTheFile(), trklet::TrackletLUT::initVMRTable(), l1tVertexFinder::InputData::InputData(), edm::PrincipalCache::insert(), edm::eventsetup::DataProxyProvider::KeyedProxies::insert(), edm::RootOutputFile::insertAncestors(), edm::RootTree::insertEntryForIndex(), mkfit::EventOfCombCandidates::insertSeed(), optutl::VariableMapCont::integerValue(), optutl::VariableMapCont::integerVector(), SiPixelTemplate2D::interpolate(), SiPixelTemplate::interpolate(), npstat::ArrayND< Numeric, StackLen, StackDim >::interpolate3(), npstat::interpolateHistoND(), npstat::ArrayND< Numeric, StackLen, StackDim >::interpolateLoop(), RectangularEtaPhiTrackingRegion::intToUseMeasurementTracker(), edm::ParameterSet::invalidateRegistration(), trklet::TrackDerTable::invert(), npstat::LinInterpolatedTableND< Numeric, Axis >::invert1DResponse(), edm::FunctionWithDict::invoke(), InvRingCalib::InvRingCalib(), trklet::TrackletConfigBuilder::iRegStr(), edm::serviceregistry::ServicesManager::isAvailable(), pos::PixelCalibConfiguration::iScan(), TrackCleaner::isCompatible(), npstat::ArrayRange::isCompatible(), npstat::ArrayND< Numeric, StackLen, StackDim >::isCompatible(), MuRingForwardDoubleLayer::isCrack(), MTDRingForwardDoubleLayer::isCrack(), GenParticlesHelper::isDirect(), edm::RootFile::isDuplicateEvent(), trklet::TrackletConfigBuilder::iSeedStr(), 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< T >::isProductEqual_(), FFTJetPFPileupCleaner::isRemovable(), npstat::ArrayND< Numeric, StackLen, StackDim >::isShapeCompatible(), PFElecTkProducer::isSharingEcalEnergyWithEgSC(), trklet::L1TStub::isTilted(), PFMuonAlgo::isTrackerTightMuon(), npstat::LinInterpolatedTableND< Numeric, Axis >::isWithinLimits(), trklet::TrackletConfigBuilder::iTCStr(), FWSelectionManager::itemChanged(), edm::stream::ProducingModuleAdaptorBase< T >::itemsMayGet(), edm::stream::EDAnalyzerAdaptorBase::itemsMayGet(), edm::stream::ProducingModuleAdaptorBase< T >::itemsToGet(), edm::stream::EDAnalyzerAdaptorBase::itemsToGet(), edm::stream::ProducingModuleAdaptorBase< T >::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< Numeric, StackLen, StackDim >::jointMemSliceScan(), KDTreeLinkerTrackHcal::KDTreeLinkerTrackHcal(), edm::core::OutputModuleCore::keepThisBranch(), edm::eventsetup::DataProxyProvider::DataProxyContainer::keyedProxies(), L1Comparator::L1Comparator(), L1DummyProducer::L1DummyProducer(), L1EmulBias::L1EmulBias(), L1HPSPFTauBuilder::L1HPSPFTauBuilder(), L1ScalersClient::L1ScalersClient(), L1TMuonBarrelParamsAllPublic::L1TMuonBarrelParamsAllPublic(), pos::PixelModuleName::ladder(), pos::PixelROCName::ladder(), pos::PixelDACScanRange::last(), HelixFitOnGPU::launchBrokenLineKernelsOnCPU(), CAHitNtupletGeneratorKernels< TTraits >::launchKernels(), HelixFitOnGPU::launchRiemannKernelsOnCPU(), pos::PixelModuleName::layer(), pos::PixelROCName::layer(), trklet::Projection::layerdisk(), TrackerMap::layerno(), trklet::Tracklet::layerstubstr(), dqm::implementation::DQMStore::leaveLumi(), hitfit::Lepjets_Event::lep(), edm::lessThan(), pos::PixelFEDTestDAC::levelEncoder(), npstat::Private::lind_invert1DSlice(), npstat::ArrayND< Numeric, StackLen, StackDim >::linearFill(), npstat::ArrayND< Numeric, StackLen, StackDim >::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(), PixelCPEFast::localPosition(), PixelCPEClusterRepair::localPosition(), PixelCPETemplateReco::localPosition(), GEMStripTopology::localStripLength(), edm::service::ELoutput::log(), edm::LoggedErrorsOnlySummary(), edm::LoggedErrorsSummary(), MELaserPrim::logicId(), trklet::TrackletLUT::lookup(), fftjetcms::LookupTable2d::LookupTable2d(), npstat::ArrayRange::lowerLimits(), edm::InputSource::luminosityBlock(), main(), DeepFlavourONNXJetTagsProducer::make_inputs(), DeepCombinedONNXJetTagsProducer::make_inputs(), DeepVertexONNXJetTagsProducer::make_inputs(), DeepDoubleXONNXJetTagsProducer::make_inputs(), ZdcHardcodeGeometryLoader::makeCell(), 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::PatternRecognitionbyCLUE3D< TILES >::makeTracksters(), ticl::PatternRecognitionbyCA< TILES >::makeTracksters(), CAHitNtupletGeneratorOnGPU::makeTuples(), CAHitNtupletGeneratorOnGPU::makeTuplesAsync(), cms::DDDetector::manager(), FFTEtaLogPtConeRadiusMapper< MyJet, Adjustable >::map(), L2RecoScaleCalculator::mapFFTJet(), L2ResScaleCalculator::mapFFTJet(), FFTGenericScaleCalculator::mapFFTJet(), L2AbsScaleCalculator::mapFFTJet(), edm::DaqProvenanceHelper::mapProcessHistoryID(), npstat::ArrayND< Numeric, StackLen, StackDim >::marginalize(), npstat::ArrayND< Numeric, StackLen, StackDim >::marginalizeInnerLoop(), mayown_ptr< T, N >::markOwn(), hitfit::Fourvec_Constrainer::mass_constraint(), trklet::Tracklet::match(), TrackerCleaner< T >::match_rechit_type(), trklet::MatchCalculator::MatchCalculator(), trklet::MatchProcessor::matchCalculator(), 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::MergeableInputProductResolver::mergeProduct(), MonitorElementCollection::mergeProduct(), edm::Wrapper< T >::mergeProduct_(), edm::RepeatingCachedRootSource::RCDelayedReader::mergeReaders_(), edm::service::MessageLoggerDefaults::MessageLoggerDefaults(), PSFitter::HybridMinimizer::Minimize(), MkFitGeometry::MkFitGeometry(), FWInteractionList::modelChanges(), FWProxyBuilderBase::modelChanges(), FWItemRandomAccessorBase::modelType(), pos::PixelModuleName::module(), pos::PixelROCName::module(), pos::PixelCalibConfiguration::moduleList(), edm::EarlyDeleteHelper::moduleRan(), edm::stream::ProducingModuleAdaptorBase< T >::modulesWhoseProductsAreConsumed(), edm::stream::EDAnalyzerAdaptorBase::modulesWhoseProductsAreConsumed(), PFECALHashNavigator::move(), FWEventItem::moveToBack(), FWEventItem::moveToFront(), FWEventItem::moveToLayer(), InputFile::moveToPreviousChunk(), MTDCPEBase::MTDCPEBase(), MTDGeometry::MTDGeometry(), npstat::ArrayND< Numeric, StackLen, StackDim >::multiMirror(), Matriplex::multiply(), Matriplex::multiply3in(), Matriplex::multiplyGeneral(), MuonPathAnalyticAnalyzer::MuonPathAnalyticAnalyzer(), MuonResiduals1DOFFitter_FCN(), MuonResiduals5DOFFitter_FCN(), MuonResiduals6DOFFitter_FCN(), MuonResiduals6DOFrphiFitter_FCN(), MuonResidualsAngleFitter_FCN(), MuonResidualsBfieldAngleFitter_FCN(), MuonResidualsFromTrack::MuonResidualsFromTrack(), MuonResidualsPositionFitter_FCN(), MVAJetPuIdProducer::MVAJetPuIdProducer(), edm::storage::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(), edm::RootPrimaryFileSequence::nextFile(), FWLayoutBuilder::nextHints(), edm::InputSource::nextItemType(), NavigationSchool::nextLayers(), edm::RootInputFileSequence::nextProcessBlock_(), edm::RootFile::nextProcessBlock_(), cms::DDFilteredView::nextSibling(), cms::DDFilteredView::nodeCopyNoAt(), cms::DDFilteredView::nodeNameAt(), CSCConditions::noiseMatrix(), CSCConditions::noiseMatrixElements(), MuonResidualsAngleFitter::npar(), MuonResidualsPositionFitter::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(), trklet::TrackletConfigBuilder::numStr(), hitfit::Fourvec_Event::obj(), reco::parser::ExpressionVar::objToDouble(), MEChannel::oneLine(), MEChannel::oneWord(), DQMNet::onMessage(), DQMNet::onPeerConnect(), DQMNet::onPeerData(), edm::storage::File::open(), edm::storage::XrdFile::open(), dqm::implementation::DQMStore::open(), FWDetailViewManager::openDetailViewFor(), mkfit::DataFile::openRead(), LowPassFilterTiming::operator()(), CordicXilinx::operator()(), reco::parser::CutSetter::operator()(), reco::parser::MethodArgumentSetter::operator()(), reco::tau::RecoTauElectronRejectionPlugin::operator()(), FsmwModeFinder3d::operator()(), PositionAtECalEntranceComputer::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), TrackCollectionCloner::Producer::operator()(), L1MuGMTMatrix< T >::operator()(), LayerHitMapCache::operator()(), npstat::LinInterpolatedTableND< Numeric, Axis >::operator()(), edmNew::DetSetVector< T >::FindForDetSetVector::operator()(), CSCDDUDataItr::operator*(), fwlite::EventContainer::operator++(), pat::eventhypothesis::Looper< T >::operator++(), EcalPhiSymRecHit::operator+=(), L1MuGMTMatrix< T >::operator+=(), EcalPhiSymInfo::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< T >::operator=(), edmNew::dstvdetails::DetSetVectorTrans::operator=(), l1tpf_calo::GridData< PreCluster >::operator=(), hitfit::Row_Vector::operator=(), BitArray< 9 >::operator=(), DTTFBitArray< N >::operator=(), DDValue::operator==(), npstat::ArrayND< Numeric, StackLen, StackDim >::operator==(), operator>>(), BitArray< 9 >::operator>>=(), DTTFBitArray< N >::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(), mkfit::MatriplexPackerSlurpIn< D >::pack(), mkfit::MatriplexErrParPackerSlurpIn< T, D >::pack(), ReadRepacker::packInternal(), pos::PixelROCName::panel(), pos::PixelModuleName::panel(), JetResolution::parameter(), cms::DDFilteredView::parameters(), edm::ParameterSetEntry::ParameterSetEntry(), edm::parameterTypeEnumToString(), KfComponentsHolder::params(), EcalHitResponse::params(), edm::SubProcess::parentProducedProductIsKept(), DDLParser::parse(), parse_int(), parseHBHEMethod2Description(), fwlite::EventContainer::parser(), parseSubdetector(), MiscalibReaderFromXML::parseXMLMiscalibFile(), 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(), trklet::Projection::phiproj(), trklet::Projection::phiprojapprox(), trklet::Projection::phiprojder(), trklet::Projection::phiprojderapprox(), trklet::Residual::phiresid(), trklet::Residual::phiresidapprox(), FlatHexagon::phiSpan(), FlatTrd::phiSpan(), HcalSimParameters::photoelectronsToAnalog(), PickEvents::PickEvents(), pos::PixelCalibConfiguration::PixelCalibConfiguration(), pos::PixelDACScanRange::PixelDACScanRange(), pos::PixelDACSettings::PixelDACSettings(), pos::PixelDelay25Calib::PixelDelay25Calib(), pos::PixelDetectorConfig::PixelDetectorConfig(), pos::PixelFEDTestDAC::PixelFEDTestDAC(), pos::PixelLowVoltageMap::PixelLowVoltageMap(), pos::PixelMaskAllPixels::PixelMaskAllPixels(), pos::PixelMaxVsf::PixelMaxVsf(), pos::PixelNameTranslation::PixelNameTranslation(), pos::PixelPortCardConfig::PixelPortCardConfig(), pos::PixelPortcardMap::PixelPortcardMap(), pixelQualityToken_(), 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(), edm::storage::XrdFile::position(), edm::storage::File::position(), pixelCPEforGPU::position(), 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(), ConfigBuilder.ConfigBuilder::prepare_L1(), FWTrackResidualDetailView::prepareData(), fireworks::prepareTrack(), edm::Worker::prePrefetchSelectionAsync(), HLTPrescaleProvider::prescaleSet(), edm::IndexIntoFile::IndexIntoFileItrNoSort::previousEventRange(), edm::IndexIntoFile::IndexIntoFileItrEntryOrder::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(), MLPFProducer::produce(), TICLLayerTileProducer::produce(), RegressionEnergyPatElectronProducer::produce(), MVAJetPuIdProducer::produce(), CandidateTriggerObjectProducer::produce(), pat::GenJetFlavourInfoPreserver::produce(), SiPixelDigiErrorsFromSoA::produce(), reco::modulesNew::Matcher< C1, C2, S, D >::produce(), SiPixelDigisClustersFromSoA::produce(), EcalDetailedTimeRecHitProducer::produce(), SiPixelClusterShapeCacheProducer::produce(), PixelTrackSoAFromCUDA::produce(), Phase2TrackerClusterizer::produce(), DeepFlavourONNXJetTagsProducer::produce(), PixelVertexProducerFromSoA::produce(), TopBottomClusterInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), DeepVertexONNXJetTagsProducer::produce(), SeedClusterRemoverPhase2::produce(), DeepCombinedONNXJetTagsProducer::produce(), TrackListMerger::produce(), DeepDoubleXONNXJetTagsProducer::produce(), SeedClusterRemover::produce(), HLTMuonTrackSelector::produce(), PFEGammaProducer::produce(), SiPixelRecHitFromCUDA::produce(), MuonDetCleaner< T1, T2 >::produce(), SiPixelRecHitSoAFromLegacy::produce(), PFProducer::produce(), BoostedJetONNXJetTagsProducer::produce(), TrackMVAClassifierBase::produce(), MinMETProducerT< T >::produce(), L1EmulBias::produce(), HITrackClusterRemover::produce(), SourceCardTextToRctDigi::produce(), GenericBoostedTauSeedsProducer< JetType, CandType >::produce(), HiFJRhoFlowModulationProducer::produce(), DeDxEstimatorProducer::produce(), PixelTrackProducerFromSoA::produce(), RunManagerMTWorker::produce(), TPStubValueMapProducer::produce(), reco::modules::TrackFullCloneSelectorBase< Selector >::produce(), HFPreReconstructor::produce(), reco::PhysObjectMatcher< C1, C2, S, D, Q >::produce(), CSCOverlapsTrackPreparation::produce(), PFSimParticleProducer::produce(), FastTrackDeDxProducer::produce(), cms::CosmicTrackFinder::produce(), pat::PATTriggerProducer::produce(), FFTJetPatRecoProducer::produce(), TotemDAQMappingESSourceXML::produce(), pat::PATMuonProducer::produce(), PileupJetIdProducer::produce(), FFTJetProducer::produce(), SiStripClusterizerFromRaw::produce(), L1FPGATrackProducer::produce(), CaloGeometryDBEP< T, U >::produceAligned(), CaloGeometryEP< T, D >::produceAligned(), cms::CkfTrackCandidateMakerBase::produceBase(), CTPPSPixelDAQMappingESSourceXML::produceCTPPSPixelAnalysisMask(), CTPPSPixelDAQMappingESSourceXML::produceCTPPSPixelDAQMapping(), edm::ProducedProductResolver::ProducedProductResolver(), HcalAlignmentEP::produceHcalAli(), PixelVertexProducerCUDA::produceOnCPU(), PixelVertexProducerCUDA::produceOnGPU(), edm::ProductProvenanceRetriever::ProductProvenanceRetriever(), trklet::Tracklet::proj(), npstat::ArrayND< Numeric, StackLen, StackDim >::project(), ProjectedSiStripRecHit2D::ProjectedSiStripRecHit2D(), KfComponentsHolder::projection(), npstat::ArrayND< Numeric, StackLen, StackDim >::projectLoop(), npstat::ArrayND< Numeric, StackLen, StackDim >::projectLoop2(), KfComponentsHolder::projFunc(), 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(), edm::Principal::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::PutOnReadInputProductResolver::PutOnReadInputProductResolver(), edm::RunPrincipal::putOrMerge(), dqm::implementation::NavigatorBase::pwd(), SiPixelGenError::qbin(), SiPixelTemplate::qbin(), SiPixelTemplate::qbin_dist(), SiPixelTemplate::qmin(), QualityTester::QualityTester(), npstat::ArrayRange::rangeLength(), edm::storage::File::read(), trklet::CircularBuffer< trklet::ProjectionTemp >::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(), edm::RootFile::readCurrentEvent(), 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_(), edm::PoolSource::readEvent_(), LmfSource::readEventWithinFile(), edm::InputSource::readFile(), edm::RootPrimaryFileSequence::readFile_(), DQMRootSource::readFile_(), l1tpf_impl::readFromFile(), edm::storage::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::RootInputFileSequence::readProcessBlock_(), edm::RootFile::readProcessBlock_(), 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(), edm::storage::DCacheFile::readv(), edm::storage::DavixFile::readv(), edm::storage::Storage::readv(), edm::storage::File::readv(), edm::storage::XrdFile::readv(), EndcapPiZeroDiscriminatorAlgo::readWeightFile(), FedRawDataInputSource::readWorker(), npstat::Private::rebinAxes(), BaseCkfTrajectoryBuilder::rebuildTrajectories(), KDTreeLinkerAlgo< DATA, DIM >::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(), DQMNet::releaseFromWait(), FFTJetProducer::removeFakePreclusters(), FWEventItemsManager::removeItem(), edm::maker::ModuleHolderT< T >::replaceModuleFor(), 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(), trklet::Tracklet::resid(), MuonResidualsTwoBin::residualsModel(), edm::storage::File::resize(), mkfit::EventOfCombCandidates::resizeAfterFiltering(), JetResolution::resolution(), edm::NoProcessProductResolver::resolveProduct_(), npstat::BoxND< Numeric >::restore(), npstat::ArrayND< Numeric, StackLen, StackDim >::restore(), edm::service::RandomNumberGeneratorService::restoreFromCache(), HEPTopTaggerV2::result(), edm::IDGeneratorSourceBase< BASE >::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< Numeric, StackLen, StackDim >::rotate(), hitfit::Row_Vector::Row_Vector(), pos::PixelCalibConfiguration::rowCounter(), PixelNtupletsFitter::run(), 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(), ecaldqm::GpuTask::runOnCpuDigis(), ecaldqm::GpuTask::runOnGpuDigis(), EcalSelectiveReadout::runSelectiveReadout0(), QCriterion::runTest(), trklet::Projection::rzproj(), trklet::Projection::rzprojapprox(), trklet::Projection::rzprojder(), trklet::Projection::rzprojderapprox(), trklet::Residual::rzresid(), trklet::Residual::rzresidapprox(), mkfit::ConfigJson::save_Iterations(), DQMFileSaver::saveForOffline(), DeepTauId::saveInputs(), matrixSaver::saveMatrix(), matrixSaver::saveMatrixVector(), MEEEGeom::sc(), hitfit::scalar(), npstat::HistoND< Numeric, Axis >::scaleBinContents(), npstat::ArrayND< Numeric, StackLen, StackDim >::scaleBySliceLoop(), npstat::HistoND< Numeric, Axis >::scaleOverflows(), FWCaloRecHitDigitSetProxyBuilder::scaleProduct(), pos::PixelCalibConfiguration::scanCounter(), pos::PixelCalibConfiguration::scanROC(), pos::PixelCalibConfiguration::scanValue(), pos::PixelROCName::sec(), pos::PixelModuleName::sec(), trklet::Settings::seedlayers(), HLTL1TSeed::seedsL1TriggerObjectMaps(), MuonHitsChamberResidual::segment_fit(), ME0TriggerPseudoBuilder::segmentConversion(), pf2pat::PtMinPFCandidateSelectorDefinition::select(), FWModelExpressionSelector::select(), FWTableView::selectCollection(), L2TauNNProducer::selectGoodTracksAndVertices(), mkfit::MkFinder::selectHitIndices(), MuonResidualsFitter::selectPeakResiduals(), MuonResidualsFitter::selectPeakResiduals_simple(), MuonAlignmentFromReference::selectResidualsPeaks(), FFTJetProducer::selectTreeNodes(), CSCAnodeData2007::selfTest(), CSCTMBTrailer::selfTest(), MTDSectorForwardDoubleLayer::selfTest(), CSCAnodeData2006::selfTest(), MTDRingForwardDoubleLayer::selfTest(), MuRingForwardDoubleLayer::selfTest(), CSCComparatorData::selfTest(), CSCStripElectronicsSim::selfTest(), CSCEventData::selfTest(), CSCTMBHeader::selfTest(), CSCALCTHeader::selfTest(), ViewerParameterGUI::separator(), jsoncollector::JSONSerializer::serialize(), edm::StreamSerializer::serializeEvent(), edm::SerialTaskQueue::SerialTaskQueue(), trklet::FPGAWord::set(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), GoldenPatternResult::set(), L1MuGMTMatrix< T >::set(), TAPD::set2DAPDoAPD0Cut(), TAPD::set2DAPDoAPD1Cut(), TAPD::set2DCut(), TAPD::set2DTimeCut(), HeterogeneousHGCalHEFCellPositionsFiller::set_conditions_(), 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(), 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(), PadeTableODE::setParameters(), ThirdOrderDelayODE::setParameters(), edm::ProcessConfiguration::setParameterSetID(), edm::RootTree::setPresence(), MahiFit::setPulseShapeTemplate(), FFTJetPFPileupCleaner::setRemovalBit(), FRDStreamSource::setRunAndEventInfo(), edm::EventPrincipal::setRunAndLumiNumber(), trklet::Sector::setSector(), MuonTrackDT13ChamberResidual::setSegmentResidual(), MuonTrackDT2ChamberResidual::setSegmentResidual(), InterpolatedPulse< 1500U >::setShape(), FWColumnLabelCellRenderer::setSortOrder(), edm::OutputProcessBlockHelper::setStoredFileInProcessOffset(), edm::OutputProcessBlockHelper::setStoredProcessOffset(), CaloGeometry::setSubdetGeometry(), pos::PixelTBMSettings::setTBMGenericValue(), edm::service::MessageLogger::setThreadContext(), edm::IndexIntoFile::IndexIntoFileItrNoSort::setToLastEventInRange(), edm::IndexIntoFile::IndexIntoFileItrSorted::setToLastEventInRange(), edm::IndexIntoFile::IndexIntoFileItrEntryOrder::setToLastEventInRange(), trklet::Tracklet::setTrackIndex(), trklet::Tracklet::setTrackletIndex(), pos::PixelROCTrimBits::setTrim(), KfComponentsHolder::setup(), FWPathsPopup::setup(), fireworks::setupAddElement(), FWProxyBuilderBase::setupElement(), HiFJGridEmptyAreaCalculator::setupGrid(), HiFJGridEmptyAreaCalculator::setupGridJet(), mkfit::LayerOfHits::setupLayer(), MELaserPrim::setVal(), EmDQM::SetVarsFromPSet(), FWTabularWidget::setWidthOfTextInColumns(), EcalPreshowerGeometry::setzPlanes(), EcalHitResponse::shape(), cms::DDFilteredView::shape(), npstat::Private::shapeOfASlice(), FTLTrackingRecHit< ObjRef >::sharesInput(), npstat::BoxND< Numeric >::shift(), FWGUIEventFilter::show(), HGCalShowerShapeHelper::ShowerShapeCalc::ShowerShapeCalc(), FWModelContextMenuHandler::showSelectedModelContext(), HcalSimParameters::signalShape(), L1DummyProducer::SimpleDigi(), TkStripMeasurementDet::simpleRecHits(), CSCGasCollisions::simulate(), SiPixelDigiErrorsCUDA::SiPixelDigiErrorsCUDA(), SiPixelDigisCUDA::SiPixelDigisCUDA(), SiPixelDigiSource::SiPixelDigiSource(), SiPixelGainCalibrationForHLTGPU::SiPixelGainCalibrationForHLTGPU(), HcalSimParameters::sipmCrossTalk(), HcalSimParameters::sipmDarkCurrentuA(), HcalSimParameters::sipmNonlinearity(), SiStripClusterizerFromRaw::SiStripClusterizerFromRaw(), edm::storage::File::size(), RecoIdealGeometry::size(), pat::eventhypothesis::Looper< T >::skip(), edm::RootEmbeddedFileSequence::skipEntries(), edm::RootPrimaryFileSequence::skipEvents(), edm::RootPrimaryFileSequence::skipEventsAtBeginning(), ctfseeding::HitExtractorSTRP::skipThis(), edm::RootInputFileSequence::skipToItem(), edm::RootInputFileSequence::skipToItemInNewFile(), funct::Slave< F >::Slave(), SeedingLayerSetsHits::SeedingLayerSet::slice(), npstat::ArrayND< Numeric, StackLen, StackDim >::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< GoldenPatternType >::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(), trklet::TrackletEngineUnit::step(), trklet::MatchEngineUnit::step(), edm::service::ConcurrentModuleTimer::stop(), evf::EvFBuildingThrottle::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::Residual::stubptr(), npstat::ArrayND< Numeric, StackLen, StackDim >::subtractFromProjection(), BuildTrackerMapPlugin::subtractMap(), mkfit::LayerOfHits::suckInDeads(), mkfit::LayerOfHits::suckInHits(), suffix_matches(), magneticfield::BaseVolumeHandle::surface(), edmNew::dstvdetails::DetSetVectorTrans::swap(), edm::Wrapper< T >::swapProduct_(), dqm::impl::MonitorElement::switchData(), fwlite::Record::syncTo(), edm::storage::File::syswritev(), edm::EventProcessor::taskCleanup(), SiPixelTemplate::temperrors(), edm::TypeWithDict::templateArgumentAt(), edm::TypeWithDict::templateName(), TPedValues::terminate(), test_standard(), edm::test::TestProcessor::testBeginLuminosityBlockImpl(), edm::test::TestProcessor::testBeginRunImpl(), TTTrack_TrackWord::testDigitizationScheme(), DTSegtoRPC::thePoints(), CSCSegtoRPC::thePoints(), HiFJGridEmptyAreaCalculator::tileIndexEta(), HiFJGridEmptyAreaCalculator::tileIndexEtaJet(), HiFJGridEmptyAreaCalculator::tileIndexPhi(), EcalHitResponse::timeOfFlight(), EcalTimeMapDigitizer::timeOfFlight(), CSCCFEBTimeSlice::timeSample(), CSCCFEBData::timeSlice(), TkOfflineVariables::TkOfflineVariables(), TkRadialStripTopology::TkRadialStripTopology(), edm::tns(), 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(), TrackingRecHit2DHeterogeneous< Traits >::TrackingRecHit2DHeterogeneous(), 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(), TTTrack_TrackWord::undigitizeSignedValue(), edm::service::MessageLogger::unEstablishModule(), FWLayoutBuilder::unindent(), RctRawToDigi::unpackCTP7(), FWSelectionManager::unselect(), FWDialogBuilder::untabs(), PrintMaterialBudgetInfo::update(), KinematicConstrainedVertexUpdatorT< nTrk, nConstraint >::update(), fwlite::RecordWriter::update(), HcaluLUTTPGCoder::update(), StMeasurementDetSet::update(), DAClusterizerInZT_vect::update(), edmNew::DetSetVector< T >::update(), edm::OutputProcessBlockHelper::updateAfterProductSelection(), edm::SubProcessBlockHelper::updateFromParentProcess(), edm::ParameterSetEntry::updateID(), DDI::Specific::updateLogicalPart(), edm::EDConsumerBase::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(), CSCPairResidualsConstraint::value(), pos::PixelDACScanRange::value(), MuonResidualsFitter::value(), npstat::ArrayND< Numeric, StackLen, StackDim >::value(), npstat::ArrayND< Numeric, StackLen, StackDim >::valueAt(), trklet::VarAdjustK::VarAdjustK(), trklet::VarAdjustKR::VarAdjustKR(), SiPixelTemplate::vavilov2_pars(), SiPixelTemplate::vavilov_pars(), DAClusterizerInZ_vect::verify(), DAClusterizerInZT_vect::verify(), npstat::ArrayND< Numeric, StackLen, StackDim >::verifyBufferSliceCompatibility(), npstat::ArrayND< Numeric, StackLen, StackDim >::verifyProjectionCompatibility(), npstat::ArrayND< Numeric, StackLen, StackDim >::verifySliceCompatibility(), FWLayoutBuilder::verticalFrame(), pos::PixelFECConfig::VMEBaseAddressFromFECNumber(), pos::PixelFEDConfig::VMEBaseAddressFromFEDNumber(), trklet::VMRouter::VMRouter(), trklet::VMRouterCM::VMRouterCM(), 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::Path::workerFinished(), edm::WorkerT< T >::WorkerT(), cms::DDDetector::world(), cms::DDDetector::worldVolume(), FRDOutputModule::write(), edm::storage::XrdFile::write(), RawEventOutputModuleForBU< Consumer >::write(), edm::storage::File::write(), mkfit::Event::write_out(), WriteESAlignments::writeAlignments(), GctFormatTranslateMCLegacy::writeAllRctCaloRegionBlock(), pos::PixelPortCardConfig::writeASCII(), pos::PixelGlobalDelay25::writeASCII(), pos::PixelTrimCommon::writeASCII(), pos::PixelTKFECConfig::writeASCII(), pos::PixelFEDConfig::writeASCII(), pos::PixelPortcardMap::writeASCII(), trklet::TrackletConfigBuilder::writeASMemories(), pos::PixelTrimCommon::writeBinary(), edm::RootOutputFile::writeBranchIDListRegistry(), MuonAlignmentOutputXML::writeComponents(), gs::writeCompressedStringArchive(), edm::RootOutputFile::writeEventAuxiliary(), edm::RootOutputFile::writeFileFormatVersion(), edm::RootOutputFile::writeFileIdentifier(), edm::RootOutputFile::writeIndexIntoFile(), DQMRootOutputModule::writeLuminosityBlock(), edm::RootOutputFile::writeOne(), edm::RootOutputFile::writeProcessBlockHelper(), edm::RootOutputFile::writeProductDependencies(), edm::RootOutputFile::writeProductDescriptionRegistry(), GctFormatTranslateMCLegacy::writeRctEmCandBlocks(), DQMRootOutputModule::writeRun(), edm::SubProcess::writeRunAsync(), trklet::TrackletConfigBuilder::writeSPDMemories(), edm::RootOutputFile::writeStoredMergeableRunProductMetadata(), gs::writeStringArchive(), trklet::DTCLinkMemory::writeStubs(), edm::RootOutputFile::writeThinnedAssociationsHelper(), l1tpf_impl::writeToFile(), edm::storage::Storage::writev(), pos::PixelPortCardConfig::writeXML(), pos::PixelDetectorConfig::writeXML(), pos::PixelNameTranslation::writeXML(), pos::PixelDetectorConfig::writeXMLHeader(), PSFitter::HybridMinimizer::X(), SiPixelTemplate::xavg(), SiPixelTemplate::xavgc2m(), SiPixelTemplate::xflcorr(), SiPixelTemplate::xgsig(), SiPixelTemplate::xgx0(), edm::storage::Storage::xread(), edm::storage::Storage::xreadv(), SiPixelTemplate::xrms(), SiPixelTemplate::xrmsc2m(), SiPixelTemplate::xsigma2(), xtalFromiEtaiPhi(), SiPixelTemplate::xtemp(), SiPixelTemplate::xtemp3d_int(), edm::storage::Storage::xwritev(), SiPixelTemplate2D::xysigma2(), SiPixelTemplate::yavg(), SiPixelTemplate::yavgc2m(), SiPixelTemplate::yflcorr(), SiPixelTemplate::ygsig(), SiPixelTemplate::ygx0(), SiPixelTemplate::yrms(), SiPixelTemplate::yrmsc2m(), SiPixelTemplate::ysigma2(), SiPixelTemplate::ytemp(), SiPixelTemplate::ytemp3d_int(), zMCLeptonDaughters(), DAClusterizerInZT_vect::zorder(), edm::eventsetup::EventSetupRecordIOVQueue::~EventSetupRecordIOVQueue(), edmNew::DetSetVector< T >::FastFiller::~FastFiller(), TrackCollectionCloner::Producer::~Producer(), edm::ReusableObjectHolder< edm::ESProductHost >::~ReusableObjectHolder(), and edmNew::DetSetVector< T >::TSFastFiller::~TSFastFiller().

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

Definition at line 8 of file chooseDevice.cc.

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

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  }
int numberOfDevices() const
Definition: CUDAService.h:24
bool enabled() const
Definition: CUDAService.h:22
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.

References cudaCheck, and relativeConstraints::value.

Referenced by SiPixelDigiErrorsCUDA::copyErrorToHostAsync(), SiPixelDigiErrorsCUDA::dataErrorToHostAsync(), EcalIntercalibConstantsGPU::getProduct(), EcalLaserAPDPNRatiosRefGPU::getProduct(), HcalChannelQualityGPU::getProduct(), HcalGainsGPU::getProduct(), HcalLUTCorrsGPU::getProduct(), EcalLaserAlphasGPU::getProduct(), HcalQIETypesGPU::getProduct(), HcalRespCorrsGPU::getProduct(), EcalTimeCalibConstantsGPU::getProduct(), HcalTimeCorrsGPU::getProduct(), EcalRechitADCToGeVConstantGPU::getProduct(), EcalRechitChannelStatusGPU::getProduct(), HcalPedestalsGPU::getProduct(), HcalConvertedPedestalsGPU::getProduct(), EcalGainRatiosGPU::getProduct(), HcalRecoParamsGPU::getProduct(), HcalGainWidthsGPU::getProduct(), HcalQIECodersGPU::getProduct(), EcalMultifitParametersGPU::getProduct(), HcalSiPMParametersGPU::getProduct(), ecal::raw::ElectronicsMappingGPU::getProduct(), EcalSamplesCorrelationGPU::getProduct(), EcalTimeBiasCorrectionsGPU::getProduct(), EcalPedestalsGPU::getProduct(), HcalConvertedPedestalWidthsGPU::getProduct(), EcalLaserAPDPNRatiosGPU::getProduct(), EcalLinearCorrectionsGPU::getProduct(), HcalSiPMCharacteristicsGPU::getProduct(), EcalRecHitParametersGPU::getProduct(), HcalPedestalWidthsGPU::getProduct(), TrackingRecHit2DHeterogeneous< Traits >::localCoordToHostAsync(), BeamSpotToCUDA::produce(), SiPixelClustersCUDA::SiPixelClustersCUDA(), SiPixelDigiErrorsCUDA::SiPixelDigiErrorsCUDA(), TrackingRecHit2DHeterogeneous< Traits >::store16ToHostAsync(), TrackingRecHit2DHeterogeneous< Traits >::store32ToHostAsync(), and TrackingRecHit2DHeterogeneous< Traits >::TrackingRecHit2DHeterogeneous().

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr void M2 & dst
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck, and relativeConstraints::value.

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr void M2 & dst
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck.

50  {
51  cudaCheck(cudaMemcpyAsync(dst.get(), src.get(), nelements * sizeof(T), cudaMemcpyHostToDevice, stream));
52  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr void M2 & dst
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck.

66  {
67  cudaCheck(cudaMemcpyAsync(dst.get(), src.get(), nelements * sizeof(T), cudaMemcpyDeviceToHost, stream));
68  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr void M2 & dst
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck.

74  {
75  cudaCheck(cudaMemcpyAsync(dst.get(), src.data(), src.size() * sizeof(T), cudaMemcpyHostToDevice, stream));
76  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr void M2 & dst
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck, and edm::get_underlying().

82  {
83  cudaCheck(cudaMemcpyAsync(
84  get_underlying(dst).get(), src.data(), src.size() * sizeof(T), cudaMemcpyHostToDevice, stream));
85  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
constexpr T & get_underlying(propagate_const< T > &)
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
bool cms::cuda::cudaCheck_ ( const char *  file,
int  line,
const char *  cmd,
CUresult  result,
std::string_view  description = std::string_view() 
)
inline

Definition at line 37 of file cudaCheck.h.

References abortOnCudaError(), getPayloadData::description, relativeConstraints::error, and LIKELY.

41  {
42  if (LIKELY(result == CUDA_SUCCESS))
43  return true;
44 
45  const char* error;
46  const char* message;
47  cuGetErrorName(result, &error);
48  cuGetErrorString(result, &message);
49  abortOnCudaError(file, line, cmd, error, message, description);
50  return false;
51  }
#define LIKELY(x)
Definition: Likely.h:20
tuple result
Definition: mps_fire.py:311
void abortOnCudaError(const char *file, int line, const char *cmd, const char *error, const char *message, std::string_view description=std::string_view())
Definition: cudaCheck.h:21
list cmd
Definition: mps_setup.py:244
bool cms::cuda::cudaCheck_ ( const char *  file,
int  line,
const char *  cmd,
cudaError_t  result,
std::string_view  description = std::string_view() 
)
inline

Definition at line 53 of file cudaCheck.h.

References abortOnCudaError(), getPayloadData::description, and LIKELY.

57  {
58  if (LIKELY(result == cudaSuccess))
59  return true;
60 
61  const char* error = cudaGetErrorName(result);
62  const char* message = cudaGetErrorString(result);
63  abortOnCudaError(file, line, cmd, error, message, description);
64  return false;
65  }
#define LIKELY(x)
Definition: Likely.h:20
tuple result
Definition: mps_fire.py:311
void abortOnCudaError(const char *file, int line, const char *cmd, const char *error, const char *message, std::string_view description=std::string_view())
Definition: cudaCheck.h:21
list cmd
Definition: mps_setup.py:244
int cms::cuda::currentDevice ( )
inline
allocator::GpuCachedBytes cms::cuda::deviceAllocatorStatus ( )
int cms::cuda::deviceCount ( )
inline

Definition at line 10 of file deviceCount.h.

References cudaCheck.

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

10  {
11  int ndevices;
12  cudaCheck(cudaGetDeviceCount(&ndevices));
13  return ndevices;
14  }
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
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.

References cudaCheck, and runTheMatrix::ret.

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

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  }
tuple ret
prodAgent to be discontinued
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
cms::cuda::for ( int  i = first)

Definition at line 15 of file HistoContainer.h.

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

15  {
16  auto off = cuda_std::upper_bound(offsets, offsets + nh + 1, i);
17  assert((*off) > 0);
18  int32_t ih = off - offsets - 1;
19  assert(ih >= 0);
20  assert(ih < int(nh));
21  (*h).count(v[i], ih);
22  }
__host__ __device__ constexpr RandomIt upper_bound(RandomIt first, RandomIt last, const T &value, Compare comp={})
assert(be >=bs)
uint32_t nh
cms::cuda::for ( )

Definition at line 78 of file HistoContainer.h.

References func.

78  {
79  func(*pj);
80  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t Func __host__ __device__ V int Func func
void cms::cuda::free_device ( int  device,
void *  ptr 
)

Definition at line 31 of file allocate_device.cc.

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

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

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  }
constexpr bool useCaching
notcub::CachingDeviceAllocator & getCachingDeviceAllocator()
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
void cms::cuda::free_host ( void *  ptr)

Definition at line 29 of file allocate_host.cc.

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

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

29  {
30  if constexpr (allocator::useCaching) {
32  } else {
33  cudaCheck(cudaFreeHost(ptr));
34  }
35  }
notcub::CachingHostAllocator & getCachingHostAllocator()
constexpr bool useCaching
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
EventCache & cms::cuda::getEventCache ( )

Definition at line 64 of file EventCache.cc.

References utilities::cache(), and CMS_THREAD_SAFE.

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

64  {
65  // the public interface is thread safe
66  CMS_THREAD_SAFE static EventCache cache;
67  return cache;
68  }
#define CMS_THREAD_SAFE
def cache
Definition: utilities.py:3
StreamCache & cms::cuda::getStreamCache ( )

Definition at line 39 of file StreamCache.cc.

References utilities::cache(), and CMS_THREAD_SAFE.

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

39  {
40  // the public interface is thread safe
41  CMS_THREAD_SAFE static StreamCache cache;
42  return cache;
43  }
#define CMS_THREAD_SAFE
def cache
Definition: utilities.py:3
void cms::cuda::launch ( void(*)()  kernel,
LaunchParameters  config 
)
inline

Definition at line 96 of file launch.h.

References cms::cuda::LaunchParameters::blockDim, cudaCheck, cms::cuda::LaunchParameters::gridDim, cms::cuda::LaunchParameters::sharedMem, and cms::cuda::LaunchParameters::stream.

96  {
97  cudaCheck(cudaLaunchKernel(
98  (const void*)kernel, config.gridDim, config.blockDim, nullptr, config.sharedMem, config.stream));
99  }
tuple config
parse the configuration file
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
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.

References writedatasetfile::args, cms::cuda::LaunchParameters::blockDim, cudaCheck, cms::cuda::LaunchParameters::gridDim, cms::cuda::LaunchParameters::sharedMem, size, and cms::cuda::LaunchParameters::stream.

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  }
tuple config
parse the configuration file
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
tuple size
Write out results.
void cms::cuda::launch_cooperative ( void(*)()  kernel,
LaunchParameters  config 
)
inline

Definition at line 121 of file launch.h.

References cms::cuda::LaunchParameters::blockDim, cudaCheck, cms::cuda::LaunchParameters::gridDim, cms::cuda::LaunchParameters::sharedMem, and cms::cuda::LaunchParameters::stream.

121  {
122  cudaCheck(cudaLaunchCooperativeKernel(
123  (const void*)kernel, config.gridDim, config.blockDim, nullptr, config.sharedMem, config.stream));
124  }
tuple config
parse the configuration file
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
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.

References writedatasetfile::args, cms::cuda::LaunchParameters::blockDim, cudaCheck, cms::cuda::LaunchParameters::gridDim, cms::cuda::LaunchParameters::sharedMem, size, and cms::cuda::LaunchParameters::stream.

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  }
tuple config
parse the configuration file
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
tuple size
Write out results.
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.

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

Referenced by HBHERecHitProducerGPU::acquire(), EcalRawToDigiGPU::acquire(), and HcalRawToDigiGPU::acquire().

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_device(int dev, size_t nbytes, cudaStream_t stream)
long double T
int currentDevice()
Definition: currentDevice.h:10
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.

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

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_device(int dev, size_t nbytes, cudaStream_t stream)
int currentDevice()
Definition: currentDevice.h:10
template<typename T , typename... Args>
device::impl::make_device_unique_selector<T>::bounded_array cms::cuda::make_device_unique ( Args &&  ...)
delete
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.

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

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_device(int dev, size_t nbytes, cudaStream_t stream)
long double T
int currentDevice()
Definition: currentDevice.h:10
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.

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

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_device(int dev, size_t nbytes, cudaStream_t stream)
int currentDevice()
Definition: currentDevice.h:10
template<typename T , typename... Args>
device::impl::make_device_unique_selector<T>::bounded_array cms::cuda::make_device_unique_uninitialized ( Args &&  ...)
delete
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.

References cudaCheck, mem, and relativeConstraints::value.

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  }
uint16_t mem[nChs][nEvts]
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck, mem, and relativeConstraints::value.

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  }
uint16_t mem[nChs][nEvts]
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
template<typename T , typename... Args>
host::noncached::impl::make_host_unique_selector<T>::bounded_array cms::cuda::make_host_noncached_unique ( Args &&  ...)
delete
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.

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

Referenced by EcalRawToDigiGPU::acquire(), HcalRawToDigiGPU::acquire(), and make_host_unique().

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_host(size_t nbytes, cudaStream_t stream)
long double T
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.

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

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_host(size_t nbytes, cudaStream_t stream)
template<typename T , typename... Args>
host::impl::make_host_unique_selector<T>::bounded_array cms::cuda::make_host_unique ( Args &&  ...)
delete
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.

References allocate_host(), and mem.

Referenced by make_host_unique_uninitialized().

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_host(size_t nbytes, cudaStream_t stream)
long double T
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.

References allocate_host(), make_host_unique_uninitialized(), and mem.

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
uint16_t mem[nChs][nEvts]
void * allocate_host(size_t nbytes, cudaStream_t stream)
template<typename T , typename... Args>
host::impl::make_host_unique_selector<T>::bounded_array cms::cuda::make_host_unique_uninitialized ( Args &&  ...)
delete
template<class T >
SimpleVector<T> cms::cuda::make_SimpleVector ( int  capacity,
T data 
)

Definition at line 124 of file SimpleVector.h.

References cms::cuda::SimpleVector< T >::construct(), and runTheMatrix::ret.

Referenced by SiPixelDigiErrorsCUDA::SiPixelDigiErrorsCUDA().

124  {
125  SimpleVector<T> ret;
126  ret.construct(capacity, data);
127  return ret;
128  }
tuple ret
prodAgent to be discontinued
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:79
template<class T >
SimpleVector<T>* cms::cuda::make_SimpleVector ( SimpleVector< T > *  mem,
int  capacity,
T data 
)

Definition at line 132 of file SimpleVector.h.

References mem, and runTheMatrix::ret.

132  {
133  auto ret = new (mem) SimpleVector<T>();
134  ret->construct(capacity, data);
135  return ret;
136  }
tuple ret
prodAgent to be discontinued
uint16_t mem[nChs][nEvts]
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:79
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.

References cudaCheck, relativeConstraints::value, and value.

Referenced by SiPixelDigiErrorsCUDA::SiPixelDigiErrorsCUDA().

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  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
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.

References cudaCheck, and value.

27  {
28  cudaCheck(cudaMemsetAsync(ptr.get(), value, nelements * sizeof(T), stream));
29  }
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
#define cudaCheck(ARG,...)
Definition: cudaCheck.h:69
long double T
int cms::cuda::numberOfDevices ( )

Definition at line 6 of file numberOfDevices.cc.

References fwrapper::cs, CUDAService::enabled(), and CUDAService::numberOfDevices().

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

6  {
8  return cs->enabled() ? cs->numberOfDevices() : 0;
9  }
unique_ptr< ClusterSequence > cs
int numberOfDevices() const
Definition: CUDAService.h:24
bool enabled() const
Definition: CUDAService.h:22
bool cms::cuda::nvmlCheck_ ( const char *  file,
int  line,
const char *  cmd,
nvmlReturn_t  result,
std::string_view  description = std::string_view() 
)
inline

Definition at line 36 of file nvmlCheck.h.

References abortOnNvmlError(), getPayloadData::description, LIKELY, AlCaHLTBitMon_QueryRunRegistry::string, and cond::impl::to_string().

40  {
41  if (LIKELY(result == NVML_SUCCESS))
42  return true;
43 
44  std::string error = "NVML Error " + std::to_string(result);
45  const char* message = nvmlErrorString(result);
46  abortOnNvmlError(file, line, cmd, error.c_str(), message, description);
47  return false;
48  }
void abortOnNvmlError(const char *file, int line, const char *cmd, const char *error, const char *message, std::string_view description=std::string_view())
Definition: nvmlCheck.h:20
#define LIKELY(x)
Definition: Likely.h:20
std::string to_string(const V &value)
Definition: OMSAccess.h:71
tuple result
Definition: mps_fire.py:311
list cmd
Definition: mps_setup.py:244

Variable Documentation

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

Definition at line 76 of file HistoContainer.h.

Referenced by OutputMagneticFieldDDToDDL::addToSolStore(), OutputDDToDDL::addToSolStore(), ElectronGeneralAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), SiPixelPhase1CompareVertexSoA::analyze(), SiPixelPhase1MonitorVertexSoA::analyze(), MuonMiniAOD::analyze(), RecoMuonValidator::analyze(), ElectronMcFakeValidator::analyze(), DiMuonHistograms::analyze(), EfficiencyAnalyzer::analyze(), MuonKinVsEtaAnalyzer::analyze(), ElectronAnalyzer::analyze(), TriggerMatchMonitor::analyze(), TrackBuildingAnalyzer::analyze(), tadqm::TrackAnalyzer::analyze(), MuonRecoOneHLT::analyze(), AnotherBeamSpotAnalyzer::analyze(), DQMAnalyzer::analyze(), BSvsPVAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), V0Monitor::analyze(), TrackingMonitor::analyze(), TrackerDpgAnalysis::analyze(), MuonTrackValidator::analyze(), TrackingNtuple::analyze(), TrackGenAssociatorByChi2Impl::associateGenToReco(), TrackGenAssociatorByChi2Impl::associateRecoToGen(), TrackAssociatorByChi2Impl::associateRecoToSim(), TrackAssociatorByChi2Impl::associateSimToReco(), StripTopologyBuilder::build(), FWConvTrackHitsDetailView::build(), FWTauProxyBuilderBase::buildBaseTau(), GlobalCoordsObtainer::calc_atan_lut(), L1GtVmeWriterCore::calculateAddress(), L1GtVmeWriterCore::calculateJetsAddress(), TrackerSeedCleaner::clean(), ReferenceTrajectory::construct(), SiStripDigitizerAlgorithm::digitize(), MultiTrackValidatorGenPs::dqmAnalyze(), MultiTrackValidator::dqmAnalyze(), BeamSpotDipServer::dqmEndLuminosityBlock(), TEveEllipsoidProjectedGL::DrawRhoZ(), TEveEllipsoidProjectedGL::drawRhoZAxis(), BeamSpotAnalyzer::endLuminosityBlock(), AlcaBeamSpotProducer::endLuminosityBlockProduce(), DTGeometryBuilderFromDDD::extractParameters(), DTGeometryParsFromDD::extractParameters(), BSvsPVHistogramMaker::fill(), BPHWriteSpecificDecay::fill(), GsfTrackProducerBase::fillMode(), BsJpsiPhiFilter::filter(), pat::PATSingleVertexSelector::filter_(), BeamMonitorBx::FitAndFill(), FakeBeamMonitor::FitAndFill(), BeamMonitor::FitAndFill(), BPHDecayVertex::fitVertex(), HcalLutManager::get_brickSet_from_oracle(), OnlineMetaDataRawToDigi::getBeamSpot(), NuclearTrackCorrector::getTrackFromTrajectory(), TrackProducer::getTransient(), TrackProducerWithSCAssociation::getTransient(), SusyDQM< Mu, Ele, Jet, Met >::goodSusyElectron(), SusyDQM< Mu, Ele, Jet, Met >::goodSusyMuon(), DDG4SolidConverter::intersection(), main(), CosmicParametersDefinerForTP::momentum(), ParametersDefinerForTP::momentum(), ParametersDefinerForTP::momentumAndVertex(), egammaisolation::EgammaTrackSelector::operator()(), VertexBeamspotOrigins::origins(), GsfTrackProducer::produce(), GsfTrackRefitter::produce(), TrackRefitter::produce(), TrackProducer::produce(), L2TauPixelTrackMatch::produce(), DAFTrackProducer::produce(), L2TauPixelIsoTagProducer::produce(), TrackProducerWithSCAssociation::produce(), SiPixelRecHitCUDA::produce(), VertexCompositeCandidateCollectionSelector::produce(), PixelVertexProducerFromSoA::produce(), MkFitEventOfHitsProducer::produce(), SiPixelRecHitSoAFromLegacy::produce(), AlCaGammaJetProducer::produce(), SeedProducerFromSoA::produce(), PATTracksToPackedCandidates::produce(), PixelVertexProducer::produce(), Onia2MuMuPAT::produce(), PixelTrackProducerFromSoA::produce(), BeamSpotToCUDA::produce(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::produce(), TemplatedSecondaryVertexProducer< IPTI, VTX >::produce(), TrackExtenderWithMTDT< TrackCollection >::produce(), MuonTrackingRegionByPtBuilder::region(), MuonTrackingRegionBuilder::region(), GlobalTrackingRegionProducerFromBeamSpot::regions(), TrackingRegionsFromBeamSpotAndL2Tau::regions(), GlobalTrackingRegionWithVerticesProducer::regions(), HITrackingRegionForPrimaryVtxProducer::regions(), CandidateSeededTrackingRegionsProducer::regions(), PointSeededTrackingRegionsProducer::regions(), L1MuonSeededTrackingRegionsProducer::regions(), EgammaHLTPixelMatchElectronAlgo::run(), pixeltemp::Cluster1DMerger< reco::Track >::setBeamSpot(), RecoTracktoTP::SetBeamSpot(), TPtoRecoTrack::SetBeamSpot(), mkfit::EventOfHits::setBeamSpot(), TtDilepEvtSolution::setBestSol(), DDErrorDetection::so(), DDG4SolidConverter::subtraction(), track_associator::trackAssociationChi2(), DDG4SolidConverter::unionsolid(), CosmicParametersDefinerForTP::vertex(), and ParametersDefinerForTP::vertex().

__host__ __device__ VT* cms::cuda::co
__host__ __device__ V V Func const & cms::cuda::func
Initial value:

Definition at line 73 of file HistoContainer.h.

Referenced by ntuplePrintersDiff::_mapdiff(), Config.Modifier::_toModify(), dqm::impl::MonitorElement::accessRootObject(), GeometryInterface::addExtractor(), CTPPSProtonReconstructionValidator::analyze(), FSQ::HandlerTemplate< TInputCandidateType, TOutputCandidateType, filter >::book(), BTagEntry::BTagEntry(), edm::stream::EDAnalyzerBase::callWhenNewProductsRegistered(), edm::EDAnalyzer::callWhenNewProductsRegistered(), edm::global::EDAnalyzerBase::callWhenNewProductsRegistered(), edm::limited::EDAnalyzerBase::callWhenNewProductsRegistered(), edm::one::EDAnalyzerBase::callWhenNewProductsRegistered(), edm::ProducerBase::callWhenNewProductsRegistered(), EcalTPGParamBuilder::computeLUT(), HFCherenkov::computeQEff(), BaseFunction::convertToArrays(), vertexPlots.VertexSummaryTable::create(), trackingPlots.TrackingSummaryTable::create(), GflashHadronShowerProfile::depthScale(), EcalZmassClient::dqmEndJob(), VVIObjFDetails::dzero(), VVIObjDetails::dzero(), sistripvvi::VVIObjDetails::dzero(), mkfit::ConfigJsonPatcher::exc_hdr(), PulseFitWithFunction::Fit_electronic(), SplitVertexResolution::fitResiduals(), TrackerOfflineValidationSummary::fitResiduals(), PVValHelper::fitResiduals(), TrackerOfflineValidation::fitResiduals(), SplitVertexResolution::fitResiduals_v0(), GflashHadronShowerProfile::fLnE1(), for(), GflashHadronShowerProfile::fTanh(), RPCSimAverage::getClSize(), RPCSimAverageNoise::getClSize(), RPCSimModelTiming::getClSize(), RPCSimAverageNoiseEff::getClSize(), RPCSimAverageNoiseEffCls::getClSize(), RPCSimAsymmetricCls::getClSize(), edm::refitem::GetRefPtrImpl< C, T, F, KEY >::getRefPtr_(), edm::refitem::GetRefPtrImpl< C, T, F, unsigned int >::getRefPtr_(), fwlite::DataGetterHelper::getThinnedKeyFrom(), BareRootProductGetter::getThinnedKeyFrom(), edm::EventPrincipal::getThinnedKeyFrom(), edm::ESProductHost< Product, RecordTypes >::ifRecordChanges(), edm::installSig(), main(), TFileDirectory::make(), edm::make_lambda_with_holder(), edm::make_waiting_task_with_holder(), edm::ESConsumesCollectorT< RECORD >::mayConsumeFrom(), operator<<(), JetResolution::parameterEtaEval(), EcalUncalibRecHitFixedAlphaBetaAlgo< C >::PerformAnalyticFit(), SymmetryFit::pol2_from_pol2(), SymmetryFit::pol2_from_pol3(), cms::cuda::impl::ScopedContextHolderHelper::pushNextTask(), stdcomb::recursive_combination(), edm::limited::impl::InputProcessBlockCacheHolder< T, CacheTypes >::registerProcessBlockCacheFiller(), edm::global::impl::InputProcessBlockCacheHolder< T, CacheTypes >::registerProcessBlockCacheFiller(), edm::one::impl::InputProcessBlockCacheHolder< T, CacheTypes >::registerProcessBlockCacheFiller(), cmsswSequenceInfo::serve(), cmsswConfigtrace::serve_main(), PSFitter::HybridMinimizer::SetFunction(), edm::ESConsumesCollectorT< RECORD >::setMayConsume(), reco::tau::sumPFVector(), PATStringObjectFunction::tryEval(), and PATStringCutObjectSelector::tryEval().

uint32_t T const* __restrict__ uint32_t const* __restrict__ int32_t int Histo::index_type* cms::cuda::mem
uint32_t T const* __restrict__ uint32_t const* __restrict__ int32_t int Histo::index_type cudaStream_t Func __host__ __device__ V int cms::cuda::n

Definition at line 73 of file HistoContainer.h.

Referenced by cms::cuda::HostAllocator< T, FLAGS >::allocate().

uint32_t cms::cuda::nh
uint32_t T const* __restrict__ uint32_t const* __restrict__ int32_t int cms::cuda::nthreads

Definition at line 43 of file HistoContainer.h.

uint32_t T const *__restrict__ uint32_t const *__restrict__ cms::cuda::offsets
Initial value:
{
int first = blockDim.x * blockIdx.x + threadIdx.x
const dim3 threadIdx
Definition: cudaCompat.h:29
const dim3 blockDim
Definition: cudaCompat.h:30
const dim3 blockIdx
Definition: cudaCompat.h:32

Definition at line 13 of file HistoContainer.h.

cudaStream_t int32_t cms::cuda::ONES
__host__ __device__ VT uint32_t cms::cuda::size

Definition at line 47 of file prefixScan.h.

Referenced by launch(), and launch_cooperative().

cudaStream_t cms::cuda::stream
Initial value:
= cudaStreamDefault
) {
typename Histo::View view = {h, nullptr, mem, -1, totSize};
launchZero(view, stream);
countFromVector(h, nh, v, offsets);
h->finalize();
fillFromVector(h, nh, v, offsets);
}
template <typename Hist
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t int Histo::index_type cudaStream_t stream
cms::cuda::HistoContainer< uint8_t, 256, 16000, 8, uint16_t > Hist
uint16_t mem[nChs][nEvts]
uint32_t nh
The Signals That Services Can Subscribe To This is based on ActivityRegistry h
Helper function to determine trigger accepts.
Definition: Activities.doc:4
uint32_t T const *__restrict__ uint32_t const *__restrict__ int32_t totSize

Definition at line 51 of file HistoContainer.h.

Referenced by CAHitNtupletGeneratorKernels< TTraits >::allocateOnGPU(), CSCFileDumper::analyze(), HLTrigReport::analyze(), L1TriggerJSONMonitoring::analyze(), HLTriggerJSONMonitoring::analyze(), BeamSpotCUDA::BeamSpotCUDA(), BTagDifferentialPlot::bookHisto(), dqm::RamdiskMonitor::bookHistograms(), EtaPtBin::buildDescriptionString(), DQMStoreStats::calcIgProfDump(), edm::StreamSerializer::compressBufferLZMA(), SiPixelDigisCUDA::copyAllToHostAsync(), SiPixelDigiErrorsCUDA::dataErrorToHostAsync(), LzmaFile::DecodeAll(), LzmaFile::DecodeBuffer(), edm::Schedule::deleteModule(), DTOccupancyClusterBuilder::drawClusters(), HLTrigReport::endRun(), fillPathSummary(), edm::SystemTimeKeeper::fillTriggerTimingReport(), SiStripDetVOffTkMapPlotter::formatIOV(), SiStripDetVOffTrendPlotter::formatIOV(), cms::cuda::StreamCache::get(), getABDCCOutputStream(), SiPixelGainCalibrationForHLTGPU::getGPUProductAsync(), SiPixelROCsStatusAndMappingWrapper::getGPUProductAsync(), PixelCPEFast::getGPUProductAsync(), SiPixelROCsStatusAndMappingWrapper::getModToUnpAllAsync(), HcalRespCorrsGPU::getProduct(), HcalGainsGPU::getProduct(), HcalTimeCorrsGPU::getProduct(), HcalLUTCorrsGPU::getProduct(), HcalChannelQualityGPU::getProduct(), HcalQIETypesGPU::getProduct(), HcalPedestalsGPU::getProduct(), HcalRecoParamsGPU::getProduct(), HcalConvertedPedestalsGPU::getProduct(), HcalGainWidthsGPU::getProduct(), HcalQIECodersGPU::getProduct(), HcalSiPMParametersGPU::getProduct(), HcalConvertedPedestalWidthsGPU::getProduct(), HcalSiPMCharacteristicsGPU::getProduct(), HcalPedestalWidthsGPU::getProduct(), evf::EvFDaqDirector::getStreamDestinations(), HLTrigReport::globalEndLuminosityBlock(), HeterogeneousSoAImpl< T, Traits >::HeterogeneousSoAImpl(), HGCRecHitCPUProduct::HGCRecHitCPUProduct(), HGCRecHitGPUProduct::HGCRecHitGPUProduct(), HGCUncalibRecHitDevice::HGCUncalibRecHitDevice(), HGCUncalibRecHitHost< edm::SortedCollection >::HGCUncalibRecHitHost(), TrackingRecHit2DHeterogeneous< Traits >::hitsModuleStartToHostAsync(), HLTMuonTrackMassFilter::hltFilter(), HLTMuonTrackMassFilter::HLTMuonTrackMassFilter(), l1t::MicroGMTLUT::initialize(), edm::Schedule::initializeEarlyDelete(), TrackingRecHit2DHeterogeneous< Traits >::localCoordToHostAsync(), gpuVertexFinder::Producer::make(), cms::cudacompat::GPUTraits::make_device_unique(), cms::cudacompat::HostTraits::make_device_unique(), cms::cudacompat::GPUTraits::make_host_unique(), cms::cudacompat::HostTraits::make_host_unique(), cms::cudacompat::GPUTraits::make_unique(), cms::cudacompat::HostTraits::make_unique(), CAHitNtupletGeneratorOnGPU::makeTuplesAsync(), hcaldqm::hashfunctions::name_TChannel(), L1GtPsbSetupConfigOnlineProd::numberFromString(), LzmaFile::Open(), operator<<(), reco::operator<<(), edm::ParentContext::ParentContext(), FastTimerService::postEvent(), FastTimerService::postModuleEvent(), FastTimerService::postModuleEventAcquire(), FastTimerService::postPathEvent(), FastTimerService::postSourceEvent(), FastTimerService::preModuleEvent(), FastTimerService::preModuleEventAcquire(), FastTimerService::prePathEvent(), FastTimerService::preSourceEvent(), QuarkoniaTrackSelector::produce(), trackerDTC::DTC::produce(), L1RCTOmdsFedVectorProducer::produce(), QuarkoniaTrackSelector::QuarkoniaTrackSelector(), RunInfoRead::readData(), EnergyScaleCorrection::readScalesFromFile(), edm::service::MessageLogger::setThreadContext(), SiPixelClustersCUDA::SiPixelClustersCUDA(), trackerDTC::DTC::split(), TrackingRecHit2DHeterogeneous< Traits >::store16ToHostAsync(), TrackingRecHit2DHeterogeneous< Traits >::store32ToHostAsync(), HLTriggerJSONMonitoring::streamBeginLuminosityBlock(), L1TriggerJSONMonitoring::streamBeginLuminosityBlock(), HLTriggerJSONMonitoring::streamEndLuminosityBlockSummary(), L1TriggerJSONMonitoring::streamEndLuminosityBlockSummary(), edm::SystemTimeKeeper::SystemTimeKeeper(), cond::impl::to_string(), HeterogeneousSoA< T >::toHostAsync(), HeterogeneousSoAImpl< T, Traits >::toHostAsync(), TrackingRecHit2DHeterogeneous< Traits >::TrackingRecHit2DHeterogeneous(), edm::StreamerInputSource::uncompressBufferLZMA(), edm::service::MessageLogger::unEstablishModule(), and CSCFileDumper::~CSCFileDumper().

uint32_t T const* __restrict__ uint32_t const* __restrict__ int32_t cms::cuda::totSize
uint32_t T const *__restrict__ cms::cuda::v

Definition at line 11 of file HistoContainer.h.

Referenced by cms::cuda::FlexiStorage< I,-1 >::init().

uint32_t T const* __restrict__ uint32_t const* __restrict__ int32_t int Histo::index_type cudaStream_t cms::cuda::V
uint32_t T const* __restrict__ uint32_t const* __restrict__ int32_t int Histo::index_type cudaStream_t Func __host__ __device__ V cms::cuda::value

Definition at line 73 of file HistoContainer.h.

Referenced by memsetAsync().

__host__ __device__ V V cms::cuda::wmax
__host__ __device__ V cms::cuda::wmin

Definition at line 85 of file HistoContainer.h.

Referenced by HGCalDDDConstants::HGCalDDDConstants().