Geant4.10
 All Data Structures Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Types | Public Member Functions | Static Public Member Functions | Protected Member Functions | Protected Attributes | Static Protected Attributes
CLHEP::Hep3Vector Class Reference

#include <ThreeVector.h>

Inheritance diagram for CLHEP::Hep3Vector:
G4StokesVector

Public Types

enum  {
  X =0, Y =1, Z =2, NUM_COORDINATES =3,
  SIZE =NUM_COORDINATES
}
 
enum  { ToleranceTicks = 100 }
 

Public Member Functions

 Hep3Vector ()
 
 Hep3Vector (double x)
 
 Hep3Vector (double x, double y)
 
 Hep3Vector (double x, double y, double z)
 
 Hep3Vector (const Hep3Vector &)
 
 ~Hep3Vector ()
 
double operator() (int) const
 
double operator[] (int) const
 
double & operator() (int)
 
double & operator[] (int)
 
double x () const
 
double y () const
 
double z () const
 
void setX (double)
 
void setY (double)
 
void setZ (double)
 
void set (double x, double y, double z)
 
double phi () const
 
double theta () const
 
double cosTheta () const
 
double cos2Theta () const
 
double mag2 () const
 
double mag () const
 
void setPhi (double)
 
void setTheta (double)
 
void setMag (double)
 
double perp2 () const
 
double perp () const
 
void setPerp (double)
 
void setCylTheta (double)
 
double perp2 (const Hep3Vector &) const
 
double perp (const Hep3Vector &) const
 
Hep3Vectoroperator= (const Hep3Vector &)
 
bool operator== (const Hep3Vector &) const
 
bool operator!= (const Hep3Vector &) const
 
bool isNear (const Hep3Vector &, double epsilon=tolerance) const
 
double howNear (const Hep3Vector &v) const
 
double deltaR (const Hep3Vector &v) const
 
Hep3Vectoroperator+= (const Hep3Vector &)
 
Hep3Vectoroperator-= (const Hep3Vector &)
 
Hep3Vector operator- () const
 
Hep3Vectoroperator*= (double)
 
Hep3Vectoroperator/= (double)
 
Hep3Vector unit () const
 
Hep3Vector orthogonal () const
 
double dot (const Hep3Vector &) const
 
Hep3Vector cross (const Hep3Vector &) const
 
double angle (const Hep3Vector &) const
 
double pseudoRapidity () const
 
void setEta (double p)
 
void setCylEta (double p)
 
Hep3VectorrotateX (double)
 
Hep3VectorrotateY (double)
 
Hep3VectorrotateZ (double)
 
Hep3VectorrotateUz (const Hep3Vector &)
 
Hep3Vectorrotate (double, const Hep3Vector &)
 
Hep3Vectoroperator*= (const HepRotation &)
 
Hep3Vectortransform (const HepRotation &)
 
void setRThetaPhi (double r, double theta, double phi)
 
void setREtaPhi (double r, double eta, double phi)
 
void setRhoPhiZ (double rho, double phi, double z)
 
void setRhoPhiTheta (double rho, double phi, double theta)
 
void setRhoPhiEta (double rho, double phi, double eta)
 
double getX () const
 
double getY () const
 
double getZ () const
 
double getR () const
 
double getTheta () const
 
double getPhi () const
 
double r () const
 
double rho () const
 
double getRho () const
 
double eta () const
 
double getEta () const
 
void setR (double s)
 
void setRho (double s)
 
int compare (const Hep3Vector &v) const
 
bool operator> (const Hep3Vector &v) const
 
bool operator< (const Hep3Vector &v) const
 
bool operator>= (const Hep3Vector &v) const
 
bool operator<= (const Hep3Vector &v) const
 
double diff2 (const Hep3Vector &v) const
 
bool isParallel (const Hep3Vector &v, double epsilon=tolerance) const
 
bool isOrthogonal (const Hep3Vector &v, double epsilon=tolerance) const
 
double howParallel (const Hep3Vector &v) const
 
double howOrthogonal (const Hep3Vector &v) const
 
double beta () const
 
double gamma () const
 
double coLinearRapidity () const
 
double angle () const
 
double theta (const Hep3Vector &v2) const
 
double cosTheta (const Hep3Vector &v2) const
 
double cos2Theta (const Hep3Vector &v2) const
 
Hep3Vector project () const
 
Hep3Vector project (const Hep3Vector &v2) const
 
Hep3Vector perpPart () const
 
Hep3Vector perpPart (const Hep3Vector &v2) const
 
double rapidity () const
 
double rapidity (const Hep3Vector &v2) const
 
double eta (const Hep3Vector &v2) const
 
double polarAngle (const Hep3Vector &v2) const
 
double deltaPhi (const Hep3Vector &v2) const
 
double azimAngle (const Hep3Vector &v2) const
 
double polarAngle (const Hep3Vector &v2, const Hep3Vector &ref) const
 
double azimAngle (const Hep3Vector &v2, const Hep3Vector &ref) const
 
Hep3Vectorrotate (const Hep3Vector &axis, double delta)
 
Hep3Vectorrotate (const HepAxisAngle &ax)
 
Hep3Vectorrotate (const HepEulerAngles &e)
 
Hep3Vectorrotate (double phi, double theta, double psi)
 

Static Public Member Functions

static double setTolerance (double tol)
 
static double getTolerance ()
 

Protected Member Functions

void setSpherical (double r, double theta, double phi)
 
void setCylindrical (double r, double phi, double z)
 
double negativeInfinity () const
 

Protected Attributes

double dx
 
double dy
 
double dz
 

Static Protected Attributes

static DLL_API double tolerance = Hep3Vector::ToleranceTicks * 2.22045e-16
 

Detailed Description

Author

Definition at line 41 of file ThreeVector.h.

Member Enumeration Documentation

anonymous enum
Enumerator
NUM_COORDINATES 
SIZE 

Definition at line 47 of file ThreeVector.h.

anonymous enum
Enumerator
ToleranceTicks 

Definition at line 298 of file ThreeVector.h.

Constructor & Destructor Documentation

CLHEP::Hep3Vector::Hep3Vector ( )
CLHEP::Hep3Vector::Hep3Vector ( double  x)
explicit
CLHEP::Hep3Vector::Hep3Vector ( double  x,
double  y 
)
CLHEP::Hep3Vector::Hep3Vector ( double  x,
double  y,
double  z 
)
CLHEP::Hep3Vector::Hep3Vector ( const Hep3Vector )
inline
CLHEP::Hep3Vector::~Hep3Vector ( )
inline

Member Function Documentation

double CLHEP::Hep3Vector::angle ( const Hep3Vector ) const
double CLHEP::Hep3Vector::angle ( ) const
inline

Referenced by polarAngle().

double CLHEP::Hep3Vector::azimAngle ( const Hep3Vector v2) const
double CLHEP::Hep3Vector::azimAngle ( const Hep3Vector v2,
const Hep3Vector ref 
) const

Definition at line 40 of file SpaceVectorD.cc.

References angle(), cross(), dot(), mag2(), and perpPart().

41  {
42 
43  Hep3Vector vperp ( perpPart(ref) );
44  if ( vperp.mag2() == 0 ) {
45  std::cerr << "Hep3Vector::azimAngle() - "
46  << "Cannot find azimuthal angle with reference direction parallel to "
47  << "vector 1 -- will return zero" << std::endl;
48  return 0;
49  }
50 
51  Hep3Vector v2perp ( v2.perpPart(ref) );
52  if ( v2perp.mag2() == 0 ) {
53  std::cerr << "Hep3Vector::azimAngle() - "
54  << "Cannot find azimuthal angle with reference direction parallel to "
55  << "vector 2 -- will return zero" << std::endl;
56  return 0;
57  }
58 
59  double ang = vperp.angle(v2perp);
60 
61  // Now compute the sign of the answer: that of U*(VxV2) or
62  // the equivalent expression V*(V2xU).
63 
64  if ( dot(v2.cross(ref)) >= 0 ) {
65  return ang;
66  } else {
67  return -ang;
68  }
69 
70  //-| Note that if V*(V2xU) is zero, we want to return 0 or PI
71  //-| depending on whether vperp is aligned or antialigned with v2perp.
72  //-| The computed angle() expression does this properly.
73 
74 } /* azimAngle (v2, ref) */
double dot(const Hep3Vector &) const
Hep3Vector perpPart() const
double CLHEP::Hep3Vector::beta ( ) const

Definition at line 30 of file SpaceVectorP.cc.

References test::b, and mag2().

Referenced by G4QMDReaction::ApplyYourself(), coLinearRapidity(), CLHEP::HepRotationZ::distance2(), CLHEP::HepRotationY::distance2(), CLHEP::HepRotationX::distance2(), and CLHEP::HepRotation::distance2().

30  {
31  double b = std::sqrt(mag2());
32 // if (b >= 1) {
33 // std::cerr << "Hep3Vector::beta() - "
34 // << "Beta taken for Hep3Vector of at least unit length" << std::endl;
35 // }
36  return b;
37 }
double mag2() const
double CLHEP::Hep3Vector::coLinearRapidity ( ) const

Definition at line 69 of file SpaceVectorP.cc.

References test::b, and beta().

69  {
70  double b = beta();
71 // if (b == 1) {
72 // std::cerr << "Hep3Vector::coLinearRapidity() - "
73 // << "Co-linear Rapidity taken for Hep3Vector of unit length -- \n"
74 // << "the log should return infinity" << std::endl;
75 // }
76 // if (b > 1) {
77 // std::cerr << "Hep3Vector::coLinearRapidity() - "
78 // << "Co-linear Rapidity taken for Hep3Vector of more than unit length -- \n"
79 // << "the log would return a NAN" << std::endl;
80 // }
81  // Want inverse std::tanh(b):
82  return (.5 * std::log((1+b)/(1-b)) );
83 }
double beta() const
Definition: SpaceVectorP.cc:30
int CLHEP::Hep3Vector::compare ( const Hep3Vector v) const

Definition at line 122 of file SpaceVector.cc.

References dx, dy, and dz.

Referenced by CLHEP::HepLorentzVector::compare(), operator<(), operator<=(), operator>(), and operator>=().

122  {
123  if ( dz > v.dz ) {
124  return 1;
125  } else if ( dz < v.dz ) {
126  return -1;
127  } else if ( dy > v.dy ) {
128  return 1;
129  } else if ( dy < v.dy ) {
130  return -1;
131  } else if ( dx > v.dx ) {
132  return 1;
133  } else if ( dx < v.dx ) {
134  return -1;
135  } else {
136  return 0;
137  }
138 } /* Compare */
double CLHEP::Hep3Vector::cos2Theta ( ) const
inline
double CLHEP::Hep3Vector::cos2Theta ( const Hep3Vector v2) const

Definition at line 201 of file ThreeVector.cc.

References dot(), and mag2().

201  {
202  double arg;
203  double ptot2 = mag2();
204  double qtot2 = q.mag2();
205  if ( ptot2 == 0 || qtot2 == 0 ) {
206  arg = 1.0;
207  }else{
208  double pdq = dot(q);
209  arg = (pdq/ptot2) * (pdq/qtot2);
210  // More naive methods overflow on vectors which can be squared
211  // but can't be raised to the 4th power.
212  if(arg > 1.0) arg = 1.0;
213  }
214  return arg;
215 }
double dot(const Hep3Vector &) const
double mag2() const
double CLHEP::Hep3Vector::cosTheta ( ) const
inline
double CLHEP::Hep3Vector::cosTheta ( const Hep3Vector v2) const

Definition at line 188 of file ThreeVector.cc.

References dot(), and mag2().

188  {
189  double arg;
190  double ptot2 = mag2()*q.mag2();
191  if(ptot2 <= 0) {
192  arg = 0.0;
193  }else{
194  arg = dot(q)/std::sqrt(ptot2);
195  if(arg > 1.0) arg = 1.0;
196  if(arg < -1.0) arg = -1.0;
197  }
198  return arg;
199 }
double dot(const Hep3Vector &) const
double mag2() const
Hep3Vector CLHEP::Hep3Vector::cross ( const Hep3Vector ) const
inline

Referenced by G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), azimAngle(), G4PolyconeSide::CalculateExtent(), G4NucleiModel::choosePointAlongTraj(), G4tgbVolume::ConstructG4PhysVol(), G4SPSAngDistribution::DefineAngRefAxes(), ExGflashEventAction::EndOfEventAction(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4gsrotm(), G4PlaneVectorRand(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4TriangularFacet::G4TriangularFacet(), G4PrimaryTransformer::GenerateSingleTrack(), G4PolarizationHelper::GetFrame(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), howOrthogonal(), howParallel(), G4TriangularFacet::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), G4StokesVector::InvRotateAz(), isOrthogonal(), isParallel(), G4Trap::MakePlane(), G4PolyconeSide::PointOnCone(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4QuasiElRatios::RelDecayIn2(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), G4StokesVector::RotateAz(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), OpNovicePrimaryGeneratorAction::SetOptPhotonPolar(), WLSPrimaryGeneratorAction::SetOptPhotonPolar(), G4ErrorSurfaceTrajParam::SetParameters(), G4GenericTrap::SurfaceNormal(), G4PolarizationHelper::TestPolarizationTransformations(), and FCALSteppingAction::UserSteppingAction().

double CLHEP::Hep3Vector::deltaPhi ( const Hep3Vector v2) const

Definition at line 172 of file ThreeVector.cc.

References getPhi().

Referenced by deltaR(), and CLHEP::HepLorentzVector::deltaR().

172  {
173  double dphi = v2.getPhi() - getPhi();
174  if ( dphi > CLHEP::pi ) {
175  dphi -= CLHEP::twopi;
176  } else if ( dphi <= -CLHEP::pi ) {
177  dphi += CLHEP::twopi;
178  }
179  return dphi;
180 } /* deltaPhi */
double getPhi() const
double CLHEP::Hep3Vector::deltaR ( const Hep3Vector v) const

Definition at line 182 of file ThreeVector.cc.

References test::a, test::b, deltaPhi(), and eta().

182  {
183  double a = eta() - v.eta();
184  double b = deltaPhi(v);
185  return std::sqrt ( a*a + b*b );
186 } /* deltaR */
double eta() const
double deltaPhi(const Hep3Vector &v2) const
Definition: ThreeVector.cc:172
double CLHEP::Hep3Vector::diff2 ( const Hep3Vector v) const
inline
double CLHEP::Hep3Vector::dot ( const Hep3Vector ) const
inline

Referenced by G4VIntersectionLocator::AdjustmentOfFoundIntersection(), G4MagHelicalStepper::AdvanceHelix(), azimAngle(), CLHEP::HepLorentzVector::boost(), G4NucleiModel::boundaryTransition(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), cos2Theta(), cosTheta(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4PolyPhiFace::Distance(), G4PolyhedraSide::Distance(), G4PolyhedraSide::DistanceAway(), G4CutTubs::DistanceToIn(), G4Tet::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4Cons::DistanceToIn(), G4PolyhedraSide::DistanceToOneSide(), G4CutTubs::DistanceToOut(), G4Tet::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Cons::DistanceToOut(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), eta(), G4TriangularFacet::Extent(), G4QuadrangularFacet::Extent(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), G4LorentzConvertor::fillKinematics(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4TriangularFacet::G4TriangularFacet(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4MultiNavigator::GetGlobalExitNormal(), G4CascadParticle::getPathToTheNextZone(), G4ClippablePolygon::GetPlanerExtent(), G4RKPropagation::GetSphereIntersectionTimes(), howNear(), CLHEP::HepLorentzVector::howNear(), CLHEP::HepLorentzVector::howNearCM(), howOrthogonal(), howParallel(), G4NucleiModel::initializeCascad(), G4Tet::Inside(), G4PolyPhiFace::Inside(), G4TriangularFacet::Intersect(), G4PolyPhiFace::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), G4VFacet::IsInside(), isNear(), CLHEP::HepLorentzVector::isNear(), CLHEP::HepLorentzVector::isNearCM(), isOrthogonal(), isParallel(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator::LocateGlobalPointAndSetup(), G4GHEKinematicsVector::Lor(), G4Trap::MakePlane(), CLHEP::HepLorentzVector::minus(), G4PolyPhiFace::Normal(), CLHEP::HepLorentzVector::plus(), G4PolyconeSide::PointOnCone(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4MagInt_Driver::PrintStatus(), project(), rapidity(), CLHEP::HepLorentzVector::rapidity(), G4VIntersectionLocator::ReportTrialStep(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), CLHEP::HepRotation::set(), G4ErrorFreeTrajParam::SetParameters(), G4ErrorSurfaceTrajParam::SetParameters(), and G4Tet::SurfaceNormal().

double CLHEP::Hep3Vector::eta ( ) const

Referenced by deltaR().

double CLHEP::Hep3Vector::eta ( const Hep3Vector v2) const

Definition at line 117 of file SpaceVectorP.cc.

References test::c, dot(), getR(), mag(), and negativeInfinity().

117  {
118  // Defined as -std::log ( std::tan ( .5* theta(u) ) );
119  //
120  // Quicker is to use cosTheta:
121  // std::tan (theta/2) = std::sin(theta)/(1 + std::cos(theta))
122 
123  double r1 = getR();
124  double v2r = v2.mag();
125  if ( (r1 == 0) || (v2r == 0) ) {
126  std::cerr << "Hep3Vector::eta() - "
127  << "Cannot find pseudorapidity of a zero vector relative to a vector"
128  << std::endl;
129  return 0.;
130  }
131  double c = dot(v2)/(r1*v2r);
132  if ( c >= 1 ) {
133  c = 1; //-| We don't want to return NAN because of roundoff
134  std::cerr << "Hep3Vector::eta() - "
135  << "Pseudorapidity of vector relative to parallel vector -- \n"
136  << "will give infinite result" << std::endl;
137  // We can just go on; tangent will be 0, so
138  // std::log (tangent) will be -INFINITY, so result
139  // will be +INFINITY.
140  }
141  if ( c <= -1 ) {
142  std::cerr << "Hep3Vector::eta() - "
143  << "Pseudorapidity of vector relative to anti-parallel vector -- \n"
144  << "will give negative infinite result"<< std::endl;
145  //-| We don't want to return NAN because of roundoff
146  return ( negativeInfinity() );
147  // If we just went on, the tangent would be NAN
148  // so return would be NAN. But the proper limit
149  // of tan is +Infinity, so the return should be
150  // -INFINITY.
151  }
152 
153  double tangent = std::sqrt (1-c*c) / ( 1 + c );
154  return (- std::log (tangent));
155 
156 } /* eta (u) */
double getR() const
double dot(const Hep3Vector &) const
double negativeInfinity() const
Definition: SpaceVector.cc:283
double CLHEP::Hep3Vector::gamma ( ) const

Definition at line 39 of file SpaceVectorP.cc.

References mag2().

39  {
40  double bbeta = std::sqrt(mag2());
41 // if (bbeta == 1) {
42 // std::cerr << "Hep3Vector::gamma() - "
43 // << "Gamma taken for Hep3Vector of unit magnitude -- infinite result"
44 // << std::endl;
45 // }
46 // if (bbeta > 1) {
47 // std::cerr << "Hep3Vector::gamma() - "
48 // << "Gamma taken for Hep3Vector of more than unit magnitude -- \n"
49 // << "the sqrt function would return NAN" << std::endl;
50 // }
51  return 1/std::sqrt(1-bbeta*bbeta);
52 }
double mag2() const
double CLHEP::Hep3Vector::getEta ( ) const
double CLHEP::Hep3Vector::getPhi ( ) const
inline
double CLHEP::Hep3Vector::getR ( ) const
inline
double CLHEP::Hep3Vector::getRho ( ) const
inline
double CLHEP::Hep3Vector::getTheta ( ) const
inline
static double CLHEP::Hep3Vector::getTolerance ( )
inlinestatic
double CLHEP::Hep3Vector::getX ( ) const
inline
double CLHEP::Hep3Vector::getY ( ) const
inline
double CLHEP::Hep3Vector::getZ ( ) const
inline
double CLHEP::Hep3Vector::howNear ( const Hep3Vector v) const

Definition at line 159 of file ThreeVector.cc.

References dot(), mag2(), and test::v.

159  {
160  // | V1 - V2 | **2 / V1 dot V2, up to 1
161  double d = (*this - v).mag2();
162  double vdv = dot(v);
163  if ( (vdv > 0) && (d < vdv) ) {
164  return std::sqrt (d/vdv);
165  } else if ( (vdv == 0) && (d == 0) ) {
166  return 0;
167  } else {
168  return 1;
169  }
170 } /* howNear */
double dot(const Hep3Vector &) const
double mag2() const
double CLHEP::Hep3Vector::howOrthogonal ( const Hep3Vector v) const

Definition at line 219 of file SpaceVector.cc.

References cross(), dot(), and mag().

Referenced by G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LivermorePolarizedComptonModel::SampleSecondaries(), and G4LivermorePolarizedGammaConversionModel::SampleSecondaries().

219  {
220  // | V1 dot V2 | / | V1 x V2 |
221 
222  double v1v2 = std::fabs(dot(v));
223  //-| Safe because both v1 and v2 can be squared
224  if ( v1v2 == 0 ) {
225  return 0; // Even if one or both are 0, they are considered orthogonal
226  }
227  Hep3Vector v1Xv2 ( cross(v) );
228  double abscross = v1Xv2.mag();
229  if ( v1v2 >= abscross ) {
230  return 1;
231  } else {
232  return v1v2/abscross;
233  }
234 
235 } /* howOrthogonal() */
double dot(const Hep3Vector &) const
Hep3Vector cross(const Hep3Vector &) const
double CLHEP::Hep3Vector::howParallel ( const Hep3Vector v) const

Definition at line 168 of file SpaceVector.cc.

References cross(), dot(), mag(), and mag2().

168  {
169  // | V1 x V2 | / | V1 dot V2 |
170  double v1v2 = std::fabs(dot(v));
171  if ( v1v2 == 0 ) {
172  // Zero is parallel to no other vector except for zero.
173  return ( (mag2() == 0) && (v.mag2() == 0) ) ? 0 : 1;
174  }
175  Hep3Vector v1Xv2 ( cross(v) );
176  double abscross = v1Xv2.mag();
177  if ( abscross >= v1v2 ) {
178  return 1;
179  } else {
180  return abscross/v1v2;
181  }
182 } /* howParallel() */
double dot(const Hep3Vector &) const
double mag2() const
Hep3Vector cross(const Hep3Vector &) const
bool CLHEP::Hep3Vector::isNear ( const Hep3Vector v,
double  epsilon = tolerance 
) const

Definition at line 154 of file ThreeVector.cc.

References dot(), and mag2().

154  {
155  double limit = dot(v)*epsilon*epsilon;
156  return ( (*this - v).mag2() <= limit );
157 } /* isNear() */
double dot(const Hep3Vector &) const
double mag2() const
bool CLHEP::Hep3Vector::isOrthogonal ( const Hep3Vector v,
double  epsilon = tolerance 
) const

Definition at line 237 of file SpaceVector.cc.

References cross(), dot(), dx, dy, dz, and mag2().

Referenced by G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LivermorePolarizedComptonModel::SampleSecondaries(), and G4LivermorePolarizedGammaConversionModel::SampleSecondaries().

238  {
239 // | V1 x V2 | **2 <= epsilon **2 | V1 dot V2 | **2
240 // V1 is *this, V2 is v
241 
242  static const double TOOBIG = std::pow(2.0,507);
243  static const double SCALE = std::pow(2.0,-507);
244  double v1v2 = std::fabs(dot(v));
245  //-| Safe because both v1 and v2 can be squared
246  if ( v1v2 >= TOOBIG ) {
247  Hep3Vector sv1 ( *this * SCALE );
248  Hep3Vector sv2 ( v * SCALE );
249  Hep3Vector sv1Xsv2 = sv1.cross(sv2);
250  double x2 = sv1Xsv2.mag2();
251  double limit = epsilon*epsilon*x2;
252  double y2 = v1v2*SCALE*SCALE;
253  return ( y2*y2 <= limit );
254  }
255 
256  // At this point we know v1v2 can be squared.
257 
258  Hep3Vector eps_v1Xv2 ( cross(epsilon*v) );
259  if ( (std::fabs (eps_v1Xv2.dx) > TOOBIG) ||
260  (std::fabs (eps_v1Xv2.dy) > TOOBIG) ||
261  (std::fabs (eps_v1Xv2.dz) > TOOBIG) ) {
262  return true;
263  }
264 
265  // At this point we know all the math we need can be done.
266 
267  return ( v1v2*v1v2 <= eps_v1Xv2.mag2() );
268 
269 } /* isOrthogonal() */
double dot(const Hep3Vector &) const
Hep3Vector cross(const Hep3Vector &) const
bool CLHEP::Hep3Vector::isParallel ( const Hep3Vector v,
double  epsilon = tolerance 
) const

Definition at line 184 of file SpaceVector.cc.

References cross(), dot(), dx, dy, dz, and mag2().

185  {
186  // | V1 x V2 | **2 <= epsilon **2 | V1 dot V2 | **2
187  // V1 is *this, V2 is v
188 
189  static const double TOOBIG = std::pow(2.0,507);
190  static const double SCALE = std::pow(2.0,-507);
191  double v1v2 = std::fabs(dot(v));
192  if ( v1v2 == 0 ) {
193  return ( (mag2() == 0) && (v.mag2() == 0) );
194  }
195  if ( v1v2 >= TOOBIG ) {
196  Hep3Vector sv1 ( *this * SCALE );
197  Hep3Vector sv2 ( v * SCALE );
198  Hep3Vector sv1Xsv2 = sv1.cross(sv2);
199  double x2 = sv1Xsv2.mag2();
200  double limit = v1v2*SCALE*SCALE;
201  limit = epsilon*epsilon*limit*limit;
202  return ( x2 <= limit );
203  }
204 
205  // At this point we know v1v2 can be squared.
206 
207  Hep3Vector v1Xv2 ( cross(v) );
208  if ( (std::fabs (v1Xv2.dx) > TOOBIG) ||
209  (std::fabs (v1Xv2.dy) > TOOBIG) ||
210  (std::fabs (v1Xv2.dz) > TOOBIG) ) {
211  return false;
212  }
213 
214  return ( (v1Xv2.mag2()) <= ((epsilon * v1v2) * (epsilon * v1v2)) );
215 
216 } /* isParallel() */
double dot(const Hep3Vector &) const
double mag2() const
Hep3Vector cross(const Hep3Vector &) const
double CLHEP::Hep3Vector::mag ( ) const
inline

Referenced by G4NeutronHPFinalState::adjust_final_state(), G4MagHelicalStepper::AdvanceHelix(), G4BinaryLightIonReaction::ApplyYourself(), G4RPGKMinusInelastic::ApplyYourself(), G4RPGNeutronInelastic::ApplyYourself(), G4RPGProtonInelastic::ApplyYourself(), G4RPGAntiLambdaInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGSigmaPlusInelastic::ApplyYourself(), G4RPGXiMinusInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiNeutronInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGOmegaMinusInelastic::ApplyYourself(), G4RPGAntiXiZeroInelastic::ApplyYourself(), G4RPGKZeroInelastic::ApplyYourself(), G4RPGLambdaInelastic::ApplyYourself(), G4RPGKPlusInelastic::ApplyYourself(), G4NeutronHPCaptureFS::ApplyYourself(), G4RPGSigmaMinusInelastic::ApplyYourself(), G4RPGXiZeroInelastic::ApplyYourself(), G4RPGAntiKZeroInelastic::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4LENDInelastic::ApplyYourself(), G4LENDCapture::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4NeutronHPInelasticBaseFS::BaseApply(), G4NucleiModel::boundaryTransition(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4RPGInelastic::CalculateMomenta(), G4QMDCollision::CalKinematicsOfBinaryCollisions(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4NucleiModel::choosePointAlongTraj(), CLHEP::HepLorentzVector::coLinearRapidity(), RE01Trajectory::CreateAttValues(), F04Trajectory::CreateAttValues(), WLSTrajectory::CreateAttValues(), G4SmoothTrajectory::CreateAttValues(), G4Trajectory::CreateAttValues(), RE04Trajectory::CreateAttValues(), G4VPhononProcess::CreateSecondary(), G4DiffractiveExcitation::CreateStrings(), G4AdjointCrossSurfChecker::CrossingASphere(), G4AblaInterface::DeExcite(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4Ellipsoid::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4TwistTubsHypeSide::DistanceToSurface(), ExGflashEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4MultiLevelLocator::EstimateIntersectionPoint(), eta(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4FissionProductYieldDist::G4GetFission(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4tgbPlaceParamLinear::G4tgbPlaceParamLinear(), G4tgbPlaceParamSquare::G4tgbPlaceParamSquare(), G4TriangularFacet::G4TriangularFacet(), G4NucleiModel::generateInteractionPartners(), DicomPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4ReactionDynamics::GenerateXandPt(), G4RKFieldIntegrator::GetAntiprotonPotential(), G4Nucleus::GetBiasedThermalNucleus(), G4NeutronHPFissionData::GetCrossSection(), G4NeutronHPCaptureData::GetCrossSection(), G4NeutronHPInelasticData::GetCrossSection(), G4NeutronHPElasticData::GetCrossSection(), G4NuclearShellModelDensity::GetDeriv(), G4NuclearFermiDensity::GetDeriv(), G4ErrorCylSurfaceTarget::GetDistanceFromPoint(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4IonsKoxCrossSection::GetElementCrossSection(), G4SigmaPlusField::GetField(), G4KaonZeroField::GetField(), G4SigmaMinusField::GetField(), G4SigmaZeroField::GetField(), G4AntiProtonField::GetField(), G4KaonPlusField::GetField(), G4KaonMinusField::GetField(), G4PionPlusField::GetField(), G4PionZeroField::GetField(), G4PionMinusField::GetField(), G4NeutronField::GetField(), G4ProtonField::GetField(), G4Navigator::GetGlobalExitNormal(), G4GlauberGribovCrossSection::GetHadronNucleonXsc(), G4GGNuclNuclCrossSection::GetHadronNucleonXsc(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXsc(), G4ComponentGGNuclNuclXsc::GetHadronNucleonXsc(), G4HadronNucleonXsc::GetHadronNucleonXscEL(), G4HadronNucleonXsc::GetHadronNucleonXscNS(), G4GlauberGribovCrossSection::GetHadronNucleonXscNS(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscNS(), G4HadronNucleonXsc::GetHadronNucleonXscPDG(), G4GlauberGribovCrossSection::GetHadronNucleonXscPDG(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscPDG(), G4HadronNucleonXsc::GetHadronNucleonXscVU(), G4GlauberGribovCrossSection::GetHNinelasticXscVU(), G4GGNuclNuclCrossSection::GetHNinelasticXscVU(), G4ComponentGGNuclNuclXsc::GetHNinelasticXscVU(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXscVU(), G4NuclNuclDiffuseElastic::GetInvCoulombElasticXsc(), G4DiffuseElastic::GetInvCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetInvElasticSumXsc(), G4DiffuseElastic::GetInvElasticSumXsc(), G4NuclNuclDiffuseElastic::GetInvElasticXsc(), G4DiffuseElastic::GetInvElasticXsc(), G4IonsShenCrossSection::GetIsoCrossSection(), G4HadronNucleonXsc::GetKaonNucleonXscGG(), G4RKFieldIntegrator::GetKaonPotential(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4FermiMomentum::GetMomentum(), G4RKFieldIntegrator::GetNeutronPotential(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4RKFieldIntegrator::GetPionPotential(), G4RKFieldIntegrator::GetProtonPotential(), G4NuclearFermiDensity::GetRelativeDensity(), G4tgrUtils::GetRotationFromDirection(), G4VIntersectionLocator::GetSurfaceNormal(), G4HadProjectile::GetTotalMomentum(), howOrthogonal(), howParallel(), G4NucleiModel::initializeCascad(), G4TwistTubsHypeSide::Inside(), G4TriangularFacet::Intersect(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4DecayProducts::IsChecked(), G4GHEKinematicsVector::Length(), G4Trap::MakePlane(), CLHEP::HepLorentzVector::minus(), G4RPGReaction::MomentumCheck(), G4RPGReaction::NuclearReaction(), G4ReactionDynamics::NuclearReaction(), operator<<(), CLHEP::HepLorentzVector::plus(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), CLHEP::HepBoost::print(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), G4IntraNucleiCascader::processSecondary(), G4GeneratorPrecompoundInterface::Propagate(), G4BinaryCascade::Propagate(), G4ErrorFreeTrajState::PropagateError(), pseudoRapidity(), rapidity(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), CexmcReconstructor::ReconstructEntryPoints(), CLHEP::HepBoost::rectify(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), G4CoupledTransportation::ReportMove(), G4PathFinder::ReportMove(), G4VIntersectionLocator::ReportTrialStep(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotate(), rotate(), G4StokesVector::RotateAz(), G4AntiNuclElastic::SampleInvariantT(), G4NuclNuclDiffuseElastic::SampleInvariantT(), G4DiffuseElastic::SampleInvariantT(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), CLHEP::HepBoost::set(), G4ReactionProduct::SetDefinitionAndUpdateE(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4HadFinalState::SetMomentumChange(), G4ParticleGun::SetParticleMomentum(), G4RPGInelastic::SetUpChange(), G4QMDSystem::ShowParticipants(), G4HelixMixedStepper::Stepper(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4PolarizationHelper::TestPolarizationTransformations(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4ReactionDynamics::TwoBody(), G4ReactionDynamics::TwoCluster(), G4ParticleChangeForTransport::UpdateStepForAlongStep(), G4ParticleChange::UpdateStepForAlongStep(), and FCALSteppingAction::UserSteppingAction().

double CLHEP::Hep3Vector::mag2 ( ) const
inline

Referenced by G4GHEKinematicsVector::Add(), G4VMultipleScattering::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4GHEKinematicsVector::Ang(), G4FTFAnnihilation::Annihilate(), G4WilsonAbrasionModel::ApplyYourself(), azimAngle(), G4NeutronHPInelasticBaseFS::BaseApply(), beta(), CLHEP::HepLorentzVector::beta(), CLHEP::HepLorentzVector::boost(), G4KineticTrackVector::BoostBeam(), CLHEP::HepLorentzVector::boostVector(), G4StatMF::BreakItUp(), G4CompetitiveFission::BreakUp(), CalculatePointInside(), CalculatePointSafety(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4NucleiModel::choosePointAlongTraj(), G4NeutronHPInelasticCompFS::CompositeApply(), G4PathFinder::ComputeStep(), cos2Theta(), G4GHEKinematicsVector::CosAng(), cosTheta(), G4DecayWithSpin::DecayIt(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4Fancy3DNucleus::DoLorentzContraction(), G4PathFinder::DoNextLinearStep(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4LorentzConvertor::fillKinematics(), G4VElasticCollision::FinalState(), G4VScatteringCollision::FinalState(), CLHEP::HepLorentzVector::findBoostToCM(), G4VKinkyStringDecay::FragmentString(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4LineSection::G4LineSection(), G4QuadrangularFacet::G4QuadrangularFacet(), G4TriangularFacet::G4TriangularFacet(), gamma(), CLHEP::HepLorentzVector::gamma(), G4PrimaryTransformer::GenerateSingleTrack(), G4MesonAbsorption::GetFinalState(), G4StatMFFragment::GetFragment(), G4MultiNavigator::GetGlobalExitNormal(), G4Navigator::GetGlobalExitNormal(), G4VIntersectionLocator::GetGlobalSurfaceNormal(), G4Navigator::GetLocalExitNormal(), G4CascadParticle::getPathToTheNextZone(), G4NuclearShellModelDensity::GetRelativeDensity(), G4RKPropagation::GetSphereIntersectionTimes(), G4VIntersectionLocator::GetSurfaceNormal(), G4Scatterer::GetTimeToInteraction(), howNear(), CLHEP::HepLorentzVector::howNearCM(), howParallel(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), isNear(), CLHEP::HepLorentzVector::isNearCM(), isOrthogonal(), isParallel(), G4VLongitudinalStringDecay::LightFragmentationTest(), G4PathFinder::Locate(), G4GHEKinematicsVector::Lor(), G4GHEKinematicsVector::Norz(), G4MagInt_Driver::OneGoodStep(), G4MagInt_Driver::PrintStat_Aux(), project(), G4GeneratorPrecompoundInterface::Propagate(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), G4MagInt_Driver::QuickAdvance(), CLHEP::HepLorentzVector::rapidity(), CexmcChargeExchangeReconstructor::Reconstruct(), CLHEP::HepBoost::rectify(), G4QuasiElRatios::RelDecayIn2(), G4PathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4VIntersectionLocator::ReportTrialStep(), CLHEP::HepRotation::rotateAxes(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4QuasiElasticChannel::Scatter(), G4DynamicParticle::Set4Momentum(), G4DynamicParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4KineticTrack::SetTrackingMomentum(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub(), G4Paraboloid::SurfaceNormal(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4KineticTrack::Update4Momentum(), and G4KineticTrack::UpdateTrackingMomentum().

double CLHEP::Hep3Vector::negativeInfinity ( ) const
protected

Definition at line 283 of file SpaceVector.cc.

Referenced by eta().

283  {
284  // A byte-order-independent way to return -Infinity
285  struct Dib {
286  union {
287  double d;
288  unsigned char i[8];
289  } u;
290  };
291  Dib negOne;
292  Dib posTwo;
293  negOne.u.d = -1.0;
294  posTwo.u.d = 2.0;
295  Dib value;
296  int k;
297  for (k=0; k<8; k++) {
298  value.u.i[k] = negOne.u.i[k] | posTwo.u.i[k];
299  }
300  return value.u.d;
301 }
const XML_Char int const XML_Char * value
bool CLHEP::Hep3Vector::operator!= ( const Hep3Vector ) const
inline
double CLHEP::Hep3Vector::operator() ( int  i) const

Definition at line 38 of file ThreeVector.cc.

References X, x(), Y, y(), Z, and z().

38  {
39  switch(i) {
40  case X:
41  return x();
42  case Y:
43  return y();
44  case Z:
45  return z();
46  default:
47  std::cerr << "Hep3Vector::operator () - "
48  << "Hep3Vector subscripting: bad index (" << i << ")"
49  << std::endl;
50  }
51  return 0.;
52 }
double x() const
double z() const
double y() const
double & CLHEP::Hep3Vector::operator() ( int  i)

Definition at line 54 of file ThreeVector.cc.

References dx, dy, dz, X, Y, and Z.

54  {
55  static double dummy;
56  switch(i) {
57  case X:
58  return dx;
59  case Y:
60  return dy;
61  case Z:
62  return dz;
63  default:
64  std::cerr
65  << "Hep3Vector::operator () - "
66  << "Hep3Vector subscripting: bad index (" << i << ")"
67  << std::endl;
68  return dummy;
69  }
70 }
Hep3Vector& CLHEP::Hep3Vector::operator*= ( double  )
inline

Referenced by rotate().

Hep3Vector & CLHEP::Hep3Vector::operator*= ( const HepRotation m1)

Definition at line 20 of file ThreeVectorR.cc.

20  {
21  return *this = m1 * (*this);
22 }
Hep3Vector& CLHEP::Hep3Vector::operator+= ( const Hep3Vector )
inline
Hep3Vector CLHEP::Hep3Vector::operator- ( ) const
inline
Hep3Vector& CLHEP::Hep3Vector::operator-= ( const Hep3Vector )
inline
Hep3Vector & CLHEP::Hep3Vector::operator/= ( double  c)

Definition at line 347 of file ThreeVector.cc.

References test::c, dx, dy, and dz.

347  {
348 // if (c == 0) {
349 // std::cerr << "Hep3Vector::operator/ () - "
350 // << "Attempt to do vector /= 0 -- "
351 // << "division by zero would produce infinite or NAN components"
352 // << std::endl;
353 // }
354  double oneOverC = 1.0/c;
355  dx *= oneOverC;
356  dy *= oneOverC;
357  dz *= oneOverC;
358  return *this;
359 }
bool CLHEP::Hep3Vector::operator< ( const Hep3Vector v) const

Definition at line 144 of file SpaceVector.cc.

References compare().

144  {
145  return (compare(v) < 0);
146 }
int compare(const Hep3Vector &v) const
Definition: SpaceVector.cc:122
bool CLHEP::Hep3Vector::operator<= ( const Hep3Vector v) const

Definition at line 150 of file SpaceVector.cc.

References compare().

150  {
151  return (compare(v) <= 0);
152 }
int compare(const Hep3Vector &v) const
Definition: SpaceVector.cc:122
Hep3Vector& CLHEP::Hep3Vector::operator= ( const Hep3Vector )
inline
bool CLHEP::Hep3Vector::operator== ( const Hep3Vector ) const
inline
bool CLHEP::Hep3Vector::operator> ( const Hep3Vector v) const

Definition at line 141 of file SpaceVector.cc.

References compare().

141  {
142  return (compare(v) > 0);
143 }
int compare(const Hep3Vector &v) const
Definition: SpaceVector.cc:122
bool CLHEP::Hep3Vector::operator>= ( const Hep3Vector v) const

Definition at line 147 of file SpaceVector.cc.

References compare().

147  {
148  return (compare(v) >= 0);
149 }
int compare(const Hep3Vector &v) const
Definition: SpaceVector.cc:122
double CLHEP::Hep3Vector::operator[] ( int  ) const
inline
double& CLHEP::Hep3Vector::operator[] ( int  )
inline
Hep3Vector CLHEP::Hep3Vector::orthogonal ( ) const
inline
double CLHEP::Hep3Vector::perp ( ) const
inline
double CLHEP::Hep3Vector::perp ( const Hep3Vector ) const
inline
double CLHEP::Hep3Vector::perp2 ( ) const
inline
double CLHEP::Hep3Vector::perp2 ( const Hep3Vector ) const
inline
Hep3Vector CLHEP::Hep3Vector::perpPart ( ) const
inline

Referenced by azimAngle().

Hep3Vector CLHEP::Hep3Vector::perpPart ( const Hep3Vector v2) const
inline
double CLHEP::Hep3Vector::phi ( ) const
inline
double CLHEP::Hep3Vector::polarAngle ( const Hep3Vector v2) const

Definition at line 28 of file SpaceVectorD.cc.

References getTheta().

28  {
29  return std::fabs(v2.getTheta() - getTheta());
30 } /* polarAngle */
double getTheta() const
double CLHEP::Hep3Vector::polarAngle ( const Hep3Vector v2,
const Hep3Vector ref 
) const

Definition at line 32 of file SpaceVectorD.cc.

References angle().

33  {
34  return std::fabs( v2.angle(ref) - angle(ref) );
35 } /* polarAngle (v2, ref) */
double angle() const
Hep3Vector CLHEP::Hep3Vector::project ( ) const
inline

Referenced by project().

Hep3Vector CLHEP::Hep3Vector::project ( const Hep3Vector v2) const

Definition at line 89 of file SpaceVectorP.cc.

References dot(), mag2(), and project().

89  {
90  double mag2v2 = v2.mag2();
91  if (mag2v2 == 0) {
92  std::cerr << "Hep3Vector::project() - "
93  << "Attempt to take projection of vector against zero reference vector"
94  << std::endl;
95  return project();
96  }
97  return ( v2 * (dot(v2)/mag2v2) );
98 }
double dot(const Hep3Vector &) const
Hep3Vector project() const
double CLHEP::Hep3Vector::pseudoRapidity ( ) const

Definition at line 92 of file ThreeVector.cc.

References mag(), and z().

92  {
93  double m1 = mag();
94  if ( m1== 0 ) return 0.0;
95  if ( m1== z() ) return 1.0E72;
96  if ( m1== -z() ) return -1.0E72;
97  return 0.5*std::log( (m1+z())/(m1-z()) );
98 }
double z() const
double mag() const
double CLHEP::Hep3Vector::r ( ) const
inline
double CLHEP::Hep3Vector::rapidity ( ) const

Definition at line 54 of file SpaceVectorP.cc.

References dz.

54  {
55 // if (std::fabs(dz) == 1) {
56 // std::cerr << "Hep3Vector::rapidity() - "
57 // << "Rapidity in Z direction taken for Hep3Vector with |Z| = 1 -- \n"
58 // << "the log should return infinity" <, std::endl;
59 // }
60 // if (std::fabs(dz) > 1) {
61 // std::cerr << "Hep3Vector::rapidity() - "
62 // << "Rapidity in Z direction taken for Hep3Vector with |Z| > 1 -- \n"
63 // << "the log would return a NAN" << std::endl;
64 // }
65  // Want inverse std::tanh(dz):
66  return (.5 * std::log((1+dz)/(1-dz)) );
67 }
double CLHEP::Hep3Vector::rapidity ( const Hep3Vector v2) const

Definition at line 100 of file SpaceVectorP.cc.

References dot(), and mag().

100  {
101  double vmag = v2.mag();
102  if ( vmag == 0 ) {
103  std::cerr << "Hep3Vector::rapidity() - "
104  << "Rapidity taken with respect to zero vector" << std::endl;
105  return 0;
106  }
107  double z1 = dot(v2)/vmag;
108 // if (std::fabs(z1) >= 1) {
109 // std::cerr << "Hep3Vector::rapidity() - "
110 // << "Rapidity taken for too large a Hep3Vector "
111 // << "-- would return infinity or NAN" << std::endl;
112 // }
113  // Want inverse std::tanh(z):
114  return (.5 * std::log((1+z1)/(1-z1)) );
115 }
double dot(const Hep3Vector &) const
double CLHEP::Hep3Vector::rho ( ) const
inline
Hep3Vector & CLHEP::Hep3Vector::rotate ( double  aangle,
const Hep3Vector aaxis 
)
Hep3Vector & CLHEP::Hep3Vector::rotate ( const Hep3Vector axis,
double  delta 
)

Definition at line 25 of file SpaceVectorR.cc.

References dx, dy, dz, getX(), getY(), getZ(), and mag().

26  {
27  double r1 = axis.mag();
28  if ( r1 == 0 ) {
29  std::cerr << "Hep3Vector::rotate() - "
30  << "Attempt to rotate around a zero vector axis! " << std::endl;
31  return *this;
32  }
33  register double scale=1.0/r1;
34  register double ux = scale*axis.getX();
35  register double uy = scale*axis.getY();
36  register double uz = scale*axis.getZ();
37  double cd = std::cos(ddelta);
38  double sd = std::sin(ddelta);
39  register double ocd = 1 - cd;
40  double rx;
41  double ry;
42  double rz;
43 
44  { register double ocdux = ocd * ux;
45  rx = dx * ( cd + ocdux * ux ) +
46  dy * ( ocdux * uy - sd * uz ) +
47  dz * ( ocdux * uz + sd * uy ) ;
48  }
49 
50  { register double ocduy = ocd * uy;
51  ry = dy * ( cd + ocduy * uy ) +
52  dz * ( ocduy * uz - sd * ux ) +
53  dx * ( ocduy * ux + sd * uz ) ;
54  }
55 
56  { register double ocduz = ocd * uz;
57  rz = dz * ( cd + ocduz * uz ) +
58  dx * ( ocduz * ux - sd * uy ) +
59  dy * ( ocduz * uy + sd * ux ) ;
60  }
61 
62  dx = rx;
63  dy = ry;
64  dz = rz;
65 
66  return *this;
67 } /* rotate */
Hep3Vector & CLHEP::Hep3Vector::rotate ( const HepAxisAngle ax)

Definition at line 112 of file SpaceVectorR.cc.

References CLHEP::HepAxisAngle::delta(), CLHEP::HepAxisAngle::getAxis(), and rotate().

112  {
113  return rotate( ax.getAxis(), ax.delta() );
114 }
Hep3Vector & rotate(double, const Hep3Vector &)
Definition: ThreeVectorR.cc:28
Hep3Vector & CLHEP::Hep3Vector::rotate ( const HepEulerAngles e)

Definition at line 116 of file SpaceVectorR.cc.

References CLHEP::HepEulerAngles::phi(), CLHEP::HepEulerAngles::psi(), rotate(), and CLHEP::HepEulerAngles::theta().

116  {
117  return rotate( ex.phi(), ex.theta(), ex.psi() );
118 }
Hep3Vector & rotate(double, const Hep3Vector &)
Definition: ThreeVectorR.cc:28
Hep3Vector & CLHEP::Hep3Vector::rotate ( double  phi,
double  theta,
double  psi 
)

Definition at line 74 of file SpaceVectorR.cc.

References dx, dy, and dz.

76  {
77 
78  double rx;
79  double ry;
80  double rz;
81 
82  register double sinPhi = std::sin( phi1 ), cosPhi = std::cos( phi1 );
83  register double sinTheta = std::sin( theta1 ), cosTheta1 = std::cos( theta1 );
84  register double sinPsi = std::sin( psi1 ), cosPsi = std::cos( psi1 );
85 
86  rx = (cosPsi * cosPhi - cosTheta1 * sinPsi * sinPhi) * dx +
87  (cosPsi * sinPhi + cosTheta1 * sinPsi * cosPhi) * dy +
88  (sinPsi * sinTheta) * dz ;
89 
90  ry = (- sinPsi * cosPhi - cosTheta1 * cosPsi * sinPhi) * dx +
91  (- sinPsi * sinPhi + cosTheta1 * cosPsi * cosPhi) * dy +
92  (cosPsi * sinTheta) * dz ;
93 
94  rz = (sinTheta * sinPhi) * dx +
95  (- sinTheta * cosPhi) * dy +
96  (cosTheta1) * dz ;
97 
98  dx = rx;
99  dy = ry;
100  dz = rz;
101 
102  return *this;
103 
104 } /* rotate */
Hep3Vector & CLHEP::Hep3Vector::rotateUz ( const Hep3Vector NewUzVector)

Definition at line 72 of file ThreeVector.cc.

References dx, dy, dz, x(), y(), and z().

Referenced by G4eplusAnnihilation::AtRestDoIt(), G4GEMChannel::BreakUp(), G4TheRayTracer::CreateBitMap(), G4MuonDecayChannelWithSpin::DecayIt(), G4PionRadiativeDecayChannel::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4SingleScatter::DoCollisionStep(), G4FissionProductYieldDist::G4GetFission(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), PrimaryGeneratorAction3::GeneratePrimaries(), PrimaryGeneratorAction4::GeneratePrimaries(), G4RDPhotoElectricAngularGeneratorSauterGavrila::GetPhotoElectronDirection(), G4HadronElasticProcess::PostStepDoIt(), G4LowEnergyRayleigh::PostStepDoIt(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyGammaConversion::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), CLHEP::HepLorentzVector::rotateUz(), G4DeltaAngleFreeScat::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4DeltaAngle::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4Generator2BN::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BS::SampleDirection(), G4WentzelVIModel::SampleScattering(), G4WentzelVIRelModel::SampleScattering(), G4GoudsmitSaundersonMscModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), MyKleinNishinaCompton::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4DNARuddIonisationExtendedModel::SampleSecondaries(), G4DNARuddIonisationModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4DNABornIonisationModel::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4ee2KNeutralModel::SampleSecondaries(), G4ee2KChargedModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4eeToTwoPiModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4eeToPGammaModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4PAIPhotonModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4PolarizationHelper::TestInteractionFrame(), and G4PAIPhotonModel::TestSecondaries().

72  {
73  // NewUzVector must be normalized !
74 
75  double u1 = NewUzVector.x();
76  double u2 = NewUzVector.y();
77  double u3 = NewUzVector.z();
78  double up = u1*u1 + u2*u2;
79 
80  if (up>0) {
81  up = std::sqrt(up);
82  double px = dx, py = dy, pz = dz;
83  dx = (u1*u3*px - u2*py)/up + u1*pz;
84  dy = (u2*u3*px + u1*py)/up + u2*pz;
85  dz = -up*px + u3*pz;
86  }
87  else if (u3 < 0.) { dx = -dx; dz = -dz; } // phi=0 teta=pi
88  else {};
89  return *this;
90 }
Hep3Vector & CLHEP::Hep3Vector::rotateX ( double  phi1)

Definition at line 124 of file ThreeVector.cc.

References dy, and dz.

Referenced by CLHEP::HepLorentzVector::rotateX(), and CLHEP::rotationXOf().

124  {
125  double sinphi = std::sin(phi1);
126  double cosphi = std::cos(phi1);
127  double ty;
128  ty = dy * cosphi - dz * sinphi;
129  dz = dz * cosphi + dy * sinphi;
130  dy = ty;
131  return *this;
132 } /* rotateX */
Hep3Vector & CLHEP::Hep3Vector::rotateY ( double  phi1)

Definition at line 134 of file ThreeVector.cc.

References dx, and dz.

Referenced by CLHEP::HepLorentzVector::rotateY(), and CLHEP::rotationYOf().

134  {
135  double sinphi = std::sin(phi1);
136  double cosphi = std::cos(phi1);
137  double tz;
138  tz = dz * cosphi - dx * sinphi;
139  dx = dx * cosphi + dz * sinphi;
140  dz = tz;
141  return *this;
142 } /* rotateY */
Hep3Vector & CLHEP::Hep3Vector::rotateZ ( double  phi1)

Definition at line 144 of file ThreeVector.cc.

References dx, and dy.

Referenced by H02DetectorConstruction::Construct(), G4TheRayTracer::CreateBitMap(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), CLHEP::HepLorentzVector::rotateZ(), and CLHEP::rotationZOf().

144  {
145  double sinphi = std::sin(phi1);
146  double cosphi = std::cos(phi1);
147  double tx;
148  tx = dx * cosphi - dy * sinphi;
149  dy = dy * cosphi + dx * sinphi;
150  dx = tx;
151  return *this;
152 } /* rotateZ */
void CLHEP::Hep3Vector::set ( double  x,
double  y,
double  z 
)
inline

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4NucleiModel::choosePointAlongTraj(), G4HadFinalState::Clear(), CML2ExpVoxels::CML2ExpVoxels(), CML2Ph_BoxInBox::CML2Ph_BoxInBox(), CML2Ph_FullWater::CML2Ph_FullWater(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), CML2AcceleratorConstruction::Construct(), CML2Ph_BoxInBox::Construct(), G4DiffractiveExcitation::CreateStrings(), G4VTwistSurface::CurrentStatus::CurrentStatus(), CLHEP::HepRotationY::decompose(), CLHEP::HepRotationZ::decompose(), CLHEP::HepRotationX::decompose(), CLHEP::HepRotation::decompose(), G4VTwistSurface::DistanceToBoundary(), G4VTwistedFaceted::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4FissionProductYieldDist::G4GetFission(), G4LatticeLogical::G4LatticeLogical(), G4TessellatedSolid::G4TessellatedSolid(), G4TriangularFacet::G4TriangularFacet(), G4TwistBoxSide::G4TwistBoxSide(), G4TwistTrapAlphaSide::G4TwistTrapAlphaSide(), G4TwistTrapFlatSide::G4TwistTrapFlatSide(), G4TwistTrapParallelSide::G4TwistTrapParallelSide(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4TwistTubsHypeSide::G4TwistTubsHypeSide(), G4TwistTubsSide::G4TwistTubsSide(), G4VEmAngularDistribution::G4VEmAngularDistribution(), G4VTwistSurface::G4VTwistSurface(), G4InuclSpecialFunctions::generateWithFixedTheta(), G4InuclSpecialFunctions::generateWithRandomAngles(), G4ScreeningMottCrossSection::GetNewDirection(), G4NucleiModel::initializeCascad(), G4VTwistedFaceted::Inside(), G4TwistedTubs::Inside(), G4TriangularFacet::Intersect(), G4QuadrangularFacet::Intersect(), G4LatticeLogical::Load_NMap(), CLHEP::operator>>(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4VTwistSurface::CurrentStatus::ResetfDone(), CML2SDWithVoxels::resetVoxelsSingle(), G4DeltaAngleFreeScat::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4DeltaAngle::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4Generator2BN::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BS::SampleDirection(), G4WentzelVIRelModel::SampleScattering(), G4WentzelVIModel::SampleScattering(), G4GoudsmitSaundersonMscModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4DNABornIonisationModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4WentzelVIRelXSection::SampleSingleScattering(), G4VTwistSurface::SetCorner(), G4SurfaceVoxelizer::SetMaxVoxels(), G4HadFinalState::SetMomentumChange(), CML2CInputData::setPhaseSpaceCentre(), CML2CInputData::setPhaseSpaceHalfSize(), G4VTwistedFaceted::SurfaceNormal(), and G4TwistedTubs::SurfaceNormal().

void CLHEP::Hep3Vector::setCylEta ( double  p)

Definition at line 293 of file ThreeVector.cc.

References dx, dy, dz, getPhi(), and getRho().

293  {
294 
295  // In cylindrical coords, set eta while keeping rho and phi fixed
296 
297  double theta1 = 2 * std::atan ( std::exp (-eta1) );
298 
299  //-| The remaining code is similar to setCylTheta, The reason for
300  //-| using a copy is so as to be able to change the messages in the
301  //-| ZMthrows to say eta rather than theta. Besides, we assumedly
302  //-| need not check for theta of 0 or PI.
303 
304  if ( (dx == 0) && (dy == 0) ) {
305  if (dz == 0) {
306  std::cerr << "Hep3Vector::setCylEta() - "
307  << "Attempt to set cylEta of zero vector -- vector is unchanged"
308  << std::endl;
309  return;
310  }
311  if (theta1 == 0) {
312  dz = std::fabs(dz);
313  return;
314  }
315  if (theta1 == CLHEP::pi) {
316  dz = -std::fabs(dz);
317  return;
318  }
319  std::cerr << "Hep3Vector::setCylEta() - "
320  << "Attempt set cylindrical eta of vector along Z axis "
321  << "to a non-trivial value, while keeping rho fixed -- "
322  << "will return zero vector" << std::endl;
323  dz = 0;
324  return;
325  }
326  double phi1 (getPhi());
327  double rho1 = getRho();
328  dz = rho1 / std::tan (theta1);
329  dy = rho1 * std::sin (phi1);
330  dx = rho1 * std::cos (phi1);
331 
332 } /* setCylEta */
double getRho() const
double getPhi() const
void CLHEP::Hep3Vector::setCylindrical ( double  r,
double  phi,
double  z 
)
protected

Definition at line 56 of file SpaceVector.cc.

References dx, dy, and dz.

59  {
60 // if ( rho1 < 0 ) {
61 // std::cerr << "Hep3Vector::setCylindrical() - "
62 // << "Cylindrical coordinates supplied with negative Rho" << std::endl;
63 // // No special return needed if warning is ignored.
64 // }
65  dz = z1;
66  dy = rho1 * std::sin (phi1);
67  dx = rho1 * std::cos (phi1);
68  return;
69 } /* setCylindrical (r, phi, z) */
void CLHEP::Hep3Vector::setCylTheta ( double  theta1)

Definition at line 245 of file ThreeVector.cc.

References dx, dy, dz, getPhi(), and getRho().

245  {
246 
247  // In cylindrical coords, set theta while keeping rho and phi fixed
248 
249  if ( (dx == 0) && (dy == 0) ) {
250  if (dz == 0) {
251  std::cerr << "Hep3Vector::setCylTheta() - "
252  << "Attempt to set cylTheta of zero vector -- vector is unchanged"
253  << std::endl;
254  return;
255  }
256  if (theta1 == 0) {
257  dz = std::fabs(dz);
258  return;
259  }
260  if (theta1 == CLHEP::pi) {
261  dz = -std::fabs(dz);
262  return;
263  }
264  std::cerr << "Hep3Vector::setCylTheta() - "
265  << "Attempt set cylindrical theta of vector along Z axis "
266  << "to a non-trivial value, while keeping rho fixed -- "
267  << "will return zero vector" << std::endl;
268  dz = 0;
269  return;
270  }
271  if ( (theta1 < 0) || (theta1 > CLHEP::pi) ) {
272  std::cerr << "Hep3Vector::setCylTheta() - "
273  << "Setting Cyl theta of a vector based on a value not in [0, PI]"
274  << std::endl;
275  // No special return needed if warning is ignored.
276  }
277  double phi1 (getPhi());
278  double rho1 = getRho();
279  if ( (theta1 == 0) || (theta1 == CLHEP::pi) ) {
280  std::cerr << "Hep3Vector::setCylTheta() - "
281  << "Attempt to set cylindrical theta to 0 or PI "
282  << "while keeping rho fixed -- infinite Z will be computed"
283  << std::endl;
284  dz = (theta1==0) ? 1.0E72 : -1.0E72;
285  return;
286  }
287  dz = rho1 / std::tan (theta1);
288  dy = rho1 * std::sin (phi1);
289  dx = rho1 * std::cos (phi1);
290 
291 } /* setCylTheta */
double getRho() const
double getPhi() const
void CLHEP::Hep3Vector::setEta ( double  p)

Definition at line 217 of file ThreeVector.cc.

References dx, dy, dz, getPhi(), and getR().

217  {
218  double phi1 = 0;
219  double r1;
220  if ( (dx == 0) && (dy == 0) ) {
221  if (dz == 0) {
222  std::cerr << "Hep3Vector::setEta() - "
223  << "Attempt to set eta of zero vector -- vector is unchanged"
224  << std::endl;
225  return;
226  }
227  std::cerr << "Hep3Vector::setEta() - "
228  << "Attempt to set eta of vector along Z axis -- will use phi = 0"
229  << std::endl;
230  r1 = std::fabs(dz);
231  } else {
232  r1 = getR();
233  phi1 = getPhi();
234  }
235  double tanHalfTheta = std::exp ( -eta1 );
236  double cosTheta1 =
237  (1 - tanHalfTheta*tanHalfTheta) / (1 + tanHalfTheta*tanHalfTheta);
238  dz = r1 * cosTheta1;
239  double rho1 = r1*std::sqrt(1 - cosTheta1*cosTheta1);
240  dy = rho1 * std::sin (phi1);
241  dx = rho1 * std::cos (phi1);
242  return;
243 }
double getR() const
double getPhi() const
void CLHEP::Hep3Vector::setMag ( double  ma)

Definition at line 25 of file ThreeVector.cc.

References mag(), setX(), setY(), setZ(), x(), y(), and z().

Referenced by G4EMDissociation::ApplyYourself(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), and CexmcChargeExchangeReconstructor::Reconstruct().

25  {
26  double factor = mag();
27  if (factor == 0) {
28  std::cerr << "Hep3Vector::setMag() - "
29  << "zero vector can't be stretched" << std::endl;
30  }else{
31  factor = ma/factor;
32  setX(x()*factor);
33  setY(y()*factor);
34  setZ(z()*factor);
35  }
36 }
double x() const
void setY(double)
double z() const
void setZ(double)
void setX(double)
double y() const
double mag() const
void CLHEP::Hep3Vector::setPerp ( double  )
inline
void CLHEP::Hep3Vector::setPhi ( double  )
inline
void CLHEP::Hep3Vector::setR ( double  s)
inline
void CLHEP::Hep3Vector::setREtaPhi ( double  r,
double  eta,
double  phi 
)
inline
void CLHEP::Hep3Vector::setRho ( double  s)
inline
void CLHEP::Hep3Vector::setRhoPhiEta ( double  rho,
double  phi,
double  eta 
)

Definition at line 98 of file SpaceVector.cc.

References dx, dy, and dz.

101  {
102  if (rho1 == 0) {
103  std::cerr << "Hep3Vector::setRhoPhiEta() - "
104  << "Attempt set vector components rho, phi, eta with zero rho -- "
105  << "zero vector is returned, ignoring eta and phi" << std::endl;
106  dx = 0; dy = 0; dz = 0;
107  return;
108  }
109  double theta1 (2 * std::atan ( std::exp (-eta1) ));
110  dz = rho1 / std::tan (theta1);
111  dy = rho1 * std::sin (phi1);
112  dx = rho1 * std::cos (phi1);
113  return;
114 } /* setCyl (rho, phi, eta) */
void CLHEP::Hep3Vector::setRhoPhiTheta ( double  rho,
double  phi,
double  theta 
)

Definition at line 71 of file SpaceVector.cc.

References dx, dy, and dz.

74  {
75  if (rho1 == 0) {
76  std::cerr << "Hep3Vector::setRhoPhiTheta() - "
77  << "Attempt set vector components rho, phi, theta with zero rho -- "
78  << "zero vector is returned, ignoring theta and phi" << std::endl;
79  dx = 0; dy = 0; dz = 0;
80  return;
81  }
82 // if ( (theta1 == 0) || (theta1 == CLHEP::pi) ) {
83 // std::cerr << "Hep3Vector::setRhoPhiTheta() - "
84 // << "Attempt set cylindrical vector vector with finite rho and "
85 // << "theta along the Z axis: infinite Z would be computed" << std::endl;
86 // }
87 // if ( (theta1 < 0) || (theta1 > CLHEP::pi) ) {
88 // std::cerr << "Hep3Vector::setRhoPhiTheta() - "
89 // << "Rho, phi, theta set with theta not in [0, PI]" << std::endl;
90 // // No special return needed if warning is ignored.
91 // }
92  dz = rho1 / std::tan (theta1);
93  dy = rho1 * std::sin (phi1);
94  dx = rho1 * std::cos (phi1);
95  return;
96 } /* setCyl (rho, phi, theta) */
void CLHEP::Hep3Vector::setRhoPhiZ ( double  rho,
double  phi,
double  z 
)
inline
void CLHEP::Hep3Vector::setRThetaPhi ( double  r,
double  theta,
double  phi 
)
inline
void CLHEP::Hep3Vector::setSpherical ( double  r,
double  theta,
double  phi 
)
protected

Definition at line 35 of file SpaceVector.cc.

References dx, dy, and dz.

38  {
39 // if ( r1 < 0 ) {
40 // std::cerr << "Hep3Vector::setSpherical() - "
41 // << "Spherical coordinates set with negative R" << std::endl;
42 // // No special return needed if warning is ignored.
43 // }
44 // if ( (theta1 < 0) || (theta1 > CLHEP::pi) ) {
45 // std::cerr << "Hep3Vector::setSpherical() - "
46 // << "Spherical coordinates set with theta not in [0, PI]" << std::endl;
47 // // No special return needed if warning is ignored.
48 // }
49  dz = r1 * std::cos(theta1);
50  double rho1 ( r1*std::sin(theta1));
51  dy = rho1 * std::sin (phi1);
52  dx = rho1 * std::cos (phi1);
53  return;
54 } /* setSpherical (r, theta1, phi1) */
void CLHEP::Hep3Vector::setTheta ( double  )
inline
double CLHEP::Hep3Vector::setTolerance ( double  tol)
static

Definition at line 271 of file SpaceVector.cc.

References tolerance.

271  {
272 // Set the tolerance for Hep3Vectors to be considered near one another
273  double oldTolerance (tolerance);
274  tolerance = tol;
275  return oldTolerance;
276 }
static DLL_API double tolerance
Definition: ThreeVector.h:399
void CLHEP::Hep3Vector::setX ( double  )
inline

Referenced by G4GHEKinematicsVector::Add3(), G4FTFAnnihilation::Annihilate(), G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), CLHEP::HepLorentzVector::boostX(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParameterisationBoxX::ComputeTransformation(), G4ParameterisationParaX::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G3Division::CreatePVReplica(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4DecayWithSpin::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceP1(), G4StokesVector::DiceP2(), G4StokesVector::DiceP3(), G4StokesVector::DiceUniform(), CexmcTrackPointsDigitizer::Digitize(), G4USolid::DistanceToOut(), Par01EnergySpot::Draw(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), DMXParticleSource::GenerateIsotropicFlux(), DMXParticleSource::GeneratePointsInVolume(), RE02PrimaryGeneratorAction::GeneratePrimaries(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4GDMLReadDefine::PositionRead(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4StokesVector::RotateAz(), G4GDMLReadDefine::RotationRead(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), and G4GDMLReadDefine::VectorRead().

void CLHEP::Hep3Vector::setY ( double  )
inline

Referenced by G4GHEKinematicsVector::Add3(), G4FTFAnnihilation::Annihilate(), G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), CLHEP::HepLorentzVector::boostY(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxY::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4DecayWithSpin::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceP1(), G4StokesVector::DiceP2(), G4StokesVector::DiceP3(), G4StokesVector::DiceUniform(), CexmcTrackPointsDigitizer::Digitize(), G4USolid::DistanceToOut(), Par01EnergySpot::Draw(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), DMXParticleSource::GenerateIsotropicFlux(), DMXParticleSource::GeneratePointsInVolume(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), RE02PrimaryGeneratorAction::GeneratePrimaries(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4GDMLReadDefine::PositionRead(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4StokesVector::RotateAz(), G4GDMLReadDefine::RotationRead(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), and G4GDMLReadDefine::VectorRead().

void CLHEP::Hep3Vector::setZ ( double  )
inline

Referenced by G4GHEKinematicsVector::Add3(), G4FTFAnnihilation::Annihilate(), G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), CLHEP::HepLorentzVector::boostZ(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationTrdZ::ComputeTransformation(), RE02DetectorConstruction::Construct(), CML2WorldConstruction::create(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4DecayWithSpin::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceP1(), G4StokesVector::DiceP2(), G4StokesVector::DiceP3(), G4StokesVector::DiceUniform(), G4USolid::DistanceToOut(), Par01PiModel::DoIt(), Par01EnergySpot::Draw(), G4StokesVector::FlipP3(), G4VKinkyStringDecay::FragmentString(), G4CutTubs::G4CutTubs(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), DMXParticleSource::GenerateIsotropicFlux(), DMXParticleSource::GeneratePointsInVolume(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4GDMLReadDefine::PositionRead(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4GDMLReadDefine::RotationRead(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4FTFParticipants::ShiftInteractionTime(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), and G4GDMLReadDefine::VectorRead().

double CLHEP::Hep3Vector::theta ( ) const
inline
double CLHEP::Hep3Vector::theta ( const Hep3Vector v2) const
inline
Hep3Vector & CLHEP::Hep3Vector::transform ( const HepRotation m1)

Definition at line 24 of file ThreeVectorR.cc.

Referenced by G4GMocrenFileSceneHandler::AddPrimitive(), and G4GMocrenFileSceneHandler::EndSavingGdd().

24  {
25  return *this = m1 * (*this);
26 }
Hep3Vector CLHEP::Hep3Vector::unit ( ) const
inline

Referenced by G4BinaryLightIonReaction::ApplyYourself(), G4RPGPiMinusInelastic::ApplyYourself(), G4RPGPiPlusInelastic::ApplyYourself(), G4RPGKMinusInelastic::ApplyYourself(), G4RPGProtonInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGSigmaPlusInelastic::ApplyYourself(), G4RPGXiMinusInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGOmegaMinusInelastic::ApplyYourself(), G4NeutronHPCaptureFS::ApplyYourself(), G4RPGKPlusInelastic::ApplyYourself(), G4RPGSigmaMinusInelastic::ApplyYourself(), G4RPGXiZeroInelastic::ApplyYourself(), G4LENDModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4MuonVDNuclearModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4ElectroVDNuclearModel::ApplyYourself(), G4TheoFSGenerator::ApplyYourself(), CexmcChargeExchangeProductionModel< OutputParticle >::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4BinaryCascade::ApplyYourself(), G4MuonMinusBoundDecay::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4INCLXXInterface::ApplyYourself(), CLHEP::HepRotation::axis(), G4NeutronHPInelasticBaseFS::BaseApply(), CLHEP::HepLorentzVector::boost(), G4GEMChannel::BreakUp(), G4PolyconeSide::CalculateExtent(), G4NucleiModel::choosePointAlongTraj(), G4TheRayTracer::CreateBitMap(), G4PionDecayMakeSpin::DaughterPolarization(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4IntraNucleiCascader::decayTrappedParticle(), G4SPSAngDistribution::DefineAngRefAxes(), G4Tet::DistanceToIn(), G4Tet::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4Cons::DistanceToOut(), G4MuMinusCaptureCascade::DoBoundMuonMinusDecay(), G4SingleScatter::DoCollisionStep(), G4LorentzConvertor::fillKinematics(), G4HadronicProcess::FillResult(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4PolyhedraSide::G4PolyhedraSide(), G4PolyPhiFace::G4PolyPhiFace(), G4QuadrangularFacet::G4QuadrangularFacet(), G4RandomDirection(), G4Tet::G4Tet(), G4TheRayTracer::G4TheRayTracer(), G4TriangularFacet::G4TriangularFacet(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4Navigator::GetGlobalExitNormal(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4Scatterer::GetTimeToInteraction(), G4TriangularFacet::Intersect(), G4LatticeLogical::Load_NMap(), G4CascadeInterface::makeDynamicParticle(), G4LatticeManager::MapKtoVDir(), Par01PiModel::ModelTrigger(), G4PolyconeSide::Normal(), G4SynchrotronRadiation::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4CascadeHistory::PrintEntry(), G4CascadParticle::propagateAlongThePath(), G4FastStep::ProposePrimaryTrackFinalKineticEnergyAndDirection(), G4FastStep::ProposePrimaryTrackFinalMomentumDirection(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), CLHEP::HepRotation::rectify(), G4QuasiElRatios::RelDecayIn2(), G4LorentzConvertor::rotate(), G4DeltaAngle::SampleDirection(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), MyKleinNishinaCompton::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4DNABornIonisationModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4PenelopeBremsstrahlungModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4PAIPhotonModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), G4DynamicParticle::Set4Momentum(), G4FastTrack::SetCurrentTrack(), G4RadioactiveDecay::SetDecayDirection(), G4TheRayTracer::SetLightDirection(), G4DynamicParticle::SetMomentum(), G4VisCommandsViewerSet::SetNewValue(), G4ParticleGun::SetParticleMomentum(), DMXParticleSource::SetParticleMomentumDirection(), G4ParticleGun::SetParticleMomentumDirection(), G4SPSAngDistribution::SetParticleMomentumDirection(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Tet::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Para::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4PAIPhotonModel::TestSecondaries(), G4TheRayTracer::Trace(), G4TheMTRayTracer::Trace(), G4RKPropagation::Transport(), G4KineticTrack::Update4Momentum(), and G4KineticTrack::UpdateTrackingMomentum().

double CLHEP::Hep3Vector::x ( ) const
inline

Referenced by G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4OTubs::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), G4eplusAnnihilation::AtRestDoIt(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4EvaporationChannel::BreakUp(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4CutTubs::CalculateExtent(), G4VTwistedFaceted::CalculateExtent(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4OTubs::CalculateExtent(), G4Ellipsoid::CalculateExtent(), G4Paraboloid::CalculateExtent(), G4Trd::CalculateExtent(), G4GenericTrap::CalculateExtent(), G4Para::CalculateExtent(), G4Tubs::CalculateExtent(), G4Cons::CalculateExtent(), G4Sphere::CalculateExtent(), G4Torus::CalculateExtent(), G4Trap::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4ReplicaNavigation::ComputeTransformation(), ExG4DetectorConstruction01::Construct(), ExG4DetectorConstruction02::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4GenericTrap::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), CexmcTrackPointsDigitizer::Digitize(), G4VTwistSurface::DistanceToBoundary(), G4USolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4OTubs::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Hype::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4USolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4OTubs::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Orb::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Trd::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Para::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), ExGflashEventAction::EndOfEventAction(), B5EventAction::EndOfEventAction(), CCalEndOfEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4SPSEneDistribution::EpnEnergyHisto(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), Analysis::FillDose(), Analysis::FillIncident(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4PolyPhiFace::G4PolyPhiFace(), G4PrimaryVertex::G4PrimaryVertex(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4ReactionDynamics::GenerateXandPt(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4SurfaceVoxelizer::GetCandidatesVoxelArray(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4CutTubs::GetMaxMinZ(), G4TessellatedSolid::GetMaxXExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4TessellatedSolid::GetMinXExtent(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPx(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4tgbGeometryDumper::GetSolidParams(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetXPositionInNucleus(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4USolid::Inside(), G4EllipticalTube::Inside(), G4CutTubs::Inside(), G4Orb::Inside(), G4OTubs::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4Hype::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4EllipticalCone::Inside(), G4Trd::Inside(), G4ExtrudedSolid::Inside(), G4Para::Inside(), G4TwistedTubs::Inside(), G4ReplicaNavigation::Inside(), G4Torus::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EllipticalTube::IntersectXY(), F04SimpleSolenoid::IsOutside(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4SurfaceVoxelizer::MinDistanceToBox(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GHEKinematicsVector::Norz(), operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4StokesVector::p1(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), G4StokesVector::PolDiv(), G4StokesVector::PolSqr(), G4StokesVector::PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), B5DriftChamberHit::Print(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), UltraPMTSD::ProcessHits(), PhantomSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ErrorFreeTrajState::PropagateError(), G4DNAChemistryManager::PushMolecule(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4GDMLReadSolids::ReflectedSolidRead(), G4PathFinder::ReLocate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4DNABornIonisationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GDMLWriteDefine::Scale_vectorWrite(), G4Scatterer::Scatter(), G4QGSParticipants::SelectInteractions(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4SPSRandomGenerator::SetEnergyBias(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), ExG4DetectorConstruction01Messenger::SetNewValue(), ExG4DetectorConstruction02Messenger::SetNewValue(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4SPSRandomGenerator::SetPhiBias(), G4PrimaryParticle::SetPolarization(), G4SPSRandomGenerator::SetPosPhiBias(), G4SPSRandomGenerator::SetPosThetaBias(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4SPSRandomGenerator::SetThetaBias(), G4RPGInelastic::SetUpChange(), G4SPSRandomGenerator::SetXBias(), G4SPSRandomGenerator::SetYBias(), G4SPSRandomGenerator::SetZBias(), G4RayShooter::Shoot(), G4EnclosingCylinder::ShouldMiss(), G4SteppingVerbose::ShowStep(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub3(), G4USolid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Orb::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4Trd::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Para::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), FCALSteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

double CLHEP::Hep3Vector::y ( ) const
inline

Referenced by G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddSolid(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4OTubs::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), G4eplusAnnihilation::AtRestDoIt(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4EvaporationChannel::BreakUp(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4CutTubs::CalculateExtent(), G4VTwistedFaceted::CalculateExtent(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4OTubs::CalculateExtent(), G4Ellipsoid::CalculateExtent(), G4Paraboloid::CalculateExtent(), G4Trd::CalculateExtent(), G4GenericTrap::CalculateExtent(), G4Para::CalculateExtent(), G4Tubs::CalculateExtent(), G4Cons::CalculateExtent(), G4Sphere::CalculateExtent(), G4Torus::CalculateExtent(), G4Trap::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4ReplicaNavigation::ComputeTransformation(), ExG4DetectorConstruction01::Construct(), ExG4DetectorConstruction02::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4GenericTrap::CreatePolyhedron(), G3Division::CreatePVReplica(), G4FastStep::CreateSecondaryTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), CexmcTrackPointsDigitizer::Digitize(), G4VTwistSurface::DistanceToBoundary(), G4USolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4OTubs::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Hype::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4USolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4OTubs::DistanceToOut(), G4Orb::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Trd::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Para::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), ExGflashEventAction::EndOfEventAction(), B5EventAction::EndOfEventAction(), CCalEndOfEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4SPSEneDistribution::EpnEnergyHisto(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), Analysis::FillDose(), Analysis::FillIncident(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4PolyPhiFace::G4PolyPhiFace(), G4PrimaryVertex::G4PrimaryVertex(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4ReactionDynamics::GenerateXandPt(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4SurfaceVoxelizer::GetCandidatesVoxelArray(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4CutTubs::GetMaxMinZ(), G4TessellatedSolid::GetMaxYExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4TessellatedSolid::GetMinYExtent(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPy(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4tgbGeometryDumper::GetSolidParams(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetYPositionInNucleus(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4USolid::Inside(), G4EllipticalTube::Inside(), G4CutTubs::Inside(), G4Orb::Inside(), G4OTubs::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4Hype::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4Trd::Inside(), G4EllipticalCone::Inside(), G4ExtrudedSolid::Inside(), G4Para::Inside(), G4TwistedTubs::Inside(), G4ReplicaNavigation::Inside(), G4Torus::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EllipticalTube::IntersectXY(), F04SimpleSolenoid::IsOutside(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4SurfaceVoxelizer::MinDistanceToBox(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GHEKinematicsVector::Norz(), operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4StokesVector::p2(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), G4StokesVector::PolDiv(), G4StokesVector::PolSqr(), G4StokesVector::PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), B5DriftChamberHit::Print(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), UltraPMTSD::ProcessHits(), PhantomSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4ErrorFreeTrajState::PropagateError(), G4DNAChemistryManager::PushMolecule(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4GDMLReadSolids::ReflectedSolidRead(), G4PathFinder::ReLocate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4DNABornIonisationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GDMLWriteDefine::Scale_vectorWrite(), G4Scatterer::Scatter(), G4QGSParticipants::SelectInteractions(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4SPSRandomGenerator::SetEnergyBias(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), ExG4DetectorConstruction01Messenger::SetNewValue(), ExG4DetectorConstruction02Messenger::SetNewValue(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4SPSRandomGenerator::SetPhiBias(), G4PrimaryParticle::SetPolarization(), G4SPSRandomGenerator::SetPosPhiBias(), G4SPSRandomGenerator::SetPosThetaBias(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4SPSRandomGenerator::SetThetaBias(), G4RPGInelastic::SetUpChange(), G4SPSRandomGenerator::SetXBias(), G4SPSRandomGenerator::SetYBias(), G4SPSRandomGenerator::SetZBias(), G4RayShooter::Shoot(), G4EnclosingCylinder::ShouldMiss(), G4SteppingVerbose::ShowStep(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub3(), G4USolid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Orb::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Para::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), CCalSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

double CLHEP::Hep3Vector::z ( ) const
inline

Referenced by G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), F04FocusSolenoid::AddFieldValue(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddSolid(), HistoManager::AddTargetStep(), G4MagHelicalStepper::AdvanceHelix(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4OTubs::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4eplusAnnihilation::AtRestDoIt(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4EvaporationChannel::BreakUp(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4CutTubs::CalculateExtent(), G4VTwistedFaceted::CalculateExtent(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4OTubs::CalculateExtent(), G4Ellipsoid::CalculateExtent(), G4Paraboloid::CalculateExtent(), G4Trd::CalculateExtent(), G4GenericTrap::CalculateExtent(), G4Para::CalculateExtent(), G4Tubs::CalculateExtent(), G4Cons::CalculateExtent(), G4Sphere::CalculateExtent(), G4Torus::CalculateExtent(), G4Trap::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedComptonModel::ComputeCrossSectionPerAtom(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationParaZ::ComputeTransformation(), ExG4DetectorConstruction01::Construct(), ExG4DetectorConstruction02::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4PolyPhiFace::Distance(), G4PolyconeSide::DistanceAway(), G4VTwistSurface::DistanceToBoundary(), G4USolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4OTubs::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Hype::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4USolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4OTubs::DistanceToOut(), G4Orb::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Trd::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Para::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), ExGflashEventAction::EndOfEventAction(), CCalEndOfEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), Analysis::FillDose(), G4StokesVector::FlipP3(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4Fancy3DNucleusHelperForSortInZ(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4PrimaryVertex::G4PrimaryVertex(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4VTwistSurface::GetBoundaryAtPZ(), G4SurfaceVoxelizer::GetCandidatesVoxelArray(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4TessellatedSolid::GetMaxZExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4TessellatedSolid::GetMinZExtent(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPz(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4TwistTubsHypeSide::GetRhoAtPZ(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4tgbGeometryDumper::GetSolidParams(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetZPositionInNucleus(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4FTFModel::Init(), G4PolarizedPEEffectCrossSection::Initialize(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4USolid::Inside(), G4EllipticalTube::Inside(), G4Orb::Inside(), G4OTubs::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4Hype::Inside(), G4Paraboloid::Inside(), G4VTwistedFaceted::Inside(), G4GenericTrap::Inside(), G4PolyPhiFace::Inside(), G4Trd::Inside(), G4EllipticalCone::Inside(), G4ExtrudedSolid::Inside(), G4Para::Inside(), G4TwistedTubs::Inside(), G4Torus::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4PolyPhiFace::Intersect(), G4Hype::IntersectHype(), F04SimpleSolenoid::IsOutside(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSFlatSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSFlatSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4SurfaceVoxelizer::MinDistanceToBox(), G4EnclosingCylinder::MustBeOutside(), G4PolyPhiFace::Normal(), G4TessellatedSolid::Normal(), G4GHEKinematicsVector::Norz(), operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4StokesVector::p3(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), G4StokesVector::PolDiv(), G4StokesVector::PolSqr(), G4StokesVector::PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), F04TrackingAction::PreUserTrackingAction(), WLSTrackingAction::PreUserTrackingAction(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4CascadeHistory::PrintEntry(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), UltraPMTSD::ProcessHits(), PhantomSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ErrorFreeTrajState::PropagateError(), pseudoRapidity(), G4DNAChemistryManager::PushMolecule(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4GDMLReadSolids::ReflectedSolidRead(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4DNABornIonisationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GDMLWriteDefine::Scale_vectorWrite(), G4Scatterer::Scatter(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), ExG4DetectorConstruction01Messenger::SetNewValue(), ExG4DetectorConstruction02Messenger::SetNewValue(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4PrimaryParticle::SetPolarization(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4RPGInelastic::SetUpChange(), G4FTFParticipants::ShiftInteractionTime(), G4RayShooter::Shoot(), G4SteppingVerbose::ShowStep(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4AttCheck::Standard(), LXeSteppingVerbose::StepInfo(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4GHEKinematicsVector::Sub3(), G4USolid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Orb::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Para::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4PolarizedComptonCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), CCalSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().

Field Documentation

double CLHEP::Hep3Vector::dx
protected
double CLHEP::Hep3Vector::dy
protected
double CLHEP::Hep3Vector::dz
protected
double CLHEP::Hep3Vector::tolerance = Hep3Vector::ToleranceTicks * 2.22045e-16
staticprotected

Definition at line 399 of file ThreeVector.h.

Referenced by setTolerance().


The documentation for this class was generated from the following files: