Typedefs | |
template<typename TrackerTraits > | |
using | CAParams = caHitNtupletGenerator::CAParamsT< TrackerTraits > |
using | Cell = GPUCACellT< TrackerTraits > |
template<typename TrackerTraits > | |
using | CellNeighborsVector = caStructures::CellNeighborsVectorT< TrackerTraits > |
template<typename TrackerTraits > | |
using | CellTracksVector = caStructures::CellTracksVectorT< TrackerTraits > |
using | Counters = caHitNtupletGenerator::Counters |
template<typename TrackerTraits > | |
using | HitContainer = typename TrackSoA< TrackerTraits >::HitContainer |
template<typename TrackerTraits > | |
using | HitsConstView = typename GPUCACellT< TrackerTraits >::HitsConstView |
template<typename TrackerTraits > | |
using | HitToTuple = caStructures::HitToTupleT< TrackerTraits > |
template<typename TrackerTraits > | |
using | OuterHitOfCell = caStructures::OuterHitOfCellT< TrackerTraits > |
using | Quality = pixelTrack::Quality |
template<typename TrackerTraits > | |
using | QualityCuts = pixelTrack::QualityCutsT< TrackerTraits > |
template<typename TrackerTraits > | |
using | TkSoAView = TrackSoAView< TrackerTraits > |
template<typename TrackerTraits > | |
using | TupleMultiplicity = caStructures::TupleMultiplicityT< TrackerTraits > |
Functions | |
template<typename TrackerTraits > | |
__attribute__ ((always_inline)) void kernel_classifyTracks(TkSoAView< TrackerTraits > tracks_view | |
TODO : why there was quality here? More... | |
assert (nCells) | |
cannot be loose More... | |
for (int idx=first, nt=(*nCells);idx< nt;idx+=gridDim.x *blockDim.x) | |
if (0==first) = ntracks | |
Variables | |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter * | apc |
auto & | c = *counters |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ CellNeighborsVector< TrackerTraits > const * | cellNeighbors |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ | cells |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ CellNeighborsVector< TrackerTraits > const CellTracksVector< TrackerTraits > const * | cellTracks |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ CellNeighborsVector< TrackerTraits > const CellTracksVector< TrackerTraits > const OuterHitOfCell< TrackerTraits > const int32_t uint32_t Counters * | counters |
QualityCuts< TrackerTraits > | cuts |
uint32_t const *__restrict__ TkSoAView< TrackerTraits > bool | dupPassThrough |
auto | first = threadIdx.x + blockIdx.x * blockDim.x |
TkSoAView< TrackerTraits > HitToTuple< TrackerTraits > const *__restrict__ int32_t | firstPrint |
auto const & | foundNtuplets = *ptuples |
auto const | good = pixelTrack::Quality::strict |
min quality of good More... | |
HitsConstView< TrackerTraits > | hh |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const * | hitToTuple |
TkSoAView< TrackerTraits > HitToTuple< TrackerTraits > const *__restrict__ int32_t int32_t int | iev |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ CellNeighborsVector< TrackerTraits > const CellTracksVector< TrackerTraits > const OuterHitOfCell< TrackerTraits > const | isOuterHitOfCell |
int | l1end = hh.hitsLayerStart()[1] |
TkSoAView< TrackerTraits > HitToTuple< TrackerTraits > const *__restrict__ int32_t int32_t | lastPrint |
auto const | longTqual = pixelTrack::Quality::highPurity |
constexpr auto | loose = pixelTrack::Quality::loose |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ CellNeighborsVector< TrackerTraits > const CellTracksVector< TrackerTraits > const OuterHitOfCell< TrackerTraits > const int32_t uint32_t | maxNumberOfDoublets |
constexpr float | maxScore = std::numeric_limits<float>::max() |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ | nCells |
TupleMultiplicity< TrackerTraits > const HitToTuple< TrackerTraits > const cms::cuda::AtomicPairCounter GPUCACellT< TrackerTraits > const *__restrict__ uint32_t const *__restrict__ CellNeighborsVector< TrackerTraits > const CellTracksVector< TrackerTraits > const OuterHitOfCell< TrackerTraits > const int32_t | nHits |
auto | nhits = hh.nHits() |
uint16_t | nmin |
constexpr float | nSigma2 = 25.f |
auto | ntracks = std::min<int>(apc->get().m, tracks_view.metadata().size() - 1) |
TkSoAView< TrackerTraits > GPUCACellT< TrackerTraits > *__restrict__ uint32_t const CellTracksVector< TrackerTraits > cms::cuda::AtomicPairCounter CAParams< TrackerTraits > | params |
HitContainer< TrackerTraits > const *__restrict__ Quality const *__restrict__ HitToTuple< TrackerTraits > const *__restrict__ | phitToTuple |
HitContainer< TrackerTraits > const *__restrict__ | ptuples |
HitContainer< TrackerTraits > const *__restrict__ Quality const *__restrict__ | quality |
auto const | reject = dupPassThrough ? loose : dup |
constexpr uint32_t | tkNotFound = std::numeric_limits<uint16_t>::max() |
uint32_t const *__restrict__ TkSoAView< TrackerTraits > | tracks_view |
TupleMultiplicity< TrackerTraits > const * | tupleMultiplicity |
HitContainer< TrackerTraits > const *__restrict__ | tuples |
using caHitNtupletGeneratorKernels::CAParams = typedef caHitNtupletGenerator::CAParamsT<TrackerTraits> |
Definition at line 65 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::Cell = typedef GPUCACellT<TrackerTraits> |
Definition at line 429 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::CellNeighborsVector = typedef caStructures::CellNeighborsVectorT<TrackerTraits> |
Definition at line 42 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::CellTracksVector = typedef caStructures::CellTracksVectorT<TrackerTraits> |
Definition at line 45 of file CAHitNtupletGeneratorKernelsImpl.h.
Definition at line 67 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::HitContainer = typedef typename TrackSoA<TrackerTraits>::HitContainer |
Definition at line 56 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::HitsConstView = typedef typename GPUCACellT<TrackerTraits>::HitsConstView |
Definition at line 59 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::HitToTuple = typedef caStructures::HitToTupleT<TrackerTraits> |
Definition at line 36 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::OuterHitOfCell = typedef caStructures::OuterHitOfCellT<TrackerTraits> |
Definition at line 48 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::Quality = typedef pixelTrack::Quality |
Definition at line 50 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::QualityCuts = typedef pixelTrack::QualityCutsT<TrackerTraits> |
Definition at line 62 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::TkSoAView = typedef TrackSoAView<TrackerTraits> |
Definition at line 53 of file CAHitNtupletGeneratorKernelsImpl.h.
using caHitNtupletGeneratorKernels::TupleMultiplicity = typedef caStructures::TupleMultiplicityT<TrackerTraits> |
Definition at line 39 of file CAHitNtupletGeneratorKernelsImpl.h.
|
inline |
TODO : why there was quality here?
Definition at line 310 of file CAHitNtupletGeneratorKernelsImpl.h.
References cms::cudacompat::__ldg(), cms::cudacompat::blockDim, cms::cudacompat::blockIdx, cellNeighbors, cells, first, cms::cudacompat::gridDim, hh, heavyIonCSV_trainingSettings::idx, PixelPluginsPhase0_cfi::isBarrel, isOuterHitOfCell, dqmiolumiharvest::j, GPUCACellT< TrackerTraits >::kUsed, nCells, nt, params, gpuPixelDoublets::stride, and cms::cudacompat::threadIdx.
caHitNtupletGeneratorKernels::assert | ( | nCells | ) |
cannot be loose
caHitNtupletGeneratorKernels::for | ( | int | idx = first | ) |
Definition at line 147 of file CAHitNtupletGeneratorKernelsImpl.h.
References cms::cudacompat::atomicAdd(), c, cells, hitToTuple, and heavyIonCSV_trainingSettings::idx.
Definition at line 86 of file CAHitNtupletGeneratorKernelsImpl.h.
References apc, cms::cudacompat::atomicAdd(), c, cms::cuda::AtomicPairCounter::get(), nCells, nHits, and tupleMultiplicity.
Referenced by VIDSelectorBase.VIDSelectorBase::__call__(), Mixins._TypedParameterizable::__findDefaultsFor(), RPCLinkSynchroStat::add(), vid_id_tools::addVIDSelectionToPATProducer(), EcalMatacqAnalyzer::analyze(), SiPhase2BadStripChannelReader::analyze(), CSCAFEBConnectAnalysis::analyze(), BTagPerformanceAnalyzerMC::analyze(), HGCGeometryValidation::analyze(), CTPPSProtonReconstructionEfficiencyEstimatorMC::analyze(), HLTrigReport::analyze(), reco::PFDisplacedVertexCandidate::associatedElements(), reco::PFBlock::associatedElements(), OMTFProcessor< GoldenPatternType >::averagePatterns(), HistogramManager::book(), HLTObjectMonitorProtonLead::bookHistograms(), HLTObjectMonitor::bookHistograms(), CosmicMuonTrajectoryBuilder::build(), magneticfield::MagGeoBuilder::buildInterpolator(), ticl::PatternRecognitionbyCLUE3D< TILES >::calculateLocalDensity(), batchmanager.BatchManager::CheckBatchScript(), CondDBESSource::CondDBESSource(), CaloTowersCreationAlgo::convert(), popcon::EcalChannelStatusHandler::cosmicsAnalysis(), DeadROCCounter_Phase1::countBadROCBarrel(), DeadROCCounter_Phase1::countBadROCForward(), python.cmstools::createBranchBuffer(), FWEveDigitSetScalableMarkerGL::DirectDraw(), getPayloadData::discover_plugins(), evf::FastMonitoringService::doSnapshot(), SiPixelLorentzAnglePCLHarvester::dqmEndJob(), SiPixelStatusHarvester::dqmEndRun(), getInfo::dumpIDs(), getInfo::dumpSNs(), EMap::EMap(), hcaldqm::DigiRunSummary::endJob(), ElectronCalibration::endJob(), OccupancyPlots::endRun(), l1t::CorrCondition::evaluateCondition(), l1t::CorrWithOverlapRemovalCondition::evaluateCondition(), trklet::TripletEngine::execute(), runMETCorrectionsAndUncertainties.RunMETCorrectionsAndUncertainties::extractMET(), ecaldqm::fetchAndFill(), dqm::impl::MonitorElement::Fill(), OMTFProcessor< GoldenPatternType >::fillCounts(), FWECALCaloDataDetailViewBuilder::fillData(), NtupleManager::FillFitParameters(), TrackerValidationVariables::fillHitQuantities(), reco::HcalNoiseInfoProducer::fillOtherSummaryVariables(), DTTimingExtractor::fillTiming(), TrackingQualityChecker::fillTrackingStatus(), LogErrorEventFilter::filter(), batchHippy.MyBatchManager::finalize(), ElectronMCTruthFinder::find(), PhotonMCTruthFinder::find(), sistrip::SpyUtilities::findAPVErrorBits(), ContainmentCorrectionAnalyzer::findMcTruth(), plotBaryCentre_VS_BeamSpot::findRunIndex(), GEMVFATStatus::GEMVFATStatus(), genlkupmap(), gen::HydjetHadronizer::get_particles(), python.Lumis::getByLabel(), python.Runs::getByLabel(), python.Events::getByLabel(), compareTotals::getCanvasMainPad(), HcalLutManager::getCompressionLutXmlFromAsciiMaster(), HcalLutManager::getCompressionLutXmlFromCoder(), EcalElectronicsMapper::getDCCId(), HistoManager::getDetIdsForType(), G2GainsValidator::getExpressGT(), HcalLutManager::getHEFineGrainLUTs(), HcalObjRepresent::HcalDataContainer< Items, Item >::getItemFromValCont(), HcalLutManager::getLinearizationLutXmlFromAsciiMasterEmap(), HcalLutManager::getLinearizationLutXmlFromCoder(), HcalLutManager::getLinearizationLutXmlFromCoderEmap(), HcalLutManager::getLutXmlFromAsciiMaster(), MT2Analyzer.MT2Analyzer::getMT2Hemi(), popcon::EcalPulseShapesHandler::getNewObjects(), DTKeyedConfigHandler::getNewObjects(), FastLineRecognition::getOneLine(), OMTFinput::getRefHits(), CSCOfflineMonitor::getSignal(), HcalLutManager::getZdcLutXml(), FWGUIEventFilter::HandleKey(), VIDSelectorBase.VIDSelectorBase::initialize(), SiPixelFedCablingMap::initializeRocs(), SiPixelTemplate::interpolate(), helpers::jetCollectionString(), getInfo::listRuns(), LoadEPDB::LoadEPDB(), HGCalGeomParameters::loadGeometryHexagon8(), HGCalGeomParameters::loadGeometryHexagonModule(), LzmaDec_DecodeToDic(), run_AlCaRecoTriggerBitsUpdateWorkflow::main(), checkRuns::main(), checkPayloads::main(), MultipleCompare::main(), BeamSpotWorkflow::main(), objects.IsoTrackAnalyzer.IsoTrackAnalyzer::makeIsoTrack(), FastTrackerRecHitMaskProducer_cfi::maskProducerFromClusterRemover(), batchHippy.MyBatchManager::mkdir(), batchmanager.BatchManager::mkdir(), GenSpecificAlgo::mkSpecificGenMETData(), MSLayersKeeperX0DetLayer::MSLayersKeeperX0DetLayer(), HGCalDDDConstants::numberCellsHexagon(), DQMNet::onMessage(), CheckHitPattern::operator()(), omtf::operator<<(), operator<<(), hitfit::operator<<(), l1t::TriggerMenuParser::parseCorrelation(), l1t::TriggerMenuParser::parseCorrelationThreeBody(), l1t::TriggerMenuParser::parseCorrelationWithOverlapRemoval(), bigModule::plot(), subModule::plot(), plotBaryCentre_VS_BeamSpot::plotbarycenter(), TritonService::preBeginJob(), MatrixInjector.MatrixInjector::prepare(), cms::DDFilteredView::printFilter(), studyJets::printJetProperties(), AlCaHLTBitMon_QueryRunRegistry::printLumi(), TTUSectorORLogic::process(), PPSAlignmentWorker::SectorData::process(), DDLSpecPar::processElement(), OMTFProcessor< GoldenPatternType >::processInput(), RecHitProcessor::processLook(), PATTauHybridProducer::produce(), trklet::KFin::produce(), PuppiProducer::produce(), L1Comparator::produce(), ecaldqm::PedestalClient::producePlots(), spr::propagateHCAL(), SiPixelTemplate::qbin(), LMap::impl::read(), plotBaryCentre_VS_BeamSpot::readBaryCentreAnalyzerTree(), FedRawDataInputSource::readWorker(), cms::DDNamespace::rotation(), production_tasks.CheckDatasetExists::run(), plotBaryCentre_VS_BeamSpot::Run(), ecaldqm::LedTask::runOnUncalibRecHits(), ecaldqm::LaserTask::runOnUncalibRecHits(), HGCDigitizerBase::runSimple(), CondDBESSource::setIntervalFor(), cms::DDNamespace::solid(), batchmanager.BatchManager::SubmitJobs(), vid_id_tools::switchOnVIDElectronIdProducer(), vid_id_tools::switchOnVIDMuonIdProducer(), vid_id_tools::switchOnVIDPhotonIdProducer(), pfTools::switchToPFMET(), dqm::impl::MonitorElement::syncCoreObject(), SiPixelTemplate::temperrors(), data_formats::to_datatables(), coreTools.RemoveMCMatching::toolCode(), trackTools.MakePATTrackCandidates::toolCode(), CaloTowerConstituentsMap::towerOf(), HGVHistoProducerAlgo::tracksters_to_SimTracksters(), CosmicMuonTrajectoryBuilder::trajectories(), omtf::translatePact2Omtf(), CSCDDUEventData::unpack_data(), reco::KalmanGhostTrackUpdater::update(), CountProcessesAction::update(), run_AlCaRecoTriggerBitsUpdateWorkflow::updateBits(), and OMTFPatternMaker::writeMergedGPs().
cms::cuda::AtomicPairCounter * caHitNtupletGeneratorKernels::apc |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by cms::cuda::OneToManyAssoc< I, NHISTS *NBINS+1, SIZE >::__attribute__(), and if().
auto& caHitNtupletGeneratorKernels::c = *counters |
Definition at line 84 of file CAHitNtupletGeneratorKernelsImpl.h.
TupleMultiplicity<TrackerTraits> const HitToTuple<TrackerTraits> const cms::cuda::AtomicPairCounter GPUCACellT<TrackerTraits> const* __restrict__ uint32_t const* __restrict__ CellNeighborsVector<TrackerTraits> const* caHitNtupletGeneratorKernels::cellNeighbors |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__(), and GPUCACellT< TrackerTraits >::__attribute__().
TkSoAView< TrackerTraits > GPUCACellT< TrackerTraits > *__restrict__ caHitNtupletGeneratorKernels::cells |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__(), and for().
TkSoAView< TrackerTraits > GPUCACellT< TrackerTraits > *__restrict__ uint32_t const CellTracksVector< TrackerTraits > * caHitNtupletGeneratorKernels::cellTracks |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Counters * caHitNtupletGeneratorKernels::counters |
Definition at line 81 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by L1TStage2EMTF::analyze(), CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::printCounters(), RPCTwinMuxRawToDigi::processBlock(), RPCAMCRawToDigi::processBlocks(), RPCAMCRawToDigi::processCDFHeaders(), RPCTwinMuxRawToDigi::processCDFHeaders(), RPCAMCRawToDigi::processCDFTrailers(), RPCTwinMuxRawToDigi::processCDFTrailers(), RPCCPPFUnpacker::processCPPF(), RPCTwinMuxRawToDigi::processRPCRecord(), RPCCPPFUnpacker::processRXRecord(), RPCTwinMuxRawToDigi::processTwinMux(), RPCCPPFUnpacker::produce(), RPCAMCRawToDigi::produce(), CSCTFPacker::produce(), RPCTwinMuxRawToDigi::produce(), RPCTwinMuxRawToDigi::putCounters(), and CAHitNtupletGeneratorKernels< cms::cudacompat::CPUTraits, TrackerTraits >::setCounters().
QualityCuts<TrackerTraits> caHitNtupletGeneratorKernels::cuts |
Definition at line 475 of file CAHitNtupletGeneratorKernelsImpl.h.
uint16_t bool caHitNtupletGeneratorKernels::dupPassThrough |
Definition at line 192 of file CAHitNtupletGeneratorKernelsImpl.h.
int caHitNtupletGeneratorKernels::first = threadIdx.x + blockIdx.x * blockDim.x |
Definition at line 175 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__().
TkSoAView<TrackerTraits> HitToTuple<TrackerTraits> const* __restrict__ int32_t caHitNtupletGeneratorKernels::firstPrint |
Definition at line 865 of file CAHitNtupletGeneratorKernelsImpl.h.
auto const& caHitNtupletGeneratorKernels::foundNtuplets = *ptuples |
Definition at line 606 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by CellularAutomaton::findNtuplets(), HGCGraphT< TILES >::findNtuplets(), CACell::findNtuplets(), for(), and ticl::PatternRecognitionbyCA< TILES >::makeTracksters().
auto const caHitNtupletGeneratorKernels::good = pixelTrack::Quality::strict |
min quality of good
Definition at line 772 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by HGcalHitIdCheck::analyze(), HGCalTestScintHits::analyze(), HGCalTestPartialWaferRecHits::analyze(), HGCalTestPartialWaferHits::analyze(), HcalTestSimHitID::analyze(), TkConvValidator::analyze(), PhotonValidator::analyze(), heppy::CMGMuonCleanerBySegmentsAlgo::clean(), HcalDbASCIIIO::createObject< HcalFrontEndMap >(), HcalDbASCIIIO::createObject< HcalSiPMCharacteristics >(), dumpLutDiff(), gpuClustering::for(), GctDigiToPsbText::GctDigiToPsbText(), HGCalWaferMask::goodCell(), GtPsbTextToDigi::GtPsbTextToDigi(), PFBadHcalPseudoClusterProducer::init(), EcalRecHitSimpleAlgo::makeRecHit(), MatcherByPullsAlgorithm::match(), MatcherByPullsAlgorithm::matchMany(), magneticfield::interpolation::binary_ifstream::operator bool(), FastFedCablingHistograms::printSummary(), CommissioningHistograms::printSummary(), GtPsbTextToDigi::produce(), modules::MuonCleanerBySegmentsT< T >::produce(), l1t::L1ComparatorRun2::produce(), RctTextToRctDigi::produce(), RctDigiToRctText::RctDigiToRctText(), RctTextToRctDigi::RctTextToRctDigi(), readCMSSWcoeff(), readCMSSWcoeffForComparison(), edm::ProductSelectorRules::Rule::Rule(), L1MuDTEtaProcessor::runEtaTrackFinder(), L1MuBMEtaProcessor::runEtaTrackFinder(), MuonSeedCleaner::SeedCandidates(), MuonOverlapSeedFromRecHits::seeds(), CosmicMuonSeedGenerator::selectSegments(), StMeasurementConditionSet::set128StripStatus(), and TkStripMeasurementDet::set128StripStatus().
HitsConstView<TrackerTraits> caHitNtupletGeneratorKernels::hh |
Definition at line 555 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__(), CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::classifyTuples(), and CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::launchKernels().
auto & caHitNtupletGeneratorKernels::hitToTuple |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by for().
TkSoAView<TrackerTraits> HitToTuple<TrackerTraits> const* __restrict__ int32_t int32_t int caHitNtupletGeneratorKernels::iev |
Definition at line 869 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by TestCUDAProducerGPUEWTask::acquire(), ProtonTransport::addPartToHepMC(), Primary4DVertexValidation::recoPrimaryVertex::addTrack(), HcalForwardLibWriter::analyze(), L1ExtraTestAnalyzer::analyze(), Primary4DVertexValidation::analyze(), CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::classifyTuples(), fwlite::Scanner< Collection >::count(), fwlite::Scanner< Collection >::countEvents(), fwlite::Scanner< Collection >::draw(), fwlite::Scanner< Collection >::draw2D(), fwlite::Scanner< Collection >::drawGraph(), fwlite::Scanner< Collection >::drawProf(), fwlite::Scanner< Collection >::fillDataSet(), Primary4DVertexValidation::matchReco2Sim(), lheh5::Events::mkEventHeader(), lheh5::Events2::mkEventHeader(), fwlite::Scanner< Collection >::scan(), CheckSecondary::update(), SimG4FluxProducer::update(), HGCPassive::update(), TotemTestGem::update(), MaterialBudgetVolume::update(), SimG4HGCalValidation::update(), SimG4HcalValidation::update(), and RootTreeHandler::writeTree().
TupleMultiplicity<TrackerTraits> const HitToTuple<TrackerTraits> const cms::cuda::AtomicPairCounter GPUCACellT<TrackerTraits> const* __restrict__ uint32_t const* __restrict__ CellNeighborsVector<TrackerTraits> const CellTracksVector<TrackerTraits> const OuterHitOfCell<TrackerTraits> const caHitNtupletGeneratorKernels::isOuterHitOfCell |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__().
int caHitNtupletGeneratorKernels::l1end = hh.hitsLayerStart()[1] |
Definition at line 726 of file CAHitNtupletGeneratorKernelsImpl.h.
TkSoAView<TrackerTraits> HitToTuple<TrackerTraits> const* __restrict__ int32_t int32_t caHitNtupletGeneratorKernels::lastPrint |
Definition at line 865 of file CAHitNtupletGeneratorKernelsImpl.h.
auto const caHitNtupletGeneratorKernels::longTqual = pixelTrack::Quality::highPurity |
Definition at line 722 of file CAHitNtupletGeneratorKernelsImpl.h.
constexpr auto caHitNtupletGeneratorKernels::loose = pixelTrack::Quality::loose |
Definition at line 231 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by EGammaCutBasedEleIdAnalyzer::analyze(), PFMuonAlgo::hasValidTrack(), AnalyticalTrackSelector::run(), MultiTrackSelector::run(), and HIMultiTrackSelector::run().
TupleMultiplicity<TrackerTraits> const HitToTuple<TrackerTraits> const cms::cuda::AtomicPairCounter GPUCACellT<TrackerTraits> const* __restrict__ uint32_t const* __restrict__ CellNeighborsVector<TrackerTraits> const CellTracksVector<TrackerTraits> const OuterHitOfCell<TrackerTraits> const int32_t uint32_t caHitNtupletGeneratorKernels::maxNumberOfDoublets |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
constexpr float caHitNtupletGeneratorKernels::maxScore = std::numeric_limits<float>::max() |
Definition at line 30 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by FastTrajectoryCleaner::clean().
uint32_t const * caHitNtupletGeneratorKernels::nCells |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__(), algorithm(), reco::helper::JetIDHelper::classifyJetComponents(), reco::helper::JetIDHelper::classifyJetTowers(), HFNoseDetIdToModule::getDetIds(), HGCSiliconDetIdToModule::getDetIds(), HGCSiliconDetIdToModule::getDetTriggerIds(), HFNoseDetIdToModule::getTriggerDetIds(), if(), HLTJetTimingProducer< T >::jetTimeFromEcalCells(), HcalHardcodeGeometryLoader::makeHECells_H2(), HcalHardcodeGeometryLoader::makeHFCells(), HcalFlexiHardcodeGeometryLoader::makeHFCells(), HcalHardcodeGeometryLoader::makeHOCells(), HcalFlexiHardcodeGeometryLoader::makeHOCells(), HLTJetTimingProducer< T >::produce(), and HcalSiPM::setNCells().
TupleMultiplicity<TrackerTraits> const HitToTuple<TrackerTraits> const cms::cuda::AtomicPairCounter GPUCACellT<TrackerTraits> const* __restrict__ uint32_t const* __restrict__ CellNeighborsVector<TrackerTraits> const CellTracksVector<TrackerTraits> const OuterHitOfCell<TrackerTraits> const int32_t caHitNtupletGeneratorKernels::nHits |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by if().
auto caHitNtupletGeneratorKernels::nhits = hh.nHits() |
Definition at line 562 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::classifyTuples(), and CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::launchKernels().
uint16_t caHitNtupletGeneratorKernels::nmin |
Definition at line 662 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by PulseFitWithFunction::Fit_parab(), gpuPixelDoublets::for(), HcalSimParametersFromDD::getDDDArray(), HGCalTBGeomParameters::getDDDArray(), HGCalGeomParameters::getDDDArray(), and TFParams::parab().
constexpr float caHitNtupletGeneratorKernels::nSigma2 = 25.f |
Definition at line 31 of file CAHitNtupletGeneratorKernelsImpl.h.
auto caHitNtupletGeneratorKernels::ntracks = std::min<int>(apc->get().m, tracks_view.metadata().size() - 1) |
Definition at line 574 of file CAHitNtupletGeneratorKernelsImpl.h.
TkSoAView<TrackerTraits> GPUCACellT<TrackerTraits>* __restrict__ uint32_t const CellTracksVector<TrackerTraits> cms::cuda::AtomicPairCounter CAParams<TrackerTraits> caHitNtupletGeneratorKernels::params |
Definition at line 381 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by __attribute__().
TkSoAView< TrackerTraits > HitToTuple< TrackerTraits > const *__restrict__ caHitNtupletGeneratorKernels::phitToTuple |
Definition at line 602 of file CAHitNtupletGeneratorKernelsImpl.h.
HitContainer<TrackerTraits> const* __restrict__ caHitNtupletGeneratorKernels::ptuples |
Definition at line 600 of file CAHitNtupletGeneratorKernelsImpl.h.
HitContainer< TrackerTraits > const *__restrict__ Quality *__restrict__ caHitNtupletGeneratorKernels::quality |
Definition at line 600 of file CAHitNtupletGeneratorKernelsImpl.h.
auto const caHitNtupletGeneratorKernels::reject = dupPassThrough ? loose : dup |
Definition at line 646 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by TkPhase2OTMeasurementDet::recHits(), L1MuDTWedgeSorter::run(), L1MuBMWedgeSorter::run(), and TriggerSummaryProducerAOD::TriggerSummaryProducerAOD().
constexpr uint32_t caHitNtupletGeneratorKernels::tkNotFound = std::numeric_limits<uint16_t>::max() |
Definition at line 29 of file CAHitNtupletGeneratorKernelsImpl.h.
TkSoAView< TrackerTraits > caHitNtupletGeneratorKernels::tracks_view |
Definition at line 172 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::classifyTuples(), gpuVertexFinder::for(), CAHitNtupletGeneratorKernelsCPU< TrackerTraits >::launchKernels(), and gpuVertexFinder::Producer< TrackerTraits >::make().
TupleMultiplicity< TrackerTraits > * caHitNtupletGeneratorKernels::tupleMultiplicity |
Definition at line 71 of file CAHitNtupletGeneratorKernelsImpl.h.
Referenced by if().
HitContainer<TrackerTraits> const* __restrict__ caHitNtupletGeneratorKernels::tuples |
Definition at line 637 of file CAHitNtupletGeneratorKernelsImpl.h.