CMS 3D CMS Logo

Classes | Typedefs | Functions | Variables
mathSSE Namespace Reference

Classes

struct  As3D
 
struct  OldRot
 
struct  OldVec
 
struct  Rot2
 
struct  Rot3
 
union  Vec2
 
union  Vec4
 
union  Vec4< double >
 

Typedefs

typedef Rot2< double > Rot2D
 
typedef Rot2< float > Rot2F
 
typedef Rot3< double > Rot3D
 
typedef Rot3< float > Rot3F
 
typedef Vec2< double > Vec2D
 
typedef Vec2< float > Vec2F
 
typedef Vec4< double > Vec3D
 
typedef Vec4< float > Vec3F
 
typedef Vec4< double > Vec4D
 
typedef Vec4< float > Vec4F
 

Functions

template<typename T >
struct mathSSE::OldVec __attribute__ ((aligned(16)))
 
template<>
bool __attribute__ ((always_inline)) __attribute__((pure)) samesign< int >(int rh
 
template<typename T >
struct mathSSE::OldRot __attribute__ ((aligned(16)))
 
template<typename T >
As3D< Tas3D (Vec4< T > const &v)
 
 return ((rh ^ lh) &mask) == 0
 
template<typename T >
bool samesign (T rh, T lh)
 
return samesign< int > (a.i, b.i)
 
return samesign< long long > (a.i, b.i)
 
template<typename T >
T sqrt (T t)
 

Variables

struct mathSSE::Rot3 __attribute__
 
a f = rh
 
bool int lh
 

Typedef Documentation

◆ Rot2D

typedef Rot2<double> mathSSE::Rot2D

Definition at line 138 of file SSERot.h.

◆ Rot2F

typedef Rot2<float> mathSSE::Rot2F

Definition at line 136 of file SSERot.h.

◆ Rot3D

typedef Rot3<double> mathSSE::Rot3D

Definition at line 73 of file SSERot.h.

◆ Rot3F

typedef Rot3<float> mathSSE::Rot3F

Definition at line 71 of file SSERot.h.

◆ Vec2D

typedef Vec2<double> mathSSE::Vec2D

Definition at line 483 of file SSEVec.h.

◆ Vec2F

typedef Vec2<float> mathSSE::Vec2F

Definition at line 480 of file SSEVec.h.

◆ Vec3D

typedef Vec4<double> mathSSE::Vec3D

Definition at line 484 of file SSEVec.h.

◆ Vec3F

typedef Vec4<float> mathSSE::Vec3F

Definition at line 482 of file SSEVec.h.

◆ Vec4D

typedef Vec4<double> mathSSE::Vec4D

Definition at line 485 of file SSEVec.h.

◆ Vec4F

typedef Vec4<float> mathSSE::Vec4F

Definition at line 481 of file SSEVec.h.

Function Documentation

◆ __attribute__() [1/3]

template<typename T >
struct mathSSE::OldVec mathSSE::__attribute__ ( (aligned(16))  )

◆ __attribute__() [2/3]

template<>
bool mathSSE::__attribute__ ( (always_inline)  )
inline

◆ __attribute__() [3/3]

template<typename T >
struct mathSSE::OldRot mathSSE::__attribute__ ( (aligned(16))  )

◆ as3D()

template<typename T >
As3D<T> mathSSE::as3D ( Vec4< T > const &  v)
inline

Definition at line 494 of file SSEVec.h.

References findQualityFiles::v.

Referenced by operator<<().

494  {
495  return v;
496  }

◆ return()

mathSSE::return ( (rh ^ lh) &  mask) == 0

Referenced by EPOS::EPOS_Wrapper::byte_num_to_double(), EPOS::EPOS_Wrapper::byte_num_to_int(), g4TestGeometry_cfi::checkOverlap(), customise_RPCgeom37X::customise(), TimeMemoryInfo::customise(), TimeMemorySummary::customise(), customiseg4PrintGeomInfo::customise(), DataMixer_DataConditions_3_8_X_data2010::customise(), SimTrackProducerForFullSim_cff::customise(), ECALHCAL::customise(), HCAL::customise(), SingleMuPt10::customise(), SingleNuE10::customise(), IgProfInfo::customise(), JeProfInfo::customise(), TimeMemoryG4Info::customise(), SimCalorimetry_setPreshowerHighGain_cff::customise(), SimWithoutCastor_cff::customise(), customise::customise(), APDSimu_cff::customise(), noAbortPDGid_custom::customise(), cpuBenchmark_cff::customise(), DigiToRecoNoPU::customise(), customiseExotica_cff::customise(), SimCalorimetry_setPreshowerLowGain_cff::customise(), DigiToRecoPU::customise(), NeutronBGforMuonsXS_cff::customise(), NeutronBGforMuonsHP_cff::customise(), valid3Dt::customise(), useSource_custom::customise(), ProcessFromBareGEN_cff::customise(), SimTrackProducerForFastSim_cff::customise(), SimTracker_SetPeak_cff::customise(), SimTracker_SetDeconv_cff::customise(), online_customizations_cfi::customise(), SimWithCastor_cff::customise(), SimCalorimetry_EcalSelectiveReadoutProducers_setBeamcom09_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(), customiseHBHEreco::hbheUseM0FullRangePhase1(), CustomConfigs::HLTDropPrevious(), CustomConfigs::L1T(), CustomConfigs::L1THLT(), MassReplace::massReplaceInputTag(), MassReplace::massReplaceParameter(), NeutronBGforMuons_cff::neutronBG(), IteratedMedianCMNSubtractor::pairMedian(), TrackerTopology::pixDouble(), g4PrintGeomInfo_cfi::printGeomInfo(), g4PrintG4Solids_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(), and beamvalidation::unpack().

◆ samesign()

template<typename T >
bool mathSSE::samesign ( T  rh,
T  lh 
)
inline

◆ samesign< int >()

return mathSSE::samesign< int > ( a.  i,
b.  i 
)

◆ samesign< long long >()

return mathSSE::samesign< long long > ( a.  i,
b.  i 
)

◆ sqrt()

template<typename T >
T mathSSE::sqrt ( T  t)
inline

Definition at line 19 of file SSEVec.h.

Referenced by gpuPixelRecHits::__attribute__(), evf::__attribute__(), fastjet::BackgroundEstimator::_compute(), PedestalTask::_dump(), LEDTask::_dump(), LaserTask::_dump(), GflashTrajectory::_refreshCache(), res::HelperJet::a(), LocalTrajectoryParameters::absdz(), SingleParticleEvent::absmom(), BPHFittedBasicSelect::accept(), sistrip::LinearFit::add(), sistrip::MeanAndStdDev::add(), MTDDetSector::add(), CTPPSRPAlignmentCorrectionData::add(), CaloSpecificAlgo::add_MET_in_HF(), FullModelReactionDynamics::AddBlackTrackParticles(), FWRecoGeometryESProducer::addCaloGeometry(), HcalHitMaker::addHit(), RadialInterval::addInterval(), ReferenceTrajectory::addMaterialEffectsBrl(), PFMuonAlgo::addMissingMuons(), BPHDecayToChargedXXbarBuilder::addParticle(), BPHDecayToTkpTknSymChargeBuilder::addParticle(), Hector::addPartToHepMC(), PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), MillePedeAlignmentAlgorithm::addPxbSurvey(), FBaseSimEvent::addSimTrack(), PixelRecoLineRZ::addTIP(), CSCPairResidualsConstraint::addTrack(), ME0SegAlgoRU::addUniqueSegments(), hitfit::adjust_e_for_mass(), hitfit::adjust_p_for_mass(), AlignmentMonitorMuonResiduals::afterAlignment(), SiStripHitResolFromCalibTree::algoAnalyze(), SiStripCalibLorentzAngle::algoBeginJob(), algorithm(), MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), AlphaTVarProducer::alphaT(), CSCStripConditions::analogNoise(), ApvLatencyAlgorithm::analyse(), FedTimingAlgorithm::analyse(), CalibrationAlgorithm::analyse(), SamplingAlgorithm::analyse(), ApvTimingAlgorithm::analyse(), DaqScopeModeAlgorithm::analyse(), FastFedCablingAlgorithm::analyse(), NoiseAlgorithm::analyse(), PedestalsAlgorithm::analyse(), PedsOnlyAlgorithm::analyse(), PedsFullNoiseAlgorithm::analyse(), CkfDebugger::analyseCompatibleMeasurements(), PFCandConnector::analyseNuclearWPrim(), PFCandConnector::analyseNuclearWSec(), ME0RecHitsValidation::analyze(), ME0SegmentsValidation::analyze(), GEMRecHitValidation::analyze(), TrackingTruthValid::analyze(), myFastSimVal::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), L1TPhase2OuterTrackerTkMET::analyze(), RPCPointVsRecHit::analyze(), OuterTrackerMonitorTrackingParticles::analyze(), L1TStage2uGMT::analyze(), EgammaBasicClusters::analyze(), ElectronTagProbeAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), RPCRecHitValid::analyze(), ZCountingElectrons::analyze(), EgammaSuperClusters::analyze(), SiPixelPhase1RecHitsV::analyze(), PrimaryVertexMonitor::analyze(), CaloTowersValidation::analyze(), EwkElecDQM::analyze(), SUSY_HLT_DoubleMuon_Hadronic::analyze(), TrackerHitAnalyzer::analyze(), TrackingRecoMaterialAnalyser::analyze(), MuonSeedsAnalyzer::analyze(), HLTMCtruth::analyze(), SiPixelRecHitsValid::analyze(), SUSY_HLT_DoubleEle_Hadronic::analyze(), ElectronMcFakeValidator::analyze(), EwkMuLumiMonitorDQM::analyze(), EcalPileUpDepMonitor::analyze(), SiPixelPhase1TrackingParticleV::analyze(), HGCalTestPartialWaferHits::analyze(), DiMuonVertexMonitor::analyze(), HLTTauDQMPathPlotter::analyze(), SUSY_HLT_DiJet_MET::analyze(), SUSY_HLT_Muon_Hadronic::analyze(), MBUEandQCDValidation::analyze(), TkAlCaRecoMonitor::analyze(), ElectronAnalyzer::analyze(), SUSY_HLT_MuEle_Hadronic::analyze(), EwkDQM::analyze(), CaloTowersAnalyzer::analyze(), HGCalShowerSeparation::analyze(), TrackSplittingMonitor::analyze(), PhotonMonitor::analyze(), TrackBuildingAnalyzer::analyze(), TopDiLeptonDQM::analyze(), SiStripLAProfileBooker::analyze(), SiPixelRecHitSource::analyze(), ValidationMisalignedTracker::analyze(), L1GctValidation::analyze(), HiggsDQM::analyze(), PhotonValidatorMiniAOD::analyze(), TrackParameterAnalyzer::analyze(), ElectronCalibration::analyze(), SiStripMonitorCluster::analyze(), DQMSourcePi0::analyze(), ContainmentCorrectionAnalyzer::analyze(), BDHadronTrackMonitoringAnalyzer::analyze(), SiPixelTrackResidualSource::analyze(), HLTInclusiveVBFSource::analyze(), SiPixelHitEfficiencySource::analyze(), MuonIdDQM::analyze(), DTCalibValidationFromMuons::analyze(), TestHits::analyze(), MuonPathSLFitter::analyze(), EtlLocalRecoValidation::analyze(), TkConvValidator::analyze(), TestSmoothHits::analyze(), SiPixelCalSingleMuonAnalyzer::analyze(), BPHMonitor::analyze(), BtlLocalRecoValidation::analyze(), StandaloneTrackMonitor::analyze(), HGCalMouseBiteTester::analyze(), PixelLumiDQM::analyze(), TestOutliers::analyze(), TestTrackHits::analyze(), HitEff::analyze(), MuonIdVal::analyze(), ResolutionAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), TkAlV0sAnalyzer::analyze(), PhotonValidator::analyze(), NearbyPixelClustersAnalyzer::analyze(), SiPixelErrorEstimation::analyze(), GeneralPurposeVertexAnalyzer::analyze(), ValidIsoTrkCalib::analyze(), SiPixelTrackingRecHitsValid::analyze(), GEMEfficiencyAnalyzer::analyze(), TrackCount::analyze(), MtdEleIsoValidation::analyze(), DiMuonVertexValidation::analyze(), DiElectronVertexValidation::analyze(), JetAnalyzer_HeavyIons::analyze(), EcalCosmicsHists::analyze(), PrimaryVertexValidation::analyze(), FSQDQM::analyze(), ZToMuMuGammaAnalyzer::analyze(), SplitVertexResolution::analyze(), EmDQMReco::analyze(), SeedMultiplicityAnalyzer::analyze(), StudyCaloResponse::analyze(), DiMuonMassBiasMonitor::analyze(), PhotonAnalyzer::analyze(), SiPixelLorentzAnglePCLWorker::analyze(), DiMuonValidation::analyze(), IsolatedTracksCone::analyze(), L1MuonRecoTreeProducer::analyze(), SiStripRecHitsValid::analyze(), TrackerDpgAnalysis::analyze(), MuonTrackValidator::analyze(), Primary4DVertexValidation::analyze(), SiStripTrackingRecHitsValid::analyze(), CMTRawAnalyzer::analyze(), ExoticaDQM::analyzeDiElectrons(), ExoticaDQM::analyzeDiJets(), ExoticaDQM::analyzeDiMuons(), ExoticaDQM::analyzeDiPhotons(), EgammaObjects::analyzeElectrons(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoMuons(), CaloSimHitAnalysis::analyzePassiveHits(), EgammaObjects::analyzePhotons(), HIPTwoBodyDecayAnalyzer::analyzeTrackCollection(), GlobalTrackerMuonAlignment::analyzeTrackTrack(), GlobalTrackerMuonAlignment::analyzeTrackTrajectory(), OverlapValidation::analyzeTrajectory(), angle(), reco::PFDisplacedVertex::angle_io(), SignedImpactParameter3D::apply(), SignedDecayLength3D::apply(), SignedTransverseImpactParameter::apply(), CSCAlignmentCorrections::applyAlignment(), BaseProtonTransport::ApplyBeamCorrection(), RegressionHelper::applyCombinationRegression(), FFTJetCorrectionProducer::applyCorrections(), HLTMuonDimuonL3Filter::applyDiMuonSelection(), GlobalHaloAlgo::ApplyMatchingCuts(), MuonSimHitProducer::applyMaterialEffects(), mkfit::applyMaterialEffects(), approx_erf(), HLTPMMassFilter::approxMomAtVtx(), CACell::areAlignedRZ(), HGCGraphT< TILES >::areTimeCompatible(), HGCalDDDConstants::assignCellTrap(), TrackstersMergeProducerV3::assignTimeToCandidates(), TrackstersMergeProducer::assignTimeToCandidates(), SegmentsTrackAssociator::associate(), TrackGenAssociatorByChi2Impl::associateGenToReco(), TrackAssociatorByChi2Impl::associateSimToReco(), pat::PATLostTracks::associateTrkToVtx(), fastmath::atan2r(), PVPositionBuilder::average(), Cluster1DCleaner< T >::average(), res::HelperJet::b(), BaseProtonTransport::BaseProtonTransport(), EcalClusterLazyToolsBase::BasicClusterTime(), reco::BeamSpot::beamWidthFromBeta(), BeamSpotObjects::beamWidthXError(), reco::BeamSpot::BeamWidthXError(), BeamSpotObjects::beamWidthYError(), reco::BeamSpot::BeamWidthYError(), gen::JetMatchingMadgraph::beforeHadronisation(), DAClusterizerInZT_vect::beta0(), reco::TrackBase::betaError(), BetaBoostEvtVtxGenerator::BetaFunction(), BetafuncEvtVtxGenerator::BetaFunction(), MixBoostEvtVtxGenerator::BetaFunction(), MuonSeedCleaner::BiggerCone(), PhysicsTools::Calibration::Histogram< float >::binError(), PhysicsTools::Calibration::Histogram2D< Value_t, AxisX_t, AxisY_t >::binError(), PhysicsTools::Calibration::Histogram3D< Value_t, AxisX_t, AxisY_t, AxisZ_t >::binError(), SiPixelPhase1Analyzer::BookBarrelBins(), SiPixelPhase1Analyzer::BookForwardBins(), BSFitter::BSFitter(), BTLElectronicsSim::BTLElectronicsSim(), PixelTrackBuilder::build(), FWTracksterProxyBuilder::build(), FWCSCRecHitProxyBuilder::build(), FWSecVertexProxyBuilder::build(), FWSecVertexCandidateProxyBuilder::build(), FWTracksterLayersProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), FWVertexProxyBuilder::build(), gen::AMPTHadronizer::build_ampt(), ConvertedPhotonProducer::buildCollections(), ME0ReDigiProducer::buildDigis(), TtFullLepHypGenMatch::buildMatchingNeutrinos(), PPSAlignmentHarvester::buildModeGraph(), SeedForPhotonConversionFromQuadruplets::buildSeedBool(), CSCSegAlgoST::buildSegments(), ME0SegmentAlgorithm::buildSegments(), TrackExtenderWithMTDT< TrackCollection >::buildTrack(), btagbtvdeep::TrackInfoBuilder::buildTrackInfo(), FinalTreeBuilder::buildTree(), ConstrainedTreeBuilder::buildTree(), ConstrainedTreeBuilderT::buildTree(), FWME0RecHitProxyBuilder::buildViewType(), FWRPCRecHitProxyBuilder::buildViewType(), FWGEMRecHitProxyBuilder::buildViewType(), EcalMixingModuleValidation::bunchSumTest(), res::HelperJet::c(), PhotonMVABasedHaloTagger::calAngleBetweenEEAndSubDet(), Averages::calc(), ClusterShapeAlgo::calc_AbsZernikeMoment(), EcalClusterToolsT< noZS >::calc_AbsZernikeMoment(), GlobalCoordsObtainer::calc_atan_lut(), MuCSCTnPFlatTableProducer::calcDeltaR(), emtf::Tree::calcError(), HiFJRhoProducer::calcMd(), L1MetPfProducer::CalcMetHLS(), RazorVarProducer::CalcMR(), razor::CalcMR(), HLTRFilter::CalcMR(), SUSY_HLT_Razor::CalcMR(), RazorMonitor::CalcMR(), razor::CalcMTR(), EnergyResolutionVsLumi::calcmuTot(), HLTRegionalEcalResonanceFilter::calcPaircluster(), HIPAlignmentAlgorithm::calcParameters(), Phase2TrackerDigitizerAlgorithm::calcQ(), SiPixelDigitizerAlgorithm::calcQ(), RazorVarProducer::CalcR(), HLTRFilter::CalcR(), SUSY_HLT_Razor::CalcR(), RazorMonitor::CalcR(), calCSVariables(), reco::helper::CastorJetIDHelper::calculate(), GsfVertexWeightCalculator::calculate(), AutocorrelationAnalyzer::calculate(), pat::CaloIsolationEnergy::calculate(), pat::LeptonJetIsolationAngle::calculate(), pat::LeptonVertexSignificance::calculate(), GlobalHaloAlgo::Calculate(), FastCircleFit::calculate(), CSCHaloAlgo::Calculate(), SuperClusterShapeAlgo::Calculate_Covariances(), SiStripClusterInfo::calculate_noise(), ECAL2DPositionCalcWithDepthCorr::calculateAndSetPositionActual(), Basic2DGenericPFlowPositionCalc::calculateAndSetPositionActual(), ApeEstimatorSummary::calculateApe(), EndcapPiZeroDiscriminatorAlgo::calculateBarrelNNInputVariables(), ZdcSD::calculateCherenkovDeposit(), TBPositionCalc::CalculateCMSPos(), JetPlusTrackCorrector::calculateCorr(), CalculateCorrection(), CorrPCCProducer::calculateCorrections(), trklet::TrackDerTable::calculateDerivatives(), ticl::PatternRecognitionbyCLUE3D< TILES >::calculateDistanceToHigher(), HGCalImagingAlgo::calculateDistanceToHigher(), dqmTnP::AbstractFitter::calculateEfficiency(), HeavyFlavorHarvesting::calculateEfficiency1D(), HeavyFlavorHarvesting::calculateEfficiency2D(), ticl::PatternRecognitionbyCLUE3D< TILES >::calculateLocalDensity(), TT6ApvMask::calculateMask(), ConvertedPhotonProducer::calculateMinApproachDistance(), PhotonMVABasedHaloTagger::calculateMVA(), MultipleAlgoIterator::calculatePedestal(), ReflectedIterator::calculatePedestal(), PileUpSubtractor::calculatePedestal(), HiPuRhoProducer::calculatePedestal(), tkDetUtil::calculatePhiWindow(), Quantile::calculateQ(), PFMETBenchmark::calculateQuantities(), ThirdHitPrediction::calculateRangesBarrel(), CalculateResponse(), HBHEPulseShapeFlagSetter::CalculateRMS8Max(), GsfElectronAlgo::calculateShowerShape(), reco::ForwardProton::calculateT(), CTPPSProtonReconstructionPlotter::CalculateTimingTrackingDistance(), reco::TauMassTagInfo::calculateTrkP4(), CSCXonStrip_MatchGatti::calculateXonStripError(), QGTagger::calcVariables(), ElectronEnergyCalibrator::calibrate(), MillePedeAlignmentAlgorithm::callMille2D(), CaloCellCrossing::CaloCellCrossing(), CaloSegment::CaloSegment(), CaloTowersClient::CaloTowersEndjob(), TwoBodyDecayModel::cartesianSecondaryMomenta(), CastorPedestalAnalysis::CastorPedVal(), MahiFit::ccTime(), HGCalDDDConstants::cellInLayer(), SummaryOutputProducer::GenericSummary::changed(), SummaryOutputProducer::TriggerSummary::changed(), PFMuonAlgo::changeTrack(), PrimaryVertexAssignment::chargedHadronVertex(), ThirdHitPredictionFromInvLine::check(), MtdTracksValidation::checkAcceptance(), PFAlgo::checkCleaning(), HitResol::checkConsistency(), ResolutionAnalyzer::checkDeltaR(), MuScleFit::checkDeltaR(), reco::modules::TrackerTrackHitFilter::checkHitAngle(), FWPFMaths::checkIntersect(), AlignmentTwoBodyDecayTrackSelector::checkMass(), AlignmentTwoBodyDecayTrackSelector::checkMETMass(), l1t::L1GTDeltaCut::checkObjects(), HFNoseNumberingScheme::checkPosition(), HGCalNumberingScheme::checkPosition(), reco::modules::TrackerTrackHitFilter::checkPXLCorrClustCharge(), GlobalTrackingRegion::checkRZ(), HitPairGeneratorFromLayerPairForPhotonConversion::checkRZCompatibilityWithSeedTrack(), RectangularEtaPhiTrackingRegion::checkRZOld(), RPCSeedPattern::checkSegmentAlgorithmSpecial(), RPCSeedPattern::checkSimplePattern(), OniaPhotonConversionProducer::checkTkVtxCompatibility(), DreamSD::cherenkovDeposit_(), makeMuonMisalignmentScenario::cholesky(), L1MuonPixelTrackFitter::Circle::Circle(), brokenline::circleFit(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::circleFit(), riemannFit::circleFit(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::circleFit(), FastTSGFromL2Muon::clean(), FastTSGFromIOHit::clean(), mkfit::Event::clean_cms_seedtracks(), mkfit::StdSeq::clean_cms_seedtracks_iter(), EcalClusterPUCleaningTools::CleanedSuperCluster(), PFMuonAlgo::cleanMismeasured(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), EgammaSuperClusters::closestMCParticle(), EcalClusterSeverityLevelAlgo::closestProblematic(), TCMETAlgo::closeToElectron(), EcalClusterToolsT< noZS >::cluster2ndMoments(), clusterIsLessThan(), PFlow2DClusterizerWithTime::clusterTimeResolution(), PFlow2DClusterizerWithTime::clusterTimeResolutionFromSeed(), EpCombinationTool::combine(), GenXSecAnalyzer::combine(), combinedOccupancy(), EcalCondTools::compareEndcap(), MTDSectorForwardDoubleLayer::compatible(), BarrelDetLayer::compatible(), ForwardDetLayer::compatible(), PixelClusterShapeSeedComparitor::compatible(), MuRingForwardDoubleLayer::compatible(), StripSubClusterShapeSeedFilter::compatible(), MTDSectorForwardLayer::compatibleDets(), MuRingForwardLayer::compatibleDets(), MuDetRing::compatibleDets(), MTDDetTray::compatibleDets(), reco::tau::compChargedHadronP4fromPxPyPz(), OutInConversionSeedFinder::completeSeed(), InOutConversionSeedFinder::completeSeed(), METCorrectionAlgorithm::compMETCorrection(), BoundSpan::compute(), GsfMultipleScatteringUpdator::compute(), MultipleScatteringUpdator::compute(), CircleEq< T >::compute(), MultipleScatteringSimulator::compute(), PairProductionSimulator::compute(), EnergyLossSimulator::compute(), EMShower::compute(), NuclearInteractionFTFSimulator::compute(), NuclearInteractionSimulator::compute(), DTParametrizedDriftAlgo::compute(), GenXSecAnalyzer::compute(), calo::multifit::compute_decomposition(), calo::multifit::compute_decomposition_forwardsubst_with_offsets(), calo::multifit::compute_decomposition_unrolled(), l1tVertexFinder::VertexFinder::computeAndSetVertexParameters(), SiStripFineDelayTLA::computeAngleCorr(), SiPixelErrorEstimation::computeAnglesFromDetPosition(), MuonDTSeedFromRecHits::computeBestPt(), EnergyLossUpdator::computeBetheBloch(), EcalUncalibRecHitTimingCCAlgo::computeCC(), TMarkov::computeChain(), ParticleKinematicLinearizedTrackState::computeChargedJacobians(), PerigeeLinearizedTrackState::computeChargedJacobians(), SiStripGainFromData::ComputeChargeOverPath(), ZeeCalibration::computeCoefficientDistanceAtIteration(), reco::EcalClustersGraph::computeCovariances(), LinkByRecHit::computeDist(), reco::TemplatedSecondaryVertex< SV >::computeDist1d(), reco::TemplatedSecondaryVertex< SV >::computeDist2d(), reco::TemplatedSecondaryVertex< SV >::computeDist3d(), DTTime2DriftParametrization::computeDriftDistance_mean(), MuonME0SegHarvestor::ComputeEff(), MuonME0DigisHarvestor::ComputeEff(), HLTGenValClient::computeEfficiency(), DQMGenericClient::computeEfficiency(), HTrackVariables::computeEfficiency(), MtdEleIsoHarvester::computeEfficiency1D(), MtdTracksHarvester::computeEfficiency1D(), Primary4DVertexHarvester::computeEfficiency1D(), GlobalMuonMatchAnalyzer::computeEfficiencyEta(), GlobalMuonMatchAnalyzer::computeEfficiencyPt(), EnergyLossUpdator::computeElectrons(), ElectronEPcombinator::computeEPcombination(), AnalyticalCurvilinearJacobian::computeFullJacobian(), PileupJetIdAlgo::computeIdVariables(), MVAJetPuId::computeIdVariables(), AnalyticalCurvilinearJacobian::computeInfinitesimalJacobian(), ElectronTagProbeAnalyzer::computeInvMass(), ElectronAnalyzer::computeInvMass(), SuperClusterHelper::computeLocalCovariances(), BPhysicsOniaDQM::computeMass(), MuonDTSeedFromRecHits::computeMean(), PuppiAlgo::computeMedRMS(), PFMETAlgorithmMVA::computeMET(), Phase1L1TJetProducer::computeMET(), Phase1L1TJetSumsProducer::computeMHT(), GaussianSumUtilities1D::computeMode(), RazorAnalyzer.RazorAnalyzer::computeMR(), RazorAnalyzer.RazorAnalyzer::computeMTR(), SeedMvaEstimator::computeMva(), HFCherenkov::computeNPE(), HFCherenkov::computeNPEinPMT(), ComputeOOTFraction(), l1tVertexFinder::Vertex::computeParameters(), RPCSeedPattern::computePtwithThreerecHits(), RPCSeedPattern::computePtWithThreerecHits(), HTrack::computePull(), CkfDebugger::computePulls(), PFGsfHelper::computeQpMode(), HGCalRadiationMap::computeRadius(), DTOccupancyCluster::computeRadius(), HTrack::computeResolution(), HTrack::computeResolutionAndPull(), reco::EcalClustersGraph::computeShowerShapes(), hgcal::EGammaPCAHelper::computeShowerWidth(), SiPixelInformationExtractor::computeStatus(), HTrack::computeTDRResolution(), EcalUncalibRecHitRatioMethodAlgo< EBDataFrame >::computeTime(), DTDigitizer::computeTime(), EcalSelectiveReadoutValidation::configFirWeights(), DDHGCalGeom::constructLayers(), AddCorrectionsToGenericMET::constructP4From(), SiTrivialDigitalConverter::convert(), converter::TrackToRefCandidate::convert(), converter::SuperClusterToCandidate::convert(), converter::TrackToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::PFClusterToRefCandidate::convert(), CaloTowersCreationAlgo::convert(), mkfit::TrackState::convertFromCartesianToCCS(), mkfit::TrackState::convertFromGlbCurvilinearToCCS(), MTDThresholdClusterizer::copy_to_buffer(), Cordic::Cordic(), JetPlusTrackCorrector::correctAA(), EGEnergyCorrector::CorrectedEnergyWithError(), EGEnergyCorrector::CorrectedEnergyWithErrorV3(), egamma::correctElectronMomentum(), plotscripts::corrections2D(), MuonMETAlgo::correctMETforMuon(), CSCCondSegFit::correctTheCovMatrix(), MeasurementTiltmeter::correctValueAndSigma(), TEcnaRun::CorrelationsBetweenSamples(), ZeeKinematicTools::cosThetaElectrons_SC(), ZeeKinematicTools::cosThetaElectrons_TK(), ConstrainedTreeBuilder::covarianceMatrix(), ConstrainedTreeBuilderT::covarianceMatrix(), PFAlgo::createCandidatesHCAL(), PFAlgo::createCandidatesHF(), FastCircle::createCircleParameters(), FastLine::createLineParameters(), CaloSD::createNewHit(), plotscripts::createPeaksProfile(), Run3ScoutingParticleToRecoPFCandidateProducer::createPFCand(), DDHGCalNoTaperEndcap::createQuarter(), fireworks::createSegment(), TGeoMgrFromDdd::createShape(), CaloDetIdAssociator::crossedElement(), ThirdHitPredictionFromInvLine::crossing(), MuonShowerInformationFiller::crossingPoint(), CTPPSFastTrackingProducer::CTPPSFastTrackingProducer(), TtFullLepKinSolver::cubic(), ThirdHitPredictionFromCircle::curvature(), ConformalMappingFit::curvature(), VectorHitBuilderAlgorithm::curvatureANDphi(), plotscripts::curvatureDTsummary(), plotscripts::curvatureplot(), reco::GhostTrackPrediction::curvilinearError(), CurvilinearTrajectoryParameters::CurvilinearTrajectoryParameters(), GeometricAnnealing::cutoff(), DeterministicAnnealing::cutoff(), ResidualRefitting::cylExtrapTrkSam(), res::HelperJet::d(), MaterialBudgetData::dataPerStep(), plotscripts::DBdiff(), CircleEq< T >::dca(), CircleEq< T >::dca0(), GlobalTrackerMuonAlignment::debugTrajectorySOS(), GlobalTrackerMuonAlignment::debugTrajectorySOSv(), GenericHouseholder::decompose(), HouseholderDecomposition::decompose(), FullModelReactionDynamics::Defs1(), AlcaBeamSpotManager::delta(), kinem::delta_R(), hitfit::delta_r(), CollinearFitAtTM2::deltaP(), JetVertexMain::DeltaR(), PythiaFilterEMJetHeep::deltaR(), reco::deltaR(), PFBenchmarkAlgo::deltaR(), IsoTrackCalib::deltaR(), MuScleFitUtils::deltaR(), JetAnalyzer_HeavyIons_matching::deltaRR(), EMEnrichingFilterAlgo::deltaRxyAtEE(), FourMomentumKinematicConstraint::derivative(), Pixel3DDigitizerAlgorithm::diffusion(), HelixBarrelPlaneCrossingByCircle::direction(), LocalTrajectoryParameters::direction(), muonisolation::PixelTrackExtractor::directionAtPresetRadius(), ConformalMappingFit::directionPhi(), reco::tau::PFRecoTauDiscriminationByMVAIsolationRun2::discriminate(), CandidateChargeBTagComputer::discriminator(), CosmicMuonGenerator::displayEv(), SurveyPxbImageLocalFit::dist(), VertexAnalysis::dist2D(), DTOccupancyPoint::distance(), VertexDistanceXY::distance(), VertexDistance3D::distance(), DisplacedVertexCluster::Distance::distance(), HGCalCLUEAlgoT< TILE, STRATEGY >::distance(), HGCalImagingAlgo::distance(), HGVHistoProducerAlgo::distance(), HGCalDDDConstants::distFromEdgeTrap(), divide(), EmDQMPostProcessor::dividehistos(), JetMETDQMPostProcessor::dividehistos(), ConversionPostprocessing::dividePlots(), PhotonPostprocessing::dividePlots(), PhotonOfflineClient::dividePlots(), external::HEPTopTaggerV2_fixed_R::djademod(), MuonAlignmentInputXML::do_rotateglobalaxis(), CSCSkim::doBFieldStudySelection(), GflashHadronShowerProfile::doCholeskyReduction(), Decay3Body::doDecay(), V0Validator::doEfficiencies(), HLTTauRefProducer::doElectrons(), V0Validator::doFakeRates(), PulseChiSqSNNLS::DoFit(), SurveyPxbImageLocalFit::doFit(), SiPixelGainCalibrationAnalysis::doFits(), MuonTestSummary::doKinematicsTests(), OutsideInMuonSeeder::doLayer(), PPSAlignmentHarvester::doMatch(), CSCOfflineMonitor::doSegments(), MultiTrackValidatorGenPs::dqmAnalyze(), TICLPFValidation::dqmAnalyze(), DTSegment2DQuality::dqmAnalyze(), DTSegment2DSLPhiQuality::dqmAnalyze(), MultiTrackValidator::dqmAnalyze(), DTSegment4DQuality::dqmAnalyze(), CaloParticleValidation::dqmAnalyze(), TICLTrackstersEdgesValidation::dqmAnalyze(), EmDQMPostProcessor::dqmEndJob(), HltSusyExoPostProcessor::dqmEndJob(), MuonRecoTest::dqmEndJob(), DTChamberEfficiencyClient::dqmEndJob(), Vx3DHLTAnalyzer::dqmEndLuminosityBlock(), DTEfficiencyTest::dqmEndLuminosityBlock(), EwkElecDQM::dqmEndRun(), TwoBodyDecayDerivatives::dqsdm(), TwoBodyDecayDerivatives::dqsdphi(), TwoBodyDecayDerivatives::dqsdpx(), TwoBodyDecayDerivatives::dqsdpy(), TwoBodyDecayDerivatives::dqsdpz(), TwoBodyDecayDerivatives::dqsdtheta(), CaloTowersValidation::dR(), CaloTowersAnalyzer::dR(), HcalSimHitsValidation::dR(), HcalRecHitsValidation::dR(), HcalRecHitsAnalyzer::dR(), IsoTrackCalib::dR(), PF_PU_AssoMapAlgos::dR(), IsoTrig::dR(), MuonGmtPair::dR(), CMTRawAnalyzer::dR(), TrackerMap::drawModule(), TEveEllipsoidProjectedGL::DrawRhoPhi(), TEveEllipsoidProjectedGL::DrawRhoZ(), SiLinearChargeCollectionDrifter::drift(), Phase2TrackerDigitizerAlgorithm::drift(), SiPixelDigitizerAlgorithm::drift(), Pixel3DDigitizerAlgorithm::driftFor3DSensors(), G4muDarkBremsstrahlungModel::DsigmaDx(), reco::PFBlockElementCluster::Dump(), reco::PFBlockElementSuperCluster::Dump(), reco::PFDisplacedVertexSeed::Dump(), reco::PFDisplacedVertexCandidate::Dump(), DAClusterizerInZ_vect::dump(), DAClusterizerInZT_vect::dump(), FittedEntriesManager::dumpEntriesSubstraction(), Fit::dumpEntryAfterFit(), Fit::dumpEntryCorrelations(), DTTrigGeom::dumpLUT(), TrackstersMergeProducerV3::dumpTrackster(), TrackstersMergeProducer::dumpTrackster(), Pi0FixedMassWindowCalibration::duringLoop(), ZeeCalibration::duringLoop(), reco::BeamSpot::dxdzError(), BeamSpotObjects::dxdzError(), reco::TrackBase::dxyError(), pat::PackedCandidate::dxyError(), l1t::TkBsCandidate::dxyPhiPair(), l1t::TkPhiCandidate::dxyTrkPair(), reco::BeamSpot::dydzError(), BeamSpotObjects::dydzError(), reco::TrackBase::dzError(), pat::PackedCandidate::dzError(), EcalHitMaker::ecalCellLine(), CSCHaloAlgo::ECALSegmentMatching(), EcalTrapezoidParameters::EcalTrapezoidParameters(), l1t::ClusterShapes::eD(), DDEcalEndcapAlgo::EECreateCR(), DDEcalEndcapAlgo::EECreateSC(), EcalEleCalibLooper::EERegionId(), SiPixelHitEfficiencyModule::eff(), EffPurFromHistos::EffPurFromHistos(), EffPurFromHistos2D::EffPurFromHistos2D(), mkfit::TrackState::einvpT(), ElectronPFIsolationWithConeVeto::ElectronPFIsolationWithConeVeto(), mkfit::TrackState::emomEta(), mkfit::TrackState::emomPhi(), CSCRecHitTrait::emplace_back(), EMShower::EMShower(), EcalLiteDTUCoder::encode(), EcalCoder::encode(), MuonGeometryArrange::endHist(), DTTPAnalyzer::endJob(), DTTTrigCorrectionFirst::endJob(), FilterOutLowPt::endJob(), DTT0CalibrationRMS::endJob(), DTT0Calibration::endJob(), L1GtTrigReport::endJob(), GenXSecAnalyzer::endJob(), GlobalTrackerMuonAlignment::endJob(), DMRChecker::endJob(), PixelLumiDQM::endLuminosityBlock(), HLTScalersClient::endLuminosityBlock(), ZeeCalibration::endOfJob(), ZeeCalibration::endOfLoop(), KinematicParameters::energy(), trigger::TriggerObject::energy(), reco::Conversion::EoverP(), reco::Conversion::EoverPrefittedTracks(), mkfit::TrackState::eposEta(), mkfit::TrackState::eposPhi(), mkfit::TrackState::eposR(), mkfit::TrackState::epT(), mkfit::TrackState::epxpx(), mkfit::TrackState::epypy(), mkfit::TrackState::epzpz(), npstat::EquidistantInLogSpace::EquidistantInLogSpace(), count_t::error(), CSCPairResidualsConstraint::error(), reco::ForwardProton::error(), stats_t< T >::error(), reco::TrackBase::error(), GSUtilities::errorCombinedMean(), MuonResidualsTwoBin::errorerror(), TValidTrackingRecHit::errorGlobalR(), TRecHit5DParamConstraint::errorGlobalR(), TRecHit2DPosConstraint::errorGlobalR(), BaseTrackerRecHit::errorGlobalR(), TValidTrackingRecHit::errorGlobalRPhi(), TRecHit5DParamConstraint::errorGlobalRPhi(), TRecHit2DPosConstraint::errorGlobalRPhi(), BaseTrackerRecHit::errorGlobalRPhi(), TValidTrackingRecHit::errorGlobalZ(), TRecHit5DParamConstraint::errorGlobalZ(), TRecHit2DPosConstraint::errorGlobalZ(), BaseTrackerRecHit::errorGlobalZ(), reco::GsfTrack::errorMode(), PixelTrackErrorParam::errPhi(), PixelTrackErrorParam::errTip(), PixelTrackErrorParam::errZip(), LandauFluctuationGenerator::ersatzt(), EcalClusterLazyToolsBase::eseffsirir(), TwoBodyDecayEstimator::estimate(), ConversionForwardEstimator::estimate(), ConversionBarrelEstimator::estimate(), fw::estimate_field(), FWRPZViewGeometry::estimateProjectionSize(), MuonSeedCreator::estimatePtSingle(), RectangularEtaPhiTrackingRegion::estimator(), res::HelperJet::et(), trigger::TriggerObject::et(), RawParticle::et(), kinem::eta(), cscdqm::Detector::Eta(), reco::TrackBase::etaError(), fastmath::etaphi(), reco::btau::etaRel(), metsig::SignAlgoResolutions::EtFunction(), mkfit::TrackState::etheta(), BTagPerformance::Eval(), ZeeCalibration::EvalDR(), l1t::CorrCondition::evaluateCondition(), l1t::CorrThreeBodyCondition::evaluateCondition(), l1t::CorrWithOverlapRemovalCondition::evaluateCondition(), PFMETAlgorithmMVA::evaluateMVA(), MonopoleEquation::EvaluateRhsGivenB(), DTMeanTimerFitter::evaluateVDriftAndReso(), AlignmentMonitorGeneric::event(), AlignmentMonitorTracksFromTrajectories::event(), trklet::TrackletCalculatorDisplaced::exactproj(), trklet::TrackletCalculatorBase::exactproj(), trklet::TrackletCalculatorDisplaced::exactprojdisk(), trklet::TrackletCalculatorBase::exacttracklet(), trklet::TrackletCalculatorDisplaced::exacttracklet(), trklet::TrackletCalculatorBase::exacttrackletdisk(), trklet::TrackletCalculatorBase::exacttrackletOverlap(), DDHGCalCell::execute(), DDHGCalWafer8::execute(), DDHGCalPassiveFull::execute(), DDHGCalWaferF::execute(), DDHGCalWaferFullRotated::execute(), DDCutTubsFromPoints::execute(), DDPixBarLayerAlgo::execute(), DDBHMAngular::execute(), DDPixBarLayerUpgradeAlgo::execute(), DDEcalBarrelNewAlgo::execute(), DDEcalBarrelAlgo::execute(), DDEcalEndcapAlgo::execute(), KinematicPerigeeConversions::extendedPerigeeFromKinematicParameters(), TrackTimeValueMapProducer::extractTrackVertexTime(), mkfit::TrackState::exx(), mkfit::TrackState::exy(), mkfit::TrackState::exz(), mkfit::TrackState::eyy(), mkfit::TrackState::eyz(), mkfit::TrackState::ezz(), TFParams::f3deg(), factorRPFromSensorCorrections(), HitQuadrupletGeneratorFromLayerPairForPhotonConversion::failCheckRZCompatibility(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), ClusterShapeAlgo::fast_AbsZernikeMoment(), EcalClusterToolsT< noZS >::fast_AbsZernikeMoment(), brokenline::fastFit(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::fastFit(), riemannFit::fastFit(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::fastFit(), CTPPSFastTrackingProducer::FastReco(), lowptgsfeleid::features_V0(), lowptgsfeleid::features_V1(), JanAlignmentAlgorithm::feed(), EcalClusterEnergyCorrection::fEtEta(), HiEgammaSCEnergyCorrectionAlgo::fEtEta(), magfieldparam::bcylDetails::ffunkti(), VertexHistogramMaker::fill(), VertexFitterResult::fill(), CTPPSAcceptancePlotter::DoubleArmPlots::fill(), EcalRegressionData::fill(), TrigObjTnPHistColl::ProbeData::fill(), HDelta::Fill(), HMassVSPart::Fill(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_generic_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), MTVHistoProducerAlgoForTracker::fill_ResoAndPull_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_simAssociated_recoTrack_histos(), SiPixelRecHitsValid::fillBarrel(), HcalTB04Analysis::fillBuffer(), TrackingNtuple::fillCandidates(), egHLT::OffHelper::fillClusShapeData(), GenSpecificAlgo::fillCommonMETData(), CombinedSVComputer::fillCommonVariables(), FittedEntriesSet::FillCorrelations(), AlignmentExtendedCorrelationsStore::fillCovariance(), AlignmentExtendedCorrelationsStore::fillCovarianceT(), DiMuonMassBiasMonitor::fillDecayHistograms(), CMTRawAnalyzer::fillDigiAmplitude(), CMTRawAnalyzer::fillDigiAmplitudeHF(), CMTRawAnalyzer::fillDigiAmplitudeHFQIE10(), CMTRawAnalyzer::fillDigiAmplitudeHO(), CMTRawAnalyzer::fillDigiAmplitudeQIE11(), DMRChecker::fillDMRs(), MaterialBudgetTrackerHistos::fillEndTrack(), MaterialBudgetHGCalHistos::fillEndTrack(), FittedEntriesSet::FillEntries(), NtupleManager::FillFitParameters(), mkfit::TTreeValidation::fillFitTree(), SiStripHitEfficiencyWorker::fillForTraj(), SiPixelRecHitsValid::fillForward(), TrackerHitProducer::fillG4MC(), GlobalHitsProdHist::fillG4MC(), GlobalHitsAnalyzer::fillG4MC(), GlobalHitsProducer::fillG4MC(), ECALRecHitAnalyzer::FillGeometry(), GlobalRecHitsProducer::fillHCal(), HGCalHistoSeedingImpl::fillHistoClusters(), HLXMonitor::FillHistograms(), tadqm::TrackAnalyzer::fillHistosForState(), TkAlCaRecoMonitor::fillHitmaps(), TrackerValidationVariables::fillHitQuantities(), MuonShowerInformationFiller::fillHitsByStation(), ApeEstimator::fillHitVariables(), AlCaHOCalibProducer::fillHOStore(), reco::tau::fillIsoMVARun2Inputs(), cms::PileupJPTJetIdAlgo::fillJPTBlock(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), GsfTrackProducerBase::fillMode(), METAnalyzer::fillMonitorElement(), TestResolution::fillMuonCollection(), ResolutionAnalyzer::fillMuonCollection(), TestCorrection::fillMuonCollection(), MuScleFitMuonSelector::fillMuonCollection(), MuScleFit::fillMuonCollection(), MuonIdProducer::fillMuonId(), SiStripPI::fillNoiseDetSummary(), egHLT::OffHelper::fillOffEleVec(), Phase2OTValidateRecHitBase::fillOTRecHitHistos(), ColinearityKinematicConstraintT< Dim >::fillParametersDerivative(), StripCPE::fillParams(), PixelCPEFastParamsHost< TrackerTraits >::fillParamsForDevice(), PixelCPEFast< TrackerTraits >::fillParamsForGpu(), DeepBoostedJetTagInfoProducer::fillParticleFeatures(), ticl::Trackster::fillPCAVariables(), PhotonProducer::fillPhotonCollection(), GEDPhotonProducer::fillPhotonCollection(), CTPPSProtonReconstructionSimulationValidator::fillPlots(), MuonTrackAnalyzer::fillPlots(), DiLepPlotHelp::PlotsVsKinematics::fillPlots(), Phase2ITValidateRecHitBase::fillRechitHistos(), SVTagInfoValidationAnalyzer::fillRecoToSim(), recoBSVTagInfoValidationAnalyzer::fillRecoToSim(), MuonTimingFiller::fillRPCTime(), SVTagInfoValidationAnalyzer::fillSimToReco(), recoBSVTagInfoValidationAnalyzer::fillSimToReco(), HGCalHistoSeedingImpl::fillSmoothHistoClusters(), SiPixelActionExecutor::fillSummary(), MuGEMMuonExtTableProducer::fillTable(), MuCSCTnPFlatTableProducer::fillTable(), MuonTimingFiller::fillTimeFromMeasurements(), CSCTimingExtractor::fillTiming(), DTTimingExtractor::fillTiming(), SiStripCondObjectRepresent::SiStripDataContainer< Item, type >::fillTrackerMap(), PrimaryVertexValidation::fillTrackHistos(), TrackingNtuple::fillTrackingParticles(), ApeEstimator::fillTrackVariables(), EnergyScaleAnalyzer::fillTree(), GlobalRecHitsAnalyzer::fillTrk(), GlobalRecHitsProducer::fillTrk(), edm::storage::StatisticsSenderService::FileStatistics::fillUDP(), ColinearityKinematicConstraintT< Dim >::fillValue(), PFMETFilter::filter(), PhotonGenFilter::filter(), PythiaFilterZJetWithOutBg::filter(), ChargedHadronTrackResolutionFilter::filter(), MuonBadTrackFilter::filter(), HLTPPSJetComparisonFilter::filter(), MCSmartSingleParticleFilter::filter(), MuScleFitFilter::filter(), MCMultiParticleFilter::filter(), MCParticlePairFilter::filter(), PythiaFilterMotherSister::filter(), HGCalTBCheckGunPostion::filter(), DisappearingMuonsSkimming::filter(), ModelpMSSMFilter::filter(), LeptonSkimming::filter(), CSCEfficiency::filter(), GenFilterInfo::filterEfficiencyError(), MvaMEtUtilities::finalize(), finalizeCommonMETData(), gen::Pythia6Hadronizer::finalizeEvent(), NoPileUpMEtUtilities::finalizeMEtData(), TwoTrackMinimumDistanceHelixHelix::finalPoints(), TwoTrackMinimumDistanceHelixLine::finalPoints(), PizeroMCTruthFinder::find(), ConversionTrackEcalImpactPoint::find(), NearbyPixelClustersProducer::findAllNearbyClusters(), PF_PU_AssoMapAlgos::FindClosest3D(), NearbyPixelClustersAnalyzer::findClosestCluster(), PF_PU_AssoMapAlgos::FindClosestZ(), EgammaHLTTrackIsolation::findIsoTracks(), EgammaHLTTrackIsolation::findIsoTracksWithoutEle(), analyzer::SiPixelLorentzAngle::findMean(), SiPixelLorentzAnglePCLHarvester::findMean(), LASPeakFinder::FindPeakIn(), ThirdHitPredictionFromInvParabola::findPointAtCurve(), EgammaObjects::findRecoMass(), Pythia8::PowhegHooksBB4L::findresscale(), mkfit::findSeedsByRoadSearch(), PFDisplacedVertexFinder::findSeedsFromCandidate(), contrib::CMSBoostedTauSeedingAlgorithm::findSubjets(), TrackerSystematicMisalignments::findSystematicMis(), RPixPlaneCombinatoryTracking::findTracks(), DivisiveVertexFinder::findVertexesAlt(), MagGeometry::findVolume(), CSCXonStrip_MatchGatti::findXOnStrip(), StraightTrackAlignment::finish(), CSCChamberFitter::fit(), MuonResidualsAngleFitter::fit(), MuonResidualsBfieldAngleFitter::fit(), MuonResidualsPositionFitter::fit(), MuonResiduals1DOFFitter::fit(), sistrip::LinearFit::fit(), DTSegmentUpdator::fit(), MuonResiduals6DOFrphiFitter::fit(), sistrip::MeanAndStdDev::fit(), VectorHitBuilderAlgorithm::fit(), hitfit::Chisq_Constrainer::fit(), VectorHitBuilderAlgorithm::fit2Dzx(), VectorHitBuilderAlgorithm::fit2Dzy(), BSFitter::Fit_dres_z_likelihood(), Fit_MaximumPoint(), V0Fitter::fitAll(), FakeBeamMonitor::FitAndFill(), BeamMonitor::FitAndFill(), SiPixelLorentzAnglePCLHarvester::fitAndStore(), fitFunction_f(), BPHKinematicFit::fitMomentum(), JetCoreClusterSplitter::fittingSplit(), TotemRPLocalTrackFitterAlgorithm::fitTrack(), RPixPlaneCombinatoryTracking::fitTrack(), PFDisplacedVertexFinder::fitVertexFromSeed(), alpgen::fixEventSingleTop(), alpgen::fixEventWZ(), hgcalsimclustertime::ComputeClusterTime::fixSizeHighestDensity(), L1GctMet::floatingPointAlgo(), SuepShower::fMaxwellBoltzmann(), SuepShower::fMaxwellBoltzmannPrime(), MuonSeedBuilder::foundMatchingSegment(), TSFit::fpol3dg(), riemannFit::fromCircleToPerigee(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::fromCircleToPerigee(), fromPtEtaPhiToPxPyPz(), MuScleFitUtils::fromPtEtaPhiToPxPyPz(), trackingTools::ftsFromVertexToPoint(), PerigeeConversions::ftsToPerigeeParameters(), FWExpressionValidator::FWExpressionValidator(), SummaryOutputProducer::GenericSummary::gained(), SummaryOutputProducer::TriggerSummary::gained(), GSUtilities::gauss(), Vx3DHLTAnalyzer::Gauss3DFunc(), PPSFastLocalSimulation::Distribution::Generate(), CMSCGEN::generate(), GaussianTailNoiseGenerator::generate_gaussian_tail(), gen::Pythia6PartonPtGun::generateEvent(), gen::Pythia6JetGun::generateEvent(), gen::Pythia6PtGun::generateEvent(), gen::Pythia6PtYDistGun::generateEvent(), SuepShower::generateFourVector(), BaseNumericalRandomGenerator::generateLin(), FullModelReactionDynamics::GenerateNBodyEvent(), edm::RandomXiThetaGunProducer::generateParticle(), gen::Py8PtAndDxyGun::generatePartonsAndHadronize(), gen::Py8PtExpGun::generatePartonsAndHadronize(), gen::Py8PtGun::generatePartonsAndHadronize(), gen::Py8PtotGun::generatePartonsAndHadronize(), gen::Py8EGun::generatePartonsAndHadronize(), gen::Py8MassGun::generatePartonsAndHadronize(), gen::Py8JetGun::generatePartonsAndHadronize(), gen::Py8PtAndLxyGun::generatePartonsAndHadronize(), SuepShower::generateShower(), PPSFastLocalSimulation::GenerateTrack(), FullModelReactionDynamics::GenerateXandPt(), DQMGenericClient::generic_eff(), HLTGenValClient::genericEff(), VertexClassifier::genPrimaryVertices(), gen::HijingHadronizer::get_particles(), PPSTools::Get_t_and_xi(), DAClusterizerInZT_vect::get_Tc(), get_triu_vector_index(), UEParameters::get_vn(), heppy::AlphaT::getAlphaT(), dtCalibration::DTTTrigFillWithAverage::getAverage(), DTMuonMillepede::getbqcMatrix(), magfieldparam::TkBfield::getBrfz(), HGCalParametersFromDD::getCellPosition(), CaloGeometryHelper::getClosestCell(), hgcal::ShowerDepth::getClusterDepthCompatibility(), StubPtConsistency::getConsistency(), egamma::conv::getConversionInfo(), HFRecalibration::getCorr(), reco::GlobalHaloData::GetCorrectedCaloMET(), DTMuonMillepede::getCqcMatrix(), ME0ReDigiProducer::getCustomStripProperties(), SteppingHelixPropagator::getDeDx(), HiGammaJetSignalDef::getDeltaR(), MuonRecoAnalyzer::getDeltaR(), DeviationsFromFileSensor2D::getDevis(), DTGeometryValidate::getDistance(), RPCSeedPattern::getDistance(), GEMGeometryValidate::getDistance(), RPCGeometryValidate::getDistance(), ME0GeometryValidate::getDistance(), CSCGeometryValidate::getDistance(), ValidateGeometry::getDistance(), reco::MuonChamberMatch::getDistancePair(), PythiaFilterIsolatedTrack::getDistInCM(), EopTreeWriter::getDistInCM(), spr::getDistInCMatEcal(), spr::getDistInCMatHcal(), EcalClusterToolsT< noZS >::getDPhiEndcap(), MuCSCTnPFlatTableProducer::GetEdgeAndDistToGap(), HitQuadrupletGeneratorFromLayerPairForPhotonConversion::getEffectiveErrorOnZ(), AntiElectronIDMVA6< TauType, ElectronType >::getElecVars(), ZdcSD::getEnergyDeposit(), CastorSD::getEnergyDeposit(), PFEnergyResolution::getEnergyResolutionHad(), CocoaDBMgr::GetEntryError(), TrackFitter::getErrTipAndErrZip(), EcalClusterLazyToolsBase::getESShape(), mkfit::getEta(), mkfit::getEtaErr2(), HcalDDDSimConstants::getEtaHO(), FWMagField::GetField(), CastorSD::getFromLibrary(), ClusterShapeTrackFilter::getGlobalDirs(), EcalHaloAlgo::GetHaloClusterCandidateEB(), EcalHaloAlgo::GetHaloClusterCandidateEE(), HcalHaloAlgo::GetHaloClusterCandidateHB(), HcalHaloAlgo::GetHaloClusterCandidateHE(), HCALResponse::getHCALEnergyResponse(), HFShowerParam::getHits(), mkfit::getHypot(), EcalClusterToolsT< noZS >::getIEta(), G4ProcessHelper::GetInclusiveCrossSection(), EcalTrivialConditionRetriever::getIntercalibConstantsFromConfiguration(), trklet::PurgeDuplicate::getInventedCoordsExtended(), MixBoostEvtVtxGenerator::GetInvLorentzBoost(), BetaBoostEvtVtxGenerator::GetInvLorentzBoost(), GflashTrajectory::getL2DAtR(), CastorLedAnalysis::GetLedConst(), HcalLedAnalysis::GetLedConst(), FactorizedJetCorrectorCalculator::getLepPt(), TwoBodyDecayLinearizationPointFinder::getLinearizationPoint(), WtoLNuSelector::getMt(), ttbarEventSelector::getMt(), HitResol::getPairParameters(), HcalPedestalAnalysis::GetPedConst(), CastorPedestalAnalysis::GetPedConst(), EcalTrivialConditionRetriever::getPFRecHitThresholdsFromConfiguration(), HitPairGeneratorFromLayerPairForPhotonConversion::getPhiRange(), L1PrefiringWeightProducer::getPrefiringRateEcal(), L1PrefiringWeightProducer::getPrefiringRateMuon(), L1TMuonDQMOffline::getProbeMuons(), JetCorrectionUncertainty::getPtRel(), FactorizedJetCorrectorCalculator::getPtRel(), LowEnergyFastSimParam::GetRadius(), fastsim::HelixTrajectory::getRadParticle(), PrimaryVertexAnalyzer4PUSlimmed::getRecoPVs(), Primary4DVertexValidation::getRecoPVs(), SCEnergyCorrectorSemiParm::getRegDataECALV1(), SCEnergyCorrectorSemiParm::getRegDataHGCALV1(), MuonRecoAnalyzer::GetRes(), pat::helper::ResolutionHelper::getResolE(), pat::helper::ResolutionHelper::getResolEt(), pat::helper::ResolutionHelper::getResolEta(), pat::helper::ResolutionHelper::getResolM(), pat::helper::ResolutionHelper::getResolP(), pat::helper::ResolutionHelper::getResolPhi(), pat::helper::ResolutionHelper::getResolPInv(), pat::helper::ResolutionHelper::getResolPt(), pat::helper::ResolutionHelper::getResolPx(), pat::helper::ResolutionHelper::getResolPy(), pat::helper::ResolutionHelper::getResolPz(), pat::helper::ResolutionHelper::getResolTheta(), HGCalShowerShapeHelper::ShowerShapeCalc::getRvar(), CastorShowerLibrary::getShowerHits(), ME0SimpleModel::getSimHitBx(), GEMSignalModel::getSimHitBx(), HLTScalersClient::getSlope_(), heppy::MuScleFitCorrector::getSmearedPt(), EnergyScaleCorrection_class::getSmearingSigma(), RPCSeedPattern::getSpecialAlgorithmErrorMatrix(), HGCalStage2ClusterDistribution::getStage2FPGAs(), TimingSD::getStepInfo(), ME0ReDigiProducer::getStripProperties(), EgammaRecHitIsolation::getSum_(), TrackDetectorAssociator::getTAMuonChamberMatches(), SiStripPI::getTheRange(), AlignmentPI::getTheRange(), mkfit::getThetaErr2(), fastsim::BarrelSimplifiedGeometry::getThickness(), L1TTauOffline::getTightMuons(), PFDisplacedVertexFinder::getTransvLongDiff(), HGCalWaferType::getType(), HGCalWaferMask::getTypeMode(), HcalTB02HcalNumberingScheme::getUnitID(), TrackingRegionsFromSuperClustersProducer::getVtxPos(), JetCharge::getWeight(), CachedTrajectory::getWideTrajectory(), HcalPedestalWidth::getWidth(), CastorPedestalWidth::getWidth(), hgcal::ClusterTools::getWidths(), CSCDriftSim::getWireHit(), TrajSeedMatcher::getZVtxFromExtrapolation(), gexp(), HFGflash::gfParameterization(), reco::GhostTrackPrediction::GhostTrackPrediction(), AlcaBeamMonitor::globalEndLuminosityBlock(), RawPCCProducer::globalEndLuminosityBlockProduce(), GenXSecAnalyzer::globalEndRun(), TValidTrackingRecHit::globalState(), BaseTrackerRecHit::globalState(), ConvBremSeedProducer::GoodCluster(), CosmicMuonGenerator::goodOrientation(), PFTrackAlgoTools::goodPtResolution(), GlobalTrackerMuonAlignment::gradientGlobal(), GlobalTrackerMuonAlignment::gradientGlobalAlg(), GlobalTrackerMuonAlignment::gradientLocal(), MuonSeedCleaner::GroupSeeds(), Basic2DGenericPFlowClusterizer::growPFClusters(), PFlow2DClusterizerWithTime::growPFClusters(), Pythia8::PowhegHooksBB4L::gSplittingScale(), TkPixelMeasurementDet::hasBadComponents(), CACell::haveSimilarCurvature(), HcalDigisClient::HcalDigisEndjob(), HcalPedestalAnalysis::HcalPedVal(), HcalRecHitsDQMClient::HcalRecHitsEndjob(), CSCHaloAlgo::HCALSegmentMatching(), PPSTools::HectorParticle2LorentzVector(), HelixArbitraryPlaneCrossing::HelixArbitraryPlaneCrossing(), HelixArbitraryPlaneCrossing2Order::HelixArbitraryPlaneCrossing2Order(), mkfit::helixAtRFromIterativeCCSFullJac(), mkfit::helixAtZ(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), BaseParticlePropagator::helixCentreDistToAxis(), HelixExtrapolatorToLine2Order::HelixExtrapolatorToLine2Order(), HelixForwardPlaneCrossing::HelixForwardPlaneCrossing(), ConversionFastHelix::helixStateAtVertex(), FastHelix::helixStateAtVertex(), Generator::HepMC2G4(), PFAlgo::hfEnergyResolution(), HGCalCalibrationCell::HGCalCalibrationCell(), HGCalMouseBite::HGCalMouseBite(), HGCalPassiveFull::HGCalPassiveFull(), TEcnaRun::HighFrequencyCorrelationsBetweenChannels(), TEcnaRun::HighFrequencyNoise(), mkfit::hipo(), fastTrackingUtilities::hitLocalError(), CAHitTripletGenerator::hitNtuplets(), CAHitQuadrupletGenerator::hitNtuplets(), HitPairGeneratorFromLayerPairForPhotonConversion::hitPairs(), MuonChamberResidual::hitposition(), PixelTemplateSmearerBase::hitsMerge(), PixelTripletNoTipGenerator::hitTriplets(), HLTDisplacedmumuFilter::hltFilter(), HLTDisplacedmumumuFilter::hltFilter(), HLTDisplacedtktkFilter::hltFilter(), HLTDisplacedtktktkFilter::hltFilter(), HLTmumutkFilter::hltFilter(), HLTmumutktkFilter::hltFilter(), HLTDeDxFilter::hltFilter(), HLTMuonDimuonL2FromL1TFilter::hltFilter(), HLTJetVBFFilter< T >::hltFilter(), HLTMuonDimuonL2Filter::hltFilter(), HLTPMDocaFilter::hltFilter(), HLTPixlMBFilt::hltFilter(), HLTMuonTrimuonL3Filter::hltFilter(), HLTPixlMBForAlignmentFilter::hltFilter(), HLTHtMhtFilter::hltFilter(), HLTElectronPFMTFilter< T >::hltFilter(), HLTVertexFilter::hltFilter(), HLTJetHbbFilter< T >::hltFilter(), HLTmmkFilter::hltFilter(), HLTmmkkFilter::hltFilter(), HLTMuonDimuonL3Filter::HLTMuonDimuonL3Filter(), htmht(), MuonSeedBuilder::IdentifyShowering(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), ConformalMappingFit::impactParameter(), gen::Pythia6Hadronizer::imposeProperTime(), inAirAfterPlug(), Primary4DVertexHarvester::incrementME(), RPLinearInduceChargeOnStrips::Induce(), SiTrivialInduceChargeOnStrips::induceVector(), TrackerMuonHitExtractor::init(), ThirdHitCorrection::init(), CircleFromThreePoints::init(), reco::GhostTrackPrediction::init(), tnp::BaseTreeFiller::init(), CSCXonStrip_MatchGatti::initChamberSpecs(), CSCGattiFunction::initChamberSpecs(), Thrust::initialAxis(), RandomMultiGauss::initialise(), CosmicMuonGenerator::initialize(), TT6PedestalCalculator::initializePedestal(), SimplePedestalCalculator::initializePedestal(), reco::MustacheKernel::inMustache(), RectangularPlaneBounds::inout(), SimpleDiskBounds::inside(), DiskSectorBounds::inside(), GeneralNSurfaceDelimitedBounds::inside(), PhiInterval::inside(), SimpleCylinderBounds::inside(), RectangularPlaneBounds::inside(), TrapezoidalPlaneBounds::inside(), SimpleConeBounds::inside(), CSCLayerGeometry::inside(), HLLHCEvtVtxGenerator::integrandCC(), fastsim::PairProduction::interact(), fastsim::EnergyLoss::interact(), fastsim::Bremsstrahlung::interact(), fastsim::MultipleScattering::interact(), fastsim::NuclearInteraction::interact(), fastsim::NuclearInteractionFTF::interact(), SiPixelTemplate::interpolate(), reco::helper::VirtualJetProducerHelper::intersection(), HGCalWaferType::intersection(), mkfit::intersectThirdLayer(), intGauss(), TSFit::inverms(), TFParams::inverpj(), TrajectoryStateAccessor::inversePtError(), Matriplex::CholeskyInverterSym< T, 3, N >::invert(), ZIterativeAlgorithmWithFit::invMassCalc(), fastmath::invSqrt(), inWallAfterAir(), DTSegmentExtendedCand::isCompatible(), DTHitPairForFit::isCompatible(), ThirdHitPrediction::isCompatibleWithMultipleScattering(), CSCPairResidualsConstraint::isFiducial(), muon::isGoodMuon(), cms::MuonTCMETValueMapProducer::isGoodTrack(), TCMETAlgo::isGoodTrack(), CSCSegAlgoShowering::isHitNearSegment(), CSCSegAlgoDF::isHitNearSegment(), PFDisplacedVertexHelper::isKaonMass(), EGammaMvaEleEstimator::isoMvaValue(), heppy::IsolationComputer::isoSumNeutralsWeighted(), mkfit::isStripQCompatible(), HGCalTBDDDConstants::isValidCell(), HGCalDDDConstants::isValidCell(), HGCalDDDConstants::isValidCell8(), cms::MuonTCMETValueMapProducer::isValidVertex(), TCMETAlgo::isValidVertex(), IterativeHelixExtrapolatorToLine::IterativeHelixExtrapolatorToLine(), mkfit::TrackState::jacobianCartesianToCCS(), mkfit::TrackState::jacobianCurvilinearToCCS(), JacobianLocalToCartesian::JacobianLocalToCartesian(), SimG4HcalValidation::jetAnalysis(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), magfieldparam::rz_harm_poly::LadderDwn(), magfieldparam::rz_harm_poly::LadderUp(), PFDisplacedVertexHelper::lambdaCP(), reco::GhostTrackState::lambdaError(), MuonSeedCleaner::LeanHighMomentum(), IPTools::linearizedSignedImpactParameter3D(), FWPFMaths::lineCircleIntersect(), ticl::LinkingAlgoByDirectionGeometric::linkTracksters(), CaloTPGTranscoderULUT::loadHCALCompress(), GflashKaonPlusShowerProfile::loadParameters(), GflashProtonShowerProfile::loadParameters(), GflashAntiProtonShowerProfile::loadParameters(), GflashKaonMinusShowerProfile::loadParameters(), GflashPiKShowerProfile::loadParameters(), HGCalTBGeomParameters::loadWaferHexagon(), HGCalGeomParameters::loadWaferHexagon(), OuterDetCompatibility::loc_dist(), RPCRoll::localError(), TrapezoidalStripTopology::localError(), ME0EtaPartition::localError(), PixelCPEGeneric::localError(), GsfTrackProducerBase::localParametersFromQpMode(), TrapezoidalStripTopology::localPitch(), GEMStripTopology::localStripLength(), TrapezoidalStripTopology::localStripLength(), CSCRadialStripTopology::localStripLength(), TkRadialStripTopology::localStripLength(), GflashEMShowerProfile::locateHitPosition(), GflashHadronShowerProfile::locateHitPosition(), OptoScanTask::locateTicks(), CSCCrossGap::logGamma(), PerigeeTrajectoryError::longitudinalImpactParameterError(), l1t::MicroGMTMatchQualSimpleLUT::lookup(), l1t::MicroGMTMatchQualFineLUT::lookup(), SummaryOutputProducer::GenericSummary::lost(), SummaryOutputProducer::TriggerSummary::lost(), TEcnaRun::LowFrequencyCorrelationsBetweenChannels(), TEcnaRun::LowFrequencyNoise(), HadronicProcessHelper::m_phaseSpace(), HadronicProcessHelper::m_reactionProductMass(), Basic2DVector< float >::mag(), Basic3DVector< long double >::mag(), Basic3DVector< align::Scalar >::mag(), JetVertexMain::Main(), main(), HybridClusterAlgo::mainSearch(), MTDThresholdClusterizer::make_cluster(), edm::RandomtXiGunProducer::make_particle(), LRHelpFunctions::makeAndFitPurityHists(), LRHelpFunctions::makeAndFitSoverSplusBHists(), SteppingHelixPropagator::makeAtomStep(), CastorHardcodeGeometryLoader::makeCell(), PointingKinematicConstraint::makeDerivative(), SimplePointingConstraint::makeDerivative(), SmartPointingConstraint::makeDerivative(), EcalCondTools::makedist(), DTTriggerEfficiencyTest::makeEfficiencyME(), DTLocalTriggerEfficiencyTest::makeEfficiencyME(), DTLocalTriggerEfficiencyTest::makeEfficiencyME2D(), fireworks::makeEveJetCone(), MuonIdProducer::makeMuon(), CastorPedestalWidth::makeNoise(), HcalAmplifier::makeNoise(), PiZeroAnalyzer::makePizero(), TotemRPDQMHarvester::MakePlaneEfficiencyHistograms(), OutInConversionSeedFinder::makeTrackState(), ticl::PatternRecognitionbyCLUE3D< TILES >::makeTracksters(), SmartPointingConstraint::makeValue(), PointingKinematicConstraint::makeValue(), SimplePointingConstraint::makeValue(), cmsTiming_parser::manipulate_log(), FFTGenericScaleCalculator::mapFFTJet(), plotscripts::mapplot(), dEdxAnalyzer::mass(), PatZToMuMuAnalyzer::mass(), ErrorsPropagationAnalyzer::massResolution(), MuScleFitUtils::massResolution(), LowPtConversion::match(), MatcherByPullsAlgorithm::match(), gen::JetMatchingMGFastJet::match(), TwoBodyDecayTrajectoryFactory::match(), L1MuonMatcherAlgoT< edm::Transition::BeginRun >::match(), L1MuonMatcherAlgoT< edm::Transition::BeginRun >::matchGeneric(), TemplatedSecondaryVertexProducer< IPTI, VTX >::matchGroomedJets(), JetFlavourClustering::matchGroomedJets(), TemplatedSecondaryVertexProducer< IPTI, VTX >::matchReclusteredJets(), JetFlavourClustering::matchReclusteredJets(), muonid::matchTracks(), Chi2MeasurementEstimatorBase::maximalLocalDisplacement(), EcalRegressionData::maxSubClusDR(), SiPixelLAHarvestMCS::MCSFitFunction(), SiStripMiscalibrate::Entry::mean_rms(), SiStripPI::Entry::mean_rms(), GEMStripTopology::measurementError(), TrapezoidalStripTopology::measurementError(), CSCRadialStripTopology::measurementError(), TkRadialStripTopology::measurementError(), TkPixelMeasurementDet::measurements(), TkStripMeasurementDet::measurements(), GflashHadronShowerProfile::medianLateralArm(), LowPtConversion::mee(), GenLumiInfoProduct::ProcessInfo::mergeXSec(), reco::MET::mEtSig(), L1TPhase2CorrelatorOffline::InCone::mindr(), edm::RandomtXiGunProducer::Minimum_t(), GlobalTrackerMuonAlignment::misalignMuonL(), EGRegressionModifierV2::modifyObject(), EGRegressionModifierV1::modifyObject(), heppy::RochCor::momcor_mc(), heppy::RochCor2012::momcor_mc(), CosmicParametersDefinerForTP::momentum(), RKCurvilinearDistance< T, N >::momentum(), CurvilinearState::momentum(), CylindricalState::momentum(), LocalTrajectoryParameters::momentum(), reco::PFDisplacedVertex::momentum(), FullModelReactionDynamics::MomentumCheck(), MuonSeedCleaner::MomentumFilter(), multiTrajectoryStateMode::momentumFromModeLocal(), FinalTreeBuilder::momentumPart(), TrajectoryManager::moveAllDaughters(), QcdHighPtDQM::moverl(), QcdHighPtDQM::movers(), MSLayersKeeperX0Averaged::MSLayersKeeperX0Averaged(), heppy::Davismt2::mt2_bisect(), heppy::Davismt2::mt2_massless(), MultipleScatteringSimulator::MultipleScatteringSimulator(), Fit::multiplyMatrices(), ZToMuMuGammaAnalyzer::mumuGammaInvMass(), ZToMuMuGammaAnalyzer::mumuInvMass(), MuonMETAlgo::MuonMETAlgo_run(), MuonPFIsolationWithConeVeto::MuonPFIsolationWithConeVeto(), MuonResidualsFitter_compute_log_convolution(), MuonResidualsFitter_integrate_pureGaussian(), MuonResidualsFitter_logGaussPowerTails(), MuonResidualsFitter_logPureGaussian2D(), MuonResidualsFromTrack::MuonResidualsFromTrack(), MuScleFit::MuScleFit(), MtdTracksValidation::mvaTPSel(), EGammaMvaEleEstimatorCSA14::mvaValue(), EGammaMvaEleEstimator::mvaValue(), AntiElectronIDMVA6< TauType, ElectronType >::mvaValue(), Vx3DHLTAnalyzer::MyFit(), HDetIdAssociator::nearElement(), WeightedMeanFitter::nearestPoint(), TCMETAlgo::nearGoodShowerTrack(), TracksClusteringFromDisplacedSeed::nearTracks(), PFAlgo::neutralHadronEnergyResolution(), L1CaloHcalScaleConfigOnlineProd::newObject(), NuclearTrackCorrector::newTrajNeeded(), BetafuncEvtVtxGenerator::newVertex(), BetaBoostEvtVtxGenerator::newVertex(), fastsim::HelixTrajectory::nextCrossingTimeC(), fastsim::StraightTrajectory::nextCrossingTimeC(), CosmicMuonGenerator::nextEvent(), CosmicMuonGenerator::nextMultiEvent(), CMSSteppingVerbose::nextStep(), ConversionHitChecker::nHitsBeforeVtx(), EvolutionECAL::NoiseFactorFE(), PhysicsTools::Calibration::Histogram< float >::normalizedError(), PhysicsTools::Calibration::Histogram2D< Value_t, AxisX_t, AxisY_t >::normalizedError(), PhysicsTools::Calibration::Histogram3D< Value_t, AxisX_t, AxisY_t, AxisZ_t >::normalizedError(), fastsim::NuclearInteraction::NuclearInteraction(), NuclearInteractionSimulator::NuclearInteractionSimulator(), oldComputeBetheBloch(), oldMUcompute(), oneOverEtResolEt(), alpha_T::operator()(), fftjetcms::JetToPeakDistance::operator()(), PixelTrackFilterByKinematics::operator()(), fftjetcms::JetConvergenceDistance::operator()(), PtIsolationAlgo< reco::Candidate, reco::CandidateCollection >::operator()(), SortMuonSegmentMatches::operator()(), RKCurvilinearDistance< T, N >::operator()(), Cluster1DMerger< T >::operator()(), GhostTrackComputer::operator()(), fftjetcms::PtEtaP4Builder::operator()(), pixeltemp::Cluster1DMerger< reco::Track >::operator()(), MtvClusterizer1D< T >::operator()(), HIPixelTrackFilter::operator()(), FsmwClusterizer1D< T >::operator()(), DTSegmentSelector::operator()(), TtHadLRSignalSelObservables::operator()(), ALPAKA_ACCELERATOR_NAMESPACE::pixelRecHits::GetHits< TrackerTraits >::operator()(), ThirdHitZPrediction::operator()(), reco::tau::RecoTauBuilderCombinatoricPlugin::operator()(), MultipleScatteringParametrisation::operator()(), MTDTrackQualityMVA::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), hitfit::METTranslatorBase< pat::MET >::operator()(), CombinedSVComputer::operator()(), pat::VertexAssociationSelector::operator()(), GenParticleCustomSelector::operator()(), PixelHitMatcher::operator()(), reco::tau::PFRecoTauChargedHadronFromGenericTrackPlugin< TrackClass >::operator()(), reco::parser::sqrt_f::operator()(), CosmicTrackingParticleSelector::operator()(), Calculate_miniAOD::operator()(), ALPAKA_ACCELERATOR_NAMESPACE::ecal::multifit::Kernel_time_compute_makeratio::operator()(), Calculate::operator()(), ALPAKA_ACCELERATOR_NAMESPACE::ecal::multifit::Kernel_time_compute_findamplchi2_and_finish::operator()(), ALPAKA_ACCELERATOR_NAMESPACE::ecal::multifit::Kernel_time_correction_and_finalize::operator()(), operator<<(), fastsim::operator<<(), SimpleL1MuGMTCand::operator=(), L1GctJetFinderParams::orcaStyleCorrect(), SurveyInputCSCfromPins::orient(), muon::overlap(), MuonSeedCleaner::OverlapSegments(), reco::TrackBase::p(), pat::helper::ParametrizationHelper::p4fromParameters(), SiStripTrackerMapCreator::paintTkMapFromHistogram(), reco::Conversion::pairInvariantMass(), riemannFit::par_uvrtopak(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::par_uvrtopak(), GflashEMShowerProfile::parameterization(), DDHCalEndcapModuleAlgo::parameterLayer(), DDHCalEndcapAlgo::parameterLayer(), HCalEndcapModuleAlgo::parameterLayer(), HCalEndcapAlgo::parameterLayer(), VertexKinematicConstraint::parametersDerivative(), MultiTrackVertexLinkKinematicConstraint::parametersDerivative(), ColinearityKinematicConstraint::parametersDerivative(), MultiTrackPointingKinematicConstraint::parametersDerivative(), TwoTrackMassKinematicConstraint::parametersDerivative(), Generator::particleAssignDaughters(), PrimaryVertexValidation::passesTrackCuts(), mkfit::passStripChargePCMfromTrack(), HelixArbitraryPlaneCrossing2Order::pathLength(), TTStubAlgorithm_official< T >::PatternHitCorrelation(), BSpdfsFcn::PDFGauss_d(), BSpdfsFcn::PDFGauss_d_resolution(), BSpdfsFcn::PDFGauss_z(), LheWeightValidation::pdfRMS(), EleRelPoint::perp(), Basic3DVector< long double >::perp(), Basic3DVector< align::Scalar >::perp(), external::HEPTopTaggerV2_fixed_R::perp(), PFClusterWidthAlgo::PFClusterWidthAlgo(), PFGsfHelper::PFGsfHelper(), HcalDeterministicFit::phase1Apply(), PulseShapeFitOOTPileupCorrection::phase1Apply(), MahiFit::phase1Debug(), G4ProcessHelper::PhaseSpace(), res::HelperJet::phi(), ThirdHitPredictionFromCircle::phi(), PerigeeTrajectoryError::phiError(), metsig::SignAlgoResolutions::PhiFunction(), PhiInterval::PhiInterval(), InnerDeltaPhi::phiRange(), PhotonPFIsolationWithConeVeto::PhotonPFIsolationWithConeVeto(), SiPixelTemplateReco2D::PixelTempReco2D(), SiPixelTemplateSplit::PixelTempSplit(), HLTTauPostProcessor::plotFilterEfficiencies(), CSCSegmentValidation::plotResolution(), CSCRecHit2DValidation::plotResolution(), SymmetryFit::pol2_from_pol2(), SymmetryFit::pol2_from_pol3(), pat::helper::ParametrizationHelper::polarP4fromParameters(), G4ProcessHelper::Pom(), VertexKinematicConstraint::positionDerivative(), MultiTrackVertexLinkKinematicConstraint::positionDerivative(), MultiTrackPointingKinematicConstraint::positionDerivative(), FTLCluster::positionError(), DDHGCalMixLayer::positionMix(), DDHGCalMixRotatedLayer::positionMix(), DDHGCalMixRotatedCassette::positionMix(), HGCalMixLayer::positionMix(), HGCalMixRotatedLayer::positionMix(), HGCalMixRotatedCassette::positionMix(), DDHGCalSiliconRotatedCassette::positionPassive(), HGCalSiliconRotatedCassette::positionPassive(), DDHGCalTBModule::positionSensitive(), DDHGCalModuleAlgo::positionSensitive(), DDHGCalEEAlgo::positionSensitive(), DDHGCalModule::positionSensitive(), DDHGCalTBModuleX::positionSensitive(), DDHGCalEEFileAlgo::positionSensitive(), DDHGCalSiliconModule::positionSensitive(), DDHGCalSiliconRotatedModule::positionSensitive(), DDHGCalSiliconRotatedCassette::positionSensitive(), DDHGCalHEFileAlgo::positionSensitive(), DDHGCalHEAlgo::positionSensitive(), HGCalEEFileAlgo::positionSensitive(), HGCalSiliconModule::positionSensitive(), HGCalSiliconRotatedModule::positionSensitive(), HGCalEEAlgo::PositionSensitive(), HGCalSiliconRotatedCassette::positionSensitive(), HGCalHEFileAlgo::positionSensitive(), HGCalHEAlgo::positionSensitive(), TotemSD::posizioEvo(), CSCLayerGeometry::possibleRecHitPosition(), PFAlgo::postCleaning(), FullModelHadronicProcess::PostStepDoIt(), reco::PFDisplacedVertex::primaryDirection(), PrintRecoObjects::print(), SiPixelDetSummary::print(), PFMETAlgorithmMVA::print(), SiStripDetSummary::print(), CSCRecHit2D::print(), hitfit::Constraint_Intermed_Constant::print(), HepMCFileReader::printEvent(), tmtt::Histos::printFitTrackPerformance(), hgcal::EGammaPCAHelper::printHits(), GlobalTrajectoryBuilderBase::printHits(), GlobalMuonRefitter::printHits(), TMatacq::printitermatacqData(), TMatacq::printmatacqData(), PFCandidateChecker::printMet(), MuonBadTrackFilter::printMuonProperties(), PFMuonAlgo::printMuonProperties(), SiStripNoises::printSummary(), SiStripThreshold::printSummary(), SiStripPI::printSummary(), tmtt::Histos::printTrackPerformance(), TrackstersMergeProducerV3::printTrackstersDebug(), TrackstersMergeProducer::printTrackstersDebug(), gen.LHEAnalyzer.LHEAnalyzer::process(), CastorDigiMonitor::processEvent(), l1t::Stage1Layer2EtSumAlgorithmImpPP::processEvent(), StraightTrackAlignment::processEvent(), HIPAlignmentAlgorithm::processHit1D(), HIPAlignmentAlgorithm::processHit2D(), AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack(), HIMultiTrackSelector::processMVA(), PPSDirectProtonSimulation::processProton(), edm::GaussRandomPThetaGunProducer::produce(), edm::RandomMultiParticlePGunProducer::produce(), edm::FlatRandomPtThetaGunProducer::produce(), edm::FlatRandomEThetaGunProducer::produce(), edm::FileRandomMultiParticlePGunProducer::produce(), edm::FlatRandomMultiParticlePGunProducer::produce(), SeedGeneratorFromProtoTracksEDProducer::produce(), edm::FileRandomKEThetaGunProducer::produce(), edm::FlatRandomOneOverPtGunProducer::produce(), TtSemiLepJetCombWMassDeltaTopMass::produce(), edm::FlatRandomEGunProducer::produce(), edm::FlatRandomPtGunProducer::produce(), edm::MultiParticleInConeGunProducer::produce(), edm::BeamMomentumGunProducer::produce(), edm::ExpoRandomPtGunProducer::produce(), PseudoTopProducer::produce(), edm::ExpoRandomPGunProducer::produce(), ParticleLevelProducer::produce(), QuarkoniaTrackSelector::produce(), CastorFastClusterProducer::produce(), ShallowRechitClustersProducer::produce(), edm::CloseByParticleGunProducer::produce(), PFTICLProducer::produce(), ShallowClustersProducer::produce(), PATMuonMerger::produce(), CaloMuonMerger::produce(), L1TkHTMissProducer::produce(), ElectronRecalibSuperClusterAssociator::produce(), edm::FlatRandomPtAndDxyGunProducer::produce(), TICLCandidateFromTrackstersProducer::produce(), JetCoreClusterSplitter::produce(), pf2pat::PFMETAlgo::produce(), pat::PATLostTracks::produce(), SiStripRegFEDSelector::produce(), TrackstersMergeProducerV3::produce(), pat::PATPhotonSlimmer::produce(), HiBadParticleCleaner::produce(), PixelVertexProducerFromSoAAlpaka::produce(), MuonTrackProducer::produce(), QjetsAdder::produce(), ShallowTrackClustersProducer::produce(), PileupInformation::produce(), ShiftedPFCandidateProducerByMatchedObject::produce(), GlobalMuonToMuonProducer::produce(), HLTMhtProducer::produce(), ShiftedJetProducerByMatchedObjectT< T >::produce(), EgammaHLTClusterShapeProducer::produce(), HLTHtMhtProducer::produce(), HLTCaloTowerHtMhtProducer::produce(), MkFitGeometryESProducer::produce(), NoPileUpPFMEtProducer::produce(), HLTDisplacedmumumuVtxProducer::produce(), PixelVertexProducerFromSoA::produce(), L1TrackerEtMissProducer::produce(), ShiftedPFCandidateProducerForPFMVAMEt::produce(), HLTDisplacedmumuVtxProducer::produce(), HLTMETCleanerUsingJetID::produce(), L1TkHTMissEmulatorProducer::produce(), HLTDisplacedtktktkVtxProducer::produce(), HLTDisplacedtktkVtxProducer::produce(), JetEnergyShift::produce(), HGCalTrackCollectionProducer::produce(), DBremWatcher::produce(), Onia2MuMuPAT::produce(), HLTTrackMETProducer::produce(), TrackTimeValueMapProducer::produce(), PixelVertexProducer::produce(), JetPlusTrackProducer::produce(), DeltaRNearestObjectComputer< T >::produce(), HLTmumutktkVtxProducer::produce(), BSCTrigger::produce(), HFJetShowerShape::produce(), SimPFProducer::produce(), pat::PATIsolatedTrackProducer::produce(), CTPPSProtonProducer::produce(), HLTmumutkVtxProducer::produce(), CastorClusterProducer::produce(), RechitClusterProducerT< Trait >::produce(), CastorTowerProducer::produce(), TrackstersMergeProducer::produce(), EcalIsolatedParticleCandidateProducer::produce(), VertexTableProducer::produce(), JetPlusTrackProducerAA::produce(), TkMSParameterizationBuilder::produce(), ConvBremSeedProducer::produce(), FastPrimaryVertexWithWeightsProducer::produce(), MuonSimHitProducer::produce(), BJetEnergyRegressionVarProducer< T >::produce(), GoodSeedProducer::produce(), ShiftedJetProducerT< T, Textractor >::produce(), PhotonIDValueMapProducer::produce(), SelectedElectronFEDListProducer< TEle, TCand >::produce(), Type2CorrectionProducer::produce(), TemplatedInclusiveVertexFinder< InputContainer, VTX >::produce(), SmearedJetProducerT< T >::produce(), TrackExtenderWithMTDT< TrackCollection >::produce(), EcalTrivialConditionRetriever::produceEcalLaserAlphas(), EcalTrivialConditionRetriever::produceEcalLaserAPDPNRatios(), ecaldqm::TestPulseClient::producePlots(), ecaldqm::PresampleClient::producePlots(), ecaldqm::TrigPrimClient::producePlots(), ecaldqm::PedestalClient::producePlots(), ecaldqm::LaserClient::producePlots(), ecaldqm::LedClient::producePlots(), ecaldqm::TimingClient::producePlots(), FullModelReactionDynamics::ProduceStrangeParticlePairs(), CTPPSProtonReconstructionPlotter::profileToRMSGraph(), CTPPSProtonReconstructionSimulationValidator::PlotGroup::profileToRMSGraph(), Strip1DMeasurementTransformator::projectionMatrix(), projectProfile2DAlongX(), projectProfile2DAlongY(), BaseParticlePropagator::propagate(), spr::propagateCalo(), CachedTrajectory::propagateForward(), mkfit::propagateHelixToPlaneMPlex(), mkfit::propagateLineToRMPlex(), BaseParticlePropagator::propagateToBeamCylinder(), BaseParticlePropagator::propagateToClosestApproach(), BaseParticlePropagator::propagateToNominalVertex(), TrackKinematicStatePropagator::propagateToTheTransversePCACharged(), spr::propagateTrackerEnd(), LowPtGsfElectronSeedProducer::propagateTrackToCalo(), DDG4SolidConverter::pseudotrap(), res::HelperElectron::pt(), res::HelperJet::pt(), reco::MuonMETCorrectionData::pt(), reco::TrackBase::pt(), CSCTFPtMethods::Pt2Stn(), CSCTFPtMethods::Pt3Stn(), MuonSeedPtExtractor::pT_extract(), reco::TrackBase::ptError(), reco::TrackBase::ptError2(), ptFast(), reco::GsfTrack::ptMode(), reco::GsfTrack::ptModeError(), EmissionVetoHook1::pTpowheg(), EmissionVetoHook1::pTpythia(), Pythia8::PowhegHooksBB4L::pTpythia(), pullDxDz(), pullDyDz(), pullX(), pullY(), PulseShapeFitOOTPileupCorrection::pulseShapeFit(), reco::EvtPlane::q(), SiPixelGenError::qbin(), SiPixelTemplate::qbin(), Pythia8::PowhegHooksBB4L::qSplittingScale(), GenericTripletGenerator::qualityFilter(), TtFullLepKinSolver::quartic(), HitDoublets::r(), RawParticle::r(), RawParticle::R(), R_min_expected_function(), JetUtil::radius(), ThirdHitPredictionFromCircle::HelixRZ::rAtZ(), MuonTimingFiller::rawFit(), TMatacq::rawPulseAnalysis(), CSCSegFit::Rdev(), MuonSegFit::Rdev(), SimG4HcalHitJetFinder::rDist(), G4ProcessHelper::ReactionProductMass(), mkfit::Event::read_in(), AlpgenSource::readAlpgenEvent(), DeviationsFromFileSensor2D::readFile(), AlignmentExtendedCorrelationsStore::readFromCovariance(), AlignmentExtendedCorrelationsStore::readFromCovarianceT(), popcon::EcalPedestalsHandler::readPedestalMC(), readRcd(), RealQuadEquation::RealQuadEquation(), SuepShower::reballanceFunction(), TkConvValidator::recalculateMomentumAtFittedVertex(), SiStripRecHitsValid::rechitanalysis(), SiStripTrackingRecHitsValid::rechitanalysis(), SiStripRecHitsValid::rechitanalysis_matched(), SiStripTrackingRecHitsValid::rechitanalysis_matched(), DTRecHitQuality::recHitPositionError(), TkPhase2OTMeasurementDet::recHits(), CSCEfficiency::recHitSegment_Efficiencies(), Conv4HitsReco2::Reconstruct(), HemisphereAlgo::reconstruct(), heppy::Hemisphere::Reconstruct(), PFAlgo::reconstructCluster(), ProtonReconstructionAlgorithm::reconstructFromMultiRP(), ProtonReconstructionAlgorithm::reconstructFromSingleRP(), PFAlgo::reconstructTrack(), PrimaryVertexAnalyzer4PUSlimmed::recoPrimaryVertex::recoPrimaryVertex(), Primary4DVertexValidation::recoPrimaryVertex::recoPrimaryVertex(), TT6PedestalCalculator::refinePedestal(), SimplePedestalCalculator::refinePedestal(), LightRay::refract(), SteppingHelixPropagator::refToDest(), AreaSeededTrackingRegionsBuilder::Builder::regionImpl(), CosmicRegionalSeedGenerator::regions(), mkfit::LayerOfHits::registerHit(), heppy::Hemisphere::RejectISR(), count_t::relative_error(), stats_t< T >::relative_error(), CaloSpecificAlgo::remove_HF_from_MET(), reco::PFCandidate::rescaleMomentum(), MuonTestSummary::ResidualCheck(), tmtt::ChiSquaredFit4::residuals(), PFJetFilter::resolution(), EnergyResolutionVsLumi::Resolution(), PrimaryVertexResolution::Resolution::Resolution(), ResolutionsCalculator(), BtoCharmDecayVertexMergerT< VTX >::resolveBtoDchain(), contrib::CMSBoostedTauSeedingAlgorithm::result(), HEPTopTaggerV2::result(), reco::GhostTrackPrediction::rho(), trklet::rinv(), trklet::TrackletConfigBuilder::rinv(), pTFrom2Stubs::rInvFrom2(), trklet::Timer::rms(), CaloValidationStatistics::RMS(), TSinglePedEntry::RMS(), RPCLinkSynchroStat::SynchroCounts::rms(), plotscripts::rms(), HcalNoiseSummary::rms10GeVHitTime(), HcalNoiseSummary::rms25GeVHitTime(), LA_Filler_Fitter::rms_profile(), SiPixelDQMRocLevelAnalyzer::RocSumOneModule(), FullModelReactionDynamics::Rotate(), TwoBodyDecayModel::rotationMatrix(), brokenline::rotationMatrix(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::rotationMatrix(), DisplacedVertexCluster::rParam(), RPGaussianTailNoiseAdder::RPGaussianTailNoiseAdder(), PixelNtupletsFitter::run(), HGCalStage1TruncationImpl::run(), HGCalStage1TruncationImplSA::run(), PixelFitterByConformalMappingAndLine::run(), BTLElectronicsSim::run(), EcalUncalibRecHitWorkerRatio::run(), ETLElectronicsSim::run(), Type1PFMET::run(), EcalUncalibRecHitWorkerGlobal::run(), external::HEPTopTaggerV2_fixed_R::run(), SubjetFilterAlgorithm::run(), ConversionTrackPairFinder::run(), ecaldqm::LaserWriter::run(), HIPAlignmentAlgorithm::run(), EcalUncalibRecHitWorkerMultiFit::run(), ecaldqm::PedestalWriter::run(), ecaldqm::PresampleWriter::run(), ecaldqm::TestPulseWriter::run(), ecaldqm::TimingWriter::run(), ecaldqm::LedWriter::run(), cms::CSJetProducer::runAlgorithm(), DTLocalTriggerEfficiencyTest::runClientDiagnostic(), ConvBremPFTrackFinder::runConvBremFinder(), ecaldqm::PiZeroTask::runOnEBRecHits(), BeamFitter::runPVandTrkFitter(), ContentSigma::runTest(), SingleParticleEvent::rVxy(), SingleParticleEvent::rVxyTmp(), SiG4UniversalFluctuation::SampleFluctuations(), G4muDarkBremsstrahlungModel::SampleSecondaries(), TEcnaRun::SampleSigmas(), HGCalSciNoiseMap::scaleByDose(), EnergyScaleCorrection_class::ScaleCorrectionUncertainty(), EnergyScaleCorrection::ScaleCorrection::scaleErr(), PowhegResHook::scaleResonance(), Pythia8::PowhegHooksBB4L::scaleResonance(), heppy::Davismt2::scan_high(), BSFitter::scanPDF(), riemannFit::scatter_cov_rad(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit::scatter_cov_rad(), PrimaryVertexSorting::score(), KDTreeLinkerTrackEcal::searchLinks(), CTPPSFastTrackingProducer::SearchTrack(), MuonDTSeedFromRecHits::seed(), SimpleCosmicBONSeeder::seeds(), ElectronSeedGenerator::seedsFromThisCluster(), plotscripts::segdiff(), plotscripts::segdiff_xalign(), MuonHitsChamberResidual::segment_fit(), RPCSeedPattern::SegmentAlgorithmSpecial(), pf2pat::IPCutPFCandidateSelectorDefinition::select(), HIProtoTrackSelector::select(), HitPixelLayersTPSelector::select(), MultiTrackSelector::select(), HIMultiTrackSelector::select(), mkfit::MkFinder::selectHitIndices(), mkfit::MkFinder::selectHitIndicesV2(), MuonResidualsFitter::selectPeakResiduals_simple(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::selectPriVtxCompatibleWithTrack(), MultiTrackSelector::selectVertices(), HIMultiTrackSelector::selectVertices(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), heppy::Davismt2::set_momenta(), heppy::mt2w_bisect::mt2w::set_momenta(), DAClusterizerInZ_vect::set_vtx_range(), DAClusterizerInZT_vect::set_vtx_range(), UpdateTProfile::setBinContent(), UpdateTProfile::setBinContents(), reco::PFCandidateElectronExtra::setClusterEnergies(), reco::PFCandidateEGammaExtra::setClusterEnergies(), MatrixMeschach::SetCorrelation(), HGCScintSD::setDetUnitId(), HGCalSD::setDetUnitId(), pat::VertexAssociation::setDistances(), JetMatchingEWKFxFx::setDJR(), PlotAlignmentValidation::setDMRHistStyleAndLegend(), PatTriggerTagAndProbe::setErrors(), l1tVertexFinder::Stub::setModuleInfo(), TtSemiLepHypothesis::setNeutrino(), LaserBeamsTEC1::setOptPhotonPolar(), LaserBeamsBarrel::setOptPhotonPolar(), LaserBeamsTEC2::setOptPhotonPolar(), CSCSegFit::setOutFromIP(), MuonSegFit::setOutFromIP(), ticl::TracksterP4FromTrackAndPCA::setP4(), reco::PFDisplacedVertex::setPrimaryDirection(), MuonTrackDT13ChamberResidual::setSegmentResidual(), MuonTrackCSCChamberResidual::setSegmentResidual(), MuonTrackDT2ChamberResidual::setSegmentResidual(), gen::Pythia6Service::setSLHAFromHeader(), FWConvTrackHitsDetailView::setTextInfo(), CMSTDormandPrince45< T_Equation, N >::SetupInterpolation5thOrder(), PHcalTB06Info::setVtxPrim(), PHcalTB04Info::setVtxPrim(), MSLayersKeeperX0AtEta::setX0(), RPixChargeShare::Share(), HGCalImagingAlgo::shareEnergy(), ecaldqm::MESetTrend::shift_(), dqm::impl::MonitorElement::ShiftFillLast(), GaussianTail::shoot(), Accumulator::sigma(), FFTJetCorrectorTransient::sigma(), SigmaPt::sigma(), EnergyScaleCorrection::SmearCorrection::sigma(), HLLHCEvtVtxGenerator::sigma(), hitfit::Resolution::sigma(), BTLElectronicsSim::sigma_stochastic(), DD4hep_MaterialAccountingGroup::sigmaEnergyLoss(), MaterialAccountingGroup::sigmaEnergyLoss(), HGCalShowerShape::sigmaEtaEtaTot(), DD4hep_MaterialAccountingGroup::sigmaLength(), MaterialAccountingGroup::sigmaLength(), TEcnaRun::SigmaOfCorrelationsBetweenSamples(), HGCalShowerShape::sigmaPhiPhi(), HGCalShowerShape::sigmaPhiPhiTot(), heppy::resolutionFunction46< T >::sigmaPt(), heppy::resolutionFunction57< T >::sigmaPt(), resolutionFunctionType46< T >::sigmaPt(), resolutionFunctionType47< T >::sigmaPt(), resolutionFunctionType45< T >::sigmaPtError(), resolutionFunctionType46< T >::sigmaPtError(), resolutionFunctionType47< T >::sigmaPtError(), DD4hep_MaterialAccountingGroup::sigmaRadiationLengths(), MaterialAccountingGroup::sigmaRadiationLengths(), HGCalShowerShape::sigmaRRMax(), HGCalShowerShape::sigmaRRMean(), HGCalShowerShape::sigmaRRTot(), SimBeamSpotObjects::sigmaX(), HGCalShowerShape::sigmaXX(), SimBeamSpotObjects::sigmaY(), reco::BeamSpot::sigmaZ0Error(), BeamSpotObjects::sigmaZError(), HGCalShowerShape::sigmaZZ(), IPTools::signedDecayLength3D(), metsig::significanceAlgo::significance(), RectangularPlaneBounds::significanceInside(), TrapezoidalPlaneBounds::significanceInside(), cscdqm::Utility::SignificanceLevelHigh(), cscdqm::Utility::SignificanceLevelLow(), SeedForPhotonConversionFromQuadruplets::similarQuadExist(), SiPixelTemplate::simpletemplate2D(), MuonErrorMatrix::simpleTerm(), TotemTimingRecHitProducerAlgorithm::simplifiedLinearRegression(), Primary4DVertexValidation::simPrimaryVertex::simPrimaryVertex(), PrimaryVertexAnalyzer4PUSlimmed::simPrimaryVertex::simPrimaryVertex(), ME0PreRecoGaussianModel::simulateNoise(), ME0SimpleModel::simulateNoise(), LinearFitErrorsIn2Coord::slope(), smearFunctionType6::smear(), smearFunctionType7::smear(), BeamDivergenceVtxGenerator::smearMomentum(), JanAlignmentAlgorithm::solve(), HelixExtrapolatorToLine2Order::solve2ndOrder(), HelixExtrapolatorToLine2Order::solve3rdOrder(), hitfit::Top_Decaykin::solve_nu(), hitfit::Top_Decaykin::solve_nu_tmass(), PhotonCoreProducer::solveAmbiguity(), JetMatchingEWKFxFx::sortIncomingProcess(), CmsTrackerOTLayerBuilder< FilteredView >::sortNS(), TotemNumberMerger::Split(), DAClusterizerInZ_vect::split(), DAClusterizerInZT_vect::split(), MuonVPlusJetsIDSelectionFunctor::spring10Cuts(), MkFitGeometryESProducer::GapCollector::sqrt_elements(), SingleGaussianState1D::standardDeviation(), stat_RMS(), lhef::LHERunInfo::statistics(), SiStripMiscalibrate::Entry::std_dev(), SiStripPI::Entry::std_dev(), plotscripts::stdev(), MuonResidualsTwoBin::stdev(), CMSTDormandPrince45< T_Equation, N >::StepWithError(), ConversionFastHelix::straightLineStateAtVertex(), FastHelix::straightLineStateAtVertex(), CSCChamberSpecs::stripNoise(), trackerDTC::Stub::Stub(), IsoTrig::studyTrigger(), LA_Filler_Fitter::subset_probability(), PixelRecoLineRZ::subTIP(), SingleParticleEvent::subtractEloss(), mkfit::LayerOfHits::suckInHits(), SuepShower::SuepShower(), MSLayersAtAngle::sumX0D(), MSLayer::sumX0D(), reco::TrackBase::t0Error(), reco::IPTagInfo< Container, Base >::taggingVariables(), ChargeSignificanceTrajectoryFilter::TBC(), heppy::mt2w_bisect::mt2w::teco(), MuonErrorMatrix::Term(), CosmicMuonGenerator::terminate(), reco::VertexCompositePtrCandidate::tError(), reco::Vertex::tError(), MinPtTrajectoryFilter::test(), plotscripts::testDeltaWithin5Sigma(), LinkByRecHit::testECALAndPSByRecHit(), LinkByRecHit::testHFEMAndHFHADByRecHit(), TkGluedMeasurementDet::testStrips(), LinkByRecHit::testTrackAndClusterByRecHit(), TrackWithVertexSelector::testVertices(), L1MuGMTLFMatchQualLUT::TheLookupFunction(), CSCSegtoRPC::thePoints(), DTSegtoRPC::thePoints(), TracktoRPC::thePoints(), DAClusterizerInZ_vect::thermalize(), DAClusterizerInZT_vect::thermalize(), res::HelperJet::theta(), kinem::theta(), SingleParticleEvent::theta(), PerigeeTrajectoryError::thetaError(), ThirdHitPredictionFromCircle::ThirdHitPredictionFromCircle(), CSCFitAFEBThr::ThresholdNoise(), ticl::LinkingAlgoByDirectionGeometric::timeAndEnergyCompatible(), BasicSingleVertexState::timeError(), CTPPSTimingTrackRecognition< CTPPSDiamondLocalTrack, CTPPSDiamondRecHit >::timeEval(), Primary4DVertexValidation::timeFromTrueMass(), SiStripFineDelayTOF::timeOfFlightBeamB(), SiStripFineDelayTOF::timeOfFlightCosmic(), hgcalsimclustertime::ComputeClusterTime::timeResolution(), CPPFCluster::timeRMS(), RPCCluster::timeRMS(), EwkMuLumiMonitorDQM::tkIso(), MultiTrackValidator::tpDR(), JetVertexMain::Track_Pt(), MultiTrackValidator::trackDR(), tmtt::TrackerModule::TrackerModule(), MuonNavigableLayer::trackingRange(), StudyCaloResponse::trackPID(), MuonTrackAnalyzer::tracksAnalysis(), ConversionSeedFinder::trackStateFromClusters(), PFMuonAlgo::tracksWithBetterMET(), TrackVertexArbitration< VTX >::trackVertexArbitrator(), reco::JetSignalVertexCompatibilityAlgo::trackVertexCompat(), ExhaustiveMuonTrajectoryBuilder::trajectories(), TrajectoryAtInvalidHit::TrajectoryAtInvalidHit(), MuCSCTnPFlatTableProducer::TrajectoryDistToSeg(), TangentApproachInRPhi::trajectoryParameters(), SeedForPhotonConversionFromQuadruplets::trajectorySeed(), trajectoryToResiduals(), EmbeddingLHEProducer::transform_mumu_to_tautau(), riemannFit::transformToPerigeePlane(), brokenline::translateKarimaki(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline::translateKarimaki(), TotemTransport::transportProton(), OpticalFunctionsTransport::transportProton(), HectorTransport::transportProton(), TangentApproachInRPhi::transverseCoord(), ClosestApproachInRPhi::transverseCoord(), PerigeeTrajectoryError::transverseCurvatureError(), TrajectoryStateClosestToBeamLine::transverseImpactParameter(), PerigeeTrajectoryError::transverseImpactParameterError(), ThirdHitPredictionFromCircle::transverseIP(), PixelRecoLineRZ::transverseIP(), SiPixelTrackResidualSource::triplets(), DDG4SolidConverter::trunctubs(), TSGForRoadSearch::TSGForRoadSearch(), CalibrationScanAlgorithm::tuneSimultaneously(), FullModelReactionDynamics::TwoBody(), FullModelReactionDynamics::TwoCluster(), TotemRPLocalTrack::txSigma(), CTPPSPixelLocalTrack::txSigma(), TotemRPLocalTrack::tySigma(), CTPPSPixelLocalTrack::tySigma(), InvariantMassFromVertex::uncertainty(), external::HEPTopTaggerV2::UnclusterFatjets(), Basic3DVector< align::Scalar >::unit(), HcalNumberingFromDDD::unitID(), pat::PackedGenParticle::unpack(), unsafe_acos71(), PedestalsTask::update(), MonopoleSteppingAction::update(), PedsFullNoiseTask::update(), DaqScopeModeTask::update(), EcalSimHitsValidProducer::update(), TrackingVerboseAction::update(), TrackingMaterialProducer::update(), HcalTestAnalysis::update(), HcalTB02Analysis::update(), ZdcTestAnalysis::update(), CastorTestAnalysis::update(), CaloSD::update(), calo::multifit::update_decomposition_forwardsubst_with_offsets(), TwoTrackMinimumDistanceHelixLine::updateCoeffs(), TSGForOIDNN::updateFeatureMap(), SimpleNoiseCalculator::updateNoise(), TT6NoiseCalculator::updateNoise(), GsfMaterialEffectsUpdator::updateState(), TrajectoryManager::updateWithDaughters(), kinem::uvectors(), L1MuonPixelTrackFitter::valInversePt(), MultiTrackVertexLinkKinematicConstraint::value(), ColinearityKinematicConstraint::value(), MultiTrackPointingKinematicConstraint::value(), FourMomentumKinematicConstraint::value(), TwoTrackMassKinematicConstraint::value(), L1GctHtMissLut::value(), AlphaT::value_(), HGCalShowerShape::varRR(), SiPixelTemplate::vavilov2_pars(), SiPixelTemplate::vavilov_pars(), CosmicParametersDefinerForTP::vertex(), VertexClassifier::vertexInformation(), reco::VertexGhostTrackState::vertexStateOnGhostTrack(), reco::TrackGhostTrackState::vertexStateOnGhostTrack(), reco::TrackGhostTrackState::vertexStateOnMeasurement(), VertexTimeAlgorithmFromTracksPID::vertexTime(), VertexTimeAlgorithmLegacy4D::vertexTime(), DAClusterizerInZT_vect::vertices(), DAClusterizerInZ_vect::vertices_in_blocks(), DAClusterizerInZ_vect::vertices_no_blocks(), tmtt::ChiSquaredFit4::Vinv(), HGCalGeomTools::waferCorner(), heppy::FSRWeightAlgo::weight(), AlcaBeamSpotManager::weight(), BeamMonitorBx::weight(), FTLCluster::weighted_mean_error(), MuonSeedCreator::weightedPt(), PosteriorWeightsCalculator::weights(), SimpleNavigableLayer::wellInside(), CSCChamberSpecs::wireNoise(), CSCWireGeometry::wireValues(), plotscripts::wmean(), HResolution::Write(), VirtualJetProducer::writeJets(), Vx3DHLTAnalyzer::writeToFile(), PVPositionBuilder::wtAverage(), MSLayer::x0(), reco::BeamSpot::x0Error(), TotemRPLocalTrack::x0Sigma(), CTPPSPixelLocalTrack::x0Sigma(), MTDTrayBarrelLayer::xError(), MuRodBarrelLayer::xError(), BeamSpotObjects::xError(), reco::Vertex::xError(), CSCXonStrip_MatchGatti::xfError_Noise(), CSCXonStrip_MatchGatti::xfError_XTasym(), Nucleus2gamma2::xfUpdate(), lhef::LHERunInfo::xsec(), RealisticHitToClusterAssociator::XYdistanceFromMaxHit(), RealisticHitToClusterAssociator::XYdistanceFromPointOnSameLayer(), reco::BeamSpot::y0Error(), TotemRPLocalTrack::y0Sigma(), CTPPSPixelLocalTrack::y0Sigma(), BeamSpotObjects::yError(), reco::Vertex::yError(), CSCWireTopology::yResolution(), CPPFCluster::yRMS(), RPCCluster::yRMS(), reco::BeamSpot::z0Error(), ThirdHitPredictionFromCircle::HelixRZ::zAtR(), MCFilterZboostHelper::zboost(), TangentApproachInRPhi::zCoord(), ClosestApproachInRPhi::zCoord(), CurvilinearTrajectoryError::zeroFieldScaling(), BeamSpotObjects::zError(), reco::Vertex::zError(), SignedTransverseImpactParameter::zImpactParameter(), BaseParticlePropagator::zImpactParameter(), MuCSCTnPFlatTableProducer::zMass(), HFFibre::zShift(), and TauValidation::Zstoa().

19  {
20  return std::sqrt(t);
21  }
T sqrt(T t)
Definition: SSEVec.h:19

Variable Documentation

◆ __attribute__

union mathSSE::Vec2 mathSSE::__attribute__
inline

◆ f

b mathSSE::f = rh

Definition at line 37 of file SIMDVec.h.

◆ lh

bool double mathSSE::lh