CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Groups Pages
Classes | Typedefs | Functions | Variables
gpuVertexFinder Namespace Reference

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)
 
hist finalize (hws)
 
 for (int idx=first, nt=TkSoA::stride();idx< nt;idx+=gridDim.x *blockDim.x)
 
 for (auto j=threadIdx.x;j< Hist::totbins();j+=blockDim.x)
 
 if (1==nvFinal)
 
pws init ()
 
 printf ("params %d %f %f %f\n", minT, eps, errmax, chi2max)
 
 printf ("booked hist with %d bins, size %d for %d tracks\n", hist.nbins(), hist.capacity(), nt)
 
wv *[i] printf ("found %d proto clusters ", foundClusters)
 
 printf ("and %d noise\n", noise)
 
 printf ("found %d proto vertices\n", foundClusters)
 
 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] = 0
 
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
 
__shared__ int nloops = 0
 
int32_t *__restrict__ nn = data.ndof
 
__shared__ int noise = 0
 
auto nt = ws.ntrks
 
uint32_t & nvFinal = data.nvFinal
 
uint32_t & nvIntermediate = ws.nvIntermediate
 
ZVertexSoA WorkSpace float ptMin
 
float const *__restrict__ ptt2 = ws.ptt2
 
float *__restrict__ ptv2 = data.ptv2
 
WorkSpacepws
 
auto const * quality = tracks.qualityData()
 
 return
 
ZVertexSoAsoa
 
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 Documentation

typedef cms::cuda::HistoContainer< uint8_t, 256, 16000, 8, uint16_t > gpuVertexFinder::Hist

Definition at line 47 of file gpuClusterTracksDBSCAN.h.

Definition at line 12 of file gpuVertexFinder.h.

Definition at line 11 of file gpuVertexFinder.h.

Function Documentation

gpuVertexFinder::__attribute__ ( (always_inline)  )
inline

Definition at line 20 of file gpuClusterTracksByDensity.h.

References __syncthreads(), funct::abs(), assert(), cms::cudacompat::atomicInc(), cms::cudacompat::blockDim, cms::cuda::OneToManyAssoc::capacity(), data, eps, er2mx, errmax, ezt2, foundClusters, hist, hws, mps_fire::i, iv, izt, dqmiolumiharvest::j, heppy_loop::loop, visualization-live-secondInstance_cfg::m, SiStripPI::max, ZVertexSoA::MAXTRACKS, ZVertexSoA::MAXVTX, min(), cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::nbins(), nn, nt, nvFinal, nvIntermediate, cms::cuda::OneToManyAssoc::off, printf(), pws, cms::cudacompat::threadIdx, cms::cuda::HistoContainer< T, NBINS, SIZE, S, I, NHISTS >::totbins(), verbose, ws, and zt.

26  {
27  using namespace gpuVertexFinder;
28  constexpr bool verbose = false; // in principle the compiler should optmize out if false
29 
30  if (verbose && 0 == threadIdx.x)
31  printf("params %d %f %f %f\n", minT, eps, errmax, chi2max);
32 
33  auto er2mx = errmax * errmax;
34 
35  auto& __restrict__ data = *pdata;
36  auto& __restrict__ ws = *pws;
37  auto nt = ws.ntrks;
38  float const* __restrict__ zt = ws.zt;
39  float const* __restrict__ ezt2 = ws.ezt2;
40 
41  uint32_t& nvFinal = data.nvFinal;
42  uint32_t& nvIntermediate = ws.nvIntermediate;
43 
44  uint8_t* __restrict__ izt = ws.izt;
45  int32_t* __restrict__ nn = data.ndof;
46  int32_t* __restrict__ iv = ws.iv;
47 
48  assert(pdata);
49  assert(zt);
50 
52  __shared__ Hist hist;
53  __shared__ typename Hist::Counter hws[32];
54  for (auto j = threadIdx.x; j < Hist::totbins(); j += blockDim.x) {
55  hist.off[j] = 0;
56  }
57  __syncthreads();
58 
59  if (verbose && 0 == threadIdx.x)
60  printf("booked hist with %d bins, size %d for %d tracks\n", hist.nbins(), hist.capacity(), nt);
61 
62  assert((int)nt <= hist.capacity());
63 
64  // fill hist (bin shall be wider than "eps")
65  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
67  int iz = int(zt[i] * 10.); // valid if eps<=0.1
68  // iz = std::clamp(iz, INT8_MIN, INT8_MAX); // sorry c++17 only
69  iz = std::min(std::max(iz, INT8_MIN), INT8_MAX);
70  izt[i] = iz - INT8_MIN;
71  assert(iz - INT8_MIN >= 0);
72  assert(iz - INT8_MIN < 256);
73  hist.count(izt[i]);
74  iv[i] = i;
75  nn[i] = 0;
76  }
77  __syncthreads();
78  if (threadIdx.x < 32)
79  hws[threadIdx.x] = 0; // used by prefix scan...
80  __syncthreads();
81  hist.finalize(hws);
82  __syncthreads();
83  assert(hist.size() == nt);
84  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
85  hist.fill(izt[i], uint16_t(i));
86  }
87  __syncthreads();
88 
89  // count neighbours
90  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
91  if (ezt2[i] > er2mx)
92  continue;
93  auto loop = [&](uint32_t j) {
94  if (i == j)
95  return;
96  auto dist = std::abs(zt[i] - zt[j]);
97  if (dist > eps)
98  return;
99  if (dist * dist > chi2max * (ezt2[i] + ezt2[j]))
100  return;
101  nn[i]++;
102  };
103 
104  cms::cuda::forEachInBins(hist, izt[i], 1, loop);
105  }
106 
107  __syncthreads();
108 
109  // find closest above me .... (we ignore the possibility of two j at same distance from i)
110  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
111  float mdist = eps;
112  auto loop = [&](uint32_t j) {
113  if (nn[j] < nn[i])
114  return;
115  if (nn[j] == nn[i] && zt[j] >= zt[i])
116  return; // if equal use natural order...
117  auto dist = std::abs(zt[i] - zt[j]);
118  if (dist > mdist)
119  return;
120  if (dist * dist > chi2max * (ezt2[i] + ezt2[j]))
121  return; // (break natural order???)
122  mdist = dist;
123  iv[i] = j; // assign to cluster (better be unique??)
124  };
125  cms::cuda::forEachInBins(hist, izt[i], 1, loop);
126  }
127 
128  __syncthreads();
129 
130 #ifdef GPU_DEBUG
131  // mini verification
132  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
133  if (iv[i] != int(i))
134  assert(iv[iv[i]] != int(i));
135  }
136  __syncthreads();
137 #endif
138 
139  // consolidate graph (percolate index of seed)
140  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
141  auto m = iv[i];
142  while (m != iv[m])
143  m = iv[m];
144  iv[i] = m;
145  }
146 
147 #ifdef GPU_DEBUG
148  __syncthreads();
149  // mini verification
150  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
151  if (iv[i] != int(i))
152  assert(iv[iv[i]] != int(i));
153  }
154 #endif
155 
156 #ifdef GPU_DEBUG
157  // and verify that we did not spit any cluster...
158  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
159  auto minJ = i;
160  auto mdist = eps;
161  auto loop = [&](uint32_t j) {
162  if (nn[j] < nn[i])
163  return;
164  if (nn[j] == nn[i] && zt[j] >= zt[i])
165  return; // if equal use natural order...
166  auto dist = std::abs(zt[i] - zt[j]);
167  if (dist > mdist)
168  return;
169  if (dist * dist > chi2max * (ezt2[i] + ezt2[j]))
170  return;
171  mdist = dist;
172  minJ = j;
173  };
174  cms::cuda::forEachInBins(hist, izt[i], 1, loop);
175  // should belong to the same cluster...
176  assert(iv[i] == iv[minJ]);
177  assert(nn[i] <= nn[iv[i]]);
178  }
179  __syncthreads();
180 #endif
181 
182  __shared__ unsigned int foundClusters;
183  foundClusters = 0;
184  __syncthreads();
185 
186  // find the number of different clusters, identified by a tracks with clus[i] == i and density larger than threshold;
187  // mark these tracks with a negative id.
188  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
189  if (iv[i] == int(i)) {
190  if (nn[i] >= minT) {
191  auto old = atomicInc(&foundClusters, 0xffffffff);
192  iv[i] = -(old + 1);
193  } else { // noise
194  iv[i] = -9998;
195  }
196  }
197  }
198  __syncthreads();
199 
201 
202  // propagate the negative id to all the tracks in the cluster.
203  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
204  if (iv[i] >= 0) {
205  // mark each track in a cluster with the same id as the first one
206  iv[i] = iv[iv[i]];
207  }
208  }
209  __syncthreads();
210 
211  // adjust the cluster id to be a positive value starting from 0
212  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
213  iv[i] = -iv[i] - 1;
214  }
215 
217 
218  if (verbose && 0 == threadIdx.x)
219  printf("found %d proto vertices\n", foundClusters);
220  }
const dim3 threadIdx
Definition: cudaCompat.h:29
int32_t *__restrict__ iv
WorkSpace int float eps
float const *__restrict__ ezt2
auto &__restrict__ data
float const *__restrict__ zt
const dim3 blockDim
Definition: cudaCompat.h:30
static constexpr uint32_t MAXVTX
Definition: ZVertexSoA.h:12
auto &__restrict__ ws
WorkSpace int float float float chi2max
static constexpr int verbose
T1 atomicInc(T1 *a, T2 b)
Definition: cudaCompat.h:48
printf("params %d %f %f %f\n", minT, eps, errmax, chi2max)
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
typename Base::Counter Counter
__shared__ Hist::Counter hws[32]
constexpr auto capacity() const
uint8_t *__restrict__ izt
T min(T a, T b)
Definition: MathUtil.h:58
WorkSpace int float float errmax
__shared__ Hist hist
static constexpr uint32_t nbins()
static constexpr uint32_t totbins()
int32_t *__restrict__ nn
static constexpr uint32_t MAXTRACKS
Definition: ZVertexSoA.h:11
__shared__ unsigned int foundClusters
gpuVertexFinder::__syncthreads ( )
inline
gpuVertexFinder::assert ( soa  )
gpuVertexFinder::assert ( nvFinal<=  nvIntermediate)
gpuVertexFinder::assert ( pdata  )
gpuVertexFinder::assert ( zt  )
gpuVertexFinder::assert ( (int) nt<=hist.capacity()  )
gpuVertexFinder::assert ( hist.  size() = =nt)
gpuVertexFinder::assert ( )
hist gpuVertexFinder::finalize ( hws  )
gpuVertexFinder::for ( int  idx = first)

Definition at line 29 of file gpuVertexFinder.cc.

References cms::cudacompat::atomicAdd(), data, fit, pixelTrack::highPurity, ZVertexSoA::idv, nHits, DiDispStaMuonMonitor_cfi::pt, pws, quality, and tracks.

29  {
30  auto nHits = tracks.nHits(idx);
31  if (nHits == 0)
32  break; // this is a guard: maybe we need to move to nTracks...
33 
34  // initialize soa...
35  soa->idv[idx] = -1;
36 
37  if (tracks.isTriplet(idx))
38  continue; // no triplets
40  continue;
41 
42  auto pt = tracks.pt(idx);
43 
44  if (pt < ptMin)
45  continue;
46 
47  auto& data = *pws;
48  auto it = atomicAdd(&data.ntrks, 1);
49  data.itrk[it] = idx;
50  data.zt[it] = tracks.zip(idx);
51  data.ezt2[it] = fit.covariance(idx)(14);
52  data.ptt2[it] = pt * pt;
53  }
uint32_t const *__restrict__ Quality * quality
constexpr float ptMin
auto const & tracks
cannot be loose
ZVertexSoA * soa
auto const & fit
caConstants::TupleMultiplicity const CAHitNtupletGeneratorKernelsGPU::HitToTuple const cms::cuda::AtomicPairCounter GPUCACell const *__restrict__ uint32_t const *__restrict__ gpuPixelDoublets::CellNeighborsVector const gpuPixelDoublets::CellTracksVector const GPUCACell::OuterHitOfCell const int32_t nHits
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:79
int16_t idv[MAXTRACKS]
Definition: ZVertexSoA.h:14
T1 atomicAdd(T1 *a, T2 b)
Definition: cudaCompat.h:61
gpuVertexFinder::for ( )

Definition at line 50 of file gpuClusterTracksDBSCAN.h.

References dqmiolumiharvest::j.

50  {
51  hist.off[j] = 0;
52  }
__shared__ Hist hist
gpuVertexFinder::if ( = = nvFinal)

Definition at line 53 of file gpuSortByPt2.h.

References cms::cudacompat::threadIdx.

53  {
54  if (threadIdx.x == 0)
55  sortInd[0] = 0;
56  return;
57  }
const dim3 threadIdx
Definition: cudaCompat.h:29
uint16_t *__restrict__ sortInd
Definition: gpuSortByPt2.h:27
pws gpuVertexFinder::init ( )
gpuVertexFinder::printf ( "params %d %f %f %f\n"  ,
minT  ,
eps  ,
errmax  ,
chi2max   
)

Referenced by gpuPixelRecHits::__attribute__(), __attribute__(), HcalRawToDigiGPU::acquire(), FWTTreeCache::AddBranch(), FWTTreeCache::AddBranchTopLevel(), FWTGeoRecoGeometryESProducer::addCaloTowerGeometry(), FWTGeoRecoGeometryESProducer::addEcalCaloGeometry(), FWTGeoRecoGeometryESProducer::addHcalCaloGeometryBarrel(), FWTGeoRecoGeometryESProducer::addHcalCaloGeometryEndcap(), FWTGeoRecoGeometryESProducer::addHcalCaloGeometryForward(), FWTGeoRecoGeometryESProducer::addHcalCaloGeometryOuter(), DeDxDiscriminatorLearner::algoAnalyzeTheTree(), SiStripGainFromCalibTree::algoAnalyzeTheTree(), SiStripGainFromData::algoBeginJob(), SiStripGainFromData::algoBeginRun(), SiStripGainsPCLHarvester::algoComputeMPVandGain(), SiStripGainFromCalibTree::algoComputeMPVandGain(), SiStripGainFromData::algoEndJob(), SiPixelDynamicInefficiencyReader::analyze(), l1t::GtInputDump::analyze(), EGEnergyAnalyzer::analyze(), EGammaCutBasedEleIdAnalyzer::analyze(), DummyEvelyser::analyze(), JanAlignmentAlgorithm::analyze(), ResidualRefitting::analyze(), FWGeometryTableManagerBase::applyTransparencyFromEditor(), TShapeAnalysis::assignChannel(), DummyEvelyser::beginJob(), DummyEvelyser::beginRun(), FWFFLooper::beginRun(), FWTTreeCache::BranchAccessCallIn(), FWPFCandidateDetailView::build(), CAHitNtupletGeneratorOnGPU::CAHitNtupletGeneratorOnGPU(), gpuCalibPixel::calibDigis(), FWOverlapTableManager::cellRenderer(), FWGeometryTableManager::cellRenderer(), L1TMuonBarrelKalmanAlgo::chain(), check_runcomplete(), FWGeometryTableManager::checkHierarchy(), FWGeometryTableManager::checkRegionOfInterest(), MuonIdTruthInfo::checkSimHitForBestMatch(), riemannFit::circleFit(), FWFileEntry::closeFile(), ResidualRefitting::CollectTrackHits(), hcal::reconstruction::compute_pulse_shape_value(), TFParams::copie_colonne_mat(), CordicXilinx::CordicXilinx(), TMatacq::countBadPulses(), riemannFit::cov_radtocart(), EcalFEtoDigi::create_TPSample(), EcalFEtoDigi::create_TTDetId(), mkfit::createPhase1TrackerGeometry(), ResidualRefitting::cylExtrapTrkSam(), HOTriggerPrimitiveDigi::data(), dbgPrintf(), LzmaFile::DecodeAll(), notcub::CachingDeviceAllocator::DeviceAllocate(), notcub::CachingDeviceAllocator::DeviceFree(), TFParams::diff_mat(), CSCValidation::doTimeMonitoring(), DataCertificationJetMET::dqmEndJob(), FWTTreeCache::DropBranch(), FWTTreeCache::DropBranchTopLevel(), DTCtcp::DTCtcp(), CSCComparatorData::dump(), ResidualRefitting::dumpMuonRecHits(), ResidualRefitting::dumpTrackExtrap(), ResidualRefitting::dumpTrackHits(), ResidualRefitting::dumpTrackRef(), CSCEfficiency::efficienciesPerChamber(), DummyEvelyser::endJob(), RPCNoise::endJob(), LogErrorEventFilter::endJob(), PixelLumiDQM::endLuminosityBlock(), DummyEvelyser::endRun(), L1TMuonBarrelKalmanAlgo::estimateChiSquare(), L1TMuonBarrelKalmanAlgo::estimateCompatibility(), EveService::EveService(), factorRPFromSensorCorrections(), riemannFit::fastFit(), JanAlignmentAlgorithm::feed(), fill_mat(), GenWeightsTableProducer::fillLHEWeightTables(), CSCEfficiency::fillRechitsSegments_info(), JetIDFailureFilter::filter(), BadGlobalMuonTagger::filter(), EcalDeadCellTriggerPrimitiveFilter::filter(), EcalDeadCellDeltaRFilter::filter(), CSCEfficiency::filter(), GenHFHadronMatcher::findInMothers(), StraightTrackAlignment::finish(), LocalTrackFitter::fit(), Fit_MaximumPoint(), LocalTrackFitter::fitAndRemoveOutliers(), TFParams::fitpj(), gpuClustering::for(), for(), gpuPixelDoublets::for(), notcub::CachingHostAllocator::FreeAllCached(), notcub::CachingDeviceAllocator::FreeAllCached(), FWFFHelper::FWFFHelper(), PPSFastLocalSimulation::GenerateTrack(), HistoManager::GetAHistogram(), HcalQLPlotHistoMgr::GetAHistogramImpl(), L1TMuonBarrelKalmanAlgo::getByCode(), HistoManager::getDetIdsForType(), HistoManager::getElecIdsForType(), FWTGeoRecoGeometryESProducer::GetMedium(), SiStripApvGainRescaler::getNewObject(), SiStripChannelGainFromDBMiscalibrator::getNewObject(), SiStripGainsPCLHarvester::getNewObject(), SiStripGainFromData::getNewObject(), SiStripGainFromCalibTree::getNewObject(), popcon::EcalTPGFineGrainEBIdMapHandler::getNewObjects(), popcon::EcalTPGFineGrainEBGroupHandler::getNewObjects(), FastLineRecognition::getOneLine(), FastLineRecognition::getPatterns(), GenWeightsTableProducer::globalBeginRun(), CmsShowNavigator::goTo(), Herwig6Hadronizer::hadronize(), HcalSiPMCharacteristicsGPU::HcalSiPMCharacteristicsGPU(), notcub::CachingHostAllocator::HostAllocate(), notcub::CachingHostAllocator::HostFree(), HOTPDigiTwinMux::HOTPDigiTwinMux(), HOTriggerPrimitiveDigi::HOTriggerPrimitiveDigi(), TPNFit::init(), Rivet::HiggsTemplateCrossSections::init(), Herwig6Hadronizer::initialize(), TFParams::inv3x3(), TSFit::inverms(), TFParams::inverse_mat(), L1TowerCalibrator::L1TowerCalibrator(), riemannFit::lineFit(), main(), ResidualRefitting::MatchTrackWithRecHits(), DTDriftTimeParametrization::MB_DT_delta_t(), DTTime2DriftParametrization::MB_DT_delta_x(), DTTime2DriftParametrization::MB_DT_drift_distance(), DTDriftTimeParametrization::MB_DT_drift_time(), riemannFit::min_eigen3D(), modulediff(), FWFileEntry::NewEventItemCallIn(), NuclearTrackCorrector::newTrajNeeded(), RootSig2XTReqHandler::Notify(), FWFileEntry::openFile(), CordicXilinx::operator()(), HcalTBObjectUnpacker::parseCalib(), TotemDAQMappingESSourceXML::ParseTreeDiamond(), CTPPSPixelDAQMappingESSourceXML::ParseTreePixel(), TotemDAQMappingESSourceXML::ParseTreeRP(), L1TMuonBarrelKalmanAlgo::phiAt2(), FWPFCandidateDetailView::plotEtChanged(), EveService::postBeginJob(), EveService::postEndJob(), FWFFLooper::postEndJob(), EveService::postEvent(), EveService::postGlobalBeginRun(), CSCChamberTimeCorrectionsValues::prefill(), CSCChipSpeedCorrectionDBConditions::prefillDBChipSpeedCorrection(), CSCGasGainCorrectionDBConditions::prefillDBGasGainCorrection(), FW3DViewDistanceMeasureTool::Print(), TFHeaderDescription::Print(), CDFRunInfo::print(), print(), AlignmentGeometry::print(), helper::ScannerBase::print(), SeedingNode< DATA >::print(), VFATFrame::Print(), GPUCACell::print_cell(), TFParams::print_mat(), TFParams::print_mat_nk(), conddb_version_mgr::print_table(), o2olib::print_table(), StraightTrackAlignment::printAlgorithmsLine(), L1TOccupancyClient::printDeadChannels(), FWTrackResidualDetailView::printDebug(), EgammaCutBasedEleId::PrintDebug(), EffectiveAreas::printEffectiveAreas(), ZElectronsSelector::printEffectiveAreas(), TotemRPSD::printHitInfo(), PPSDiamondSD::printHitInfo(), printId(), riemannFit::printIt(), TMatacq::printitermatacqData(), StraightTrackAlignment::printLineSeparator(), TMatacq::printmatacqData(), StraightTrackAlignment::printN(), StraightTrackAlignment::printQuantitiesLine(), FWGeoTopNode::printSelected(), TShapeAnalysis::printshapeData(), bitset_utilities::printWords(), L1TMuonBarrelKalmanRegionModule::process(), L1TMuonBarrelKalmanTrackFinder::process(), StraightTrackAlignment::processEvent(), TotemTriggerRawToDigi::ProcessLoneGFrame(), TRootXTReq::ProcessQueue(), HcalRawToDigiGPU::produce(), L1TMuonBarrelKalmanStubProducer::produce(), SiPixelRecHitSoAFromLegacy::produce(), L1TowerCalibrator::produce(), NuclearTrackCorrector::produce(), PPSFastLocalSimulation::produce(), TFParams::produit_mat(), TFParams::produit_mat_int(), L1TMuonBarrelKalmanAlgo::propagate(), TShapeAnalysis::putAllVals(), TMatacq::rawPulseAnalysis(), EcalFEtoDigi::readInput(), Herwig6Hadronizer::readSettings(), QcdLowPtDQM::reallyPrint(), DTCtcp::Receive(), CSCEfficiency::recHitSegment_Efficiencies(), FW3DViewDistanceMeasureTool::refCurrentVertex(), ElectronEnergyRegressionEvaluate::regressionUncertaintyNoTrkVar(), ElectronEnergyRegressionEvaluate::regressionUncertaintyNoTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithSubClusters(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVar(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVarV2(), ElectronEnergyRegressionEvaluate::regressionValueNoTrkVar(), ElectronEnergyRegressionEvaluate::regressionValueNoTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionValueWithSubClusters(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVar(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVarV2(), LocalTrackFitter::removeInsufficientPots(), FWFileEntry::RemovingEventItemCallIn(), FWPFCandidateDetailView::rnrHcalChanged(), FWTriggerTableView::saveImageTo(), FWTableView::saveImageTo(), FWTEveViewer::SavePng(), fwlite::Scanner< Collection >::scan(), TFParams::set_const(), HIPAlignmentAlgorithm::setAlignmentPositionError(), FW3DViewBase::setCurrentDMTVertex(), L1MuKBMTrack::setKalmanGain(), L1TOccupancyClientHistogramService::setMaskedBins(), notcub::CachingHostAllocator::SetMaxCachedBytes(), notcub::CachingDeviceAllocator::SetMaxCachedBytes(), EveService::slotExit(), JanAlignmentAlgorithm::solve(), TFParams::somme_mat_int(), HepMCFilterDriver::statistics(), SiStripGainFromCalibTree::storeOnTree(), CSCEfficiency::stripWire_Efficiencies(), ResidualRefitting::trkExtrap(), HcalUnpacker::unpackUTCA(), spu::Untar(), FWGeometryTableManager::updateFilter(), L1TMuonBarrelKalmanAlgo::updateLUT(), L1TMuonBarrelKalmanAlgo::updateOffline(), L1TMuonBarrelKalmanAlgo::updateOffline1D(), L1TMuonBarrelKalmanAlgo::vertexConstraintLUT(), L1TMuonBarrelKalmanAlgo::vertexConstraintOffline(), l1tpf_impl::COEFile::writeTracksToFile(), ResidualRefitting::zero_storage(), DTCtcp::~DTCtcp(), and EveService::~EveService().

gpuVertexFinder::printf ( "booked hist with %d  bins,
size%d for%d tracks\n"  ,
hist.  nbins(),
hist.  capacity(),
nt   
)
wv* [i] gpuVertexFinder::printf ( "found %d proto clusters "  ,
foundClusters   
)
gpuVertexFinder::printf ( "and %d noise\n"  ,
noise   
)
gpuVertexFinder::printf ( "found %d proto vertices\n"  ,
foundClusters   
)
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, mps_fire::i, dqmiolumiharvest::j, isotrackApplyRegressor::k, heppy_loop::loop, visualization-live-secondInstance_cfg::m, min(), nloops, nt, AlCaHLTBitMon_ParallelJobs::p, and cms::cudacompat::threadIdx.

Referenced by ThreeThresholdAlgorithm::addToCandidate(), EcalSimParametersFromDD::build(), commentSkipper.buildFileCommentSkipper::filterMultilineComment(), dqm_interfaces.DQMcommunicator::get_runs_list(), and histoStyle::savePlots().

109  {
110  if (1 == nloops % 2) {
111  for (auto i = threadIdx.x; i < nt; i += blockDim.x) {
112  auto m = iv[i];
113  while (m != iv[m])
114  m = iv[m];
115  iv[i] = m;
116  }
117  } else {
118  more = false;
119  for (auto k = threadIdx.x; k < hist.size(); k += blockDim.x) {
120  auto p = hist.begin() + k;
121  auto i = (*p);
122  auto be = std::min(Hist::bin(izt[i]) + 1, int(hist.nbins() - 1));
123  if (nn[i] < minT)
124  continue; // DBSCAN core rule
125  auto loop = [&](uint32_t j) {
126  assert(i != j);
127  if (nn[j] < minT)
128  return; // DBSCAN core rule
129  auto dist = std::abs(zt[i] - zt[j]);
130  if (dist > eps)
131  return;
132  if (dist * dist > chi2max * (ezt2[i] + ezt2[j]))
133  return;
134  auto old = atomicMin(&iv[j], iv[i]);
135  if (old != iv[i]) {
136  // end the loop only if no changes were applied
137  more = true;
138  }
139  atomicMin(&iv[i], old);
140  };
141  ++p;
142  for (; p < hist.end(be); ++p)
143  loop(*p);
144  } // for i
145  }
146  if (threadIdx.x == 0)
147  ++nloops;
148  } // while
const dim3 threadIdx
Definition: cudaCompat.h:29
int32_t *__restrict__ iv
WorkSpace int float eps
float const *__restrict__ ezt2
float const *__restrict__ zt
const dim3 blockDim
Definition: cudaCompat.h:30
assert(be >=bs)
WorkSpace int float float float chi2max
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
uint8_t *__restrict__ izt
T min(T a, T b)
Definition: MathUtil.h:58
int nt
Definition: AMPTWrapper.h:42
__shared__ Hist hist
static constexpr uint32_t nbins()
int32_t *__restrict__ nn
T1 atomicMin(T1 *a, T2 b)
Definition: cudaCompat.h:85

Variable Documentation

float const *__restrict__ gpuVertexFinder::chi2 = data.chi2

Definition at line 28 of file gpuFitVertices.h.

WorkSpace float gpuVertexFinder::chi2Max
WorkSpace int float float float gpuVertexFinder::chi2max
Initial value:
{
constexpr bool verbose = false
static constexpr int verbose

Definition at line 23 of file gpuClusterTracksDBSCAN.h.

Referenced by DTSegmentExtendedCand::good().

auto &__restrict__ gpuVertexFinder::data = *pdata

Definition at line 31 of file gpuClusterTracksDBSCAN.h.

Referenced by __attribute__(), and for().

WorkSpace int float gpuVertexFinder::eps
auto gpuVertexFinder::er2mx = errmax * errmax

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__().

auto gpuVertexFinder::first = blockIdx.x * blockDim.x + threadIdx.x

Definition at line 28 of file gpuVertexFinder.cc.

auto const& gpuVertexFinder::fit = tracks.stateAtBS
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(), APVCyclePhaseMonitor::beginRun(), Book::book(), HLTDQMFilterEffHists< ObjType >::book1D(), HLTDQMFilterEffHists< ObjType >::book2D(), GEMBaseValidation::bookDetectorOccupancy(), L1TStage2EMTF::bookHistograms(), GEMEffByGEMCSCSegmentSource::bookNumerator1D(), GEMEfficiencyAnalyzer::bookNumerator1D(), GEMEfficiencyAnalyzer::bookNumerator2D(), GEMBaseValidation::bookPIDHist(), GEMBaseValidation::bookZROccupancy(), TrackerG4SimHitNumberingScheme::buildAll(), ClusMultInvestPlots(), Combined2DHisto(), CombinedHisto(), GEMEfficiencyHarvester::doResolution(), fwlite::Scanner< Collection >::draw(), fwlite::Scanner< Collection >::draw2D(), fwlite::Scanner< Collection >::drawProf(), L1TEMTFEventInfoClient::dumpContentMonitorElements(), L1TEventInfoClient::dumpContentMonitorElements(), EcalPedHists::endJob(), EcalURecHitHists::endJob(), EcalCosmicsHists::endJob(), DQMHistNormalizer::endRun(), l1tVertexFinder::VertexFinder::fastHisto(), ExpressionHisto< T >::fill(), TrigObjTnPHistColl::HistColl::fill(), GEMDQMBase::MEMapInfT< M, K >::Fill(), GEMDQMBase::MEMapInfT< M, K >::FillBits(), HLTDQMFilterEffHists< ObjType >::fillHists(), edm::Principal::fillPrincipal(), Rivet::HiggsTemplateCrossSections::finalize(), EgHLTOfflineSummaryClient::getEgHLTSumHist_(), MuonGEMBaseHarvestor::getElement(), fwlite::Scanner< Collection >::getSameH1(), fwlite::Scanner< Collection >::getSameH2(), fwlite::Scanner< Collection >::getSameProf(), SiStripSummaryCreator::getSummaryME(), 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(), RPCGeometryValidate::makeHistogram(), GEMGeometryValidate::makeHistogram(), ME0GeometryValidate::makeHistogram(), CSCGeometryValidate::makeHistogram(), ValidateGeometry::makeHistogram(), SiStripSpyDisplayModule::MakeProcessedRawDigiHist_(), SiStripSpyDisplayModule::MakeRawDigiHist_(), DDExpandedView::mergedSpecificsV(), DQMGenericClient::normalizeToEntries(), DQMRivetClient::normalizeToIntegral(), DQMRivetClient::normalizeToLumi(), CSCAlignmentCorrections::plot(), MuonResidualsFitter::plotsimple(), MuonResidualsFitter::plotweighted(), EcalPedHists::readEBdigis(), EcalPedHists::readEEdigis(), edm::OneLumiPoolSource::readLuminosityBlockAuxiliary_(), PatternOptimizerBase::savePatternsInRoot(), DQMRivetClient::scaleByFactor(), DDExpandedView::specificsV(), tfwliteselectortest::ThingsTSelector::terminate(), tfwliteselectortest::ThingsTSelector2::terminate(), __class__< T >::terminate(), sistrip::EnsembleCalibrationLA::write_ensembles_plots(), sistrip::MeasureLA::write_report_plots(), and sistrip::EnsembleCalibrationLA::write_samples_plots().

__shared__ Hist::Counter gpuVertexFinder::hws = 0

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(), reco::IsoDeposit::algoWithin(), SiPixelPhase1MonitorVertexSoA::analyze(), HcalRecHitsAnalyzer::analyze(), IsoTrig::analyze(), PrimaryVertexAnalyzer4PUSlimmed::analyze(), IsolatedTracksNxN::analyze(), Primary4DVertexValidation::analyze(), XtalDedxAnalysis::analyzeHits(), HGCalTimingAnalyzer::analyzeSimTracks(), HGCalTBAnalyzer::analyzeSimTracks(), gen::PhotosInterface::apply(), HLTMuonDimuonL3Filter::applyDiMuonSelection(), magneticfield::MagGeoBuilder::build(), MagGeoBuilderFromDDD::build(), PFPileUpAlgo::chargedHadronVertex(), PrimaryVertexAssignment::chargedHadronVertex(), PFIsolationEstimator::chargedHadronVertex(), IsoTrig::chgIsolation(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), SeedMvaEstimator::computeMva(), gen::TauolappInterface::decay(), reco::IsoDeposit::depositAndCountWithin(), SiPixelActionExecutor::fillFEDErrorSummary(), SiPixelActionExecutor::fillGrandBarrelSummaryHistos(), SiPixelActionExecutor::fillGrandEndcapSummaryHistos(), GsfTrackProducerBase::fillMode(), SiPixelActionExecutor::fillSummary(), TrackingFailureFilter::filter(), PythiaDauVFilter::filter(), PythiaAllDauVFilter::filter(), PythiaDauVFilterMatchID::filter(), FFTJetPFPileupCleaner::findSomeVertexWFakes(), DivisiveVertexFinder::findVertexesAlt(), CaloTowerGeometry::getSummary(), CaloSubdetectorGeometry::getSummary(), HcalGeometry::getSummary(), HGCalTypes::getUnpackedV(), edm::OneToMany< std::vector< Trajectory >, std::vector< TrajectorySeed >, unsigned int >::insert(), edm::OneToOneGeneric< std::vector< TrackCandidate >, std::vector< Trajectory >, unsigned int >::insert(), edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double >::insert(), 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(), HGCalMixLayer::positionMix(), DDHGCalEEAlgo::positionSensitive(), DDHGCalEEFileAlgo::positionSensitive(), DDHGCalSiliconModule::positionSensitive(), DDHGCalHEAlgo::positionSensitive(), DDHGCalHEFileAlgo::positionSensitive(), HGCalEEFileAlgo::positionSensitive(), HGCalSiliconModule::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(), HitParentTest::validSimTrack(), spr::validSimTrack(), ConfigurableTrimmedVertexFinder::vertexCandidates(), HGCalWaferIndex::waferV(), and ZdcNumberingScheme::ZdcNumberingScheme().

uint8_t *__restrict__ gpuVertexFinder::izt = ws.izt
WorkSpace float gpuVertexFinder::maxChi2
Initial value:
{
constexpr bool verbose = false
static constexpr int verbose

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
bool gpuVertexFinder::more = true
gpuVertexFinder::nloops = 0

Definition at line 102 of file gpuClusterTracksIterative.h.

Referenced by while().

int32_t const *__restrict__ gpuVertexFinder::nn = data.ndof
gpuVertexFinder::noise = 0

Definition at line 50 of file gpuFitVertices.h.

Referenced by Phase2TrackerDigitizerAlgorithm::add_noise(), SiPixelDigitizerAlgorithm::add_noise(), GaussNoiseFP420::addNoise(), RPGaussianTailNoiseAdder::addNoise(), HcalAmplifier::addPedestals(), CastorAmplifier::amplify(), SiStripNoisesBuilder::analyze(), SiStripNoiseNormalizedWithApvGainBuilder::analyze(), SiStripMonitorCluster::analyze(), SiStripNoisesFromDBMiscalibrator::analyze(), DTnoiseDBValidation::beginRun(), SiStripAPVRestorer::cleaner_LocalMinimumAdder(), SiStripMonitorTrack::clusterInfos(), TShapeAnalysis::computeShape(), HPDIonFeedbackSim::correctPE(), PulseFitWithShape::doFit(), DTNoiseAnalysisTest::dqmEndLuminosityBlock(), DaqScopeModeSummaryFactory::extract(), NoiseSummaryFactory::extract(), PedestalsSummaryFactory::extract(), PedsOnlySummaryFactory::extract(), PedsFullNoiseSummaryFactory::extract(), popcon::SiStripPopConHandlerUnitTest< T >::fillObject(), popcon::SiStripPopConHandlerUnitTestNoise< T >::fillObject(), SiStripFedZeroSuppression::fillThresholds_(), SiStripDigitizer::finalizeEvent(), LASPeakFinder::FindPeakIn(), GaussNoiseProducerFP420::generate(), GaussianTailNoiseGenerator::generate(), HPDIonFeedbackSim::getIonFeedback(), SiStripNoisesFromDBMiscalibrator::getNewObject(), SiStripNoisesFromDBMiscalibrator::getNewObject_withDefaults(), HFNoisyHitsFilter::getNoiseBits(), HGCalVFESummationImpl::HGCalVFESummationImpl(), SiStripNoiseBuilderFromDb::makeNoise(), muonisolation::CaloExtractor::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseEcal(), muonisolation::CaloExtractor::noiseHcal(), muonisolation::CaloExtractorByAssociator::noiseHcal(), muonisolation::CaloExtractorByAssociator::noiseHOcal(), muonisolation::CaloExtractorByAssociator::noiseRecHit(), HcalDeterministicFit::phase1Apply(), RPCPerformanceESSource::produce(), SiStripNoiseESSource::produce(), ShallowClustersProducer::produce(), SiStripNoisesFakeESSource::produce(), SiStripFineDelayHit::produceNoTracking(), PreMixingSiStripWorker::put(), ZdcSimpleRecAlgoImpl::reco2(), FP420ClusterMain::run(), HGCDigitizerBase::runSimple(), HGCalSciNoiseMap::scaleByDose(), TShapeAnalysis::set_const(), ClusterNoiseFP420::ElectrodData::setData(), DeDxTools::shapeSelection(), sistrip::FEDEmulator::subtractPedestals(), PedestalsTask::update(), DaqScopeModeTask::update(), ApvAnalysis::updateCalibration(), and ZeroSuppressFP420::ZeroSuppressFP420().

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 gpuVertexFinder::ptMin
Initial value:
{
uint32_t const *__restrict__ TkSoA const *__restrict__ ptracks
assert(be >=bs)

Definition at line 21 of file gpuVertexFinder.cc.

Referenced by 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
Initial value:
{
auto& __restrict__ data = *pdata
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:79

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().

gpuVertexFinder::return

Definition at line 33 of file gpuSortByPt2.h.

Referenced by AlCaElectronsTest::analyze(), AlCaElectronsTest::beginJob(), EPOS::EPOS_Wrapper::byte_num_to_double(), EPOS::EPOS_Wrapper::byte_num_to_int(), g4TestGeometry_cfi::checkOverlap(), CustomConfigs::CTPPSRun2Geometry(), SingleMuPt10::customise(), SingleNuE10::customise(), IgProfInfo::customise(), TimeMemoryG4Info::customise(), TimeMemoryInfo::customise(), TimeMemorySummary::customise(), customiseg4PrintGeomInfo::customise(), customise_RPCgeom37X::customise(), DataMixer_DataConditions_3_8_X_data2010::customise(), SimTrackProducerForFullSim_cff::customise(), ECALHCAL::customise(), HCAL::customise(), noAbortPDGid_custom::customise(), useSource_custom::customise(), SimCalorimetry_EcalSelectiveReadoutProducers_setBeamcom09_cff::customise(), SimCalorimetry_setPreshowerHighGain_cff::customise(), SimCalorimetry_setPreshowerLowGain_cff::customise(), DigiToRecoPU::customise(), online_customizations_cfi::customise(), APDSimu_cff::customise(), ProcessFromBareGEN_cff::customise(), cpuBenchmark_cff::customise(), Pomwig_custom::customise(), customiseExotica_cff::customise(), NeutronBGforMuonsHP_cff::customise(), NeutronBGforMuonsXS_cff::customise(), customise::customise(), SimWithCastor_cff::customise(), SimWithoutCastor_cff::customise(), DigiToRecoNoPU::customise(), SimTrackProducerForFastSim_cff::customise(), SimTracker_SetDeconv_cff::customise(), SimTracker_SetPeak_cff::customise(), customise_stdgeom::customise(), NoHcalZeroSuppression_cff::customise(), HBHE_ZSrevert_2TS_cff::customise_2TS(), HBHE_revert_8TS_cff::customise_8TS(), reproc2011_2012_cff::customiseG4(), TimeMemoryJobReport::customiseWithTimeMemoryJobReport(), AlCaElectronsTest::endJob(), AlCaElectronsTest::fillAroundBarrel(), AlCaElectronsTest::fillAroundEndcap(), customiseHBHEreco::hbheUseM0FullRangePhase1(), cms::DDFilteredView::history(), CustomConfigs::HLTDropPrevious(), CustomConfigs::L1T(), CustomConfigs::L1THLT(), MassReplace::massReplaceInputTag(), MassReplace::massReplaceParameter(), NeutronBGforMuons_cff::neutronBG(), IteratedMedianCMNSubtractor::pairMedian(), g4PrintGeomInfo_cfi::printGeomInfo(), g4PrintGeomSummary_cfi::printGeomSummary(), CustomConfigs::ProcessName(), fullMixCustomize_cff::setCrossingFrameOn(), TrackerTopology::tecGlued(), TB2006Analysis_cfi::testbeam2006(), TrackerTopology::tibGlued(), TrackerTopology::tidGlued(), TrackerTopology::tobGlued(), timeUnitHelper::unpack(), getBeamSpotDB::unpack(), CommonMethods::unpack(), beamvalidation::unpack(), and cms::DDNamespace::vecFloat().

ZVertexSoA* gpuVertexFinder::soa
gpuVertexFinder::sortInd[i] = data.sortInd

Definition at line 27 of file gpuSortByPt2.h.

auto const& gpuVertexFinder::tracks = *ptracks

Definition at line 24 of file gpuVertexFinder.cc.

Referenced by for().

auto &__restrict__ gpuVertexFinder::ws = *pws
float *__restrict__ gpuVertexFinder::wv = data.wv
float const *__restrict__ gpuVertexFinder::zt = ws.zt
float *__restrict__ gpuVertexFinder::zv = data.zv