Classes | |
class | Cartesian2Cartesian3D |
class | Cylindrical2Cartesian |
class | OnePiRange |
class | Phi |
class | Polar2Cartesian |
class | Spherical2Cartesian |
class | Theta |
Functions | |
double | deltaBarePhi (double phi1, double phi2) |
template<class Vector1 , class Vector2 > | |
double | deltaPhi (const Vector1 &v1, const Vector2 &v2) |
double | deltaPhi (float phi1, float phi2) |
double | deltaPhi (double phi1, double phi2) |
template<class Vector1 , class Vector2 > | |
double | deltaR (const Vector1 &v1, const Vector2 &v2) |
template<class Vector1 , class Vector2 > | |
double | deltaR2 (const Vector1 &v1, const Vector2 &v2) |
float | fhalfPi () |
float | fpi () |
float | ftwoPi () |
double | halfPi () |
template<class T , class Scalar > | |
Phi< T > | operator* (const Phi< T > &a, const Scalar &b) |
Multiplication with scalar, does not change the precision. | |
template<class T > | |
OnePiRange< T > | operator* (double a, const OnePiRange< T > &b) |
Multiplication with scalar. | |
template<class T > | |
Phi< T > | operator* (double a, const Phi< T > &b) |
Multiplication with scalar. | |
template<class T , class Scalar > | |
OnePiRange< T > | operator* (const OnePiRange< T > &a, const Scalar &b) |
Multiplication with scalar, does not change the precision. | |
template<class T > | |
OnePiRange< T > | operator+ (const OnePiRange< T > &a, const OnePiRange< T > &b) |
Addition. | |
template<class T , class Scalar > | |
OnePiRange< T > | operator+ (const Scalar &a, const OnePiRange< T > &b) |
Addition with scalar, does not change the precision. | |
template<class T > | |
Phi< T > | operator+ (const Phi< T > &a, const Phi< T > &b) |
Addition. | |
template<class T , class Scalar > | |
OnePiRange< T > | operator+ (const OnePiRange< T > &a, const Scalar &b) |
Addition with scalar, does not change the precision. | |
template<class T , class Scalar > | |
Phi< T > | operator+ (const Phi< T > &a, const Scalar &b) |
Addition with scalar, does not change the precision. | |
template<class T , class Scalar > | |
Phi< T > | operator+ (const Scalar &a, const Phi< T > &b) |
Addition with scalar, does not change the precision. | |
template<class T > | |
OnePiRange< T > | operator- (const OnePiRange< T > &a) |
| |
template<class T > | |
Phi< T > | operator- (const Phi< T > &a, const Phi< T > &b) |
Subtraction. | |
template<class T , class Scalar > | |
Phi< T > | operator- (const Phi< T > &a, const Scalar &b) |
Subtraction with scalar, does not change the precision. | |
template<class T , class Scalar > | |
OnePiRange< T > | operator- (const OnePiRange< T > &a, const Scalar &b) |
Subtraction with scalar, does not change the precision. | |
template<class T > | |
OnePiRange< T > | operator- (const OnePiRange< T > &a, const OnePiRange< T > &b) |
Subtraction. | |
template<class T , class Scalar > | |
OnePiRange< T > | operator- (const Scalar &a, const OnePiRange< T > &b) |
Subtraction with scalar, does not change the precision. | |
template<class T > | |
Phi< T > | operator- (const Phi< T > &a) |
| |
template<class T , class Scalar > | |
Phi< T > | operator- (const Scalar &a, const Phi< T > &b) |
Subtraction with scalar, does not change the precision. | |
template<class T > | |
T | operator/ (const Phi< T > &a, const Phi< T > &b) |
Division. | |
template<class T > | |
T | operator/ (const OnePiRange< T > &a, const OnePiRange< T > &b) |
Division. | |
template<class T > | |
OnePiRange< T > | operator/ (const OnePiRange< T > &a, double b) |
Division by scalar. | |
template<class T > | |
Phi< T > | operator/ (const Phi< T > &a, double b) |
Division by scalar. | |
bool | phiLess (float phi1, float phi2) |
template<class Vector1 , class Vector2 > | |
bool | phiLess (const Vector1 &v1, const Vector2 &v2) |
bool | phiLess (double phi1, double phi2) |
double | pi () |
double | twoPi () |
Variables | |
class Geom::Polar2Cartesian | __attribute__ |
double Geom::deltaBarePhi | ( | double | phi1, |
double | phi2 | ||
) | [inline] |
Find aximutal Angle difference between two generic vectors ( v2.Phi() - v1.Phi() ) The only requirements on the Vector classes is that they implement the Phi() method
v1 | Vector of any type implementing the Phi() operator |
v2 | Vector of any type implementing the Phi() operator |
Definition at line 21 of file VectorUtil.h.
References M_PI.
Referenced by deltaPhi().
double Geom::deltaPhi | ( | const Vector1 & | v1, |
const Vector2 & | v2 | ||
) |
Definition at line 39 of file VectorUtil.h.
References deltaBarePhi().
{ return deltaBarePhi(v1.phi(),v2.phi()); }
double Geom::deltaPhi | ( | float | phi1, |
float | phi2 | ||
) | [inline] |
Definition at line 30 of file VectorUtil.h.
References deltaBarePhi(), and Phi_mpi_pi().
Referenced by PhotonValidator::analyze(), PhotonsWithConversionsAnalyzer::analyze(), SusyDQM< Mu, Ele, Jet, Met >::analyze(), MBUEandQCDValidation::analyze(), MuonCSCSeedFromRecHits::analyze(), ErsatzMEt::analyze(), L1GctValidation::analyze(), Rivet::MC_LES_HOUCHES_SYSTEMATICS_CMS::analyze(), PatElectronAnalyzer::analyze(), SimpleConvertedPhotonAnalyzer::analyze(), myFastSimVal::analyze(), SimplePhotonAnalyzer::analyze(), QcdPhotonsDQM::analyze(), JPTJetAnalyzer::analyze(), Rivet::CMS_QCD_10_010::analyze(), TopHLTDiMuonDQM::analyze(), PFCandidateChecker::analyze(), TkConvValidator::analyze(), myJetAna::analyze(), EgammaObjects::analyzeElectrons(), EgammaObjects::analyzePhotons(), TrackAssociatorByChi2::associateRecoToSim(), TrackAssociatorByChi2::associateSimToReco(), MuonCSCSeedFromRecHits::bestEndcapHit(), PFRecoTauAlgorithm::buildPFTau(), EwkDQM::calcDeltaPhi(), calcDeltaPhi(), HiggsDQM::calcDeltaPhi(), EwkElecDQM::calcDeltaPhi(), L1TauAnalyzer::calcL1MCPFTauMatching(), L1TauAnalyzer::calcL1MCTauMatching(), AlignmentTwoBodyDecayTrackSelector::checkAcoplanarity(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), ConversionProducer::checkPhi(), RoadSearchCloudMakerAlgorithm::CheckZPhiIntersection(), EventShapeVariables::circularity(), MuonTrajectoryCleaner::clean(), TrackerSeedCleaner::clean(), FastTSGFromIOHit::clean(), FastTSGFromL2Muon::clean(), EgammaSuperClusters::closestMCParticle(), TCMETAlgo::closeToElectron(), egammaisolation::EgammaRecHitExtractor::collect(), TrackAssociatorByChi2::compareTracksParam(), RPCSeedrecHitFinder::complete(), MuonSeedOrcaPatternRecognition::complete(), TIDRing::computeCrossings(), CompositeTECWedge::computeCrossings(), TECLayer::computeCrossings(), DDPixFwdBlades::computeNippleParameters(), METManager::coutTailEvents(), RPCSeedPattern::createSeed(), CosmicMuonSeedGenerator::createSeed(), TGeoMgrFromDdd::createShape(), MuonShowerInformationFiller::cscPositionToDets(), CATopJetAlgorithm::decomposeJet(), TtDilepLRSignalSelObservables::delta(), CalibratableTest::deltaR(), deltaR2(), MuonSeedOrcaPatternRecognition::discriminator(), HiggsDQM::DistancePhi(), CSCValidation::doStandalone(), MuonShowerInformationFiller::dtPositionToDets(), EcalTBMCInfoProducer::EcalTBMCInfoProducer(), ErsatzMEt::ersatzFabrik(), L1TauAnalyzer::evalL1extraDecisions(), PFPhotonAlgo::EvaluateSingleLegMVA(), DDPixFwdBlades::execute(), RPCSeedPattern::extropolateStep(), HDelta::Fill(), HMassResolutionVSPart::Fill(), GenericBenchmark::fillHistos(), TrackerValidationVariables::fillHitQuantities(), MuonShowerInformationFiller::fillHitsByStation(), egHLT::OffHelper::fillHLTData(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTriggerwrtMuonTrigger(), JetMETHLTOfflineSource::fillMEforTriggerNTfired(), RoadSearchCloudMakerAlgorithm::FillRecHitsIntoCloudGeneral(), TrackerOfflineValidation::fillTree(), TrackerOfflineValidationSummary::fillTree(), QcdUeDQM::fillUE_with_ChargedJets(), QcdUeDQM::fillUE_with_MaxpTtrack(), PythiaFilterGammaJet::filter(), PythiaFilterGammaJetIsoPi0::filter(), PythiaFilterEMJet::filter(), PythiaFilterGammaJetWithOutBg::filter(), PythiaFilterGammaJetWithBg::filter(), HLTMuonTrackMassFilter::filter(), HLTDiJetAveFilter::filter(), HLTEgammaDoubleEtDeltaPhiFilter::filter(), HLTMuonDimuonL3Filter::filter(), MuonSeedOrcaPatternRecognition::filterOverlappingChambers(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), MuonShowerInformationFiller::findPhiCluster(), RPCSeedrecHitFinder::getdeltaPhifromrecHits(), IsolatedPixelTrackCandidateProducer::GetEtaPhiAtEcal(), PythiaFilterIsolatedTrack::GetEtaPhiAtEcal(), ConversionProducer::getMatchedBC(), HitPairGeneratorFromLayerPairForPhotonConversion::getPhiRange(), RPCSeedPattern::getSpecialAlgorithmErrorMatrix(), EgammaRecHitIsolation::getSum_(), EgammaTowerIsolation::getTowerESum(), EgammaTowerIsolation::getTowerEtSum(), HitQuadrupletGeneratorFromLayerPairForPhotonConversion::hitPairs(), HitPairGeneratorFromLayerPair::hitPairs(), DiskSectorBounds::inside(), ConversionSeedFilter::isCompatible(), cms::MuonTCMETValueMapProducer::isGoodCaloMuon(), CSCSegAlgoShowering::isHitNearSegment(), CSCSegAlgoDF::isHitNearSegment(), GoodSeedProducer::IsIsolated(), EventShapeVariables::isotropy(), main(), CosmicMuonSeedGenerator::makeSegPairs(), L1MuonMatcherAlgo::match(), MuonIdTruthInfo::matchChi2(), ConversionTools::matchesConversion(), L1MuonMatcherAlgo::matchGeneric(), ConversionProducer::matchingSC(), DetIdAssociator::nearElement(), MuonShowerInformationFiller::AbsLessDPhi::operator()(), MuonShowerInformationFiller::LessDPhi::operator()(), DeltaPhi< T1, T2 >::operator()(), DeltaPhiMinPairSelector::operator()(), TtDilepLRSignalSelObservables::operator()(), InnerDeltaPhi::operator()(), CMSInsideOutAlgorithm::ListIteratorLesserByDeltaR::operator()(), operator<<(), HLTmmkFilter::overlap(), egHLT::EgJetTagProbeCut< T >::pass(), egHLT::EgJetB2BCut< T >::pass(), PFRootEventManager::pfCandCompare(), phiLess(), InnerDeltaPhi::phiRange(), PFAlgo::postCleaning(), PFCandidateChecker::printJets(), PFTauElecRejectionBenchmark::process(), JetPlusTrackProducerAA::produce(), TauJetSelectorForHLTTrackSeeding::produce(), JetPlusTrackProducer::produce(), HLTJetL1MatchProducer::produce(), ConversionSeedFilterCharge::produce(), BaseParticlePropagator::propagate(), pftools::CaloWindow::relativePosition(), RPCSeedPattern::SegmentAlgorithmSpecial(), MuonCSCSeedFromRecHits::segmentQuality(), QcdLowPtDQM::trackletVertexUnbinned(), DDG4SolidConverter::trunctubs(), DDI::Cons::volume(), and RoadSearchCloudMakerAlgorithm::ZPhiDeltaPhi().
{ using ROOT::Math::VectorUtil::Phi_mpi_pi; return deltaBarePhi(Phi_mpi_pi(phi2),Phi_mpi_pi(phi1)); }
double Geom::deltaPhi | ( | double | phi1, |
double | phi2 | ||
) | [inline] |
Definition at line 34 of file VectorUtil.h.
References deltaBarePhi(), and Phi_mpi_pi().
{ using ROOT::Math::VectorUtil::Phi_mpi_pi; return deltaBarePhi(Phi_mpi_pi(phi2),Phi_mpi_pi(phi1)); }
double Geom::deltaR | ( | const Vector1 & | v1, |
const Vector2 & | v2 | ||
) |
Definition at line 84 of file VectorUtil.h.
References deltaR2(), and mathSSE::sqrt().
Referenced by reco::VertexFilter::operator()(), CombinedSVComputer::operator()(), GhostTrackComputer::operator()(), HiGenCleaner< T2 >::produce(), and reco::SecondaryVertexTagInfo::taggingVariables().
double Geom::deltaR2 | ( | const Vector1 & | v1, |
const Vector2 & | v2 | ||
) |
Find difference in pseudorapidity (Eta) and Phi betwen two generic vectors The only requirements on the Vector classes is that they implement the Phi() and Eta() method
v1 | Vector 1 |
v2 | Vector 2 |
Definition at line 78 of file VectorUtil.h.
References deltaPhi().
Referenced by EgammaHLTHcalIsolation::acceptHit_(), helper::SimpleJetTrackAssociator::associate(), helper::SimpleJetTrackAssociator::associateTransient(), pat::LeptonJetIsolationAngle::calculate(), deltaR(), PythiaFilterGammaJetIsoPi0::filter(), PythiaFilterGammaJet::filter(), PythiaFilterGammaJetWithOutBg::filter(), PythiaFilterGammaJetWithBg::filter(), PhotonEnrichmentFilter::filter(), CMSMidpointAlgorithm::findStableConesFromMidPoints(), EcalBarrelGeometry::getCells(), InvariantMassAlgorithm::getMinimumClusterDR(), L1MuonMatcherAlgo::match(), PFB::match(), L1MuonMatcherAlgo::matchGeneric(), pat::OverlapByDeltaR::operator()(), CMSInsideOutAlgorithm::ListIteratorLesserByDeltaR::operator()(), DeltaRMinPairSelector::operator()(), DeltaRNearestObjectComputer< T >::produce(), TauJetSelectorForHLTTrackSeeding::produce(), JetVetoedTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRCalo::produce(), NearbyCandCountComputer::produce(), JetPlusTrackCorrector::rebuildJta(), CMSIterativeConeAlgorithm::run(), CMSInsideOutAlgorithm::run(), GenJetClosestMatchSelectorDefinition::select(), and CMSMidpointAlgorithm::splitAndMerge().
{ double dphi = deltaPhi(v1,v2); double deta = v2.eta() - v1.eta(); return dphi*dphi + deta*deta; }
float Geom::fhalfPi | ( | ) | [inline] |
float Geom::fpi | ( | ) | [inline] |
Definition at line 35 of file Pi.h.
Referenced by MagGeoBuilderFromDDD::build(), and PixelTripletHLTGenerator::mergePhiRanges().
{return 3.141592653589793238f;}
float Geom::ftwoPi | ( | ) | [inline] |
Definition at line 36 of file Pi.h.
Referenced by MagGeoBuilderFromDDD::build(), PixelTripletHLTGenerator::checkPhiInRange(), and PixelTripletHLTGenerator::mergePhiRanges().
{return 2.f *3.141592653589793238f;}
double Geom::halfPi | ( | ) | [inline] |
Definition at line 33 of file Pi.h.
Referenced by RoadSearchCloudMakerAlgorithm::makecircle(), and TrackAssociatorByChi2::parametersAtClosestApproach().
{return 0.5*3.141592653589793238;}
OnePiRange<T> Geom::operator* | ( | double | a, |
const OnePiRange< T > & | b | ||
) | [inline] |
OnePiRange<T> Geom::operator* | ( | const OnePiRange< T > & | a, |
const Scalar & | b | ||
) | [inline] |
Multiplication with scalar, does not change the precision.
Definition at line 110 of file OnePiRange.h.
References a.
OnePiRange<T> Geom::operator+ | ( | const OnePiRange< T > & | a, |
const OnePiRange< T > & | b | ||
) | [inline] |
OnePiRange<T> Geom::operator+ | ( | const Scalar & | a, |
const OnePiRange< T > & | b | ||
) | [inline] |
Addition with scalar, does not change the precision.
Definition at line 86 of file OnePiRange.h.
References b.
OnePiRange<T> Geom::operator+ | ( | const OnePiRange< T > & | a, |
const Scalar & | b | ||
) | [inline] |
Addition with scalar, does not change the precision.
Definition at line 81 of file OnePiRange.h.
References a.
OnePiRange<T> Geom::operator- | ( | const OnePiRange< T > & | a | ) | [inline] |
Definition at line 71 of file OnePiRange.h.
References Geom::OnePiRange< T >::value().
{return OnePiRange<T>(-a.value());}
OnePiRange<T> Geom::operator- | ( | const OnePiRange< T > & | a, |
const Scalar & | b | ||
) | [inline] |
Subtraction with scalar, does not change the precision.
Definition at line 98 of file OnePiRange.h.
References a.
OnePiRange<T> Geom::operator- | ( | const OnePiRange< T > & | a, |
const OnePiRange< T > & | b | ||
) | [inline] |
OnePiRange<T> Geom::operator- | ( | const Scalar & | a, |
const OnePiRange< T > & | b | ||
) | [inline] |
Subtraction with scalar, does not change the precision.
Definition at line 104 of file OnePiRange.h.
References Geom::OnePiRange< T >::value().
Definition at line 69 of file Phi.h.
References Geom::Phi< T >::value().
{return Phi<T>(-a.value());}
Phi<T> Geom::operator- | ( | const Scalar & | a, |
const Phi< T > & | b | ||
) | [inline] |
Subtraction with scalar, does not change the precision.
Definition at line 101 of file Phi.h.
References Geom::Phi< T >::value().
T Geom::operator/ | ( | const OnePiRange< T > & | a, |
const OnePiRange< T > & | b | ||
) | [inline] |
OnePiRange<T> Geom::operator/ | ( | const OnePiRange< T > & | a, |
double | b | ||
) | [inline] |
bool Geom::phiLess | ( | float | phi1, |
float | phi2 | ||
) | [inline] |
Definition of ordering of azimuthal angles. phi1 is less than phi2 if the angle covered by a point going from phi1 to phi2 in the counterclockwise direction is smaller than pi. It makes sense only if ALL phis are in a single hemisphere...
Definition at line 57 of file VectorUtil.h.
References deltaPhi().
Referenced by tkDetUtil::calculatePhiWindow(), boundSpan::computeSpan(), PhiLess::operator()(), and DetPhiLess::operator()().
{ return deltaPhi(phi1,phi2)<0; }
bool Geom::phiLess | ( | const Vector1 & | v1, |
const Vector2 & | v2 | ||
) |
bool Geom::phiLess | ( | double | phi1, |
double | phi2 | ||
) | [inline] |
Definition at line 60 of file VectorUtil.h.
References deltaPhi().
{ return deltaPhi(phi1,phi2)<0; }
double Geom::pi | ( | ) | [inline] |
Definition at line 31 of file Pi.h.
Referenced by PhotonsWithConversionsAnalyzer::analyze(), DTVDriftCalibration::analyze(), SimpleConvertedPhotonAnalyzer::analyze(), DTLocalTriggerSynchTask::analyze(), EgammaObjects::analyzeElectrons(), EgammaObjects::analyzePhotons(), MagGeoBuilderFromDDD::buildInterpolator(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_Covariances(), RoadSearchSeedFinderAlgorithm::calculateCircleSeedsFromRingsOneInnerOneOuter(), RoadSearchSeedFinderAlgorithm::calculateCircleSeedsFromRingsOneInnerTwoOuter(), RoadSearchSeedFinderAlgorithm::calculateCircleSeedsFromRingsTwoInnerOneOuter(), RoadSearchCloudMakerAlgorithm::CheckZPhiIntersection(), NavVolume6Faces::computeBounds(), DTTime2DriftParametrization::computeDriftDistance_mean(), PFClusterShapeAlgo::covariances(), EcalClusterTools::covariances(), Geom::Phi< float >::degrees(), Geom::OnePiRange< T >::degrees(), EcalEtaPhiRegion::EcalEtaPhiRegion(), ECALPositionCalculator::ecalPhi(), HResolution::HResolution(), HResolution1DRecHit::HResolution1DRecHit(), HTrackVariables::HTrackVariables(), EcalEtaPhiRegion::inRegion(), ESListOfFEDSProducer::ListOfFEDS(), EcalListOfFEDSProducer::ListOfFEDS(), EcalRawToRecHitRoI::ListOfFEDS(), HLTAlCa::ListOfFEDS(), Ring::map_phi(), RoadSearchCloudMakerAlgorithm::map_phi2(), HLTDTActivityFilter::matchChamber(), Geom::Phi< float >::normalize(), Geom::OnePiRange< T >::normalize(), DTSegmentSelector::operator()(), RoadSearchCircleSeed::Phi0(), PhiBorderFinder::PhiBorderFinder(), L2MuonSeedGenerator::produce(), SteppingHelixPropagator::refToDest(), RoadSearchCloudMakerAlgorithm::run(), TrapezoidalCylindricalMFGrid::TrapezoidalCylindricalMFGrid(), DTTrigGeomUtils::trigPos(), DDI::Sphere::volume(), DDI::EllipticalTube::volume(), and DDI::Orb::volume().
{return 3.141592653589793238;}
double Geom::twoPi | ( | ) | [inline] |
Definition at line 32 of file Pi.h.
Referenced by PhotonsWithConversionsAnalyzer::analyze(), SimpleConvertedPhotonAnalyzer::analyze(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_Covariances(), RoadSearchSeedFinderAlgorithm::calculateCircleSeedsFromRingsOneInnerOneOuter(), RoadSearchSeedFinderAlgorithm::calculateCircleSeedsFromRingsOneInnerTwoOuter(), RoadSearchSeedFinderAlgorithm::calculateCircleSeedsFromRingsTwoInnerOneOuter(), Ring::containsDetId(), PFClusterShapeAlgo::covariances(), EcalClusterTools::covariances(), EcalEtaPhiRegion::EcalEtaPhiRegion(), ECALPositionCalculator::ecalPhi(), FWLegoCandidate::FWLegoCandidate(), EgammaTowerIsolation::getTowerESum(), EgammaTowerIsolation::getTowerEtSum(), EcalEtaPhiRegion::inRegion(), RoadSearchCloudMakerAlgorithm::map_phi(), Ring::map_phi(), RoadSearchCloudMakerAlgorithm::map_phi2(), Geom::Phi< float >::normalize(), PhiBorderFinder::positiveRange(), and GeneralBinFinderInPhi< T >::positiveRange().
{return 2. *3.141592653589793238;}