Classes | |
class | Producer |
struct | WorkSpace |
Typedefs | |
using | Hist = cms::cuda::HistoContainer< uint8_t, 256, 16000, 8, uint16_t > |
using | TkSoA = pixelTrack::TrackSoA |
using | ZVertices = ZVertexSoA |
Functions | |
__device__ | __attribute__ ((always_inline)) void clusterTracksByDensity(gpuVertexFinder |
__syncthreads () | |
assert (soa) | |
assert (nvFinal<=nvIntermediate) | |
assert (pdata) | |
assert (zt) | |
assert ((int) nt<=hist.capacity()) | |
assert (hist.size()==nt) | |
assert (foundClusters< ZVertices::MAXVTX) | |
size d for d tracks hist hist | capacity () |
hist | finalize (hws) |
for (int idx=first, nt=tracks.nTracks();idx< nt;idx+=gridDim.x *blockDim.x) | |
for (auto j=threadIdx.x;j< Hist::totbins();j+=blockDim.x) = float(nn[i]) / chi2[i] | |
if (verbose &&0==threadIdx.x) printf("params %d %f %f %f\ | |
if (1==nvFinal) | |
if (threadIdx.x< 32) hws[threadIdx.x]=0 | |
pws | init () |
size d for d tracks hist | nbins () |
while (__syncthreads_or(more)) | |
Variables | |
float *__restrict__ | chi2 = data.chi2 |
__device__ WorkSpace float | chi2Max |
WorkSpace int float float float | chi2max |
auto &__restrict__ | data = *pdata |
WorkSpace int float | eps |
auto | er2mx = errmax * errmax |
WorkSpace int float float | errmax |
float const *__restrict__ | ezt2 = ws.ezt2 |
auto | first = blockIdx.x * blockDim.x + threadIdx.x |
auto const & | fit = tracks.stateAtBS |
__shared__ unsigned int | foundClusters = 0 |
__shared__ Hist | hist |
__shared__ Hist::Counter | hws [32] |
int32_t *__restrict__ | iv = ws.iv |
uint8_t *__restrict__ | izt = ws.izt |
__device__ WorkSpace float | maxChi2 |
constexpr float | maxChi2ForFinalFit = 5000.f |
constexpr float | maxChi2ForFirstFit = 50.f |
constexpr float | maxChi2ForSplit = 9.f |
WorkSpace int | minT |
bool | more = true |
size d for d tracks | n |
__shared__ int | nloops = 0 |
int32_t *__restrict__ | nn = data.ndof |
__shared__ int | noise |
auto | nt = ws.ntrks |
uint32_t & | nvFinal = data.nvFinal |
uint32_t & | nvIntermediate = ws.nvIntermediate |
ZVertexSoA WorkSpace float float | ptMax |
ZVertexSoA WorkSpace float | ptMin |
float const *__restrict__ | ptt2 = ws.ptt2 |
float *__restrict__ | ptv2 = data.ptv2 |
WorkSpace * | pws |
auto const * | quality = tracks.qualityData() |
ZVertexSoA * | soa |
uint16_t *__restrict__ | sortInd = data.sortInd |
auto const & | tracks = *ptracks |
auto &__restrict__ | ws = *pws |
float *__restrict__ | wv = data.wv |
float const *__restrict__ | zt = ws.zt |
float *__restrict__ | zv = data.zv |
typedef cms::cuda::HistoContainer< uint8_t, 256, 16000, 8, uint16_t > gpuVertexFinder::Hist |
Definition at line 47 of file gpuClusterTracksDBSCAN.h.
using gpuVertexFinder::TkSoA = typedef pixelTrack::TrackSoA |
Definition at line 13 of file gpuVertexFinder.h.
using gpuVertexFinder::ZVertices = typedef ZVertexSoA |
Definition at line 12 of file gpuVertexFinder.h.
|
inline |
Definition at line 20 of file gpuClusterTracksByDensity.h.
References __syncthreads(), funct::abs(), assert(), cms::cudacompat::atomicInc(), cms::cudacompat::blockDim, cms::cuda::OneToManyAssoc::capacity(), chi2max, data, eps, er2mx, errmax, ezt2, foundClusters, hist, hws, mps_fire::i, createfilelist::int, iv, izt, dqmiolumiharvest::j, heppy_loop::loop, visualization-live-secondInstance_cfg::m, SiStripPI::max, ZVertexSoA::MAXTRACKS, ZVertexSoA::MAXVTX, SiStripPI::min, minT, cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::nbins(), nn, nt, nvFinal, nvIntermediate, cms::cuda::OneToManyAssoc::off, pws, cms::cudacompat::threadIdx, cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::totbins(), verbose, ws, and zt.
|
inline |
Definition at line 132 of file cudaCompat.h.
Referenced by gpuPixelRecHits::__attribute__(), __attribute__(), cms::cuda::__attribute__(), gpuClustering::for(), for(), and CandsGPU::BestCands< MaxCandsPerSeed, BlockSize >::merge_cands_for_seed().
gpuVertexFinder::assert | ( | soa | ) |
gpuVertexFinder::assert | ( | nvFinal<= | nvIntermediate | ) |
gpuVertexFinder::assert | ( | pdata | ) |
Referenced by __attribute__(), for(), gpuVertexFinder::Producer::make(), and while().
gpuVertexFinder::assert | ( | zt | ) |
gpuVertexFinder::assert | ( | (int) nt<=hist.capacity() | ) |
gpuVertexFinder::assert | ( | hist. | size() = =nt | ) |
gpuVertexFinder::assert | ( | ) |
Referenced by reco::TaggingVariableList::insert().
gpuVertexFinder::for | ( | int | idx = first | ) |
Definition at line 29 of file gpuVertexFinder.cc.
References assert(), cms::cudacompat::atomicAdd(), data, pixelTrack::highPurity, ZVertexSoA::idv, heavyIonCSV_trainingSettings::idx, SiStripPI::min, nHits, DiDispStaMuonMonitor_cfi::pt, ptMax, ptMin, pws, quality, soa, and tracks.
Definition at line 50 of file gpuClusterTracksDBSCAN.h.
References hist, dqmiolumiharvest::j, and cms::cuda::OneToManyAssoc::off.
gpuVertexFinder::if | ( | verbose && | 0 = = threadIdx.x | ) |
gpuVertexFinder::if | ( | 1 | = = nvFinal | ) |
|
pure virtual |
pws gpuVertexFinder::init | ( | ) |
Referenced by gpuVertexFinder::Producer::make().
gpuVertexFinder::while | ( | __syncthreads_or(more) | ) |
Definition at line 109 of file gpuClusterTracksIterative.h.
References funct::abs(), assert(), cms::cudacompat::atomicMin(), cms::cuda::be, cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::bin(), cms::cudacompat::blockDim, chi2max, eps, ezt2, hist, mps_fire::i, iv, izt, dqmiolumiharvest::j, dqmdumpme::k, heppy_loop::loop, visualization-live-secondInstance_cfg::m, SiStripPI::min, minT, more, cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::nbins(), nloops, nn, nt, AlCaHLTBitMon_ParallelJobs::p, cms::cudacompat::threadIdx, and zt.
Referenced by ThreeThresholdAlgorithm::addToCandidate(), EcalSimParametersFromDD::build(), cppFunctionSkipper::delLines(), cppFunctionSkipper::filterFile(), commentSkipper.buildFileCommentSkipper::filterMultilineComment(), mkfit::MkBuilder::find_tracks_in_layers(), mkfit::MkBuilder::findTracksStandard(), dqm_interfaces.DQMcommunicator::get_runs_list(), and histoStyle::savePlots().
float const *__restrict__ gpuVertexFinder::chi2 = data.chi2 |
Definition at line 28 of file gpuFitVertices.h.
WorkSpace float gpuVertexFinder::chi2Max |
Definition at line 18 of file gpuFitVertices.h.
WorkSpace int float float float gpuVertexFinder::chi2max |
Definition at line 23 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
auto &__restrict__ gpuVertexFinder::data = *pdata |
Definition at line 31 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and for().
WorkSpace int float gpuVertexFinder::eps |
Definition at line 18 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
Definition at line 29 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__().
WorkSpace int float float gpuVertexFinder::errmax |
Definition at line 18 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__().
float const *__restrict__ gpuVertexFinder::ezt2 = ws.ezt2 |
Definition at line 35 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
auto gpuVertexFinder::first = blockIdx.x * blockDim.x + threadIdx.x |
Definition at line 28 of file gpuVertexFinder.cc.
auto const& gpuVertexFinder::fit = tracks.stateAtBS |
Definition at line 25 of file gpuVertexFinder.cc.
auto gpuVertexFinder::foundClusters = 0 |
Definition at line 199 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__().
__shared__ Hist gpuVertexFinder::hist |
Definition at line 48 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), DDSpecificsHasNamedValueFilter::accept(), DDSpecificsMatchesValueFilter::accept(), DDSpecificsFilter::accept_impl(), PVValHelper::add(), DTT0Calibration::analyze(), HGCalHitValidation::analyzeHGCalSimHit(), APVCyclePhaseMonitor::beginRun(), Book::book(), HLTDQMFilterEffHists< ProbeType >::book1D(), HLTDQMFilterEffHists< ProbeType >::book2D(), GEMBaseValidation::bookDetectorOccupancy(), L1TStage2EMTF::bookHistograms(), GEMDQMEfficiencySourceBase::bookNumerator1D(), GEMDQMEfficiencySourceBase::bookNumerator2D(), GEMBaseValidation::bookPIDHist(), GEMBaseValidation::bookZROccupancy(), BTagEntry::BTagEntry(), TrackerG4SimHitNumberingScheme::buildAll(), ClusMultInvestPlots(), Combined2DHisto(), CombinedHisto(), HGCalSimHitValidation::createHisto(), DeadTimeAPVCycle(), fwlite::Scanner< Collection >::draw(), fwlite::Scanner< Collection >::draw2D(), fwlite::Scanner< Collection >::drawProf(), DTTMax::DTTMax(), L1TEMTFEventInfoClient::dumpContentMonitorElements(), L1TEventInfoClient::dumpContentMonitorElements(), EcalPedHists::endJob(), EcalURecHitHists::endJob(), EcalCosmicsHists::endJob(), DQMHistNormalizer::endRun(), l1tVertexFinder::VertexFinder::fastHisto(), l1tVertexFinder::VertexFinder::fastHistoEmulation(), ExpressionHisto< T >::fill(), DigiCollectionProfiler< T >::fill(), TrigObjTnPHistColl::HistColl::fill(), GEMDQMBase::MEMapInfT< M, K >::Fill(), helper::ScannerBase::fill1D(), helper::ScannerBase::fill2D(), GEMDQMBase::MEMapInfT< M, K >::FillBits(), HLTDQMFilterEffHists< ProbeType >::fillHists(), GEMDQMEfficiencySourceBase::fillMEWithinLimits(), edm::Principal::fillPrincipal(), helper::ScannerBase::fillProf(), Rivet::HiggsTemplateCrossSections::finalize(), LA_Filler_Fitter::find_rebin(), SplitVertexResolution::fitResiduals(), TrackerOfflineValidationSummary::fitResiduals(), PVValHelper::fitResiduals(), TrackerOfflineValidation::fitResiduals(), SplitVertexResolution::fitResiduals_v0(), DiMuonMassBiasClient::fitVoigt(), for(), TrackerOfflineValidation::Fwhm(), EgHLTOfflineSummaryClient::getEgHLTSumHist_(), MuonGEMBaseHarvestor::getElement(), HcalObjRepresent::HcalDataContainer< Items, Item >::GetProjection(), L1TPhase2CorrelatorOffline::getQuantile(), HcalObjRepresent::HcalDataContainer< Items, Item >::GetRange(), fwlite::Scanner< Collection >::getSameH1(), fwlite::Scanner< Collection >::getSameH2(), fwlite::Scanner< Collection >::getSameProf(), SiStripSummaryCreator::getSummaryME(), hTMaxCell::GetT0Factor(), PPSAlignmentHarvester::getTH1DFromTGraphErrors(), HGCalTBMB::HGCalTBMB(), HGCalTBMBAnalyzer::HGCalTBMBAnalyzer(), FWEveViewManager::highlightAdded(), HistoAnalyzer< C >::HistoAnalyzer(), MuonResidualsFitter::histogramChi2GaussianFit(), CTPPSCommonDQMSource::GlobalPlots::Init(), EcalDisplaysByEvent::init2DEcalHist(), EcalDisplaysByEvent::init3DEcalHist(), EcalURecHitHists::initHists(), EcalCosmicsHists::initHists(), ExpressionHisto< T >::initialize(), TopDiLeptonOffline::MonitorEnsemble::loggerBinLabels(), main(), LA_Filler_Fitter::make_and_fit_symmchi2(), SiStripSpyDisplayModule::MakeDigiHist_(), DTGeometryValidate::makeHistogram(), GEMGeometryValidate::makeHistogram(), RPCGeometryValidate::makeHistogram(), ME0GeometryValidate::makeHistogram(), CSCGeometryValidate::makeHistogram(), ValidateGeometry::makeHistogram(), Phase1PixelMaps::makeNicePlotStyle(), SiStripPI::makeNicePlotStyle(), SiPixelPI::makeNicePlotStyle(), AlignmentPI::makeNicePlotStyle(), AlignmentPI::makeNiceStats(), SiStripPI::makeNiceStyle(), SiStripSpyDisplayModule::MakeProcessedRawDigiHist_(), SiStripSpyDisplayModule::MakeRawDigiHist_(), DDExpandedView::mergedSpecificsV(), DQMGenericClient::normalizeToEntries(), DQMRivetClient::normalizeToIntegral(), DQMRivetClient::normalizeToLumi(), TrigObjTnPHistColl::HistFiller::operator()(), CSCAlignmentCorrections::plot(), MuonResidualsFitter::plotsimple(), MuonResidualsFitter::plotweighted(), SymmetryFit::pol2_from_pol2(), SymmetryFit::pol2_from_pol3(), printPlot(), EcalPedHists::readEBdigis(), EcalPedHists::readEEdigis(), edm::OneLumiPoolSource::readLuminosityBlockAuxiliary_(), PatternOptimizerBase::savePatternsInRoot(), DQMRivetClient::scaleByFactor(), SiPixelUtility::setDrawingOption(), SiStripHistoPlotter::setDrawingOption(), DDFilteredView::setScope(), DDExpandedView::specificsV(), tfwliteselectortest::ThingsTSelector::terminate(), tfwliteselectortest::ThingsTSelector2::terminate(), __class__< T >::terminate(), th1ToFormulaBinTree(), th1ToFormulaLin(), while(), sistrip::EnsembleCalibrationLA::write_ensembles_plots(), sistrip::MeasureLA::write_report_plots(), and sistrip::EnsembleCalibrationLA::write_samples_plots().
__shared__ Hist::Counter gpuVertexFinder::hws |
Definition at line 49 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__().
int32_t *__restrict__ gpuVertexFinder::iv = ws.iv |
Definition at line 42 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), RPCLinkSynchroStat::add(), TAPD::addEntry(), FBaseSimEvent::addSimTrack(), reco::IsoDeposit::algoWithin(), SiPixelPhase1MonitorVertexSoA::analyze(), HcalRecHitsAnalyzer::analyze(), IsoTrig::analyze(), PrimaryVertexAnalyzer4PUSlimmed::analyze(), IsolatedTracksNxN::analyze(), Primary4DVertexValidation::analyze(), XtalDedxAnalysis::analyzeHits(), HGCalTimingAnalyzer::analyzeSimTracks(), HGCalTBAnalyzer::analyzeSimTracks(), HLTMuonDimuonL3Filter::applyDiMuonSelection(), Basic2DVector< float >::Basic2DVector(), Basic3DVector< align::Scalar >::Basic3DVector(), magneticfield::MagGeoBuilder::build(), MagGeoBuilderFromDDD::build(), HGCalCellUV::cellUVFromXY1(), HGCalCellUV::cellUVFromXY3(), PFPileUpAlgo::chargedHadronVertex(), PrimaryVertexAssignment::chargedHadronVertex(), PFIsolationEstimator::chargedHadronVertex(), IsoTrig::chgIsolation(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), SeedMvaEstimator::computeMva(), gen::TauolappInterface::decay(), reco::IsoDeposit::depositAndCountWithin(), TMultiDimFet::EvalControl(), SiPixelActionExecutor::fillFEDErrorSummary(), SiPixelActionExecutor::fillGrandBarrelSummaryHistos(), SiPixelActionExecutor::fillGrandEndcapSummaryHistos(), GsfTrackProducerBase::fillMode(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), SiPixelActionExecutor::fillSummary(), TrackingFailureFilter::filter(), PythiaDauVFilter::filter(), PythiaAllDauVFilter::filter(), PythiaDauVFilterMatchID::filter(), FFTJetPFPileupCleaner::findSomeVertexWFakes(), DivisiveVertexFinder::findVertexesAlt(), CaloTowerGeometry::getSummary(), CaloSubdetectorGeometry::getSummary(), HcalGeometry::getSummary(), HGCalTypes::getUnpackedV(), reco::Photon::hcalTowerSumEt(), reco::GsfElectron::hcalTowerSumEt(), reco::Photon::hcalTowerSumEtBc(), reco::GsfElectron::hcalTowerSumEtBc(), HGCalCellUV::HGCalCellUV(), edm::OneToMany< std::vector< Trajectory >, std::vector< TrajectorySeed >, unsigned int >::insert(), edm::OneToOneGeneric< std::vector< TrackCandidate >, std::vector< Trajectory >, unsigned int >::insert(), edm::OneToManyWithQualityGeneric< TrackingVertexCollection, edm::View< reco::Vertex >, double, unsigned int >::insert(), FFTJetPFPileupCleaner::isAcceptableVtx(), edm::isTransientEqual(), G4SimEvent::load(), TMultiDimFet::MakeCandidates(), Primary4DVertexValidation::matchReco2Sim(), JetPlusTrackCorrector::matchTracks(), multiTrajectoryStateMode::momentumFromModeLocal(), reco::IsoDeposit::nearestDR(), HGCalTypes::packTypeUV(), HitParentTest::parentSimTrack(), spr::parentSimTrack(), multiTrajectoryStateMode::positionFromModeLocal(), DDHGCalMixLayer::positionMix(), DDHGCalMixRotatedLayer::positionMix(), HGCalMixLayer::positionMix(), DDHGCalEEAlgo::positionSensitive(), DDHGCalEEFileAlgo::positionSensitive(), DDHGCalSiliconModule::positionSensitive(), DDHGCalSiliconRotatedModule::positionSensitive(), DDHGCalHEFileAlgo::positionSensitive(), DDHGCalHEAlgo::positionSensitive(), HGCalEEFileAlgo::positionSensitive(), HGCalSiliconModule::positionSensitive(), HGCalSiliconRotatedModule::positionSensitive(), HGCalEEAlgo::PositionSensitive(), HGCalHEFileAlgo::positionSensitive(), HGCalHEAlgo::positionSensitive(), SeedGeneratorFromProtoTracksEDProducer::produce(), JetTracksAssociationDRVertexAssigned::produce(), PFV0Producer::produce(), FFTJetVertexAdder::produce(), PrimaryVertexProducer::produce(), ConvBremSeedProducer::produce(), LmfSource::readEventWithinFile(), ZdcSimpleRecAlgoImpl::reco2(), rpcrawtodigi::RecordCD::RecordCD(), PointSeededTrackingRegionsProducer::regions(), PATPrimaryVertexSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), EMShower::setIntervals(), CaloNumberingScheme::setVerbosity(), ZdcNumberingScheme::setVerbosity(), spr::simTrackAtOrigin(), edm::OneToMany< std::vector< Trajectory >, std::vector< TrajectorySeed >, unsigned int >::val(), edm::OneToOneGeneric< std::vector< TrackCandidate >, std::vector< Trajectory >, unsigned int >::val(), edm::OneToManyWithQualityGeneric< TrackingVertexCollection, edm::View< reco::Vertex >, double, unsigned int >::val(), spr::validSimTrack(), HitParentTest::validSimTrack(), ConfigurableTrimmedVertexFinder::vertexCandidates(), HGCalWaferIndex::waferV(), while(), and ZdcNumberingScheme::ZdcNumberingScheme().
uint8_t *__restrict__ gpuVertexFinder::izt = ws.izt |
Definition at line 40 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
WorkSpace float gpuVertexFinder::maxChi2 |
Definition at line 15 of file gpuSplitVertices.h.
constexpr float gpuVertexFinder::maxChi2ForFinalFit = 5000.f |
Definition at line 16 of file gpuVertexFinder.cc.
Referenced by gpuVertexFinder::Producer::make().
constexpr float gpuVertexFinder::maxChi2ForFirstFit = 50.f |
Definition at line 15 of file gpuVertexFinder.cc.
Referenced by gpuVertexFinder::Producer::make().
constexpr float gpuVertexFinder::maxChi2ForSplit = 9.f |
Definition at line 19 of file gpuVertexFinder.cc.
Referenced by gpuVertexFinder::Producer::make().
WorkSpace int gpuVertexFinder::minT |
Definition at line 18 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
bool gpuVertexFinder::more = true |
Definition at line 108 of file gpuClusterTracksIterative.h.
Referenced by KalmanVertexTrackCompatibilityEstimator< N >::estimateDifference(), std::hash_specialization< Head, ndims >::operator()(), and while().
Definition at line 56 of file gpuClusterTracksDBSCAN.h.
gpuVertexFinder::nloops = 0 |
Definition at line 102 of file gpuClusterTracksIterative.h.
Referenced by while().
int32_t const *__restrict__ gpuVertexFinder::nn = data.ndof |
Definition at line 41 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
gpuVertexFinder::noise |
Definition at line 50 of file gpuFitVertices.h.
auto gpuVertexFinder::nt = ws.ntrks |
Definition at line 33 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and while().
uint32_t & gpuVertexFinder::nvFinal = data.nvFinal |
Definition at line 37 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__().
uint32_t & gpuVertexFinder::nvIntermediate = ws.nvIntermediate |
Definition at line 38 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__().
ZVertexSoA WorkSpace float float gpuVertexFinder::ptMax |
Definition at line 21 of file gpuVertexFinder.cc.
Referenced by for(), and gpuVertexFinder::Producer::make().
ZVertexSoA WorkSpace float gpuVertexFinder::ptMin |
Definition at line 21 of file gpuVertexFinder.cc.
Referenced by for(), and gpuVertexFinder::Producer::make().
float const* __restrict__ gpuVertexFinder::ptt2 = ws.ptt2 |
Definition at line 22 of file gpuSortByPt2.h.
float* __restrict__ gpuVertexFinder::ptv2 = data.ptv2 |
Definition at line 26 of file gpuSortByPt2.h.
WorkSpace * gpuVertexFinder::pws |
Definition at line 18 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), and for().
auto const* gpuVertexFinder::quality = tracks.qualityData() |
Definition at line 26 of file gpuVertexFinder.cc.
Referenced by for().
ZVertexSoA* gpuVertexFinder::soa |
Definition at line 21 of file gpuVertexFinder.cc.
Referenced by for(), HGCRecHitCPUProduct::get(), HGCRecHitGPUProduct::get(), gpuVertexFinder::Producer::make(), CAHitNtupletGeneratorOnGPU::makeTuples(), CAHitNtupletGeneratorOnGPU::makeTuplesAsync(), and PixelVertexProducerFromSoA::produce().
uint16_t* __restrict__ gpuVertexFinder::sortInd = data.sortInd |
Definition at line 27 of file gpuSortByPt2.h.
Referenced by if().
auto const& gpuVertexFinder::tracks = *ptracks |
Definition at line 24 of file gpuVertexFinder.cc.
Referenced by for().
auto &__restrict__ gpuVertexFinder::ws = *pws |
Definition at line 32 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), HGCalValidator::bookHistograms(), GlobalLogicParser::buildRpnVector(), L1GtLogicParser::buildRpnVector(), HGCalValidator::dqmAnalyze(), EcalTBWeightsXMLTranslator::dumpXML(), gpuClustering::for(), HoughGrouping::getAveragePoint(), ApeSettingAlgorithm::initialize(), CSCGeometryValidate::makeHistograms2(), FWDetailViewManager::openDetailViewFor(), EcalTBWeightsXMLTranslator::readWeightSet(), EcalTBWeightsXMLTranslator::readXML(), regressionTest_first(), L1MuDTTrackFinder::setup(), and EcalTBWeightsXMLTranslator::writeWeightSet().
float *__restrict__ gpuVertexFinder::wv = data.wv |
Definition at line 27 of file gpuFitVertices.h.
Referenced by JetPartonMatcher::fillAlgoritDefinition(), JetPartonMatcher::fillPhysicsDefinition(), load_dddefinition(), JetPartonMatcher::produce(), and EvtPlaneProducer::produce().
float const *__restrict__ gpuVertexFinder::zt = ws.zt |
Definition at line 34 of file gpuClusterTracksDBSCAN.h.
Referenced by __attribute__(), jacobianCartesianToCurvilinear(), jacobianCurvilinearToCartesian(), DTTrigGeom::localPosition(), and while().
float *__restrict__ gpuVertexFinder::zv = data.zv |
Definition at line 26 of file gpuFitVertices.h.
Referenced by FastTimeGeometryLoader::build(), L1TkEmParticleProducer::CorrectedEta(), HFShowerLibrary::fillHits(), ZtoMMEventSelector::filter(), ZtoEEEventSelector::filter(), HFShowerParam::getHits(), HFShower::getHits(), HGCalGeomParameters::loadCellTrapezoid(), HGCalGeomParameters::loadGeometryHexagon(), HCalSD::plotHF(), MultiHitGeneratorFromChi2::refit2Hits(), and HcalForwardAnalysis::setPhotons().