Namespaces | |
internal | |
Classes | |
struct | CholeskyInverter |
struct | CholeskyInverter< T, 3, N > |
struct | CholeskyInverterSym |
struct | CholeskyInverterSym< T, 3, N > |
struct | CramerInverter |
struct | CramerInverter< T, 2, N > |
struct | CramerInverter< T, 3, N > |
struct | CramerInverterSym |
struct | CramerInverterSym< T, 2, N > |
struct | CramerInverterSym< T, 3, N > |
class | MatriplexVector |
struct | MultiplyCls |
struct | MultiplyCls< T, 3, N > |
struct | MultiplyCls< T, 6, N > |
struct | SymMultiplyCls |
struct | SymMultiplyCls< T, 3, N > |
struct | SymMultiplyCls< T, 6, N > |
Typedefs | |
typedef int | idx_t |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
using | MPlex = Matriplex< T, D1, D2, N > |
template<typename T , idx_t D, idx_t N> | |
using | MPlexSym = MatriplexSym< T, D, N > |
template<class MP > | |
using | MPlexVec = MatriplexVector< MP > |
Functions | |
template<typename T , idx_t D, idx_t N> | |
class | __attribute__ ((aligned(32))) MatriplexSym |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
class | __attribute__ ((aligned(32))) Matriplex |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | abs (const MPlex< T, D1, D2, N > &a) |
void | align_check (const char *pref, void *adr) |
void * | aligned_alloc64 (std::size_t size) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | atan2 (const MPlex< T, D1, D2, N > &y, const MPlex< T, D1, D2, N > &x) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | cos (const MPlex< T, D1, D2, N > &a) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | hypot (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D, idx_t N> | |
void | invertCholesky (MPlexVec< MPlex< T, D, D, N >> &A, int n_to_process=0) |
template<typename T , idx_t D, idx_t N> | |
void | invertCholesky (MPlex< T, D, D, N > &A) |
template<typename T , idx_t D, idx_t N> | |
void | invertCholeskySym (MPlexVec< MPlexSym< T, D, N >> &A, int n_to_process=0) |
template<typename T , idx_t D, idx_t N> | |
void | invertCholeskySym (MPlexSym< T, D, N > &A) |
template<typename T , idx_t D, idx_t N> | |
void | invertCramer (MPlexVec< MPlex< T, D, D, N >> &A, int n_to_process=0) |
template<typename T , idx_t D, idx_t N> | |
void | invertCramer (MPlex< T, D, D, N > &A, double *determ=nullptr) |
template<typename T , idx_t D, idx_t N> | |
void | invertCramerSym (MPlexVec< MPlexSym< T, D, N >> &A, int n_to_process=0) |
template<typename T , idx_t D, idx_t N> | |
void | invertCramerSym (MPlexSym< T, D, N > &A, double *determ=nullptr) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | max (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | min (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
void | min_max (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b, MPlex< T, D1, D2, N > &min, MPlex< T, D1, D2, N > &max) |
template<typename T , idx_t D1, idx_t D2, idx_t D3, idx_t N> | |
void | multiply (const MPlexVec< MPlex< T, D1, D2, N >> &A, const MPlexVec< MPlex< T, D2, D3, N >> &B, MPlexVec< MPlex< T, D1, D3, N >> &C, int n_to_process=0) |
template<typename T , idx_t D, idx_t N> | |
void | multiply (const MPlexVec< MPlexSym< T, D, N >> &A, const MPlexVec< MPlexSym< T, D, N >> &B, MPlexVec< MPlex< T, D, D, N >> &C, int n_to_process=0) |
template<typename T , idx_t D, idx_t N> | |
void | multiply (const MPlexSym< T, D, N > &A, const MPlexSym< T, D, N > &B, MPlex< T, D, D, N > &C) |
template<typename T , idx_t D, idx_t N> | |
void | multiply (const MPlex< T, D, D, N > &A, const MPlex< T, D, D, N > &B, MPlex< T, D, D, N > &C) |
template<typename T , idx_t D1, idx_t D2, idx_t D3, idx_t N> | |
void | multiply3in (MPlexVec< MPlex< T, D1, D2, N >> &A, MPlexVec< MPlex< T, D2, D3, N >> &B, MPlexVec< MPlex< T, D1, D3, N >> &C, int n_to_process=0) |
template<typename T , idx_t D1, idx_t D2, idx_t D3, idx_t N> | |
void | multiplyGeneral (const MPlexVec< MPlex< T, D1, D2, N >> &A, const MPlexVec< MPlex< T, D2, D3, N >> &B, MPlexVec< MPlex< T, D1, D3, N >> &C, int n_to_process=0) |
template<typename T , idx_t D1, idx_t D2, idx_t D3, idx_t N> | |
void | multiplyGeneral (const MPlex< T, D1, D2, N > &A, const MPlex< T, D2, D3, N > &B, MPlex< T, D1, D3, N > &C) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | negate (const MPlex< T, D1, D2, N > &a) |
template<typename T , typename TT , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | negate_if_ltz (const MPlex< T, D1, D2, N > &a, const MPlex< TT, D1, D2, N > &sign) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator* (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator* (const MPlex< T, D1, D2, N > &a, T b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator* (T a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator+ (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator+ (const MPlex< T, D1, D2, N > &a, T b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator+ (T a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator- (const MPlex< T, D1, D2, N > &a) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator- (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator- (const MPlex< T, D1, D2, N > &a, T b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator- (T a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator/ (const MPlex< T, D1, D2, N > &a, const MPlex< T, D1, D2, N > &b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator/ (const MPlex< T, D1, D2, N > &a, T b) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | operator/ (T a, const MPlex< T, D1, D2, N > &b) |
constexpr std::size_t | round_up_align64 (std::size_t size) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | sin (const MPlex< T, D1, D2, N > &a) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
void | sincos (const MPlex< T, D1, D2, N > &a, MPlex< T, D1, D2, N > &s, MPlex< T, D1, D2, N > &c) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
void | sincos4 (const MPlex< T, D1, D2, N > &a, MPlex< T, D1, D2, N > &s, MPlex< T, D1, D2, N > &c) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | sqr (const MPlex< T, D1, D2, N > &a) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | sqrt (const MPlex< T, D1, D2, N > &a) |
template<typename T , idx_t D1, idx_t D2, idx_t N> | |
MPlex< T, D1, D2, N > | tan (const MPlex< T, D1, D2, N > &a) |
Variables | |
const idx_t | gSymOffsets [7][36] |
typedef int Matriplex::idx_t |
Definition at line 98 of file MatriplexCommon.h.
using Matriplex::MPlex = typedef Matriplex<T, D1, D2, N> |
Definition at line 483 of file Matriplex.h.
using Matriplex::MPlexSym = typedef MatriplexSym<T, D, N> |
Definition at line 280 of file MatriplexSym.h.
using Matriplex::MPlexVec = typedef MatriplexVector<MP> |
Definition at line 48 of file MatriplexVector.h.
class Matriplex::__attribute__ | ( | (aligned(32)) | ) |
no. of matrix rows
no. of matrix columns
no of elements: lower triangle
size of the whole matriplex
Definition at line 26 of file MatriplexSym.h.
References a, PVValHelper::add(), ASSUME_ALIGNED, b, ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), filterCSVwithJSON::copy, ztail::d, gSymOffsets, mps_fire::i, recoMuon::in, dqmiolumiharvest::j, isotrackApplyRegressor::k, visualization-live-secondInstance_cfg::m, N, create_idmaps::n, hgchebackDigitizer_cfi::noise, upgradeWorkflowComponents::offsets, operator=(), operator[](), AlCaHLTBitMon_ParallelJobs::p, alignCSCRings::s, isotrackNtupler::scale, TrackRefitter_38T_cff::src, electronEcalRecHitIsolationLcone_cfi::subtract, submitPVValidationJobs::t, createJobs::tmp, mitigatedMETSequence_cff::U, interactiveExample::ui, findQualityFiles::v, and geometryCSVtoXML::xx.
class Matriplex::__attribute__ | ( | (aligned(32)) | ) |
return no. of matrix rows
return no. of matrix columns
return no of elements: rows*columns
size of the whole matriplex
Definition at line 35 of file Matriplex.h.
References a, abs(), PVValHelper::add(), atan2(), b, DummyCfis::c, ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), filterCSVwithJSON::copy, cos(), mkfit::mini_propagators::fast_atan2(), mkfit::mini_propagators::fast_sincos(), mkfit::mini_propagators::fast_tan(), hypot(), mps_fire::i, recoMuon::in, dqmiolumiharvest::j, isotrackApplyRegressor::k, visualization-live-secondInstance_cfg::m, N, create_idmaps::n, negate(), negate_if_ltz(), operator*=(), operator+=(), operator-(), operator-=(), operator/=(), operator=(), operator[](), alignCSCRings::s, isotrackNtupler::scale, Validation_hcalonly_cfi::sign, sin(), sincos(), Matriplex::internal::sincos4(), sincos4(), sqr(), sqrt(), TrackRefitter_38T_cff::src, submitPVValidationJobs::t, tan(), createJobs::tmp, mitigatedMETSequence_cff::U, interactiveExample::ui, findQualityFiles::v, x, and geometryCSVtoXML::xx.
MPlex<T, D1, D2, N> Matriplex::abs | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 595 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__().
void Matriplex::align_check | ( | const char * | pref, |
void * | adr | ||
) |
Definition at line 4 of file MatriplexCommon.cc.
Referenced by mkfit::MkFitter::checkAlignment().
|
inline |
Definition at line 13 of file Memory.h.
References aligned_alloc(), and round_up_align64().
Referenced by mkfit::Pool< mkfit::MkFitter >::create(), and Matriplex::MatriplexVector< MP >::MatriplexVector().
MPlex<T, D1, D2, N> Matriplex::atan2 | ( | const MPlex< T, D1, D2, N > & | y, |
const MPlex< T, D1, D2, N > & | x | ||
) |
Definition at line 648 of file Matriplex.h.
References submitPVValidationJobs::t, and x.
Referenced by __attribute__(), ALPAKA_ACCELERATOR_NAMESPACE::lst::addMDToMemory(), Hector::addPartToHepMC(), algorithm(), EwkMuDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), Phase2OTValidateTrackingParticles::analyze(), ValidationMisalignedTracker::analyze(), L1GctValidation::analyze(), MuonGeometrySVGTemplate::analyze(), SiPixelTrackResidualSource::analyze(), MuonAlignmentAnalyzer::analyze(), SiPixelErrorEstimation::analyze(), SiPixelTrackingRecHitsValid::analyze(), analyzer::SiPixelLorentzAngle::analyze(), SiPixelLorentzAnglePCLWorker::analyze(), GlobalTrackerMuonAlignment::analyzeTrackTrack(), GlobalTrackerMuonAlignment::analyzeTrackTrajectory(), BaseProtonTransport::ApplyBeamCorrection(), HGCalDDDConstants::assignCellTrap(), lst_math::ATan2(), Basic2DVector< float >::barePhi(), Basic3DVector< long double >::barePhi(), Basic3DVector< align::Scalar >::barePhi(), Basic3DVector< long double >::bareTheta(), Basic3DVector< align::Scalar >::bareTheta(), mkfit::MkFinder::bkFitFitTracks(), mkfit::MkFinder::bkFitFitTracksBH(), emtf::calc_theta_rad_from_eta(), L1MetPfProducer::CalcMlMet(), emtf::phase2::tp::calcThetaRadFromEta(), tt::Setup::calculateConstants(), CSCPairResidualsConstraint::calculatePhi(), PFMETBenchmark::calculateQuantities(), reco::modules::TrackerTrackHitFilter::checkHitAngle(), reco::modules::TrackerTrackHitFilter::checkPXLCorrClustCharge(), brokenline::circleFit(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::circleFit(), SiPixelErrorEstimation::computeAnglesFromDetPosition(), TotemT2Segmentation::computeBins(), SiStripGainFromData::ComputeChargeOverPath(), HFCherenkov::computeNPE(), StripTopologyBuilder::constructForward(), MuonMETAlgo::correctMETforMuon(), fireworks::createSegment(), CaloDetIdAssociator::crossedElement(), VectorHitBuilderAlgorithm::curvatureANDphi(), CurvilinearTrajectoryParameters::CurvilinearTrajectoryParameters(), FullModelReactionDynamics::Defs1(), HGCalDDDConstants::distFromEdgeTrap(), MuonAlignmentInputXML::do_setposition(), PF_PU_AssoMapAlgos::dR(), geometryDiffVisualization::draw_disk(), Pixel3DDigitizerAlgorithm::driftFor3DSensors(), EcalEleCalibLooper::EEregionCheck(), EcalEleCalibLooper::EERegionId(), trklet::TrackletCalculatorDisplaced::exactprojdisk(), trklet::TrackletCalculatorDisplaced::exacttracklet(), DDHCalTestBeamAlgo::execute(), DDPixFwdDiskAlgo::execute(), DDPixPhase1FwdDiskAlgo::execute(), HIPplots::extractAlignShifts(), brokenline::fastFit(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::fastFit(), riemannFit::fastFit(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::fastFit(), CTPPSFastTrackingProducer::FastReco(), MultiplicityCorrelatorHistogramMaker::fill(), SiPixelHitEfficiencyModule::fill(), HcalTB04Analysis::fillBuffer(), TrackerHitProducer::fillG4MC(), TrackerValidationVariables::fillHitQuantities(), METAnalyzer::fillMonitorElement(), MuonGeometryArrange::fillTree(), EnergyScaleAnalyzer::fillTree(), ColinearityKinematicConstraintT< Dim >::fillValue(), MvaMEtUtilities::finalize(), finalizeCommonMETData(), NoPileUpMEtUtilities::finalizeMEtData(), FakeBeamMonitor::FitAndFill(), BeamMonitor::FitAndFill(), L1GctMet::floatingPointAlgo(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::for(), riemannFit::fromCircleToPerigee(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::fromCircleToPerigee(), FWExpressionValidator::FWExpressionValidator(), UEParameters::get_psin(), hi::GenPlane::getAngle(), heppy::Apc::getApcJetMetMin(), ZdcSD::getEnergyDeposit(), mkfit::getEta(), CastorSD::getFromLibrary(), HCalSD::getHitFibreBundle(), HCalSD::getHitPMT(), CastorShowerLibraryMaker::GetKinematics(), TwoBodyDecayLinearizationPointFinder::getLinearizationPoint(), TrackFitter::getPhi(), mkfit::getPhi(), HGCalTriggerTools::getPhi(), hgcal::RecHitTools::getPhi(), CastorShowerLibrary::getShowerHits(), mkfit::getTheta(), CachedTrajectory::getWideTrajectory(), CosmicMuonGenerator::goodOrientation(), BaseParticlePropagator::helixCentrePhi(), BaseParticlePropagator::helixStartPhi(), SiStripMonitorTrack::hitStudy(), VertexKinematicConstraintT::init(), riemannFit::lineFit(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::lineFit(), reco::mlpf::makeCandidate(), GEMStripTopology::measurementPosition(), CSCRadialStripTopology::measurementPosition(), GlobalTrackerMuonAlignment::misalignMuonL(), muonisolation::CaloExtractor::MuonAtCaloPosition(), MuonDT13ChamberResidual::MuonDT13ChamberResidual(), MuonTrackDT13ChamberResidual::MuonTrackDT13ChamberResidual(), SiPixelFedCablingMapBuilder::myprint(), CosmicMuonGenerator::nextMultiEvent(), HiEvtPlaneFlatten::offsetPsi(), TrackerDpgAnalysis::onTrackAngles(), reco::parser::atan2_f::operator()(), reco::isodeposit::Direction::operator-(), SurveyInputCSCfromPins::orient(), riemannFit::par_uvrtopak(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::par_uvrtopak(), DDHCalEndcapModuleAlgo::parameterLayer(), DDHCalEndcapAlgo::parameterLayer(), HCalEndcapModuleAlgo::parameterLayer(), HCalEndcapAlgo::parameterLayer(), VertexKinematicConstraint::parametersDerivative(), TTStubAlgorithm_official< T >::PatternHitCorrelation(), kinem::phi(), ALPAKA_ACCELERATOR_NAMESPACE::lst::phi(), mtd::MTDGeomUtil::phi(), trklet::L1TStub::phi(), Basic2DVector< float >::phi(), SingleParticleEvent::phi(), ecaldqm::phi(), pat::MET::Vector2::phi(), P2L1HTMHTEmu::phi_cordic(), CSCSegAlgoSK::phiAtZ(), CSCSegAlgoTC::phiAtZ(), CSCSegAlgoRU::phiAtZ(), L1MetPfProducer::PhiFromXY(), ConformalMappingFit::phiRot(), HFFibreFiducial::PMTNumber(), DDHGCalMixRotatedCassette::positionMix(), DDHGCalMixRotatedLayer::positionMix(), DDHGCalMixRotatedFineCassette::positionMix(), HGCalMixRotatedLayer::positionMix(), HGCalMixRotatedCassette::positionMix(), HGCalMixRotatedFineCassette::positionMix(), DDHGCalSiliconRotatedCassette::positionPassive(), HGCalSiliconRotatedCassette::positionPassive(), DDHGCalEEAlgo::positionSensitive(), DDHGCalSiliconRotatedModule::positionSensitive(), DDHGCalSiliconRotatedCassette::positionSensitive(), HGCalSiliconRotatedModule::positionSensitive(), HGCalSiliconRotatedCassette::positionSensitive(), brokenline::prepareBrokenLineData(), PFMETAlgorithmMVA::print(), l1t::Stage1Layer2EtSumAlgorithmImpPP::processEvent(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), PseudoTopProducer::produce(), edm::CosMuoGenProducer::produce(), L1TrackerEtMissProducer::produce(), L1TkHTMissEmulatorProducer::produce(), RechitClusterProducerT< Trait >::produce(), HiFJRhoFlowModulationProducer::produce(), BaseParticlePropagator::propagateToBeamCylinder(), BaseParticlePropagator::propagateToNominalVertex(), SiPixelTemplate::pushfile(), heppy::Hemisphere::Reconstruct(), AreaSeededTrackingRegionsBuilder::Builder::regionImpl(), ElectronEnergyRegressionEvaluate::regressionUncertaintyNoTrkVar(), ElectronEnergyRegressionEvaluate::regressionUncertaintyNoTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithSubClusters(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVar(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionUncertaintyWithTrkVarV2(), ElectronEnergyRegressionEvaluate::regressionValueNoTrkVar(), ElectronEnergyRegressionEvaluate::regressionValueNoTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionValueWithSubClusters(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVar(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVarV1(), ElectronEnergyRegressionEvaluate::regressionValueWithTrkVarV2(), heppy::Hemisphere::RejectISR(), HGCalStage2ClusterDistribution::rotatedphi(), HGCalStage1TruncationImplSA::rotatedphi(), HGCalStage1TruncationImpl::rotatedphi(), KFBasedPixelFitter::run(), riemannFit::scatter_cov_rad(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::scatter_cov_rad(), mkfit::MkFinder::selectHitIndices(), tt::SensorModule::SensorModule(), HGCalSD::setDetUnitId(), IdealResult::solve(), mkfit::sortByPhi(), DAClusterizerInZT_vect::split(), GEMStripTopology::strip(), OffsetRadialStripTopology::strip(), CSCRadialStripTopology::strip(), trackerDTC::Stub::Stub(), kinem::theta(), tmtt::TrackerModule::theta(), tmtt::Stub::theta(), tmtt::KFTrackletTrack::theta(), SingleParticleEvent::theta(), Basic3DVector< align::Scalar >::theta(), tmtt::L1track3D::theta(), tmtt::L1fittedTrack::theta(), align::toAngles(), ConversionSeedFinder::trackStateFromClusters(), SiStripMonitorTrack::trajectoryStudy(), brokenline::translateKarimaki(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::translateKarimaki(), HcalNumberingFromDDD::unitID(), TrackingVerboseAction::update(), ZdcTestAnalysis::update(), CastorTestAnalysis::update(), FP420Test::update(), BscTest::update(), TwoTrackMinimumDistanceHelixHelix::updateCoeffs(), VertexKinematicConstraint::value(), ColinearityKinematicConstraint::value(), L1GctHtMissLut::value(), MuonAlignmentOutputXML::writeComponents(), and z().
MPlex<T, D1, D2, N> Matriplex::cos | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 628 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__(), sincos(), and Matriplex::internal::sincos4().
MPlex<T, D1, D2, N> Matriplex::hypot | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
Definition at line 616 of file Matriplex.h.
References a, b, and submitPVValidationJobs::t.
Referenced by __attribute__(), mkfit::MkFinder::addBestHit(), RegressionHelper::applyCombinationRegression(), objects.METAnalyzer.METAnalyzer::applyDeltaMet(), mkfit::MkFinder::bkFitFitTracks(), mkfit::MkFinder::bkFitFitTracksBH(), L1MetPfProducer::CalcMlMet(), PFEGammaAlgo::calculateEleMVA(), PhotonEnergyCalibratorRun2::calibrate(), ElectronEnergyCalibratorRun2::calibrate(), mkfit::TrackBase::canReachRadius(), MuonGEMBaseHarvestor::computeEfficiency(), DQMGenericClient::computeEfficiency(), JetReCalibrator.Type1METCorrector::correct(), mkfit::TrackBase::d0BeamSpot(), L1JetRecoTreeProducer::doPFMetNoMu(), L1JetRecoTreeProducer::doPUPPIMetNoMu(), HLTRegionalEcalResonanceFilter::doSelection(), pat::PATMuonProducer::embedHighLevel(), pat::PATElectronProducer::embedHighLevel(), trklet::TrackletEventProcessor::event(), Phase2TrackerMonitorDigi::fillITPixelDigiHistos(), LHETablesProducer::fillLHEObjectTable(), Phase2TrackerMonitorDigi::fillOTDigiHistos(), Phase2TrackerValidateDigi::fillSimHitInfo(), mkfit::MkFinder::findCandidates(), GEMEfficiencyAnalyzer::findCSCSegmentCosmics(), GenParticles2HepMCConverter::FourVector(), Point::GetSigmaDeltaMu(), mkfit::kalmanOperation(), mkfit::kalmanPropagateAndComputeChi2(), mkfit::kalmanPropagateAndUpdate(), objects.METAnalyzer::makeGenTkMet(), mkfit::TrackBase::maxReachRadius(), LowPtElectronModifier::modifyObject(), l1tpf::ParametricResolution::operator()(), reco::parser::hypot_f::operator()(), mkfit::MkFitter::printPt(), DeepMETProducer::produce(), DeepMETSonicProducer::produce(), L1TPFMetNoMuProducer::produce(), PseudoTopProducer::produce(), JetConstituentTableProducer< T >::produce(), PATTracksToPackedCandidates::produce(), EvtPlaneProducer::produce(), L1FPGATrackProducer::produce(), mkfit::mini_propagators::InitialState::propagate_to_r(), mkfit::mini_propagators::InitialStatePlex::propagate_to_r(), mkfit::propagateHelixToPlaneMPlex(), mkfit::propagateHelixToZMPlex(), mkfit::MkBase::propagateTracksToHitR(), mkfit::MkBase::propagateTracksToPCAZ(), trklet::L1TStub::r(), mkfit::TrackBase::rAtZ(), EcalUncalibRecHitWorkerMultiFit::run(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), MultiTrackSelector::select(), mkfit::MkFinder::selectHitIndices(), mkfit::MkFinder::selectHitIndicesV2(), pat::LeptonUpdater< T >::setDZ(), EGEtScaleSysModifier::setEcalEnergy(), ElectronEnergyCalibrator::setEcalEnergy(), PhotonEnergyCalibrator::setEnergyAndSystVarations(), JetReCalibrator::setFakeRawMETOnOldMiniAODs(), JetId::setNNVectorVar(), pat::MET::shiftedP4(), pat::MET::shiftedP4_74x(), XHistogram::splitSegment(), DD4hep_XHistogram::splitSegment(), objects.METAnalyzer::sumXY(), reco::ForwardProton::t(), and mkfit::TrackBase::zAtR().
void Matriplex::invertCholesky | ( | MPlexVec< MPlex< T, D, D, N >> & | A, |
int | n_to_process = 0 |
||
) |
Definition at line 126 of file MatriplexVector.h.
References A, mps_fire::i, invertCholesky(), and np.
Definition at line 1019 of file Matriplex.h.
References A, and Matriplex::CholeskyInverter< T, D, N >::invert().
Referenced by invertCholesky().
void Matriplex::invertCholeskySym | ( | MPlexVec< MPlexSym< T, D, N >> & | A, |
int | n_to_process = 0 |
||
) |
Definition at line 144 of file MatriplexVector.h.
References A, mps_fire::i, invertCholeskySym(), and np.
void Matriplex::invertCholeskySym | ( | MPlexSym< T, D, N > & | A | ) |
Definition at line 472 of file MatriplexSym.h.
References A, and Matriplex::CholeskyInverterSym< T, D, N >::invert().
Referenced by invertCholeskySym().
void Matriplex::invertCramer | ( | MPlexVec< MPlex< T, D, D, N >> & | A, |
int | n_to_process = 0 |
||
) |
Definition at line 117 of file MatriplexVector.h.
References A, mps_fire::i, invertCramer(), and np.
void Matriplex::invertCramer | ( | MPlex< T, D, D, N > & | A, |
double * | determ = nullptr |
||
) |
Definition at line 965 of file Matriplex.h.
References A, and Matriplex::CramerInverter< T, D, N >::invert().
Referenced by mkfit::conformalFitMPlex(), and invertCramer().
void Matriplex::invertCramerSym | ( | MPlexVec< MPlexSym< T, D, N >> & | A, |
int | n_to_process = 0 |
||
) |
Definition at line 135 of file MatriplexVector.h.
References A, mps_fire::i, invertCramerSym(), and np.
void Matriplex::invertCramerSym | ( | MPlexSym< T, D, N > & | A, |
double * | determ = nullptr |
||
) |
Definition at line 421 of file MatriplexSym.h.
References A, and Matriplex::CramerInverterSym< T, D, N >::invert().
Referenced by invertCramerSym(), mkfit::kalmanOperation(), mkfit::kalmanOperationEndcap(), mkfit::kalmanOperationPlane(), and mkfit::kalmanOperationPlaneLocal().
MPlex<T, D1, D2, N> Matriplex::max | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
Definition at line 723 of file Matriplex.h.
References a, b, mps_fire::i, and submitPVValidationJobs::t.
Referenced by min_max().
MPlex<T, D1, D2, N> Matriplex::min | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
Definition at line 714 of file Matriplex.h.
References a, b, mps_fire::i, and submitPVValidationJobs::t.
Referenced by min_max().
void Matriplex::min_max | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b, | ||
MPlex< T, D1, D2, N > & | min, | ||
MPlex< T, D1, D2, N > & | max | ||
) |
Definition at line 703 of file Matriplex.h.
References a, b, mps_fire::i, max(), and min().
Referenced by mkfit::MkFinder::selectHitIndicesV2().
void Matriplex::multiply | ( | const MPlexVec< MPlex< T, D1, D2, N >> & | A, |
const MPlexVec< MPlex< T, D2, D3, N >> & | B, | ||
MPlexVec< MPlex< T, D1, D3, N >> & | C, | ||
int | n_to_process = 0 |
||
) |
Definition at line 53 of file MatriplexVector.h.
References A, cms::cuda::assert(), B, correctionTermsCaloMet_cff::C, mps_fire::i, multiply(), and np.
void Matriplex::multiply | ( | const MPlexVec< MPlexSym< T, D, N >> & | A, |
const MPlexVec< MPlexSym< T, D, N >> & | B, | ||
MPlexVec< MPlex< T, D, D, N >> & | C, | ||
int | n_to_process = 0 |
||
) |
Definition at line 100 of file MatriplexVector.h.
References A, cms::cuda::assert(), B, correctionTermsCaloMet_cff::C, mps_fire::i, multiply(), and np.
void Matriplex::multiply | ( | const MPlexSym< T, D, N > & | A, |
const MPlexSym< T, D, N > & | B, | ||
MPlex< T, D, D, N > & | C | ||
) |
Definition at line 348 of file MatriplexSym.h.
References A, B, correctionTermsCaloMet_cff::C, and Matriplex::SymMultiplyCls< T, D, N >::multiply().
void Matriplex::multiply | ( | const MPlex< T, D, D, N > & | A, |
const MPlex< T, D, D, N > & | B, | ||
MPlex< T, D, D, N > & | C | ||
) |
Definition at line 881 of file Matriplex.h.
References A, B, correctionTermsCaloMet_cff::C, Matriplex::MultiplyCls< T, D, N >::multiply(), and N.
Referenced by multiply(), multiply3in(), and AlignmentExtendedCorrelationsEntry::operator*=().
void Matriplex::multiply3in | ( | MPlexVec< MPlex< T, D1, D2, N >> & | A, |
MPlexVec< MPlex< T, D2, D3, N >> & | B, | ||
MPlexVec< MPlex< T, D1, D3, N >> & | C, | ||
int | n_to_process = 0 |
||
) |
Definition at line 83 of file MatriplexVector.h.
References A, cms::cuda::assert(), B, correctionTermsCaloMet_cff::C, mps_fire::i, multiply(), and np.
void Matriplex::multiplyGeneral | ( | const MPlexVec< MPlex< T, D1, D2, N >> & | A, |
const MPlexVec< MPlex< T, D2, D3, N >> & | B, | ||
MPlexVec< MPlex< T, D1, D3, N >> & | C, | ||
int | n_to_process = 0 |
||
) |
Definition at line 68 of file MatriplexVector.h.
References A, cms::cuda::assert(), B, correctionTermsCaloMet_cff::C, mps_fire::i, multiplyGeneral(), and np.
void Matriplex::multiplyGeneral | ( | const MPlex< T, D1, D2, N > & | A, |
const MPlex< T, D2, D3, N > & | B, | ||
MPlex< T, D1, D3, N > & | C | ||
) |
Definition at line 736 of file Matriplex.h.
References A, B, correctionTermsCaloMet_cff::C, trklet::D3, mps_fire::i, dqmiolumiharvest::j, isotrackApplyRegressor::k, N, and create_idmaps::n.
Referenced by multiplyGeneral().
MPlex<T, D1, D2, N> Matriplex::negate | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 497 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__().
MPlex<T, D1, D2, N> Matriplex::negate_if_ltz | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< TT, D1, D2, N > & | sign | ||
) |
Definition at line 504 of file Matriplex.h.
References a, Validation_hcalonly_cfi::sign, and submitPVValidationJobs::t.
Referenced by __attribute__().
MPlex<T, D1, D2, N> Matriplex::operator* | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator* | ( | const MPlex< T, D1, D2, N > & | a, |
T | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator* | ( | T | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator+ | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator+ | ( | const MPlex< T, D1, D2, N > & | a, |
T | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator+ | ( | T | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator- | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 490 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__().
MPlex<T, D1, D2, N> Matriplex::operator- | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator- | ( | const MPlex< T, D1, D2, N > & | a, |
T | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator- | ( | T | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator/ | ( | const MPlex< T, D1, D2, N > & | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator/ | ( | const MPlex< T, D1, D2, N > & | a, |
T | b | ||
) |
MPlex<T, D1, D2, N> Matriplex::operator/ | ( | T | a, |
const MPlex< T, D1, D2, N > & | b | ||
) |
constexpr std::size_t Matriplex::round_up_align64 | ( | std::size_t | size | ) |
Definition at line 8 of file Memory.h.
References ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), and ALPAKA_ACCELERATOR_NAMESPACE::pixelClustering::pixelStatus::mask.
Referenced by aligned_alloc64().
MPlex<T, D1, D2, N> Matriplex::sin | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 622 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__(), sincos(), and Matriplex::internal::sincos4().
void Matriplex::sincos | ( | const MPlex< T, D1, D2, N > & | a, |
MPlex< T, D1, D2, N > & | s, | ||
MPlex< T, D1, D2, N > & | c | ||
) |
Definition at line 634 of file Matriplex.h.
References a, DummyCfis::c, cos(), mps_fire::i, alignCSCRings::s, and sin().
Referenced by __attribute__().
void Matriplex::sincos4 | ( | const MPlex< T, D1, D2, N > & | a, |
MPlex< T, D1, D2, N > & | s, | ||
MPlex< T, D1, D2, N > & | c | ||
) |
Definition at line 696 of file Matriplex.h.
References a, DummyCfis::c, and alignCSCRings::s.
Referenced by __attribute__().
MPlex<T, D1, D2, N> Matriplex::sqr | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 601 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__().
MPlex<T, D1, D2, N> Matriplex::sqrt | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 610 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__(), Matriplex::CholeskyInverter< T, 3, N >::invert(), and mkfit::MkFinder::selectHitIndicesV2().
MPlex<T, D1, D2, N> Matriplex::tan | ( | const MPlex< T, D1, D2, N > & | a | ) |
Definition at line 642 of file Matriplex.h.
References a, and submitPVValidationJobs::t.
Referenced by __attribute__().
const idx_t Matriplex::gSymOffsets[7][36] |
Definition at line 13 of file MatriplexSym.h.
Referenced by __attribute__().