CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
List of all members | Public Types | Public Member Functions | Protected Attributes
PV3DBase< T, PVType, FrameType > Class Template Reference

#include <PV3DBase.h>

Public Types

typedef Basic3DVector< TBasicVectorType
 
typedef
BasicVectorType::Cylindrical 
Cylindrical
 
typedef BasicVectorType::MathVector MathVector
 
typedef BasicVectorType::Polar Polar
 
typedef T ScalarType
 
typedef BasicVectorType::Spherical Spherical
 

Public Member Functions

T barePhi () const
 
T bareTheta () const
 
const BasicVectorTypebasicVector () const
 
T eta () const
 
T mag () const
 
T mag2 () const
 
MathVector const & mathVector () const
 
MathVectormathVector ()
 
T perp () const
 
T perp2 () const
 
Geom::Phi< Tphi () const
 
 PV3DBase ()
 
 PV3DBase (const T &x, const T &y, const T &z)
 construct from cartesian coordinates More...
 
 PV3DBase (const Cylindrical &set)
 
 PV3DBase (const Polar &set)
 construct from polar coordinates More...
 
 PV3DBase (const Geom::Theta< T > &th, const Geom::Phi< T > &ph, const T &r)
 
template<class U >
 PV3DBase (const Basic3DVector< U > &v)
 
Geom::Theta< Ttheta () const
 
T transverse () const
 
T x () const
 
T y () const
 
T z () const
 

Protected Attributes

BasicVectorType theVector
 

Detailed Description

template<class T, class PVType, class FrameType>
class PV3DBase< T, PVType, FrameType >

Base class for Point and Vector classes with restricted set of operations and coordinate frame compile time checking. This class restricts the interface of Basic3DVector, removing all algebraic operations and limiting the constructors. The Point and Vector classes inherit from this class, and add the relevant algebraic operations.

Definition at line 15 of file PV3DBase.h.

Member Typedef Documentation

template<class T, class PVType, class FrameType>
typedef Basic3DVector<T> PV3DBase< T, PVType, FrameType >::BasicVectorType

Definition at line 19 of file PV3DBase.h.

template<class T, class PVType, class FrameType>
typedef BasicVectorType::Cylindrical PV3DBase< T, PVType, FrameType >::Cylindrical

Definition at line 20 of file PV3DBase.h.

template<class T, class PVType, class FrameType>
typedef BasicVectorType::MathVector PV3DBase< T, PVType, FrameType >::MathVector

Definition at line 23 of file PV3DBase.h.

template<class T, class PVType, class FrameType>
typedef BasicVectorType::Polar PV3DBase< T, PVType, FrameType >::Polar

Definition at line 22 of file PV3DBase.h.

template<class T, class PVType, class FrameType>
typedef T PV3DBase< T, PVType, FrameType >::ScalarType

Definition at line 18 of file PV3DBase.h.

template<class T, class PVType, class FrameType>
typedef BasicVectorType::Spherical PV3DBase< T, PVType, FrameType >::Spherical

Definition at line 21 of file PV3DBase.h.

Constructor & Destructor Documentation

template<class T, class PVType, class FrameType>
PV3DBase< T, PVType, FrameType >::PV3DBase ( )
inline

default constructor uses default constructor of T to initialize the components. For built-in floating-point types this means initialization to zero

Definition at line 30 of file PV3DBase.h.

30 : theVector() {}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
PV3DBase< T, PVType, FrameType >::PV3DBase ( const T x,
const T y,
const T z 
)
inline

construct from cartesian coordinates

Definition at line 33 of file PV3DBase.h.

33 : theVector(x, y, z) {}
T y() const
Definition: PV3DBase.h:63
T z() const
Definition: PV3DBase.h:64
BasicVectorType theVector
Definition: PV3DBase.h:79
T x() const
Definition: PV3DBase.h:62
template<class T, class PVType, class FrameType>
PV3DBase< T, PVType, FrameType >::PV3DBase ( const Cylindrical set)
inline

Construct from cylindrical coordinates.

Definition at line 37 of file PV3DBase.h.

37 : theVector( set) {}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
PV3DBase< T, PVType, FrameType >::PV3DBase ( const Polar set)
inline

construct from polar coordinates

Definition at line 40 of file PV3DBase.h.

40 : theVector( set) {}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
PV3DBase< T, PVType, FrameType >::PV3DBase ( const Geom::Theta< T > &  th,
const Geom::Phi< T > &  ph,
const T r 
)
inline

Deprecated construct from polar coordinates, use constructor from Polar( theta, phi, r) instead.

Definition at line 45 of file PV3DBase.h.

46  : theVector(th,ph,r) {}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
template<class U >
PV3DBase< T, PVType, FrameType >::PV3DBase ( const Basic3DVector< U > &  v)
inlineexplicit

Explicit constructor from BasicVectorType, possibly of different precision

Definition at line 51 of file PV3DBase.h.

51 : theVector(v) {}
BasicVectorType theVector
Definition: PV3DBase.h:79

Member Function Documentation

template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::barePhi ( ) const
inline
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::bareTheta ( ) const
inline

Definition at line 74 of file PV3DBase.h.

74 { return basicVector().bareTheta();}
T bareTheta() const
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
template<class T, class PVType, class FrameType>
const BasicVectorType& PV3DBase< T, PVType, FrameType >::basicVector ( ) const
inline

Access to the basic vector, use only when the operations on Point and Vector are too restrictive (preferably never).

Definition at line 56 of file PV3DBase.h.

Referenced by PV3DBase< long double, PointTag, GlobalTag >::barePhi(), PV3DBase< long double, PointTag, GlobalTag >::bareTheta(), JacobianCurvilinearToLocal::compute(), ThreePlaneCrossing::crossing(), NavPlane::distanceAlongLine(), PV3DBase< long double, PointTag, GlobalTag >::eta(), RKLocalFieldProvider::inTesla(), GeomDetCompatibilityChecker::isCompatible(), MuonNavigableLayer::isInsideOut(), PV3DBase< long double, PointTag, GlobalTag >::mag(), PV3DBase< long double, PointTag, GlobalTag >::mag2(), SeedMatcher::matchSimTrack(), PathToPlane2Order::operator()(), Point3DBase< float, MeasurementTag >::operator==(), DirectTrackerNavigation::outward(), PV3DBase< long double, PointTag, GlobalTag >::perp(), PV3DBase< long double, PointTag, GlobalTag >::perp2(), PV3DBase< long double, PointTag, GlobalTag >::phi(), reco::PFRecHit::position(), RecHitsSortedInPhi::RecHitsSortedInPhi(), PV3DBase< long double, PointTag, GlobalTag >::theta(), GloballyPositioned< align::Scalar >::toGlobal(), Surface::toGlobal(), GloballyPositioned< T >::ToLocal::toLocal(), GloballyPositioned< align::Scalar >::toLocal(), PV3DBase< long double, PointTag, GlobalTag >::transverse(), defaultRKPropagator::TrivialFieldProvider::valueInTesla(), PV3DBase< long double, PointTag, GlobalTag >::x(), PV3DBase< long double, PointTag, GlobalTag >::y(), and PV3DBase< long double, PointTag, GlobalTag >::z().

56 { return theVector;}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::eta ( ) const
inline
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::mag ( ) const
inline

Definition at line 67 of file PV3DBase.h.

Referenced by PreshowerHitMaker::addHit(), TwoTrackMinimumDistanceLineLine::calculate(), siStripClusterTools::chargePerCM(), VZeroFinder::checkTrackPair(), GsfMultipleScatteringUpdator::compute(), VolumeEnergyLossEstimator::computeBetheBloch(), VolumeEnergyLossEstimator::computeElectrons(), CurvilinearTrajectoryParameters::CurvilinearTrajectoryParameters(), CylindricalState::CylindricalState(), DTDigiSyncTOFCorr::digitizerOffset(), TangentHelix::directionAtVertex(), VertexDistance3D::distance(), VolumeMultipleScatteringEstimator::estimate(), TrajectoryExtrapolatorToLine::extrapolate(), AnalyticalTrajectoryExtrapolatorToLine::extrapolateSingleState(), RecoTracktoTP::hasPCA(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), CosmicMuonUtilities::isTraversing(), jacobianCartesianToCurvilinear(), JacobianCartesianToLocal::JacobianCartesianToLocal(), jacobianCurvilinearToCartesian(), CSCCrossGap::length(), IdealZPrism::localCorners(), StripCPEgeometric::localParameters(), LocalTrajectoryParameters::LocalTrajectoryParameters(), RKPropagatorInZ::myPropagate(), DTTTrigSyncTOFCorr::offset(), RKCylindricalDistance< T, N >::operator()(), PathToPlane2Order::operator()(), CrossingPtBasedLinearizationPointFinder::CompareTwoTracks::operator()(), susybsm::RPCHit4D::operator<(), AnalyticalImpactPointExtrapolator::propagateWithHelix(), AnalyticalTrajectoryExtrapolatorToLine::propagateWithHelix(), RecoTracktoTP::s_dsz(), RecoTracktoTP::s_qoverp(), GlobalTrajectoryParameters::signedInverseMomentum(), CosmicMuonUtilities::stepPropagate(), spr::timeOfFlight(), reco::TrackGhostTrackState::vertexStateOnGhostTrack(), and reco::TrackGhostTrackState::vertexStateOnMeasurement().

67 { return basicVector().mag();}
T mag() const
The vector magnitude. Equivalent to sqrt(vec.mag2())
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::mag2 ( ) const
inline

Definition at line 66 of file PV3DBase.h.

Referenced by VZeroFinder::checkTrackPair(), PrintRecoObjects::print(), and CaloGeometryDBEP< T, U >::produceAligned().

66 { return basicVector().mag2();}
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
T mag2() const
The vector magnitude squared. Equivalent to vec.dot(vec)
template<class T, class PVType, class FrameType>
MathVector const& PV3DBase< T, PVType, FrameType >::mathVector ( ) const
inline

Definition at line 58 of file PV3DBase.h.

58 { return theVector.v;}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
MathVector& PV3DBase< T, PVType, FrameType >::mathVector ( )
inline

Definition at line 59 of file PV3DBase.h.

59 { return theVector.v;}
BasicVectorType theVector
Definition: PV3DBase.h:79
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::perp ( ) const
inline

Definition at line 72 of file PV3DBase.h.

Referenced by ThirdHitPredictionFromInvLine::add(), FiducialVolume::addActivePoint(), LayerCollector::allLayers(), CSCRecHit2DValidation::analyze(), MuonCSCDetLayerGeometryBuilder::buildLayer(), MuonGEMDetLayerGeometryBuilder::buildLayer(), MuonDTDetLayerGeometryBuilder::buildLayers(), pat::TrackerIsolationPt::calculate(), MuonSeedSimpleCleaner::checkPt(), VZeroFinder::checkTrackPair(), ForwardDetLayer::compatible(), BarrelDetLayer::compatible(), MuDetRod::compatibleDets(), GsfMultipleScatteringUpdator::compute(), JacobianCurvilinearToLocal::compute(), JacobianLocalToCurvilinear::compute(), FastLine::createLineParameters(), MuonSeedFromRecHits::createSeed(), CylindricalState::CylindricalState(), MultipleScatteringGeometry::detLayers(), EleRelPointPair::dPerp(), MuonPatternRecoDumper::dumpFTS(), TValidTrackingRecHit::errorGlobalRPhi(), TRecHit5DParamConstraint::errorGlobalRPhi(), TRecHit2DPosConstraint::errorGlobalRPhi(), ConversionForwardEstimator::estimate(), ForwardMeasurementEstimator::estimate(), BarrelMeasurementEstimator::estimate(), HLTMuonPointingFilter::filter(), FTSFromVertexToPointFactory::get(), GlobalDetRodRangeZPhi::GlobalDetRodRangeZPhi(), GlobalTrajectoryParameters::GlobalTrajectoryParameters(), RecHitsSortedInPhi::gv(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), CosmicTrackingRegion::hits_(), SeedFromConsecutiveHitsStraightLineCreator::initialKinematic(), SimpleCylinderBounds::inside(), SimpleConeBounds::inside(), GeomDetLess::insideOutLess(), SmartPropagator::insideTkVol(), PolyFit2DParametrizedMagneticField::inTeslaUnchecked(), PolyFit2DParametrizedMagneticField::isDefined(), VolumeBasedMagneticField::isDefined(), TrackerBounds::isInside(), CosmicMuonUtilities::isTraversing(), jacobianCartesianToCurvilinear(), jacobianCurvilinearToCartesian(), OuterDetCompatibility::maximalLocalDisplacement(), DetBelowR::operator()(), StateOnTrackerBound::operator()(), PropagationDirectionChooser::operator()(), TrimmedTrackFilter::operator()(), OuterHitCompatibility< Algo >::operator()(), PathToPlane2Order::operator()(), CylinderBuilderFromDet::operator()(), CompareTwoTracks::operator()(), operator<<(), trajectoryStateTransform::persistentState(), CSCRecHit2DValidation::plotResolution(), CosmicMuonUtilities::print(), GlobalMuonToMuonProducer::printTrackRecHits(), StraightLinePropagator::propagateParametersOnCylinder(), CSCPairResidualsConstraint::radius(), ThirdHitPredictionFromInvLine::remove(), VZeroFinder::rotate(), RZLine::RZLine(), RecoTracktoTP::s_dsz(), RecoTracktoTP::s_dxy(), RecoTracktoTP::s_dz(), Cylinder::side(), GlobalTrajectoryParameters::signedInverseTransverseMomentum(), SimpleTECWedge::SimpleTECWedge(), ThresholdPtTrajectoryFilter::test(), MuonNavigableLayer::trackingRange(), ConversionSeedFinder::trackStateFromClusters(), and DTTrigGeomUtils::trigPos().

72 { return basicVector().perp();}
T perp() const
Magnitude of transverse component.
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::perp2 ( ) const
inline
template<class T, class PVType, class FrameType>
Geom::Phi<T> PV3DBase< T, PVType, FrameType >::phi ( ) const
inline

Definition at line 69 of file PV3DBase.h.

Referenced by Particle.Particle::__str__(), EgammaHLTHcalIsolation::acceptHit_(), CSCRecHit2DValidation::analyze(), MuonCSCDetLayerGeometryBuilder::buildLayer(), MuonGEMDetLayerGeometryBuilder::buildLayer(), MuonDTDetLayerGeometryBuilder::buildLayers(), TwoTrackMinimumDistanceLineLine::calculate(), SuperClusterShapeAlgo::Calculate_Covariances(), TBPositionCalc::CalculateCMSPos(), FastTSGFromIOHit::clean(), MuDetRod::compatibleDets(), PrimitiveConverterRPC::convert(), CylindricalState::CylindricalState(), egammaisolation::EgammaHcalExtractor::deposit(), MuonPatternRecoDumper::dumpFTS(), EtaPhiEstimator::estimate(), ConversionForwardEstimator::estimate(), ConversionBarrelEstimator::estimate(), BarrelMeasurementEstimator::estimate(), KinematicPerigeeConversions::extendedPerigeeFromKinematicParameters(), MagBSector::findVolume(), MagBLayer::findVolume(), GlobalDetRodRangeZPhi::GlobalDetRodRangeZPhi(), CosmicTrackingRegion::hits_(), IdealZPrism::initCorners(), PhotonFixCMS::initialise(), PolyFit2DParametrizedMagneticField::inTeslaUnchecked(), jacobianCurvilinearToCartesian(), PreshowerPhiClusterAlgo::makeOneCluster(), L1MuonMatcherAlgo::match(), OuterDetCompatibility::maximalLocalDisplacement(), HDetIdAssociator::nearElement(), ForwardDiskSectorBuilderFromWedges::operator()(), BeamSpotAlignmentDerivatives::operator()(), operator<<(), FlatTrd::phiPos(), CSCRecHit2DValidation::plotResolution(), RecoTracktoTP::s_phi(), L1Analysis::L1AnalysisRecoMuon2::SetMuon(), EcalGeomPhiSymHelper::setup(), DTTrigGeomUtils::trigPos(), and AsciiNeutronWriter::writeCluster().

69 { return basicVector().phi();}
Geom::Phi< T > phi() const
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
template<class T, class PVType, class FrameType>
Geom::Theta<T> PV3DBase< T, PVType, FrameType >::theta ( ) const
inline
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::transverse ( ) const
inline
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::x ( ) const
inline

Definition at line 62 of file PV3DBase.h.

Referenced by ThirdHitPredictionFromInvLine::add(), MuonDT2ChamberResidual::addResidual(), MuonCSCChamberResidual::addResidual(), MuonDT13ChamberResidual::addResidual(), MuonGeometrySVGTemplate::analyze(), ListIds::analyze(), SignedTransverseImpactParameter::apply(), SignedDecayLength3D::apply(), CSCAlignmentCorrections::applyAlignment(), FWTrackTrackingRecHitProxyBuilder::build(), FWCSCSegmentProxyBuilder::build(), FWPSimHitProxyBuilder::buildViewType(), FWDTRecHitProxyBuilder::buildViewType(), FWDTSegmentProxyBuilder::buildViewType(), GsfVertexWeightCalculator::calculate(), TBPositionCalc::CalculateCMSPos(), tkDetUtil::calculatePhiWindow(), CaloCellCrossing::CaloCellCrossing(), DTTopology::channel(), GlobalTrackingRegion::checkRZ(), VZeroFinder::checkTrackPair(), HelixBarrelCylinderCrossing::chooseSolution(), CircleFromThreePoints::CircleFromThreePoints(), MultiVertexStateCombiner::combine(), VertexDistanceXY::compatibility(), VertexDistance3D::compatibility(), DTRecHitSegmentResidual::compute(), GsfMultipleScatteringUpdator::compute(), MultipleScatteringSimulator::compute(), JacobianCurvilinearToLocal::compute(), JacobianLocalToCurvilinear::compute(), RodPlaneBuilderFromDet::computeBounds(), PlaneBuilderForGluedDet::computeRectBounds(), RodPlaneBuilderFromDet::computeRotation(), ForwardDiskSectorBuilderFromWedges::computeRotation(), PlaneBuilderForGluedDet::computeRotation(), DTTrigGeomUtils::computeSCCoordinates(), BasicSingleVertexState::computeWeightTimesPos(), RecoVertex::convertPos(), RectangularStripTopology::coveredStrips(), CurvilinearTrajectoryParameters::CurvilinearTrajectoryParameters(), CylindricalState::CylindricalState(), DetectorVector(), TangentHelix::directionAtVertex(), SurveyPxbImageLocalFit::dist(), VertexDistance3D::distance(), VertexDistanceXY::distance(), Line::distance(), SurveyPxbDicer::doDice(), SiLinearChargeCollectionDrifter::drift(), shallow::drift(), StripCPE::driftDirection(), SiHitDigitizer::DriftDirection(), SiLinearChargeDivider::driftXPos(), RecHitComparatorByPosition::equals(), MFProducer::evaluate(), KinematicPerigeeConversions::extendedPerigeeFromKinematicParameters(), TSOSHistogramMaker::fill(), VertexKinematicConstraintT::fillParametersDerivative(), VertexKinematicConstraintT::fillPositionDerivative(), MuonKinkFinder::fillTrkKink(), VertexKinematicConstraintT::fillValue(), HLTRPCFilter::filter(), SurveyAlignmentPoints::findAlignPars(), ConformalMappingFit::findRot(), CollinearFitAtTM::fit(), CollinearFitAtTM2::fit(), FourPointPlaneBounds::FourPointPlaneBounds(), sim::Field::GetFieldValue(), BaseTrackerRecHit::getKfComponents1D(), BaseTrackerRecHit::getKfComponents2D(), TwoBodyDecayLinearizationPointFinder::getLinearizationPoint(), MuonDetIdAssociator::getPosition(), TkSimHitPrinter::getPropagationSign(), SurveyDBUploader::getSurveyInfo(), CaloCellGeometry::getTransform(), TrackPropagation::globalPointToHep3Vector(), TrackPropagation::globalPointToHepPoint3D(), TrackPropagation::globalVectorToHep3Vector(), TrackPropagation::globalVectorToHepNormal3D(), TkPixelMeasurementDet::hasBadComponents(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), HelixBarrelPlaneCrossing2OrderLocal::HelixBarrelPlaneCrossing2OrderLocal(), FastHelix::helixStateAtVertex(), MuonChamberResidual::hitposition(), HLTCSCOverlapFilter::hltFilter(), HLTCSCRing2or3Filter::hltFilter(), VertexKinematicConstraintT::init(), ThirdHitPredictionFromInvParabola::init(), IdealZDCTrapezoid::initCorners(), PreshowerStrip::initCorners(), IdealCastorTrapezoid::initCorners(), PhotonFixCMS::initialise(), RectangularPlaneBounds::inout(), FourPointPlaneBounds::inside(), SimpleDiskBounds::inside(), DiskSectorBounds::inside(), RectangularPlaneBounds::inside(), TrapezoidalPlaneBounds::inside(), CaloCellGeometry::inside(), OAEParametrizedMagneticField::inTeslaUnchecked(), DTHitPairForFit::isCompatible(), CosmicMuonUtilities::isTraversing(), jacobianCartesianToCurvilinear(), JacobianCartesianToLocal::JacobianCartesianToLocal(), jacobianCurvilinearToCartesian(), KinematicRefittedTrackState::kinematicMomentumVector(), KinematicPerigeeConversions::kinematicParametersFromExPerigee(), KinematicPerigeeConversions::kinematicState(), TrapezoidalStripTopology::localPitch(), DTRecHit1DPair::localPositionError(), TrapezoidalStripTopology::localStripLength(), PreshowerPhiClusterAlgo::makeOneCluster(), OuterDetCompatibility::maximalLocalDisplacement(), TrapezoidalStripTopology::measurementError(), RectangularStripTopology::measurementPosition(), DTTopology::measurementPosition(), TrapezoidalStripTopology::measurementPosition(), ParametersDefinerForTP::momentum(), RKPropagatorInZ::myPropagate(), CSCSlantedWireGeometry::nearestWire(), ConversionHitChecker::nHitsBeforeVtx(), TrajectorySeedHitCandidate::operator!=(), RecHitComparatorByPosition::operator()(), TransverseBoundPlaneFactory::operator()(), PerpendicularBoundPlaneBuilder::operator()(), LinTrackCache::Comparer::operator()(), PropagationDirectionChooser::operator()(), TSCBLBuilderWithPropagator::operator()(), DTSegmentSelector::operator()(), TransientTrackKinematicStateBuilder::operator()(), DTHitPairForFit::operator<(), operator<<(), KinematicVertex::operator==(), OptimalHelixPlaneCrossing::OptimalHelixPlaneCrossing(), InvariantMassFromVertex::p4(), DTSLRecCluster::param(), DTRecSegment2D::param(), TRecHit2DPosConstraint::parameters(), GenericProjectedRecHit2D::parameters(), RecHit1D::parameters(), EmulatedME0Segment::parameters(), ME0Segment::parameters(), BeamSpotTransientTrackingRecHit::parameters(), GEMCSCSegment::parameters(), VertexKinematicConstraint::parametersDerivative(), ColinearityKinematicConstraint::parametersDerivative(), MultiTrackPointingKinematicConstraint::parametersDerivative(), MultiTrackMassKinematicConstraint::parametersDerivative(), TwoTrackMassKinematicConstraint::parametersDerivative(), StraightLineCylinderCrossing::pathLength(), StraightLineBarrelCylinderCrossing::pathLength(), HelixArbitraryPlaneCrossing2Order::pathLength(), GlobalErrorBase< double, ErrorMatrixTag >::phierr(), GlobalErrorBaseExtended< double, ErrorMatrixTag >::phierr(), CSCWireDigiValidation::plotResolution(), CSCStripDigiValidation::plotResolution(), VertexKinematicConstraint::positionDerivative(), MultiTrackPointingKinematicConstraint::positionDerivative(), ColinearityKinematicConstraint::positionDerivative(), MultiTrackMassKinematicConstraint::positionDerivative(), TwoTrackMassKinematicConstraint::positionDerivative(), HelixBarrelPlaneCrossing2OrderLocal::positionOnly(), TkSimHitPrinter::printGlobal(), SimHitPrinter::printGlobal(), TkSimHitPrinter::printLocal(), SimHitPrinter::printLocal(), ShallowRechitClustersProducer::produce(), PixelClusterSelectorTopBottom::produce(), StripClusterSelectorTopBottom::produce(), Strip1DMeasurementTransformator::projectionMatrix(), StraightLinePropagator::propagateParametersOnCylinder(), StraightLinePropagator::propagateParametersOnPlane(), MuonSeedDetLayer::radius(), DTSurvey::ReadChambers(), GEMRecHitMatcher::recHitMeanPosition(), ThirdHitPredictionFromInvLine::remove(), GlobalErrorBase< double, ErrorMatrixTag >::rerr(), GlobalErrorBaseExtended< double, ErrorMatrixTag >::rerr(), PixelFitterByConformalMappingAndLine::run(), RecoTracktoTP::s_dsz(), RecoTracktoTP::s_dz(), GloballyPositioned< align::Scalar >::setCache(), Cone::side(), VertexDistanceXY::signedDistance(), VertexDistance3D::signedDistance(), RPCSimParam::simulate(), SiStripGaussianSmearingRecHitConverterAlgorithm::smearHit(), MaterialAccountingStep::split(), VirtualKinematicParticle::stateAtPoint(), TransientTrackKinematicParticle::stateAtPoint(), SteppingHelixStateInfo::SteppingHelixStateInfo(), CosmicMuonUtilities::stepPropagate(), FastHelix::straightLineStateAtVertex(), RectangularStripTopology::strip(), TrapezoidalStripTopology::strip(), OffsetRadialStripTopology::strip(), TangentHelix::TangentHelix(), ThirdHitPredictionFromInvLine::ThirdHitPredictionFromInvLine(), OffsetRadialStripTopology::toPrime(), KalmanVertexTrackUpdator< N >::trackRefit(), trajectoryToResiduals(), SurveyPxbDicer::transform(), TrackerFrameRotation::transformPoint(), FakeFrameRotation::transformPoint(), StandardFrameRotation::transformPoint(), MuonEndcapFrameRotation::transformPoint(), MuonRPCFrameRotation::transformPoint(), MuonGEMFrameRotation::transformPoint(), MuonME0FrameRotation::transformPoint(), TrajectoryStateClosestToBeamLine::transverseImpactParameter(), KinematicConstrainedVertexUpdator::update(), VertexKinematicConstraint::value(), ColinearityKinematicConstraint::value(), MultiTrackMassKinematicConstraint::value(), MultiTrackPointingKinematicConstraint::value(), TwoTrackMassKinematicConstraint::value(), GlobalTrajectoryParameters::vector(), ParametersDefinerForTP::vertex(), KVFHelper< N >::vertexChi2(), SurveyOutput::write(), AlignableDataIORoot::writeAbsRaw(), AsciiNeutronWriter::writeCluster(), AlignableDataIORoot::writeRelRaw(), EnergyDepositUnit::x(), SignalPoint::x(), EnergySegmentFP420::x(), and SignedTransverseImpactParameter::zImpactParameter().

62 { return basicVector().x();}
T x() const
Cartesian x coordinate.
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::y ( ) const
inline

Definition at line 63 of file PV3DBase.h.

Referenced by ThirdHitPredictionFromInvLine::add(), MuonDT2ChamberResidual::addResidual(), MuonCSCChamberResidual::addResidual(), MuonDT13ChamberResidual::addResidual(), MuonGeometrySVGTemplate::analyze(), ListIds::analyze(), SignedTransverseImpactParameter::apply(), SignedDecayLength3D::apply(), CSCAlignmentCorrections::applyAlignment(), FWTrackTrackingRecHitProxyBuilder::build(), FWCSCSegmentProxyBuilder::build(), FWPSimHitProxyBuilder::buildViewType(), FWDTSegmentProxyBuilder::buildViewType(), GsfVertexWeightCalculator::calculate(), TBPositionCalc::CalculateCMSPos(), tkDetUtil::calculatePhiWindow(), CaloCellCrossing::CaloCellCrossing(), GlobalTrackingRegion::checkRZ(), VZeroFinder::checkTrackPair(), HelixBarrelCylinderCrossing::chooseSolution(), CircleFromThreePoints::CircleFromThreePoints(), MultiVertexStateCombiner::combine(), VertexDistance3D::compatibility(), VertexDistanceXY::compatibility(), MuDetRod::compatibleDets(), PixelRod::compatibleDetsV(), DTRecHitSegmentResidual::compute(), GsfMultipleScatteringUpdator::compute(), MultipleScatteringSimulator::compute(), JacobianCurvilinearToLocal::compute(), JacobianLocalToCurvilinear::compute(), RodPlaneBuilderFromDet::computeBounds(), PlaneBuilderForGluedDet::computeRectBounds(), RodPlaneBuilderFromDet::computeRotation(), ForwardDiskSectorBuilderFromWedges::computeRotation(), PlaneBuilderForGluedDet::computeRotation(), DTTrigGeomUtils::computeSCCoordinates(), BasicSingleVertexState::computeWeightTimesPos(), RecoVertex::convertPos(), CurvilinearTrajectoryParameters::CurvilinearTrajectoryParameters(), CylindricalState::CylindricalState(), DetectorVector(), TangentHelix::directionAtVertex(), SurveyPxbImageLocalFit::dist(), VertexDistance3D::distance(), VertexDistanceXY::distance(), Line::distance(), SurveyPxbDicer::doDice(), SiLinearChargeCollectionDrifter::drift(), shallow::drift(), StripCPE::driftDirection(), SiHitDigitizer::DriftDirection(), RecHitComparatorByPosition::equals(), MFProducer::evaluate(), KinematicPerigeeConversions::extendedPerigeeFromKinematicParameters(), TSOSHistogramMaker::fill(), VertexKinematicConstraintT::fillParametersDerivative(), VertexKinematicConstraintT::fillPositionDerivative(), MuonKinkFinder::fillTrkKink(), VertexKinematicConstraintT::fillValue(), OverlapProblemTSOSPositionFilter::filter(), SurveyAlignmentPoints::findAlignPars(), ConformalMappingFit::findRot(), CollinearFitAtTM::fit(), CollinearFitAtTM2::fit(), FourPointPlaneBounds::FourPointPlaneBounds(), sim::Field::GetFieldValue(), BaseTrackerRecHit::getKfComponents2D(), TwoBodyDecayLinearizationPointFinder::getLinearizationPoint(), MuonDetIdAssociator::getPosition(), TkSimHitPrinter::getPropagationSign(), RPCSynchronizer::getSimHitBx(), SurveyDBUploader::getSurveyInfo(), CaloCellGeometry::getTransform(), TrackPropagation::globalPointToHep3Vector(), TrackPropagation::globalPointToHepPoint3D(), TrackPropagation::globalVectorToHep3Vector(), TrackPropagation::globalVectorToHepNormal3D(), TkPixelMeasurementDet::hasBadComponents(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), HelixBarrelPlaneCrossing2OrderLocal::HelixBarrelPlaneCrossing2OrderLocal(), FastHelix::helixStateAtVertex(), MuonChamberResidual::hitposition(), HLTCSCRing2or3Filter::hltFilter(), HLTCSCOverlapFilter::hltFilter(), VertexKinematicConstraintT::init(), ThirdHitPredictionFromInvParabola::init(), IdealZDCTrapezoid::initCorners(), PreshowerStrip::initCorners(), IdealCastorTrapezoid::initCorners(), PhotonFixCMS::initialise(), RectangularPlaneBounds::inout(), FourPointPlaneBounds::inside(), SimpleDiskBounds::inside(), DiskSectorBounds::inside(), RectangularPlaneBounds::inside(), TrapezoidalPlaneBounds::inside(), CaloCellGeometry::inside(), OAEParametrizedMagneticField::inTeslaUnchecked(), CosmicMuonUtilities::isTraversing(), jacobianCartesianToCurvilinear(), JacobianCartesianToLocal::JacobianCartesianToLocal(), jacobianCurvilinearToCartesian(), KinematicRefittedTrackState::kinematicMomentumVector(), KinematicPerigeeConversions::kinematicParametersFromExPerigee(), KinematicPerigeeConversions::kinematicState(), TrapezoidalStripTopology::localPitch(), TrapezoidalStripTopology::localStripLength(), PreshowerPhiClusterAlgo::makeOneCluster(), OuterDetCompatibility::maximalLocalDisplacement(), TrapezoidalStripTopology::measurementError(), RectangularStripTopology::measurementPosition(), DTTopology::measurementPosition(), TrapezoidalStripTopology::measurementPosition(), ParametersDefinerForTP::momentum(), RKPropagatorInZ::myPropagate(), CSCSlantedWireGeometry::nearestWire(), CSCNonslantedWireGeometry::nearestWire(), ConversionHitChecker::nHitsBeforeVtx(), DTTTrigSyncTOFCorr::offset(), TrajectorySeedHitCandidate::operator!=(), RecHitComparatorByPosition::operator()(), TransverseBoundPlaneFactory::operator()(), PerpendicularBoundPlaneBuilder::operator()(), LinTrackCache::Comparer::operator()(), CompareHitPairsY::operator()(), BeamSpotAlignmentDerivatives::operator()(), PropagationDirectionChooser::operator()(), TSCBLBuilderWithPropagator::operator()(), DTSegmentSelector::operator()(), TransientTrackKinematicStateBuilder::operator()(), KinematicVertex::operator==(), OptimalHelixPlaneCrossing::OptimalHelixPlaneCrossing(), InvariantMassFromVertex::p4(), TRecHit2DPosConstraint::parameters(), GenericProjectedRecHit2D::parameters(), EmulatedME0Segment::parameters(), ME0Segment::parameters(), GEMCSCSegment::parameters(), VertexKinematicConstraint::parametersDerivative(), MultiTrackPointingKinematicConstraint::parametersDerivative(), ColinearityKinematicConstraint::parametersDerivative(), MultiTrackMassKinematicConstraint::parametersDerivative(), TwoTrackMassKinematicConstraint::parametersDerivative(), StraightLineCylinderCrossing::pathLength(), StraightLineBarrelCylinderCrossing::pathLength(), HelixArbitraryPlaneCrossing2Order::pathLength(), GlobalErrorBase< double, ErrorMatrixTag >::phierr(), GlobalErrorBaseExtended< double, ErrorMatrixTag >::phierr(), CSCWireDigiValidation::plotResolution(), CSCStripDigiValidation::plotResolution(), CSCRecHit2DValidation::plotResolution(), VertexKinematicConstraint::positionDerivative(), MultiTrackPointingKinematicConstraint::positionDerivative(), ColinearityKinematicConstraint::positionDerivative(), MultiTrackMassKinematicConstraint::positionDerivative(), TwoTrackMassKinematicConstraint::positionDerivative(), HelixBarrelPlaneCrossing2OrderLocal::positionOnly(), PrintRecoObjects::print(), TkSimHitPrinter::printGlobal(), SimHitPrinter::printGlobal(), TkSimHitPrinter::printLocal(), SimHitPrinter::printLocal(), ShallowRechitClustersProducer::produce(), PixelClusterSelectorTopBottom::produce(), StripClusterSelectorTopBottom::produce(), StraightLinePropagator::propagateParametersOnCylinder(), StraightLinePropagator::propagateParametersOnPlane(), MuonSeedDetLayer::radius(), DTSurvey::ReadChambers(), GEMRecHitMatcher::recHitMeanPosition(), ThirdHitPredictionFromInvLine::remove(), GlobalErrorBase< double, ErrorMatrixTag >::rerr(), GlobalErrorBaseExtended< double, ErrorMatrixTag >::rerr(), PixelFitterByConformalMappingAndLine::run(), RecoTracktoTP::s_dsz(), RecoTracktoTP::s_dz(), GloballyPositioned< align::Scalar >::setCache(), Cone::side(), VertexDistanceXY::signedDistance(), VertexDistance3D::signedDistance(), SiStripGaussianSmearingRecHitConverterAlgorithm::smearHit(), MaterialAccountingStep::split(), VirtualKinematicParticle::stateAtPoint(), TransientTrackKinematicParticle::stateAtPoint(), SteppingHelixStateInfo::SteppingHelixStateInfo(), CosmicMuonUtilities::stepPropagate(), FastHelix::straightLineStateAtVertex(), TrapezoidalStripTopology::strip(), OffsetRadialStripTopology::strip(), TangentHelix::TangentHelix(), ThirdHitPredictionFromInvLine::ThirdHitPredictionFromInvLine(), OffsetRadialStripTopology::toPrime(), KalmanVertexTrackUpdator< N >::trackRefit(), trajectoryToResiduals(), SurveyPxbDicer::transform(), TrackerFrameRotation::transformPoint(), FakeFrameRotation::transformPoint(), StandardFrameRotation::transformPoint(), MuonEndcapFrameRotation::transformPoint(), MuonRPCFrameRotation::transformPoint(), MuonGEMFrameRotation::transformPoint(), MuonME0FrameRotation::transformPoint(), TrajectoryStateClosestToBeamLine::transverseImpactParameter(), KinematicConstrainedVertexUpdator::update(), VertexKinematicConstraint::value(), ColinearityKinematicConstraint::value(), MultiTrackMassKinematicConstraint::value(), MultiTrackPointingKinematicConstraint::value(), TwoTrackMassKinematicConstraint::value(), GlobalTrajectoryParameters::vector(), ParametersDefinerForTP::vertex(), KVFHelper< N >::vertexChi2(), SurveyOutput::write(), AlignableDataIORoot::writeAbsRaw(), AsciiNeutronWriter::writeCluster(), AlignableDataIORoot::writeRelRaw(), EnergyDepositUnit::y(), SignalPoint::y(), EnergySegmentFP420::y(), and SignedTransverseImpactParameter::zImpactParameter().

63 { return basicVector().y();}
T y() const
Cartesian y coordinate.
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
template<class T, class PVType, class FrameType>
T PV3DBase< T, PVType, FrameType >::z ( ) const
inline

Definition at line 64 of file PV3DBase.h.

Referenced by FiducialVolume::addActivePoint(), MuonDT2ChamberResidual::addResidual(), MuonCSCChamberResidual::addResidual(), MuonDT13ChamberResidual::addResidual(), LayerCollector::allLayers(), ListIds::analyze(), SignedTransverseImpactParameter::apply(), SignedDecayLength3D::apply(), GeomDetLess::barrelForwardLess(), TkLayerLess::barrelForwardLess(), FWTrackTrackingRecHitProxyBuilder::build(), CylinderBuilderFromDet::build(), FWCSCSegmentProxyBuilder::build(), MuonCSCDetLayerGeometryBuilder::buildLayer(), MuonGEMDetLayerGeometryBuilder::buildLayer(), FWPSimHitProxyBuilder::buildViewType(), FWDTSegmentProxyBuilder::buildViewType(), GsfVertexWeightCalculator::calculate(), TwoTrackMinimumDistanceLineLine::calculate(), TBPositionCalc::CalculateCMSPos(), tkDetUtil::calculatePhiWindow(), CaloCellCrossing::CaloCellCrossing(), siStripClusterTools::chargePerCM(), MuonSeedSimpleCleaner::checkPt(), GlobalTrackingRegion::checkRZ(), VZeroFinder::checkTrackPair(), MultiVertexStateCombiner::combine(), VertexDistance3D::compatibility(), ForwardDetLayer::compatible(), BarrelDetLayer::compatible(), MuDetRod::compatibleDets(), PixelRod::compatibleDetsV(), DTRecHitSegmentResidual::compute(), GsfMultipleScatteringUpdator::compute(), GEMRecHitStandardAlgo::compute(), RPCRecHitStandardAlgo::compute(), MultipleScatteringSimulator::compute(), JacobianCurvilinearToLocal::compute(), JacobianLocalToCurvilinear::compute(), RodPlaneBuilderFromDet::computeBounds(), AlignableDTStation::computePosition(), AlignableDTWheel::computePosition(), AlignableCSCEndcap::computePosition(), AlignableCSCRing::computePosition(), AlignableCSCStation::computePosition(), AlignableDTBarrel::computePosition(), PlaneBuilderForGluedDet::computeRectBounds(), RodPlaneBuilderFromDet::computeRotation(), PlaneBuilderForGluedDet::computeRotation(), DTTrigGeomUtils::computeSCCoordinates(), BasicSingleVertexState::computeWeightTimesPos(), RecoVertex::convertPos(), FastLine::createLineParameters(), BeamHaloPropagator::crossingTk(), CurvilinearTrajectoryParameters::CurvilinearTrajectoryParameters(), CylindricalState::CylindricalState(), DetectorVector(), MultipleScatteringGeometry::detLayers(), TangentHelix::directionAtVertex(), VertexDistance3D::distance(), Line::distance(), SiLinearChargeCollectionDrifter::drift(), SiLinearChargeDivider::driftXPos(), EleRelPointPair::dZ(), ECALPositionCalculator::ecalPhi(), LayerCrossingSide::endcapSide(), ConversionBarrelEstimator::estimate(), ForwardMeasurementEstimator::estimate(), BarrelMeasurementEstimator::estimate(), MFProducer::evaluate(), KinematicPerigeeConversions::extendedPerigeeFromKinematicParameters(), fastProp(), TSOSHistogramMaker::fill(), VertexKinematicConstraintT::fillParametersDerivative(), VertexKinematicConstraintT::fillPositionDerivative(), MuonKinkFinder::fillTrkKink(), VertexKinematicConstraintT::fillValue(), HLTMuonPointingFilter::filter(), SurveyAlignmentPoints::findAlignPars(), MagESector::findVolume(), MagBRod::findVolume(), FTSFromVertexToPointFactory::get(), StripCPE::getAlgoParam(), sim::Field::GetFieldValue(), TwoBodyDecayLinearizationPointFinder::getLinearizationPoint(), MuonDetIdAssociator::getPosition(), TkSimHitPrinter::getPropagationSign(), SurveyDBUploader::getSurveyInfo(), CaloCellGeometry::getTransform(), TrackPropagation::globalPointToHep3Vector(), TrackPropagation::globalPointToHepPoint3D(), GlobalTrajectoryParameters::GlobalTrajectoryParameters(), TrackPropagation::globalVectorToHep3Vector(), TrackPropagation::globalVectorToHepNormal3D(), HelixBarrelCylinderCrossing::HelixBarrelCylinderCrossing(), HelixBarrelPlaneCrossing2OrderLocal::HelixBarrelPlaneCrossing2OrderLocal(), FastHelix::helixStateAtVertex(), ThirdHitCorrection::init(), VertexKinematicConstraintT::init(), IdealZDCTrapezoid::initCorners(), PreshowerStrip::initCorners(), IdealZPrism::initCorners(), IdealCastorTrapezoid::initCorners(), PhotonFixCMS::initialise(), ThirdHitRZPredictionBase::initLayer(), SimpleDiskBounds::inside(), DiskSectorBounds::inside(), SimpleCylinderBounds::inside(), RectangularPlaneBounds::inside(), TrapezoidalPlaneBounds::inside(), SimpleConeBounds::inside(), CaloCellGeometry::inside(), GeomDetLess::insideOutLess(), TkLayerLess::insideOutLess(), TkLayerLess::insideOutLessSigned(), SmartPropagator::insideTkVol(), ParabolicParametrizedMagneticField::inTeslaUnchecked(), PolyFit2DParametrizedMagneticField::inTeslaUnchecked(), OAEParametrizedMagneticField::inTeslaUnchecked(), MagneticFieldMap::inTeslaZ(), TrajectoryStateAccessor::inversePtError(), DTSegmentExtendedCand::isCompatible(), DTHitPairForFit::isCompatible(), PolyFit2DParametrizedMagneticField::isDefined(), ParabolicParametrizedMagneticField::isDefined(), OAEParametrizedMagneticField::isDefined(), VolumeBasedMagneticField::isDefined(), TrackerBounds::isInside(), CosmicMuonUtilities::isTraversing(), jacobianCartesianToCurvilinear(), JacobianCartesianToLocal::JacobianCartesianToLocal(), jacobianCurvilinearToCartesian(), JacobianCurvilinearToLocal::JacobianCurvilinearToLocal(), KinematicRefittedTrackState::kinematicMomentumVector(), KinematicPerigeeConversions::kinematicParametersFromExPerigee(), KinematicPerigeeConversions::kinematicState(), StripCPEgeometric::localParameters(), PreshowerPhiClusterAlgo::makeOneCluster(), OuterDetCompatibility::maximalLocalDisplacement(), SymmetricLayerFinder::mirrorPartner(), ParametersDefinerForTP::momentum(), KinematicPerigeeConversions::momentumFromPerigee(), RKPropagatorInZ::myPropagate(), ConversionHitChecker::nHitsBeforeVtx(), TrajectorySeedHitCandidate::operator!=(), TransverseBoundPlaneFactory::operator()(), DetLessZ::operator()(), PerpendicularBoundPlaneBuilder::operator()(), DetBelowZ::operator()(), LinTrackCache::Comparer::operator()(), CompareHitPairsY::operator()(), StateOnTrackerBound::operator()(), PropagationDirectionChooser::operator()(), ThirdHitZPrediction::operator()(), MuonDetLayerComp::operator()(), TSCBLBuilderWithPropagator::operator()(), DTSegmentSelector::operator()(), CylinderBuilderFromDet::operator()(), TransientTrackKinematicStateBuilder::operator()(), operator<<(), KinematicVertex::operator==(), OptimalHelixPlaneCrossing::OptimalHelixPlaneCrossing(), InvariantMassFromVertex::p4(), DTRecSegment2D::param(), EmulatedME0Segment::parameters(), ME0Segment::parameters(), GEMCSCSegment::parameters(), VertexKinematicConstraint::parametersDerivative(), HelixArbitraryPlaneCrossing2Order::pathLength(), VertexKinematicConstraint::positionDerivative(), MultiTrackPointingKinematicConstraint::positionDerivative(), HelixBarrelPlaneCrossing2OrderLocal::positionOnly(), TkSimHitPrinter::printGlobal(), SimHitPrinter::printGlobal(), TkSimHitPrinter::printLocal(), SimHitPrinter::printLocal(), PixelClusterSelectorTopBottom::produce(), StripClusterSelectorTopBottom::produce(), StraightLinePropagator::propagateParametersOnCylinder(), StraightLinePropagator::propagateParametersOnPlane(), TrackExtrapolator::propagateTrackToVolume(), DTSurvey::ReadChambers(), GEMRecHitMatcher::recHitMeanPosition(), VZeroFinder::rotate(), PixelFitterByConformalMappingAndLine::run(), RZLine::RZLine(), RecoTracktoTP::s_dsz(), RecoTracktoTP::s_dz(), Cone::side(), VertexDistance3D::signedDistance(), SimpleTECWedge::SimpleTECWedge(), SiStripGaussianSmearingRecHitConverterAlgorithm::smearHit(), MaterialAccountingStep::split(), Traj2TrackHits::split(), VirtualKinematicParticle::stateAtPoint(), TransientTrackKinematicParticle::stateAtPoint(), SteppingHelixStateInfo::SteppingHelixStateInfo(), CosmicMuonUtilities::stepPropagate(), TangentHelix::TangentHelix(), MuonNavigableLayer::trackingRange(), KalmanVertexTrackUpdator< N >::trackRefit(), ConversionSeedFinder::trackStateFromClusters(), FakeFrameRotation::transformPoint(), TrackerFrameRotation::transformPoint(), StandardFrameRotation::transformPoint(), MuonEndcapFrameRotation::transformPoint(), MuonRPCFrameRotation::transformPoint(), MuonGEMFrameRotation::transformPoint(), MuonME0FrameRotation::transformPoint(), GlobalTrajectoryParameters::transverseCurvature(), KinematicConstrainedVertexUpdator::update(), VertexKinematicConstraint::value(), MultiTrackPointingKinematicConstraint::value(), GlobalTrajectoryParameters::vector(), ParametersDefinerForTP::vertex(), KVFHelper< N >::vertexChi2(), SurveyOutput::write(), AlignableDataIORoot::writeAbsRaw(), AsciiNeutronWriter::writeCluster(), AlignableDataIORoot::writeRelRaw(), EnergyDepositUnit::z(), EnergySegmentFP420::z(), MuonSeedDetLayer::z(), and SignedTransverseImpactParameter::zImpactParameter().

64 { return basicVector().z();}
T z() const
Cartesian z coordinate.
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56

Member Data Documentation

template<class T, class PVType, class FrameType>
BasicVectorType PV3DBase< T, PVType, FrameType >::theVector
protected