Geant4-11
Public Types | Public Member Functions | Static Public Member Functions | Static Public Attributes | Protected Member Functions | Protected Attributes | Static Protected Attributes | Private Attributes
G4StokesVector Class Reference

#include <G4StokesVector.hh>

Inheritance diagram for G4StokesVector:
CLHEP::Hep3Vector

Public Types

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

Public Member Functions

double angle () const
 
double angle (const Hep3Vector &) const
 
double azimAngle (const Hep3Vector &v2) const
 
double azimAngle (const Hep3Vector &v2, const Hep3Vector &ref) const
 
double beta () const
 
double coLinearRapidity () const
 
int compare (const Hep3Vector &v) const
 
double cos2Theta () const
 
double cos2Theta (const Hep3Vector &v2) const
 
double cosTheta () const
 
double cosTheta (const Hep3Vector &v2) const
 
Hep3Vector cross (const Hep3Vector &) const
 
double deltaPhi (const Hep3Vector &v2) const
 
double deltaR (const Hep3Vector &v) const
 
void DiceP1 ()
 
void DiceP2 ()
 
void DiceP3 ()
 
void DiceUniform ()
 
double diff2 (const Hep3Vector &v) const
 
double dot (const Hep3Vector &) const
 
double eta () const
 
double eta (const Hep3Vector &v2) const
 
void FlipP3 ()
 
 G4StokesVector ()
 
 G4StokesVector (const G4ThreeVector &v)
 
double gamma () const
 
G4double GetBeta ()
 
double getEta () const
 
double getPhi () const
 
double getR () const
 
double getRho () const
 
double getTheta () const
 
double getX () const
 
double getY () const
 
double getZ () const
 
double howNear (const Hep3Vector &v) const
 
double howOrthogonal (const Hep3Vector &v) const
 
double howParallel (const Hep3Vector &v) const
 
void InvRotateAz (G4ThreeVector nInteractionFrame, G4ThreeVector particleDirection)
 
bool isNear (const Hep3Vector &, double epsilon=tolerance) const
 
bool isOrthogonal (const Hep3Vector &v, double epsilon=tolerance) const
 
bool isParallel (const Hep3Vector &v, double epsilon=tolerance) const
 
G4bool IsZero () const
 
double mag () const
 
double mag2 () const
 
bool operator!= (const Hep3Vector &) const
 
double & operator() (int)
 
double operator() (int) const
 
Hep3Vectoroperator*= (const HepRotation &)
 
Hep3Vectoroperator*= (double)
 
Hep3Vectoroperator+= (const Hep3Vector &)
 
Hep3Vector operator- () const
 
Hep3Vectoroperator-= (const Hep3Vector &)
 
Hep3Vectoroperator/= (double)
 
bool operator< (const Hep3Vector &v) const
 
bool operator<= (const Hep3Vector &v) const
 
bool operator== (const Hep3Vector &) const
 
bool operator> (const Hep3Vector &v) const
 
bool operator>= (const Hep3Vector &v) const
 
double & operator[] (int)
 
double operator[] (int) const
 
Hep3Vector orthogonal () const
 
G4double p1 () const
 
G4double p2 () const
 
G4double p3 () const
 
double perp () const
 
double perp (const Hep3Vector &) const
 
double perp2 () const
 
double perp2 (const Hep3Vector &) const
 
Hep3Vector perpPart () const
 
Hep3Vector perpPart (const Hep3Vector &v2) const
 
double phi () const
 
double polarAngle (const Hep3Vector &v2) const
 
double polarAngle (const Hep3Vector &v2, const Hep3Vector &ref) const
 
G4ThreeVector PolDiv (const G4StokesVector &)
 
G4ThreeVector PolError (const G4StokesVector &sum2, long n)
 
G4ThreeVector PolSqr () const
 
G4ThreeVector PolSqrt () const
 
Hep3Vector project () const
 
Hep3Vector project (const Hep3Vector &v2) const
 
double pseudoRapidity () const
 
double r () const
 
double rapidity () const
 
double rapidity (const Hep3Vector &v2) const
 
double rho () const
 
Hep3Vectorrotate (const Hep3Vector &axis, double delta)
 
Hep3Vectorrotate (const HepAxisAngle &ax)
 
Hep3Vectorrotate (const HepEulerAngles &e)
 
Hep3Vectorrotate (double phi, double theta, double psi)
 
Hep3Vectorrotate (double, const Hep3Vector &)
 
void RotateAz (G4double cosphi, G4double sinphi)
 
void RotateAz (G4ThreeVector nInteractionFrame, G4ThreeVector particleDirection)
 
Hep3VectorrotateUz (const Hep3Vector &)
 
Hep3VectorrotateX (double)
 
Hep3VectorrotateY (double)
 
Hep3VectorrotateZ (double)
 
void set (double x, double y, double z)
 
void setCylEta (double p)
 
void setCylTheta (double)
 
void setEta (double p)
 
void setMag (double)
 
void setPerp (double)
 
void setPhi (double)
 
void SetPhoton ()
 
void setR (double s)
 
void setREtaPhi (double r, double eta, double phi)
 
void setRho (double s)
 
void setRhoPhiEta (double rho, double phi, double eta)
 
void setRhoPhiTheta (double rho, double phi, double theta)
 
void setRhoPhiZ (double rho, double phi, double z)
 
void setRThetaPhi (double r, double theta, double phi)
 
void setTheta (double)
 
void setX (double)
 
void setY (double)
 
void setZ (double)
 
double theta () const
 
double theta (const Hep3Vector &v2) const
 
Hep3Vectortransform (const HepRotation &)
 
G4double Transverse () const
 
Hep3Vector unit () const
 
double x () const
 
double y () const
 
double z () const
 
 ~G4StokesVector ()=default
 

Static Public Member Functions

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

Static Public Attributes

static const G4StokesVector M1
 
static const G4StokesVector M2
 
static const G4StokesVector M3
 
static const G4StokesVector P1
 
static const G4StokesVector P2
 
static const G4StokesVector P3
 
static const G4StokesVector ZERO
 

Protected Member Functions

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

Protected Attributes

double data [3]
 

Static Protected Attributes

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

Private Attributes

G4bool fIsPhoton
 

Detailed Description

Definition at line 45 of file G4StokesVector.hh.

Member Enumeration Documentation

◆ anonymous enum

anonymous enum
inherited
Enumerator
NUM_COORDINATES 
SIZE 

Definition at line 42 of file ThreeVector.h.

◆ anonymous enum

anonymous enum
inherited
Enumerator
ToleranceTicks 

Definition at line 295 of file ThreeVector.h.

295{ ToleranceTicks = 100 };

Constructor & Destructor Documentation

◆ G4StokesVector() [1/2]

G4StokesVector::G4StokesVector ( )

Definition at line 55 of file G4StokesVector.cc.

57 , fIsPhoton(false)
58{}
CLHEP::Hep3Vector G4ThreeVector

Referenced by PolError().

◆ G4StokesVector() [2/2]

G4StokesVector::G4StokesVector ( const G4ThreeVector v)
explicit

Definition at line 60 of file G4StokesVector.cc.

61 : G4ThreeVector(v)
62 , fIsPhoton(false)
63{}

◆ ~G4StokesVector()

G4StokesVector::~G4StokesVector ( )
default

Member Function Documentation

◆ angle() [1/2]

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

◆ angle() [2/2]

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

◆ azimAngle() [1/2]

double CLHEP::Hep3Vector::azimAngle ( const Hep3Vector v2) const
inherited

◆ azimAngle() [2/2]

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

Definition at line 36 of file SpaceVectorD.cc.

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

References CLHEP::Hep3Vector::angle(), CLHEP::Hep3Vector::cross(), CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag2(), and CLHEP::Hep3Vector::perpPart().

◆ beta()

double CLHEP::Hep3Vector::beta ( ) const
inherited

Definition at line 26 of file SpaceVectorP.cc.

26 {
27 double b = std::sqrt(mag2());
28// if (b >= 1) {
29// std::cerr << "Hep3Vector::beta() - "
30// << "Beta taken for Hep3Vector of at least unit length" << std::endl;
31// }
32 return b;
33}
double mag2() const

References CLHEP::Hep3Vector::mag2().

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

◆ coLinearRapidity()

double CLHEP::Hep3Vector::coLinearRapidity ( ) const
inherited

Definition at line 65 of file SpaceVectorP.cc.

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

References CLHEP::Hep3Vector::beta().

◆ compare()

int CLHEP::Hep3Vector::compare ( const Hep3Vector v) const
inherited

Definition at line 118 of file SpaceVector.cc.

118 {
119 if ( z() > v.z() ) {
120 return 1;
121 } else if ( z() < v.z() ) {
122 return -1;
123 } else if ( y() > v.y() ) {
124 return 1;
125 } else if ( y() < v.y() ) {
126 return -1;
127 } else if ( x() > v.x() ) {
128 return 1;
129 } else if ( x() < v.x() ) {
130 return -1;
131 } else {
132 return 0;
133 }
134} /* Compare */
double z() const
double x() const
double y() const

References CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

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

◆ cos2Theta() [1/2]

double CLHEP::Hep3Vector::cos2Theta ( ) const
inlineinherited

◆ cos2Theta() [2/2]

double CLHEP::Hep3Vector::cos2Theta ( const Hep3Vector v2) const
inherited

Definition at line 164 of file ThreeVector.cc.

164 {
165 double arg;
166 double ptot2 = mag2();
167 double qtot2 = q.mag2();
168 if ( ptot2 == 0 || qtot2 == 0 ) {
169 arg = 1.0;
170 }else{
171 double pdq = dot(q);
172 arg = (pdq/ptot2) * (pdq/qtot2);
173 // More naive methods overflow on vectors which can be squared
174 // but can't be raised to the 4th power.
175 if(arg > 1.0) arg = 1.0;
176 }
177 return arg;
178}

References CLHEP::Hep3Vector::dot(), and CLHEP::Hep3Vector::mag2().

◆ cosTheta() [1/2]

double CLHEP::Hep3Vector::cosTheta ( ) const
inlineinherited

◆ cosTheta() [2/2]

double CLHEP::Hep3Vector::cosTheta ( const Hep3Vector v2) const
inherited

Definition at line 151 of file ThreeVector.cc.

151 {
152 double arg;
153 double ptot2 = mag2()*q.mag2();
154 if(ptot2 <= 0) {
155 arg = 0.0;
156 }else{
157 arg = dot(q)/std::sqrt(ptot2);
158 if(arg > 1.0) arg = 1.0;
159 if(arg < -1.0) arg = -1.0;
160 }
161 return arg;
162}

References CLHEP::Hep3Vector::dot(), and CLHEP::Hep3Vector::mag2().

◆ cross()

Hep3Vector CLHEP::Hep3Vector::cross ( const Hep3Vector ) const
inlineinherited

Referenced by G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), CLHEP::Hep3Vector::azimAngle(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4PolyconeSide::CalculateExtent(), G4OpBoundaryProcess::CalculateReflectivity(), GFlashShowerModel::CheckContainment(), G4EmBiasingManager::CheckDirection(), G4NucleiModel::choosePointAlongTraj(), G4tgbVolume::ConstructG4PhysVol(), G4Tet::CreatePolyhedron(), G4SPSAngDistribution::DefineAngRefAxes(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricLUT(), G4OpBoundaryProcess::DielectricLUTDAVIS(), G4OpBoundaryProcess::DielectricMetal(), GFlashShowerModel::ElectronDoIt(), G4gsrotm(), G4PlaneVectorRand(), G4PolyhedraSide::G4PolyhedraSide(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4TriangularFacet::G4TriangularFacet(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4SPSPosDistribution::GenerateRotationMatrices(), G4PrimaryTransformer::GenerateSingleTrack(), G4PolarizationHelper::GetFrame(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TwistTubsSide::GetNormal(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4Para::GetPointOnSurface(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4BinaryCascade::GetSpherePoint(), G4Para::GetSurfaceArea(), CLHEP::Hep3Vector::howOrthogonal(), CLHEP::Hep3Vector::howParallel(), G4TriangularFacet::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), InvRotateAz(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4Para::MakePlanes(), G4GenericTrap::NormalToPlane(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4PolyconeSide::PointOnCone(), G4MicroElecSurface::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4OpWLS2::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4QuasiElRatios::RelDecayIn2(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), RotateAz(), G4StatMFChannel::RotateMomentum(), G4DNAChampionElasticModel::SampleSecondaries(), G4DNAELSEPAElasticModel::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MicroElecElasticModel_new::SampleSecondaries(), G4MicroElecLOPhononModel::SampleSecondaries(), G4PolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedPhotoElectricModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4DNAPTBElasticModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), CLHEP::HepRotation::setArbitrarily(), CLHEP::HepRotation::setCols(), G4ErrorSurfaceTrajParam::SetParameters(), G4GenericTrap::SurfaceNormal(), G4PolyhedraSide::SurfaceTriangle(), G4PolyPhiFace::SurfaceTriangle(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), and G4PolarizationHelper::TestPolarizationTransformations().

◆ deltaPhi()

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

Definition at line 135 of file ThreeVector.cc.

135 {
136 double dphi = v2.getPhi() - getPhi();
137 if ( dphi > CLHEP::pi ) {
138 dphi -= CLHEP::twopi;
139 } else if ( dphi <= -CLHEP::pi ) {
140 dphi += CLHEP::twopi;
141 }
142 return dphi;
143} /* deltaPhi */
double getPhi() const
static constexpr double twopi
Definition: SystemOfUnits.h:56
static constexpr double pi
Definition: SystemOfUnits.h:55

References CLHEP::Hep3Vector::getPhi(), CLHEP::pi, and CLHEP::twopi.

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

◆ deltaR()

double CLHEP::Hep3Vector::deltaR ( const Hep3Vector v) const
inherited

Definition at line 145 of file ThreeVector.cc.

145 {
146 double a = eta() - v.eta();
147 double b = deltaPhi(v);
148 return std::sqrt ( a*a + b*b );
149} /* deltaR */
double eta() const
double deltaPhi(const Hep3Vector &v2) const
Definition: ThreeVector.cc:135

References CLHEP::Hep3Vector::deltaPhi(), and CLHEP::Hep3Vector::eta().

◆ DiceP1()

void G4StokesVector::DiceP1 ( )

Definition at line 171 of file G4StokesVector.cc.

172{
173 if(G4UniformRand() > 0.5)
174 setX(1.);
175 else
176 setX(-1.);
177 setY(0.);
178 setZ(0.);
179}
#define G4UniformRand()
Definition: Randomize.hh:52
void setY(double)
void setZ(double)
void setX(double)

References G4UniformRand, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ DiceP2()

void G4StokesVector::DiceP2 ( )

Definition at line 181 of file G4StokesVector.cc.

182{
183 setX(0.);
184 if(G4UniformRand() > 0.5)
185 setY(1.);
186 else
187 setY(-1.);
188 setZ(0.);
189}

References G4UniformRand, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ DiceP3()

void G4StokesVector::DiceP3 ( )

Definition at line 191 of file G4StokesVector.cc.

192{
193 setX(0.);
194 setY(0.);
195 if(G4UniformRand() > 0.5)
196 setZ(1.);
197 else
198 setZ(-1.);
199}

References G4UniformRand, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ DiceUniform()

void G4StokesVector::DiceUniform ( )

Definition at line 161 of file G4StokesVector.cc.

162{
163 G4double costheta = 2. * G4UniformRand() - 1.;
164 G4double sintheta = std::sqrt(1. - costheta * costheta);
165 G4double aphi = 2. * CLHEP::pi * G4UniformRand();
166 setX(std::sin(aphi) * sintheta);
167 setY(std::cos(aphi) * sintheta);
168 setZ(costheta);
169}
double G4double
Definition: G4Types.hh:83

References G4UniformRand, CLHEP::pi, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ diff2()

double CLHEP::Hep3Vector::diff2 ( const Hep3Vector v) const
inlineinherited

◆ dot()

double CLHEP::Hep3Vector::dot ( const Hep3Vector ) const
inlineinherited

Referenced by G4VIntersectionLocator::AdjustmentOfFoundIntersection(), G4MagHelicalStepper::AdvanceHelix(), G4Tet::ApproxSurfaceNormal(), CLHEP::Hep3Vector::azimAngle(), CLHEP::HepLorentzVector::boost(), G4TessellatedSolid::CheckStructure(), G4GeomTools::ClosestPointOnTriangle(), G4ParameterisedNavigation::ComputeStep(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), CLHEP::Hep3Vector::cos2Theta(), CLHEP::Hep3Vector::cosTheta(), G4Tet::CreatePolyhedron(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4PolyhedraSide::Distance(), G4PolyPhiFace::Distance(), G4QuadrangularFacet::Distance(), G4PolyhedraSide::DistanceAway(), G4Cons::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Orb::DistanceToIn(), G4Tet::DistanceToIn(), G4PolyhedraSide::DistanceToOneSide(), G4Cons::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Orb::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Tet::DistanceToOut(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), G4VSolid::EstimateSurfaceArea(), CLHEP::Hep3Vector::eta(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), G4QuadrangularFacet::Extent(), G4TriangularFacet::Extent(), G4LorentzConvertor::fillKinematics(), G4PolyhedraSide::G4PolyhedraSide(), G4TriangularFacet::G4TriangularFacet(), G4TessellatedSolid::GetCubicVolume(), G4ITMultiNavigator::GetGlobalExitNormal(), G4MultiNavigator::GetGlobalExitNormal(), G4CascadParticle::getPathToTheNextZone(), G4LivermorePolarizedComptonModel::GetPerpendicularPolarization(), G4LivermorePolarizedGammaConversionModel::GetPerpendicularPolarization(), G4LowEPPolarizedComptonModel::GetPerpendicularPolarization(), G4ClippablePolygon::GetPlanerExtent(), G4CutTubs::GetPointOnSurface(), G4RKPropagation::GetSphereIntersectionTimes(), CLHEP::Hep3Vector::howNear(), CLHEP::HepLorentzVector::howNear(), CLHEP::HepLorentzVector::howNearCM(), CLHEP::Hep3Vector::howOrthogonal(), CLHEP::Hep3Vector::howParallel(), G4Tet::Initialize(), G4NucleiModel::initializeCascad(), G4Tet::Inside(), G4PolyPhiFace::Inside(), G4TessellatedSolid::InsideNoVoxels(), G4TessellatedSolid::InsideVoxels(), G4TriangularFacet::Intersect(), G4PolyhedraSide::Intersect(), G4PolyPhiFace::Intersect(), G4PolyconeSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), G4VFacet::IsInside(), CLHEP::Hep3Vector::isNear(), CLHEP::HepLorentzVector::isNear(), CLHEP::HepLorentzVector::isNearCM(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), CLHEP::HepLorentzVector::minus(), G4PolyPhiFace::Normal(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), CLHEP::HepLorentzVector::plus(), G4PolyconeSide::PointOnCone(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4MagInt_Driver::PrintStatus(), G4OldMagIntDriver::PrintStatus(), G4DriverReporter::PrintStatus(), CLHEP::Hep3Vector::project(), CLHEP::HepLorentzVector::rapidity(), CLHEP::Hep3Vector::rapidity(), G4VIntersectionLocator::ReportTrialStep(), G4NavigationLogger::ReportVolumeAndIntersection(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), G4BetheHeitler5DModel::SampleSecondaries(), CLHEP::HepRotation::set(), CLHEP::HepRotation::setCols(), G4ErrorFreeTrajParam::SetParameters(), and G4ErrorSurfaceTrajParam::SetParameters().

◆ eta() [1/2]

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

◆ eta() [2/2]

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

Definition at line 113 of file SpaceVectorP.cc.

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

References CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::getR(), CLHEP::Hep3Vector::mag(), and CLHEP::Hep3Vector::negativeInfinity().

◆ FlipP3()

void G4StokesVector::FlipP3 ( )

Definition at line 201 of file G4StokesVector.cc.

201{ setZ(-z()); }

References CLHEP::Hep3Vector::setZ(), and CLHEP::Hep3Vector::z().

◆ gamma()

double CLHEP::Hep3Vector::gamma ( ) const
inherited

Definition at line 35 of file SpaceVectorP.cc.

35 {
36 double bbeta = std::sqrt(mag2());
37// if (bbeta == 1) {
38// std::cerr << "Hep3Vector::gamma() - "
39// << "Gamma taken for Hep3Vector of unit magnitude -- infinite result"
40// << std::endl;
41// }
42// if (bbeta > 1) {
43// std::cerr << "Hep3Vector::gamma() - "
44// << "Gamma taken for Hep3Vector of more than unit magnitude -- \n"
45// << "the sqrt function would return NAN" << std::endl;
46// }
47 return 1/std::sqrt(1-bbeta*bbeta);
48}

References CLHEP::Hep3Vector::mag2().

Referenced by G4QMDReaction::calcOffSetOfCollision().

◆ GetBeta()

G4double G4StokesVector::GetBeta ( )

Definition at line 151 of file G4StokesVector.cc.

152{
153 G4double bet = getPhi();
154 if(fIsPhoton)
155 {
156 bet *= 0.5;
157 }
158 return bet;
159}

References fIsPhoton, and CLHEP::Hep3Vector::getPhi().

◆ getEta()

double CLHEP::Hep3Vector::getEta ( ) const
inherited

◆ getPhi()

double CLHEP::Hep3Vector::getPhi ( ) const
inlineinherited

◆ getR()

double CLHEP::Hep3Vector::getR ( ) const
inlineinherited

◆ getRho()

double CLHEP::Hep3Vector::getRho ( ) const
inlineinherited

◆ getTheta()

double CLHEP::Hep3Vector::getTheta ( ) const
inlineinherited

◆ getTolerance()

static double CLHEP::Hep3Vector::getTolerance ( )
inlinestaticinherited

◆ getX()

double CLHEP::Hep3Vector::getX ( ) const
inlineinherited

◆ getY()

double CLHEP::Hep3Vector::getY ( ) const
inlineinherited

◆ getZ()

double CLHEP::Hep3Vector::getZ ( ) const
inlineinherited

◆ howNear()

double CLHEP::Hep3Vector::howNear ( const Hep3Vector v) const
inherited

Definition at line 122 of file ThreeVector.cc.

122 {
123 // | V1 - V2 | **2 / V1 dot V2, up to 1
124 double d = (*this - v).mag2();
125 double vdv = dot(v);
126 if ( (vdv > 0) && (d < vdv) ) {
127 return std::sqrt (d/vdv);
128 } else if ( (vdv == 0) && (d == 0) ) {
129 return 0;
130 } else {
131 return 1;
132 }
133} /* howNear */

References CLHEP::Hep3Vector::dot(), and CLHEP::Hep3Vector::mag2().

◆ howOrthogonal()

double CLHEP::Hep3Vector::howOrthogonal ( const Hep3Vector v) const
inherited

Definition at line 215 of file SpaceVector.cc.

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

References CLHEP::Hep3Vector::cross(), CLHEP::Hep3Vector::dot(), and CLHEP::Hep3Vector::mag().

Referenced by G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), and G4BetheHeitler5DModel::SampleSecondaries().

◆ howParallel()

double CLHEP::Hep3Vector::howParallel ( const Hep3Vector v) const
inherited

Definition at line 164 of file SpaceVector.cc.

164 {
165 // | V1 x V2 | / | V1 dot V2 |
166 double v1v2 = std::fabs(dot(v));
167 if ( v1v2 == 0 ) {
168 // Zero is parallel to no other vector except for zero.
169 return ( (mag2() == 0) && (v.mag2() == 0) ) ? 0 : 1;
170 }
171 Hep3Vector v1Xv2 ( cross(v) );
172 double abscross = v1Xv2.mag();
173 if ( abscross >= v1v2 ) {
174 return 1;
175 } else {
176 return abscross/v1v2;
177 }
178} /* howParallel() */

References CLHEP::Hep3Vector::cross(), CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag(), and CLHEP::Hep3Vector::mag2().

◆ InvRotateAz()

void G4StokesVector::InvRotateAz ( G4ThreeVector  nInteractionFrame,
G4ThreeVector  particleDirection 
)

Definition at line 100 of file G4StokesVector.cc.

102{
103 // note if incoming particle is on z-axis,
104 // we might encounter some nummerical problems, since
105 // nInteratonFrame and yParticleFrame are actually (almost) the same momentum
106 // and the normalization is only good to 10^-12 !
107
108 G4ThreeVector yParticleFrame =
110 G4double cosphi = yParticleFrame * nInteractionFrame;
111
112 if(cosphi > 1. + 1.e-8 || cosphi < -1. - 1.e-8)
113 {
115 ed << " warning G4StokesVector::RotateAz cosphi>1 or cosphi<-1\n";
116 G4Exception("G4StokesVector::InvRotateAz", "pol030", JustWarning, ed);
117 }
118 if(cosphi > 1.)
119 cosphi = 1.;
120 else if(cosphi < -1.)
121 cosphi = -1.;
122
123 // check sign once more!
124 G4double hel =
125 (yParticleFrame.cross(nInteractionFrame) * particleDirection) > 0. ? 1.
126 : -1.;
127 G4double sinphi = hel * std::sqrt(std::fabs(1. - cosphi * cosphi));
128 RotateAz(cosphi, -sinphi);
129}
@ JustWarning
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
Definition: G4Exception.cc:35
std::ostringstream G4ExceptionDescription
Definition: G4Exception.hh:40
static G4ThreeVector GetParticleFrameY(const G4ThreeVector &)
void RotateAz(G4ThreeVector nInteractionFrame, G4ThreeVector particleDirection)

References CLHEP::Hep3Vector::cross(), G4Exception(), G4PolarizationHelper::GetParticleFrameY(), JustWarning, and RotateAz().

Referenced by G4PolarizedAnnihilationModel::SampleSecondaries(), G4PolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), and G4PolarizedPhotoElectricModel::SampleSecondaries().

◆ isNear()

bool CLHEP::Hep3Vector::isNear ( const Hep3Vector v,
double  epsilon = tolerance 
) const
inherited

Definition at line 117 of file ThreeVector.cc.

117 {
118 double limit = dot(v)*epsilon*epsilon;
119 return ( (*this - v).mag2() <= limit );
120} /* isNear() */
G4double epsilon(G4double density, G4double temperature)

References CLHEP::Hep3Vector::dot(), epsilon(), and CLHEP::Hep3Vector::mag2().

◆ isOrthogonal()

bool CLHEP::Hep3Vector::isOrthogonal ( const Hep3Vector v,
double  epsilon = tolerance 
) const
inherited

Definition at line 233 of file SpaceVector.cc.

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

References CLHEP::Hep3Vector::cross(), CLHEP::Hep3Vector::dot(), epsilon(), CLHEP::Hep3Vector::mag2(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

Referenced by G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), and G4LowEPPolarizedComptonModel::SampleSecondaries().

◆ isParallel()

bool CLHEP::Hep3Vector::isParallel ( const Hep3Vector v,
double  epsilon = tolerance 
) const
inherited

Definition at line 180 of file SpaceVector.cc.

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

References CLHEP::Hep3Vector::cross(), CLHEP::Hep3Vector::dot(), epsilon(), CLHEP::Hep3Vector::mag2(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ IsZero()

G4bool G4StokesVector::IsZero ( ) const

◆ mag()

double CLHEP::Hep3Vector::mag ( ) const
inlineinherited

Referenced by G4ParticleHPFinalState::adjust_final_state(), G4MagHelicalStepper::AdvanceHelix(), G4WilsonAbrasionModel::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4BinaryLightIonReaction::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4ParticleHPCaptureFS::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4ParticleHPInelasticBaseFS::BaseApply(), G4NucleiModel::boundaryTransition(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4OpBoundaryProcess::CalculateReflectivity(), G4QMDCollision::CalKinematicsOfBinaryCollisions(), G4BinaryCascade::Capture(), G4EmBiasingManager::CheckDirection(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4FastStep::CheckIt(), G4ParticleChange::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4PVPlacement::CheckOverlaps(), G4NucleiModel::choosePointAlongTraj(), CLHEP::HepLorentzVector::coLinearRapidity(), G4DNABrownianTransportation::ComputeStep(), G4BinaryCascade::CorrectFinalPandE(), G4SmoothTrajectory::CreateAttValues(), G4Trajectory::CreateAttValues(), G4VPhononProcess::CreateSecondary(), G4DiffractiveExcitation::CreateStrings(), G4AdjointCrossSurfChecker::CrossingASphere(), G4DNAMolecularDissociation::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4AblaInterface::DeExcite(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricLUT(), G4QuadrangularFacet::Distance(), G4TriangularFacet::Distance(), G4Orb::DistanceToIn(), G4ScaledSolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4ScaledSolid::DistanceToOut(), G4Orb::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4TwistTubsHypeSide::DistanceToSurface(), G4PathFinder::DoNextCurvedStep(), G4MultiLevelLocator::EstimateIntersectionPoint(), CLHEP::Hep3Vector::eta(), G4BinaryCascade::FillVoidNucleusProducts(), G4NeutrinoNucleusModel::FinalMomentum(), G4StatMFChannel::FragmentsMomenta(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4FissionProductYieldDist::G4GetFission(), G4PolyhedraSide::G4PolyhedraSide(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4tgbPlaceParamLinear::G4tgbPlaceParamLinear(), G4tgbPlaceParamSquare::G4tgbPlaceParamSquare(), G4TriangularFacet::G4TriangularFacet(), G4CRCoalescence::GenerateDeuterons(), G4NucleiModel::generateInteractionPartners(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4RKFieldIntegrator::GetAntiprotonPotential(), G4Nucleus::GetBiasedThermalNucleus(), G4ParticleHPCaptureData::GetCrossSection(), G4ParticleHPElasticData::GetCrossSection(), G4ParticleHPFissionData::GetCrossSection(), G4ParticleHPInelasticData::GetCrossSection(), G4NuclearFermiDensity::GetDeriv(), G4NuclearShellModelDensity::GetDeriv(), G4ErrorCylSurfaceTarget::GetDistanceFromPoint(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4AntiProtonField::GetField(), G4KaonMinusField::GetField(), G4KaonPlusField::GetField(), G4KaonZeroField::GetField(), G4NeutronField::GetField(), G4PionMinusField::GetField(), G4PionPlusField::GetField(), G4PionZeroField::GetField(), G4ProtonField::GetField(), G4SigmaMinusField::GetField(), G4SigmaPlusField::GetField(), G4SigmaZeroField::GetField(), G4BinaryCascade::GetFinalNucleusMomentum(), G4Navigator::GetGlobalExitNormal(), G4ITNavigator1::GetGlobalExitNormal(), G4ITNavigator2::GetGlobalExitNormal(), G4MicroElecSurface::GetIncidentAngle(), G4OpBoundaryProcess::GetIncidentAngle(), G4DiffuseElastic::GetInvCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetInvCoulombElasticXsc(), G4DiffuseElastic::GetInvElasticSumXsc(), G4NuclNuclDiffuseElastic::GetInvElasticSumXsc(), G4DiffuseElastic::GetInvElasticXsc(), G4NuclNuclDiffuseElastic::GetInvElasticXsc(), G4IonsShenCrossSection::GetIsoCrossSection(), G4RKFieldIntegrator::GetKaonPotential(), G4QGSParticipants::GetList(), G4VIntersectionLocator::GetLocalSurfaceNormal(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4FermiMomentum::GetMomentum(), G4RKFieldIntegrator::GetNeutronPotential(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4RKFieldIntegrator::GetPionPotential(), G4Trap::GetPointOnSurface(), G4RKFieldIntegrator::GetProtonPotential(), G4NuclearFermiDensity::GetRelativeDensity(), G4tgrUtils::GetRotationFromDirection(), G4Trap::GetSurfaceArea(), G4VIntersectionLocator::GetSurfaceNormal(), CLHEP::Hep3Vector::howOrthogonal(), CLHEP::Hep3Vector::howParallel(), G4Tet::Initialize(), G4NucleiModel::initializeCascad(), G4TwistTubsHypeSide::Inside(), G4BinaryLightIonReaction::Interact(), G4TriangularFacet::Intersect(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4DecayProducts::IsChecked(), G4GenericTrap::IsSegCrossingZ(), G4DNAIRT::MakeReaction(), G4DNAIRT_geometries::MakeReaction(), CLHEP::HepLorentzVector::minus(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), CLHEP::HepLorentzVector::plus(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), CLHEP::HepBoost::print(), G4BinaryCascade::PrintKTVector(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), G4IntraNucleiCascader::processSecondary(), G4BinaryCascade::Propagate(), G4ErrorFreeTrajState::PropagateError(), G4ErrorFreeTrajState::PropagateErrorIoni(), G4ErrorFreeTrajState::PropagateErrorMSC(), CLHEP::Hep3Vector::pseudoRapidity(), G4CRCoalescence::PushDeuteron(), CLHEP::Hep3Vector::rapidity(), CLHEP::HepBoost::rectify(), G4Fancy3DNucleus::ReduceSum(), G4VIntersectionLocator::ReEstimateEndpoint(), G4MicroElecSurface::Reflexion(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4PropagatorInField::ReportLoopingParticle(), G4TransportationLogger::ReportLoopingTrack(), G4PathFinder::ReportMove(), G4ITPathFinder::ReportMove(), G4CoupledTransportation::ReportMove(), G4VIntersectionLocator::ReportTrialStep(), G4LorentzConvertor::rotate(), CLHEP::Hep3Vector::rotate(), CLHEP::HepRotation::rotate(), RotateAz(), G4DiffuseElastic::SampleInvariantT(), G4DiffuseElasticV2::SampleInvariantT(), G4NuclNuclDiffuseElastic::SampleInvariantT(), G4AntiNuclElastic::SampleInvariantT(), G4TDNAOneStepThermalizationModel< MODEL >::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4PolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedPhotoElectricModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4DiffuseElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), CLHEP::HepBoost::set(), G4Fragment::SetAngularMomentum(), G4Trap::SetCachedValues(), G4ReactionProduct::SetDefinitionAndUpdateE(), CLHEP::Hep3Vector::setMag(), G4HadFinalState::SetMomentumChange(), G4ParticleGun::SetParticleMomentum(), G4QMDSystem::ShowParticipants(), G4StatMFChannel::SolveEqOfMotion(), G4BinaryCascade::StepParticlesOut(), G4HelixMixedStepper::Stepper(), G4Orb::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4PolarizationHelper::TestPolarizationTransformations(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4DNAMakeReaction::UpdatePositionForReaction(), G4ParticleChange::UpdateStepForAlongStep(), and G4ParticleChangeForTransport::UpdateStepForAlongStep().

◆ mag2()

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

Referenced by G4VMultipleScattering::AlongStepDoIt(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4WilsonAbrasionModel::ApplyYourself(), G4EMDissociation::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), CLHEP::Hep3Vector::azimAngle(), G4ParticleHPInelasticBaseFS::BaseApply(), CLHEP::HepLorentzVector::beta(), CLHEP::Hep3Vector::beta(), CLHEP::HepLorentzVector::boost(), G4KineticTrackVector::BoostBeam(), CLHEP::HepLorentzVector::boostVector(), G4StatMF::BreakItUp(), G4BinaryCascade::BuildTargetList(), G4NavigationLogger::CheckAndReportBadNormal(), G4FastStep::CheckIt(), G4ParticleChange::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4Fancy3DNucleus::ChooseFermiMomenta(), G4NucleiModel::choosePointAlongTraj(), G4Fancy3DNucleus::ChoosePositions(), G4GeomTools::ClosestPointOnSegment(), G4GeomTools::ClosestPointOnTriangle(), G4ParticleHPInelasticCompFS::CompositeApply(), G4PathFinder::ComputeStep(), G4ITPathFinder::ComputeStep(), G4BinaryCascade::CorrectFinalPandE(), CLHEP::Hep3Vector::cos2Theta(), CLHEP::Hep3Vector::cosTheta(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4BFieldIntegrationDriver::CurvatureRadius(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4BinaryCascade::DecayVoidNucleus(), G4QGSParticipants::DeterminePartonMomenta(), G4LineSection::Dist(), G4QuadrangularFacet::Distance(), G4TriangularFacet::Distance(), G4GeomTools::DistancePointSegment(), G4Orb::DistanceToIn(), G4Orb::DistanceToOut(), G4Fancy3DNucleus::DoLorentzContraction(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ElasticHNScattering::ElasticScattering(), G4ExcitedStringDecay::EnergyAndMomentumCorrector(), G4BinaryLightIonReaction::EnergyAndMomentumCorrector(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), G4QuarkExchange::ExciteParticipants(), G4SingleDiffractiveExcitation::ExciteParticipants(), G4QGSDiffractiveExcitation::ExciteParticipants(), G4DiffractiveExcitation::ExciteParticipants_doDiffraction(), G4DiffractiveExcitation::ExciteParticipants_doNonDiffraction(), G4RKPropagation::FieldTransport(), G4LorentzConvertor::fillKinematics(), G4VElasticCollision::FinalState(), G4VScatteringCollision::FinalState(), CLHEP::HepLorentzVector::findBoostToCM(), G4StatMFChannel::FragmentsMomenta(), G4ExcitedStringDecay::FragmentStrings(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4LineSection::G4LineSection(), G4QuadrangularFacet::G4QuadrangularFacet(), G4TriangularFacet::G4TriangularFacet(), CLHEP::HepLorentzVector::gamma(), CLHEP::Hep3Vector::gamma(), G4PrimaryTransformer::GenerateSingleTrack(), G4WilsonAbrasionModel::GetAbradedNucleons(), G4Nucleus::GetBiasedThermalNucleus(), G4OpBoundaryProcess::GetFacetNormal(), G4BinaryCascade::GetFinalNucleusMomentum(), G4MesonAbsorption::GetFinalState(), G4StatMFFragment::GetFragment(), G4ITMultiNavigator::GetGlobalExitNormal(), G4MultiNavigator::GetGlobalExitNormal(), G4Navigator::GetGlobalExitNormal(), G4ITNavigator1::GetGlobalExitNormal(), G4ITNavigator2::GetGlobalExitNormal(), G4VIntersectionLocator::GetGlobalSurfaceNormal(), G4Navigator::GetLocalExitNormal(), G4ITNavigator1::GetLocalExitNormal(), G4ITNavigator2::GetLocalExitNormal(), G4VIntersectionLocator::GetLocalSurfaceNormal(), G4CascadParticle::getPathToTheNextZone(), G4NuclearShellModelDensity::GetRelativeDensity(), G4FTFModel::GetResiduals(), G4QGSParticipants::GetResiduals(), G4RKPropagation::GetSphereIntersectionTimes(), G4VIntersectionLocator::GetSurfaceNormal(), G4Scatterer::GetTimeToInteraction(), CLHEP::Hep3Vector::howNear(), CLHEP::HepLorentzVector::howNearCM(), CLHEP::Hep3Vector::howParallel(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedGammaConversionXS::Initialize(), G4Orb::Inside(), CLHEP::Hep3Vector::isNear(), CLHEP::HepLorentzVector::isNearCM(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4PathFinder::Locate(), G4ITPathFinder::Locate(), G4GDMLWriteParamvol::ParametersWrite(), G4StatMFChannel::PlaceFragments(), G4DriverReporter::PrintStat_Aux(), G4MagInt_Driver::PrintStat_Aux(), G4OldMagIntDriver::PrintStat_Aux(), G4VLongitudinalStringDecay::ProduceOneHadron(), CLHEP::Hep3Vector::project(), G4GeneratorPrecompoundInterface::Propagate(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), G4MagInt_Driver::QuickAdvance(), G4OldMagIntDriver::QuickAdvance(), CLHEP::HepLorentzVector::rapidity(), CLHEP::HepBoost::rectify(), G4QuasiElRatios::RelDecayIn2(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4ITSafetyHelper::ReLocateWithinVolume(), G4MultiLevelLocator::ReportFieldValue(), G4VIntersectionLocator::ReportTrialStep(), CLHEP::HepRotation::rotateAxes(), G4StatMFChannel::RotateMomentum(), G4LundStringFragmentation::Sample4Momentum(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4QuasiElasticChannel::Scatter(), G4DynamicParticle::Set4Momentum(), CLHEP::HepRotation::setArbitrarily(), G4DynamicParticle::SetMomentum(), G4VisCommandsViewerSet::SetNewValue(), G4KineticTrack::SetTrackingMomentum(), G4StatMFChannel::SolveEqOfMotion(), G4LundStringFragmentation::SplitEandP(), G4QGSMFragmentation::SplitEandP(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4RKPropagation::Transport(), G4FieldTrackUpdator::Update(), G4KineticTrack::Update4Momentum(), and G4KineticTrack::UpdateTrackingMomentum().

◆ negativeInfinity()

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

Definition at line 279 of file SpaceVector.cc.

279 {
280 // A byte-order-independent way to return -Infinity
281 struct Dib {
282 union {
283 double d;
284 unsigned char i[8];
285 } u;
286 };
287 Dib negOne;
288 Dib posTwo;
289 negOne.u.d = -1.0;
290 posTwo.u.d = 2.0;
291 Dib value;
292 int k;
293 for (k=0; k<8; k++) {
294 value.u.i[k] = negOne.u.i[k] | posTwo.u.i[k];
295 }
296 return value.u.d;
297}

Referenced by CLHEP::Hep3Vector::eta().

◆ operator!=()

bool CLHEP::Hep3Vector::operator!= ( const Hep3Vector ) const
inlineinherited

◆ operator()() [1/2]

double & CLHEP::Hep3Vector::operator() ( int  )
inlineinherited

◆ operator()() [2/2]

double CLHEP::Hep3Vector::operator() ( int  ) const
inlineinherited

◆ operator*=() [1/2]

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

Definition at line 16 of file ThreeVectorR.cc.

16 {
17 return *this = m1 * (*this);
18}

◆ operator*=() [2/2]

Hep3Vector & CLHEP::Hep3Vector::operator*= ( double  )
inlineinherited

◆ operator+=()

Hep3Vector & CLHEP::Hep3Vector::operator+= ( const Hep3Vector )
inlineinherited

◆ operator-()

Hep3Vector CLHEP::Hep3Vector::operator- ( ) const
inlineinherited

◆ operator-=()

Hep3Vector & CLHEP::Hep3Vector::operator-= ( const Hep3Vector )
inlineinherited

◆ operator/=()

Hep3Vector & CLHEP::Hep3Vector::operator/= ( double  c)
inherited

Definition at line 307 of file ThreeVector.cc.

307 {
308// if (c == 0) {
309// std::cerr << "Hep3Vector::operator/ () - "
310// << "Attempt to do vector /= 0 -- "
311// << "division by zero would produce infinite or NAN components"
312// << std::endl;
313// }
314 *this *= 1.0/c;
315 return *this;
316}

◆ operator<()

bool CLHEP::Hep3Vector::operator< ( const Hep3Vector v) const
inherited

Definition at line 140 of file SpaceVector.cc.

140 {
141 return (compare(v) < 0);
142}
int compare(const Hep3Vector &v) const
Definition: SpaceVector.cc:118

References CLHEP::Hep3Vector::compare().

◆ operator<=()

bool CLHEP::Hep3Vector::operator<= ( const Hep3Vector v) const
inherited

Definition at line 146 of file SpaceVector.cc.

146 {
147 return (compare(v) <= 0);
148}

References CLHEP::Hep3Vector::compare().

◆ operator==()

bool CLHEP::Hep3Vector::operator== ( const Hep3Vector ) const
inlineinherited

◆ operator>()

bool CLHEP::Hep3Vector::operator> ( const Hep3Vector v) const
inherited

Definition at line 137 of file SpaceVector.cc.

137 {
138 return (compare(v) > 0);
139}

References CLHEP::Hep3Vector::compare().

◆ operator>=()

bool CLHEP::Hep3Vector::operator>= ( const Hep3Vector v) const
inherited

Definition at line 143 of file SpaceVector.cc.

143 {
144 return (compare(v) >= 0);
145}

References CLHEP::Hep3Vector::compare().

◆ operator[]() [1/2]

double & CLHEP::Hep3Vector::operator[] ( int  )
inlineinherited

◆ operator[]() [2/2]

double CLHEP::Hep3Vector::operator[] ( int  ) const
inlineinherited

◆ orthogonal()

Hep3Vector CLHEP::Hep3Vector::orthogonal ( ) const
inlineinherited

◆ p1()

G4double G4StokesVector::p1 ( ) const
inline

◆ p2()

G4double G4StokesVector::p2 ( ) const
inline

◆ p3()

G4double G4StokesVector::p3 ( ) const
inline

◆ perp() [1/2]

double CLHEP::Hep3Vector::perp ( ) const
inlineinherited

◆ perp() [2/2]

double CLHEP::Hep3Vector::perp ( const Hep3Vector ) const
inlineinherited

◆ perp2() [1/2]

double CLHEP::Hep3Vector::perp2 ( ) const
inlineinherited

◆ perp2() [2/2]

double CLHEP::Hep3Vector::perp2 ( const Hep3Vector ) const
inlineinherited

◆ perpPart() [1/2]

Hep3Vector CLHEP::Hep3Vector::perpPart ( ) const
inlineinherited

◆ perpPart() [2/2]

Hep3Vector CLHEP::Hep3Vector::perpPart ( const Hep3Vector v2) const
inlineinherited

◆ phi()

double CLHEP::Hep3Vector::phi ( ) const
inlineinherited

◆ polarAngle() [1/2]

double CLHEP::Hep3Vector::polarAngle ( const Hep3Vector v2) const
inherited

Definition at line 24 of file SpaceVectorD.cc.

24 {
25 return std::fabs(v2.getTheta() - getTheta());
26} /* polarAngle */
double getTheta() const

References CLHEP::Hep3Vector::getTheta().

Referenced by G4UCNBoundaryProcess::MRDiffRefl(), and G4UCNBoundaryProcess::MRDiffTrans().

◆ polarAngle() [2/2]

double CLHEP::Hep3Vector::polarAngle ( const Hep3Vector v2,
const Hep3Vector ref 
) const
inherited

Definition at line 28 of file SpaceVectorD.cc.

29 {
30 return std::fabs( v2.angle(ref) - angle(ref) );
31} /* polarAngle (v2, ref) */
double angle() const

References CLHEP::Hep3Vector::angle().

◆ PolDiv()

G4ThreeVector G4StokesVector::PolDiv ( const G4StokesVector b)

Definition at line 213 of file G4StokesVector.cc.

214{
215 return G4ThreeVector(b.x() != 0. ? x() / b.x() : 11111.,
216 b.y() != 0. ? y() / b.y() : 11111.,
217 b.z() != 0. ? z() / b.z() : 11111.);
218}

References CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ PolError()

G4ThreeVector G4StokesVector::PolError ( const G4StokesVector sum2,
long  n 
)

Definition at line 203 of file G4StokesVector.cc.

204{
205 // delta x = sqrt[ ( <x^2> - <x>^2 )/(n-1) ]
206 G4ThreeVector mean = (1. / n) * G4ThreeVector(*this);
207 G4ThreeVector polsqr = G4StokesVector(mean).PolSqr();
208 G4ThreeVector result =
209 G4StokesVector((1. / (n - 1.) * ((1. / n) * sum2 - polsqr))).PolSqrt();
210 return result;
211}

References G4StokesVector(), and CLHEP::detail::n.

◆ PolSqr()

G4ThreeVector G4StokesVector::PolSqr ( ) const
inline

Definition at line 60 of file G4StokesVector.hh.

61 {
62 return G4ThreeVector(x() * x(), y() * y(), z() * z());
63 }

References CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ PolSqrt()

G4ThreeVector G4StokesVector::PolSqrt ( ) const
inline

Definition at line 64 of file G4StokesVector.hh.

65 {
66 return G4ThreeVector(std::sqrt(x()), std::sqrt(y()), std::sqrt(z()));
67 }

References CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ project() [1/2]

Hep3Vector CLHEP::Hep3Vector::project ( ) const
inlineinherited

◆ project() [2/2]

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

Definition at line 85 of file SpaceVectorP.cc.

85 {
86 double mag2v2 = v2.mag2();
87 if (mag2v2 == 0) {
88 std::cerr << "Hep3Vector::project() - "
89 << "Attempt to take projection of vector against zero reference vector"
90 << std::endl;
91 return project();
92 }
93 return ( v2 * (dot(v2)/mag2v2) );
94}
Hep3Vector project() const

References CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag2(), and CLHEP::Hep3Vector::project().

◆ pseudoRapidity()

double CLHEP::Hep3Vector::pseudoRapidity ( ) const
inherited

Definition at line 55 of file ThreeVector.cc.

55 {
56 double m1 = mag();
57 if ( m1== 0 ) return 0.0;
58 if ( m1== z() ) return 1.0E72;
59 if ( m1== -z() ) return -1.0E72;
60 return 0.5*std::log( (m1+z())/(m1-z()) );
61}
double mag() const

References CLHEP::Hep3Vector::mag(), and CLHEP::Hep3Vector::z().

◆ r()

double CLHEP::Hep3Vector::r ( ) const
inlineinherited

◆ rapidity() [1/2]

double CLHEP::Hep3Vector::rapidity ( ) const
inherited

Definition at line 50 of file SpaceVectorP.cc.

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

References CLHEP::Hep3Vector::z().

◆ rapidity() [2/2]

double CLHEP::Hep3Vector::rapidity ( const Hep3Vector v2) const
inherited

Definition at line 96 of file SpaceVectorP.cc.

96 {
97 double vmag = v2.mag();
98 if ( vmag == 0 ) {
99 std::cerr << "Hep3Vector::rapidity() - "
100 << "Rapidity taken with respect to zero vector" << std::endl;
101 return 0;
102 }
103 double z1 = dot(v2)/vmag;
104// if (std::fabs(z1) >= 1) {
105// std::cerr << "Hep3Vector::rapidity() - "
106// << "Rapidity taken for too large a Hep3Vector "
107// << "-- would return infinity or NAN" << std::endl;
108// }
109 // Want inverse std::tanh(z):
110 return (.5 * std::log((1+z1)/(1-z1)) );
111}

References CLHEP::Hep3Vector::dot(), and CLHEP::Hep3Vector::mag().

◆ rho()

double CLHEP::Hep3Vector::rho ( ) const
inlineinherited

◆ rotate() [1/5]

Hep3Vector & CLHEP::Hep3Vector::rotate ( const Hep3Vector axis,
double  delta 
)
inherited

Definition at line 24 of file SpaceVectorR.cc.

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

References cd, CLHEP::Hep3Vector::getX(), CLHEP::Hep3Vector::getY(), CLHEP::Hep3Vector::getZ(), CLHEP::Hep3Vector::mag(), CLHEP::Hep3Vector::set(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ rotate() [2/5]

Hep3Vector & CLHEP::Hep3Vector::rotate ( const HepAxisAngle ax)
inherited

Definition at line 106 of file SpaceVectorR.cc.

106 {
107 return rotate( ax.getAxis(), ax.delta() );
108}
Hep3Vector & rotate(double, const Hep3Vector &)
Definition: ThreeVectorR.cc:24

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

◆ rotate() [3/5]

Hep3Vector & CLHEP::Hep3Vector::rotate ( const HepEulerAngles e)
inherited

Definition at line 110 of file SpaceVectorR.cc.

110 {
111 return rotate( ex.phi(), ex.theta(), ex.psi() );
112}

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

◆ rotate() [4/5]

Hep3Vector & CLHEP::Hep3Vector::rotate ( double  phi,
double  theta,
double  psi 
)
inherited

Definition at line 71 of file SpaceVectorR.cc.

73 {
74
75 double rx;
76 double ry;
77 double rz;
78
79 double sinPhi = std::sin( phi1 ), cosPhi = std::cos( phi1 );
80 double sinTheta = std::sin( theta1 ), cosTheta1 = std::cos( theta1 );
81 double sinPsi = std::sin( psi1 ), cosPsi = std::cos( psi1 );
82
83 rx = (cosPsi * cosPhi - cosTheta1 * sinPsi * sinPhi) * x() +
84 (cosPsi * sinPhi + cosTheta1 * sinPsi * cosPhi) * y() +
85 (sinPsi * sinTheta) * z() ;
86
87 ry = (- sinPsi * cosPhi - cosTheta1 * cosPsi * sinPhi) * x() +
88 (- sinPsi * sinPhi + cosTheta1 * cosPsi * cosPhi) * y() +
89 (cosPsi * sinTheta) * z() ;
90
91 rz = (sinTheta * sinPhi) * x() +
92 (- sinTheta * cosPhi) * y() +
93 (cosTheta1) * z() ;
94
95 set(rx, ry, rz);
96 return *this;
97
98} /* rotate */

References CLHEP::Hep3Vector::set(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ rotate() [5/5]

Hep3Vector & CLHEP::Hep3Vector::rotate ( double  angle1,
const Hep3Vector aaxis 
)
inherited

◆ RotateAz() [1/2]

void G4StokesVector::RotateAz ( G4double  cosphi,
G4double  sinphi 
)

Definition at line 131 of file G4StokesVector.cc.

132{
133 if(!fIsPhoton)
134 {
135 G4double xsi1 = cosphi * p1() + sinphi * p2();
136 G4double xsi2 = -sinphi * p1() + cosphi * p2();
137 setX(xsi1);
138 setY(xsi2);
139 return;
140 }
141
142 G4double sin2phi = 2. * cosphi * sinphi;
143 G4double cos2phi = cosphi * cosphi - sinphi * sinphi;
144
145 G4double xsi1 = cos2phi * p1() + sin2phi * p2();
146 G4double xsi2 = -sin2phi * p1() + cos2phi * p2();
147 setX(xsi1);
148 setY(xsi2);
149}
G4double p1() const
G4double p2() const

References fIsPhoton, p1(), p2(), CLHEP::Hep3Vector::setX(), and CLHEP::Hep3Vector::setY().

◆ RotateAz() [2/2]

void G4StokesVector::RotateAz ( G4ThreeVector  nInteractionFrame,
G4ThreeVector  particleDirection 
)

Definition at line 67 of file G4StokesVector.cc.

69{
70 G4ThreeVector yParticleFrame =
72
73 G4double cosphi = yParticleFrame * nInteractionFrame;
74 if(cosphi > (1. + 1.e-8) || cosphi < (-1. - 1.e-8))
75 {
77 ed << " warning G4StokesVector::RotateAz cosphi>1 or cosphi<-1\n"
78 << " cosphi=" << cosphi << "\n"
79 << " zAxis=" << particleDirection << " (" << particleDirection.mag()
80 << ")\n"
81 << " yAxis=" << yParticleFrame << " (" << yParticleFrame.mag() << ")\n"
82 << " nAxis=" << nInteractionFrame << " (" << nInteractionFrame.mag()
83 << ")\n";
84 G4Exception("G4StokesVector::RotateAz", "pol030", JustWarning, ed);
85 }
86 if(cosphi > 1.)
87 cosphi = 1.;
88 else if(cosphi < -1.)
89 cosphi = -1.;
90
91 G4double hel =
92 (yParticleFrame.cross(nInteractionFrame) * particleDirection) > 0. ? 1.
93 : -1.;
94
95 G4double sinphi = hel * std::sqrt(1. - cosphi * cosphi);
96
97 RotateAz(cosphi, sinphi);
98}

References CLHEP::Hep3Vector::cross(), G4Exception(), G4PolarizationHelper::GetParticleFrameY(), JustWarning, CLHEP::Hep3Vector::mag(), and RotateAz().

Referenced by InvRotateAz(), RotateAz(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4PolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), and G4PolarizedPhotoElectricModel::SampleSecondaries().

◆ rotateUz()

Hep3Vector & CLHEP::Hep3Vector::rotateUz ( const Hep3Vector NewUzVector)
inherited

Definition at line 33 of file ThreeVector.cc.

33 {
34 // NewUzVector must be normalized !
35
36 double u1 = NewUzVector.x();
37 double u2 = NewUzVector.y();
38 double u3 = NewUzVector.z();
39 double up = u1*u1 + u2*u2;
40
41 if (up > 0) {
42 up = std::sqrt(up);
43 double px = (u1 * u3 * x() - u2 * y()) / up + u1 * z();
44 double py = (u2 * u3 * x() + u1 * y()) / up + u2 * z();
45 double pz = -up * x() + u3 * z();
46 set(px, py, pz);
47 } else if (u3 < 0.) {
48 setX(-x());
49 setZ(-z());
50 } // phi=0 teta=pi
51
52 return *this;
53}

References CLHEP::Hep3Vector::set(), CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

Referenced by G4PreCompoundEmission::AngularDistribution(), G4MuonVDNuclearModel::CalculateEMVertex(), G4TheRayTracer::CreateBitMap(), G4MuonDecayChannelWithSpin::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4PionRadiativeDecayChannel::DecayIt(), G4HadronicProcess::FillResult(), G4FissionProductYieldDist::G4GetFission(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4OpBoundaryProcess::GetFacetNormal(), G4UCNBoundaryProcess::LDiffRefl(), G4NeutrinoElectronProcess::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), CLHEP::HepLorentzVector::rotateUz(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4ModifiedMephi::SampleDirection(), G4DeltaAngle::SampleDirection(), G4DeltaAngleFreeScat::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4DNABornAngle::SampleDirectionForShell(), G4DNARuddAngle::SampleDirectionForShell(), G4VLEPTSModel::SampleNewDirection(), G4ModifiedMephi::SamplePairDirections(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4UrbanAdjointMscModel::SampleScattering(), G4GoudsmitSaundersonMscModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4WentzelVIModel::SampleScattering(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNARelativisticIonisationModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4PenelopeRayleighModelMI::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4eDPWACoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4ee2KChargedModel::SampleSecondaries(), G4ee2KNeutralModel::SampleSecondaries(), G4eeToPGammaModel::SampleSecondaries(), G4eeToTwoPiModel::SampleSecondaries(), and G4PolarizationHelper::TestInteractionFrame().

◆ rotateX()

Hep3Vector & CLHEP::Hep3Vector::rotateX ( double  phi1)
inherited

Definition at line 87 of file ThreeVector.cc.

87 {
88 double sinphi = std::sin(phi1);
89 double cosphi = std::cos(phi1);
90 double ty = y() * cosphi - z() * sinphi;
91 double tz = z() * cosphi + y() * sinphi;
92 setY(ty);
93 setZ(tz);
94 return *this;
95} /* rotateX */

References CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

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

◆ rotateY()

Hep3Vector & CLHEP::Hep3Vector::rotateY ( double  phi1)
inherited

Definition at line 97 of file ThreeVector.cc.

97 {
98 double sinphi = std::sin(phi1);
99 double cosphi = std::cos(phi1);
100 double tx = x() * cosphi + z() * sinphi;
101 double tz = z() * cosphi - x() * sinphi;
102 setX(tx);
103 setZ(tz);
104 return *this;
105} /* rotateY */

References CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::x(), and CLHEP::Hep3Vector::z().

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

◆ rotateZ()

Hep3Vector & CLHEP::Hep3Vector::rotateZ ( double  phi1)
inherited

Definition at line 107 of file ThreeVector.cc.

107 {
108 double sinphi = std::sin(phi1);
109 double cosphi = std::cos(phi1);
110 double tx = x() * cosphi - y() * sinphi;
111 double ty = y() * cosphi + x() * sinphi;
112 setX(tx);
113 setY(ty);
114 return *this;
115} /* rotateZ */

References CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::x(), and CLHEP::Hep3Vector::y().

Referenced by G4TheRayTracer::CreateBitMap(), G4CrystalUnitCell::G4CrystalUnitCell(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnASphereBoundary(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), CLHEP::HepLorentzVector::rotateZ(), and CLHEP::rotationZOf().

◆ set()

void CLHEP::Hep3Vector::set ( double  x,
double  y,
double  z 
)
inlineinherited

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4PreCompoundEmission::AngularDistribution(), G4Voxelizer::BuildVoxelLimits(), G4NucleiModel::choosePointAlongTraj(), G4Fancy3DNucleus::ChoosePositions(), G4HadFinalState::Clear(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4VTwistSurface::CurrentStatus::CurrentStatus(), CLHEP::HepRotation::decompose(), CLHEP::HepRotationX::decompose(), CLHEP::HepRotationY::decompose(), CLHEP::HepRotationZ::decompose(), G4VTwistSurface::DistanceToBoundary(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4TwistedTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4BoundingEnvelope::G4BoundingEnvelope(), G4FissionProductYieldDist::G4GetFission(), G4GoudsmitSaundersonMscModel::G4GoudsmitSaundersonMscModel(), G4HadProjectile::G4HadProjectile(), G4LatticeLogical::G4LatticeLogical(), G4Para::G4Para(), G4TessellatedSolid::G4TessellatedSolid(), G4TriangularFacet::G4TriangularFacet(), G4TwistBoxSide::G4TwistBoxSide(), G4TwistTrapAlphaSide::G4TwistTrapAlphaSide(), G4TwistTrapFlatSide::G4TwistTrapFlatSide(), G4TwistTrapParallelSide::G4TwistTrapParallelSide(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4TwistTubsHypeSide::G4TwistTubsHypeSide(), G4TwistTubsSide::G4TwistTubsSide(), G4VEmAngularDistribution::G4VEmAngularDistribution(), G4VTwistSurface::G4VTwistSurface(), G4eeToHadronsModel::GenerateCMPhoton(), G4InuclSpecialFunctions::generateWithFixedTheta(), G4InuclSpecialFunctions::generateWithRandomAngles(), G4OpBoundaryProcess::GetFacetNormal(), G4CutTubs::GetPointOnSurface(), G4Para::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4EllipticalTube::GetPointOnSurface(), G4Polyhedra::GetPointOnSurface(), G4Trap::GetVertices(), G4EmExtraParameters::Initialise(), G4TessellatedSolid::Initialize(), G4NucleiModel::initializeCascad(), G4TwistedTubs::Inside(), G4VTwistedFaceted::Inside(), G4TwistedTubs::LastState::LastState(), G4VTwistedFaceted::LastState::LastState(), G4TwistedTubs::LastValue::LastValue(), G4VTwistedFaceted::LastValue::LastValue(), G4TwistedTubs::LastValueWithDoubleVector::LastValueWithDoubleVector(), G4VTwistedFaceted::LastValueWithDoubleVector::LastValueWithDoubleVector(), G4TwistedTubs::LastVector::LastVector(), G4VTwistedFaceted::LastVector::LastVector(), G4LatticeLogical::Load_NMap(), CLHEP::operator>>(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4VTwistSurface::CurrentStatus::ResetfDone(), CLHEP::Hep3Vector::rotate(), CLHEP::Hep3Vector::rotateUz(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4ModifiedMephi::SampleDirection(), G4DeltaAngle::SampleDirection(), G4DeltaAngleFreeScat::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4GammaTransition::SampleDirection(), G4DNABornAngle::SampleDirectionForShell(), G4DNARuddAngle::SampleDirectionForShell(), G4UrbanAdjointMscModel::SampleDisplacement(), G4UrbanMscModel::SampleDisplacement(), G4UrbanAdjointMscModel::SampleDisplacementNew(), G4UrbanMscModel::SampleDisplacementNew(), G4GoudsmitSaundersonMscModel::SampleMSC(), G4ModifiedMephi::SamplePairDirections(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4UrbanAdjointMscModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4WentzelVIModel::SampleScattering(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel_new::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4VTwistSurface::SetCorner(), G4VTwistSurface::CurrentStatus::SetCurrentStatus(), G4Voxelizer::SetMaxVoxels(), G4HadFinalState::SetMomentumChange(), G4Voxelizer::SetReductionRatio(), CLHEP::Hep3Vector::setRhoPhiEta(), CLHEP::Hep3Vector::setRhoPhiTheta(), G4StatMFChannel::SolveEqOfMotion(), G4GeomTools::SphereExtent(), G4TwistedTubs::SurfaceNormal(), and G4VTwistedFaceted::SurfaceNormal().

◆ setCylEta()

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

Definition at line 256 of file ThreeVector.cc.

256 {
257
258 // In cylindrical coords, set eta while keeping rho and phi fixed
259
260 double theta1 = 2 * std::atan ( std::exp (-eta1) );
261
262 //-| The remaining code is similar to setCylTheta, The reason for
263 //-| using a copy is so as to be able to change the messages in the
264 //-| ZMthrows to say eta rather than theta. Besides, we assumedly
265 //-| need not check for theta of 0 or PI.
266
267 if ( (x() == 0) && (y() == 0) ) {
268 if (z() == 0) {
269 std::cerr << "Hep3Vector::setCylEta() - "
270 << "Attempt to set cylEta of zero vector -- vector is unchanged"
271 << std::endl;
272 return;
273 }
274 if (theta1 == 0) {
275 setZ(std::fabs(z()));
276 return;
277 }
278 if (theta1 == CLHEP::pi) {
279 setZ(-std::fabs(z()));
280 return;
281 }
282 std::cerr << "Hep3Vector::setCylEta() - "
283 << "Attempt set cylindrical eta of vector along Z axis "
284 << "to a non-trivial value, while keeping rho fixed -- "
285 << "will return zero vector" << std::endl;
286 setZ(0.0);
287 return;
288 }
289 double phi1 (getPhi());
290 double rho1 = getRho();
291 setZ(rho1 / std::tan (theta1));
292 setY(rho1 * std::sin (phi1));
293 setX(rho1 * std::cos (phi1));
294
295} /* setCylEta */
double getRho() const

References CLHEP::Hep3Vector::getPhi(), CLHEP::Hep3Vector::getRho(), CLHEP::pi, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ setCylindrical()

void CLHEP::Hep3Vector::setCylindrical ( double  r,
double  phi,
double  z 
)
protectedinherited

Definition at line 52 of file SpaceVector.cc.

55 {
56// if ( rho1 < 0 ) {
57// std::cerr << "Hep3Vector::setCylindrical() - "
58// << "Cylindrical coordinates supplied with negative Rho" << std::endl;
59// // No special return needed if warning is ignored.
60// }
61 setZ(z1);
62 setY(rho1 * std::sin (phi1));
63 setX(rho1 * std::cos (phi1));
64 return;
65} /* setCylindrical (r, phi, z) */

References CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ setCylTheta()

void CLHEP::Hep3Vector::setCylTheta ( double  theta1)
inherited

Definition at line 208 of file ThreeVector.cc.

208 {
209
210 // In cylindrical coords, set theta while keeping rho and phi fixed
211
212 if ( (x() == 0) && (y() == 0) ) {
213 if (z() == 0) {
214 std::cerr << "Hep3Vector::setCylTheta() - "
215 << "Attempt to set cylTheta of zero vector -- vector is unchanged"
216 << std::endl;
217 return;
218 }
219 if (theta1 == 0) {
220 setZ(std::fabs(z()));
221 return;
222 }
223 if (theta1 == CLHEP::pi) {
224 setZ(-std::fabs(z()));
225 return;
226 }
227 std::cerr << "Hep3Vector::setCylTheta() - "
228 << "Attempt set cylindrical theta of vector along Z axis "
229 << "to a non-trivial value, while keeping rho fixed -- "
230 << "will return zero vector" << std::endl;
231 setZ(0.0);
232 return;
233 }
234 if ( (theta1 < 0) || (theta1 > CLHEP::pi) ) {
235 std::cerr << "Hep3Vector::setCylTheta() - "
236 << "Setting Cyl theta of a vector based on a value not in [0, PI]"
237 << std::endl;
238 // No special return needed if warning is ignored.
239 }
240 double phi1 (getPhi());
241 double rho1 = getRho();
242 if ( (theta1 == 0) || (theta1 == CLHEP::pi) ) {
243 std::cerr << "Hep3Vector::setCylTheta() - "
244 << "Attempt to set cylindrical theta to 0 or PI "
245 << "while keeping rho fixed -- infinite Z will be computed"
246 << std::endl;
247 setZ((theta1==0) ? 1.0E72 : -1.0E72);
248 return;
249 }
250 setZ(rho1 / std::tan (theta1));
251 setY(rho1 * std::sin (phi1));
252 setX(rho1 * std::cos (phi1));
253
254} /* setCylTheta */

References CLHEP::Hep3Vector::getPhi(), CLHEP::Hep3Vector::getRho(), CLHEP::pi, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ setEta()

void CLHEP::Hep3Vector::setEta ( double  p)
inherited

Definition at line 180 of file ThreeVector.cc.

180 {
181 double phi1 = 0;
182 double r1;
183 if ( (x() == 0) && (y() == 0) ) {
184 if (z() == 0) {
185 std::cerr << "Hep3Vector::setEta() - "
186 << "Attempt to set eta of zero vector -- vector is unchanged"
187 << std::endl;
188 return;
189 }
190 std::cerr << "Hep3Vector::setEta() - "
191 << "Attempt to set eta of vector along Z axis -- will use phi = 0"
192 << std::endl;
193 r1 = std::fabs(z());
194 } else {
195 r1 = getR();
196 phi1 = getPhi();
197 }
198 double tanHalfTheta = std::exp ( -eta1 );
199 double cosTheta1 =
200 (1 - tanHalfTheta*tanHalfTheta) / (1 + tanHalfTheta*tanHalfTheta);
201 double rho1 = r1*std::sqrt(1 - cosTheta1*cosTheta1);
202 setZ(r1 * cosTheta1);
203 setY(rho1 * std::sin (phi1));
204 setX(rho1 * std::cos (phi1));
205 return;
206}

References CLHEP::Hep3Vector::getPhi(), CLHEP::Hep3Vector::getR(), CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

◆ setMag()

void CLHEP::Hep3Vector::setMag ( double  ma)
inherited

Definition at line 20 of file ThreeVector.cc.

20 {
21 double factor = mag();
22 if (factor == 0) {
23 std::cerr << "Hep3Vector::setMag() - "
24 << "zero vector can't be stretched" << std::endl;
25 }else{
26 factor = ma/factor;
27 setX(x()*factor);
28 setY(y()*factor);
29 setZ(z()*factor);
30 }
31}

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

Referenced by G4EMDissociation::ApplyYourself(), G4UCNBoundaryProcess::GetCoordinateTransformMatrix(), G4DNAIRT::MakeReaction(), G4DNAIRT_geometries::MakeReaction(), and G4DNAMakeReaction::UpdatePositionForReaction().

◆ setPerp()

void CLHEP::Hep3Vector::setPerp ( double  )
inlineinherited

◆ setPhi()

void CLHEP::Hep3Vector::setPhi ( double  )
inlineinherited

◆ SetPhoton()

void G4StokesVector::SetPhoton ( )
inline

◆ setR()

void CLHEP::Hep3Vector::setR ( double  s)
inlineinherited

◆ setREtaPhi()

void CLHEP::Hep3Vector::setREtaPhi ( double  r,
double  eta,
double  phi 
)
inlineinherited

◆ setRho()

void CLHEP::Hep3Vector::setRho ( double  s)
inlineinherited

◆ setRhoPhiEta()

void CLHEP::Hep3Vector::setRhoPhiEta ( double  rho,
double  phi,
double  eta 
)
inherited

Definition at line 94 of file SpaceVector.cc.

97 {
98 if (rho1 == 0) {
99 std::cerr << "Hep3Vector::setRhoPhiEta() - "
100 << "Attempt set vector components rho, phi, eta with zero rho -- "
101 << "zero vector is returned, ignoring eta and phi" << std::endl;
102 set(0.0, 0.0, 0.0);
103 return;
104 }
105 double theta1 (2 * std::atan ( std::exp (-eta1) ));
106 setZ(rho1 / std::tan (theta1));
107 setY(rho1 * std::sin (phi1));
108 setX(rho1 * std::cos (phi1));
109 return;
110} /* setCyl (rho, phi, eta) */

References CLHEP::Hep3Vector::set(), CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ setRhoPhiTheta()

void CLHEP::Hep3Vector::setRhoPhiTheta ( double  rho,
double  phi,
double  theta 
)
inherited

Definition at line 67 of file SpaceVector.cc.

70 {
71 if (rho1 == 0) {
72 std::cerr << "Hep3Vector::setRhoPhiTheta() - "
73 << "Attempt set vector components rho, phi, theta with zero rho -- "
74 << "zero vector is returned, ignoring theta and phi" << std::endl;
75 set(0.0, 0.0, 0.0);
76 return;
77 }
78// if ( (theta1 == 0) || (theta1 == CLHEP::pi) ) {
79// std::cerr << "Hep3Vector::setRhoPhiTheta() - "
80// << "Attempt set cylindrical vector vector with finite rho and "
81// << "theta along the Z axis: infinite Z would be computed" << std::endl;
82// }
83// if ( (theta1 < 0) || (theta1 > CLHEP::pi) ) {
84// std::cerr << "Hep3Vector::setRhoPhiTheta() - "
85// << "Rho, phi, theta set with theta not in [0, PI]" << std::endl;
86// // No special return needed if warning is ignored.
87// }
88 setZ(rho1 / std::tan (theta1));
89 setY(rho1 * std::sin (phi1));
90 setX(rho1 * std::cos (phi1));
91 return;
92} /* setCyl (rho, phi, theta) */

References CLHEP::Hep3Vector::set(), CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ setRhoPhiZ()

void CLHEP::Hep3Vector::setRhoPhiZ ( double  rho,
double  phi,
double  z 
)
inlineinherited

◆ setRThetaPhi()

void CLHEP::Hep3Vector::setRThetaPhi ( double  r,
double  theta,
double  phi 
)
inlineinherited

◆ setSpherical()

void CLHEP::Hep3Vector::setSpherical ( double  r,
double  theta,
double  phi 
)
protectedinherited

Definition at line 31 of file SpaceVector.cc.

34 {
35// if ( r1 < 0 ) {
36// std::cerr << "Hep3Vector::setSpherical() - "
37// << "Spherical coordinates set with negative R" << std::endl;
38// // No special return needed if warning is ignored.
39// }
40// if ( (theta1 < 0) || (theta1 > CLHEP::pi) ) {
41// std::cerr << "Hep3Vector::setSpherical() - "
42// << "Spherical coordinates set with theta not in [0, PI]" << std::endl;
43// // No special return needed if warning is ignored.
44// }
45 double rho1 ( r1*std::sin(theta1));
46 setZ(r1 * std::cos(theta1));
47 setY(rho1 * std::sin (phi1));
48 setX(rho1 * std::cos (phi1));
49 return;
50} /* setSpherical (r, theta1, phi1) */

References CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), and CLHEP::Hep3Vector::setZ().

◆ setTheta()

void CLHEP::Hep3Vector::setTheta ( double  )
inlineinherited

◆ setTolerance()

double CLHEP::Hep3Vector::setTolerance ( double  tol)
staticinherited

Definition at line 267 of file SpaceVector.cc.

267 {
268// Set the tolerance for Hep3Vectors to be considered near one another
269 double oldTolerance (tolerance);
270 tolerance = tol;
271 return oldTolerance;
272}
static DLL_API double tolerance
Definition: ThreeVector.h:394

References CLHEP::Hep3Vector::tolerance.

◆ setX()

void CLHEP::Hep3Vector::setX ( double  )
inlineinherited

Referenced by G4LENDElastic::ApplyYourself(), G4LENDModel::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::HepLorentzVector::boostX(), G4Torus::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParameterisationBoxX::ComputeTransformation(), G4ParameterisationParaX::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4TessellatedSolid::CreateVertexList(), G4GDMLReadSolids::CutTubeRead(), G4KL3DecayChannel::DecayIt(), G4BetaMinusDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4SFDecay::DecayIt(), DiceP1(), DiceP2(), DiceP3(), DiceUniform(), G4StatMFChannel::FragmentsMomenta(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4SPSAngDistribution::GenerateUserDefFlux(), G4OpBoundaryProcess::GetFacetNormal(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedAnnihilationXS::Initialize(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedGammaConversionXS::Initialize(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4DecayWithSpin::PostStepDoIt(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), G4GDMLReadSolids::ReflectedSolidRead(), RotateAz(), CLHEP::Hep3Vector::rotateUz(), CLHEP::Hep3Vector::rotateY(), CLHEP::Hep3Vector::rotateZ(), G4GDMLReadDefine::RotationRead(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylindrical(), CLHEP::Hep3Vector::setCylTheta(), CLHEP::Hep3Vector::setEta(), CLHEP::Hep3Vector::setMag(), G4ReactionProduct::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEPPolarizedComptonModel::SetNewPolarization(), G4ReactionProduct::SetPositionInNucleus(), CLHEP::Hep3Vector::setRhoPhiEta(), CLHEP::Hep3Vector::setRhoPhiTheta(), CLHEP::Hep3Vector::setSpherical(), G4Box::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4Channeling::UpdateParameters(), and G4GDMLReadDefine::VectorRead().

◆ setY()

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

Referenced by G4LENDElastic::ApplyYourself(), G4LENDModel::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::HepLorentzVector::boostY(), G4Torus::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParameterisationBoxY::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4TessellatedSolid::CreateVertexList(), G4GDMLReadSolids::CutTubeRead(), G4KL3DecayChannel::DecayIt(), G4BetaMinusDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4SFDecay::DecayIt(), DiceP1(), DiceP2(), DiceP3(), DiceUniform(), G4StatMFChannel::FragmentsMomenta(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4SPSAngDistribution::GenerateUserDefFlux(), G4OpBoundaryProcess::GetFacetNormal(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedAnnihilationXS::Initialize(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedGammaConversionXS::Initialize(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4DecayWithSpin::PostStepDoIt(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), G4GDMLReadSolids::ReflectedSolidRead(), RotateAz(), CLHEP::Hep3Vector::rotateX(), CLHEP::Hep3Vector::rotateZ(), G4GDMLReadDefine::RotationRead(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylindrical(), CLHEP::Hep3Vector::setCylTheta(), CLHEP::Hep3Vector::setEta(), CLHEP::Hep3Vector::setMag(), G4ReactionProduct::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEPPolarizedComptonModel::SetNewPolarization(), G4ReactionProduct::SetPositionInNucleus(), CLHEP::Hep3Vector::setRhoPhiEta(), CLHEP::Hep3Vector::setRhoPhiTheta(), CLHEP::Hep3Vector::setSpherical(), G4Box::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), and G4GDMLReadDefine::VectorRead().

◆ setZ()

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

Referenced by G4LENDElastic::ApplyYourself(), G4LENDModel::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::HepLorentzVector::boostZ(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationTrdZ::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4TessellatedSolid::CreateVertexList(), G4GDMLReadSolids::CutTubeRead(), G4KL3DecayChannel::DecayIt(), G4BetaMinusDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4SFDecay::DecayIt(), DiceP1(), DiceP2(), DiceP3(), DiceUniform(), FlipP3(), G4StatMFChannel::FragmentsMomenta(), G4CutTubs::G4CutTubs(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4SPSAngDistribution::GenerateUserDefFlux(), G4OpBoundaryProcess::GetFacetNormal(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedAnnihilationXS::Initialize(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedGammaConversionXS::Initialize(), G4FragmentingString::LorentzRotate(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4DecayWithSpin::PostStepDoIt(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), G4GDMLReadSolids::ReflectedSolidRead(), CLHEP::Hep3Vector::rotateUz(), CLHEP::Hep3Vector::rotateX(), CLHEP::Hep3Vector::rotateY(), G4GDMLReadDefine::RotationRead(), G4LundStringFragmentation::Sample4Momentum(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylindrical(), CLHEP::Hep3Vector::setCylTheta(), CLHEP::Hep3Vector::setEta(), CLHEP::Hep3Vector::setMag(), G4ReactionProduct::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEPPolarizedComptonModel::SetNewPolarization(), G4FragmentingString::SetPleft(), G4ReactionProduct::SetPositionInNucleus(), G4FragmentingString::SetPright(), CLHEP::Hep3Vector::setRhoPhiEta(), CLHEP::Hep3Vector::setRhoPhiTheta(), CLHEP::Hep3Vector::setSpherical(), G4FTFParticipants::ShiftInteractionTime(), G4LundStringFragmentation::SplitEandP(), G4QGSMFragmentation::SplitEandP(), G4Box::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4FragmentingString::TransformToAlignedCms(), G4FragmentingString::TransformToCenterOfMass(), and G4GDMLReadDefine::VectorRead().

◆ theta() [1/2]

double CLHEP::Hep3Vector::theta ( ) const
inlineinherited

◆ theta() [2/2]

double CLHEP::Hep3Vector::theta ( const Hep3Vector v2) const
inlineinherited

◆ transform()

Hep3Vector & CLHEP::Hep3Vector::transform ( const HepRotation m1)
inherited

◆ Transverse()

G4double G4StokesVector::Transverse ( ) const
inline

Definition at line 58 of file G4StokesVector.hh.

58{ return perp(); }
double perp() const

References CLHEP::Hep3Vector::perp().

◆ unit()

Hep3Vector CLHEP::Hep3Vector::unit ( ) const
inlineinherited

Referenced by G4PreCompoundEmission::AngularDistribution(), G4ParticleHPChannelList::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4LENDInelastic::ApplyYourself(), G4LENDModel::ApplyYourself(), G4ElectroVDNuclearModel::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4ANuElNucleusCcModel::ApplyYourself(), G4ANuElNucleusNcModel::ApplyYourself(), G4ANuMuNucleusCcModel::ApplyYourself(), G4ANuMuNucleusNcModel::ApplyYourself(), G4MuonVDNuclearModel::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NuElNucleusCcModel::ApplyYourself(), G4NuElNucleusNcModel::ApplyYourself(), G4NuMuNucleusCcModel::ApplyYourself(), G4NuMuNucleusNcModel::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4MuonMinusBoundDecay::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4LowEGammaNuclearModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4LEpp::ApplyYourself(), G4BinaryCascade::ApplyYourself(), G4BinaryLightIonReaction::ApplyYourself(), G4INCLXXInterface::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4TheoFSGenerator::ApplyYourself(), G4ParticleHPCaptureFS::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4Ellipsoid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), CLHEP::HepRotation::axis(), G4ParticleHPInelasticBaseFS::BaseApply(), CLHEP::HepLorentzVector::boost(), G4UnstableFragmentBreakUp::BreakUpChain(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4MuonVDNuclearModel::CalculateEMVertex(), G4PolyconeSide::CalculateExtent(), G4NucleiModel::choosePointAlongTraj(), G4NeutrinoNucleusModel::ClusterDecay(), G4BinaryCascade::CorrectFinalPandE(), G4BinaryCascade::CorrectShortlivedFinalsForFermi(), G4TheRayTracer::CreateBitMap(), G4PionDecayMakeSpin::DaughterPolarization(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4IntraNucleiCascader::decayTrappedParticle(), G4SPSAngDistribution::DefineAngRefAxes(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricMetal(), G4MultiUnion::DistanceToIn(), G4TessellatedSolid::DistanceToInCore(), G4MultiUnion::DistanceToInNoVoxels(), G4Cons::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4Hype::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TessellatedSolid::DistanceToOutCore(), G4MultiUnion::DistanceToOutNoVoxels(), G4MultiUnion::DistanceToOutVoxels(), G4NRESP71M03::DKINMA(), G4RKPropagation::FieldTransport(), G4LorentzConvertor::fillKinematics(), G4MuonicAtomDecay::FillResult(), G4CrystalUnitCell::G4CrystalUnitCell(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4PolyhedraSide::G4PolyhedraSide(), G4PolyPhiFace::G4PolyPhiFace(), G4TheRayTracer::G4TheRayTracer(), G4TriangularFacet::G4TriangularFacet(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4SPSPosDistribution::GenerateRotationMatrices(), G4OpBoundaryProcess::GetFacetNormal(), G4Navigator::GetGlobalExitNormal(), G4ITNavigator1::GetGlobalExitNormal(), G4ITNavigator2::GetGlobalExitNormal(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4BinaryCascade::GetSpherePoint(), G4Scatterer::GetTimeToInteraction(), G4CrystalUnitCell::GetUnitBasisTrigonal(), G4Tet::Initialize(), G4TessellatedSolid::InsideVoxels(), G4TriangularFacet::Intersect(), G4UCNBoundaryProcess::LDiffRefl(), G4LatticeLogical::Load_NMap(), G4CascadeInterface::makeDynamicParticle(), G4LatticeManager::MapKtoVDir(), G4NeutrinoNucleusModel::MesonDecay(), G4UCNBoundaryProcess::MRDiffRefl(), G4UCNBoundaryProcess::MRDiffTrans(), G4UCNBoundaryProcess::MRreflect(), G4UCNBoundaryProcess::MRreflectHigh(), G4PolyconeSide::Normal(), G4GenericTrap::NormalToPlane(), G4TwistBoxSide::NormAng(), G4TwistTrapAlphaSide::NormAng(), G4TwistTrapParallelSide::NormAng(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4Channeling::PostStepDoIt(), G4UCNBoundaryProcess::PostStepDoIt(), G4MicroElecSurface::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4CascadeHistory::PrintEntry(), G4CascadParticle::propagateAlongThePath(), G4FastStep::ProposePrimaryTrackFinalKineticEnergyAndDirection(), G4FastStep::ProposePrimaryTrackFinalMomentumDirection(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), CLHEP::HepRotation::rectify(), G4Fancy3DNucleus::ReduceSum(), G4UCNBoundaryProcess::Reflect(), G4MicroElecSurface::Reflexion(), G4QuasiElRatios::RelDecayIn2(), G4LENDModel::returnUnchanged(), G4LorentzConvertor::rotate(), G4StatMFChannel::RotateMomentum(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAELSEPAElasticModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4DNARelativisticIonisationModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MicroElecElasticModel_new::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel_new::SampleSecondaries(), G4MicroElecLOPhononModel::SampleSecondaries(), G4PenelopeBremsstrahlungModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4DNAPTBElasticModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), G4DynamicParticle::Set4Momentum(), CLHEP::HepRotation::setArbitrarily(), G4TwistBoxSide::SetBoundaries(), G4TwistTrapAlphaSide::SetBoundaries(), G4TwistTrapFlatSide::SetBoundaries(), G4TwistTrapParallelSide::SetBoundaries(), G4TwistTubsFlatSide::SetBoundaries(), G4TwistTubsHypeSide::SetBoundaries(), G4TwistTubsSide::SetBoundaries(), CLHEP::HepRotation::setCols(), G4FastTrack::SetCurrentTrack(), G4RadioactiveDecay::SetDecayDirection(), G4TheRayTracer::SetLightDirection(), G4DynamicParticle::SetMomentum(), G4VisCommandsViewerSet::SetNewValue(), G4ParticleGun::SetParticleMomentum(), G4SPSAngDistribution::SetParticleMomentumDirection(), G4ParticleGun::SetParticleMomentumDirection(), G4UnionSolid::SurfaceNormal(), G4Box::SurfaceNormal(), G4Cons::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Hype::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Tet::SurfaceNormal(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), G4AblaInterface::toG4Particle(), G4INCLXXInterface::toG4Particle(), G4TheMTRayTracer::Trace(), G4TheRayTracer::Trace(), G4RKPropagation::Transport(), G4KineticTrack::Update4Momentum(), and G4KineticTrack::UpdateTrackingMomentum().

◆ x()

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

Referenced by G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4FTFModel::AdjustNucleonsAlgorithm_Sampling(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), G4ReactionProduct::Angle(), G4LFission::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4Box::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4CutTubs::ApproxSurfaceNormal(), G4Para::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Ellipsoid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), G4GDMLWriteStructure::AssemblyWrite(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4IntersectionSolid::BoundingLimits(), G4ScaledSolid::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Trap::BoundingLimits(), G4Voxelizer::BuildBoundingBox(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4EllipticalCone::CalculateExtent(), G4BoundingEnvelope::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4NavigationLogger::CheckAndReportBadNormal(), G4BoundingEnvelope::CheckBoundingBox(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChange::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4PVPlacement::CheckOverlaps(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4CRCoalescence::Coalescence(), CLHEP::Hep3Vector::compare(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4PolarizedAnnihilation::ComputeSaturationFactor(), G4PolarizedIonisation::ComputeSaturationFactor(), G4ReplicaNavigation::ComputeTransformation(), G4DNABoundingBox::contains(), G4Qt3DUtils::ConvertToQVector3D(), G4UIcommand::ConvertToString(), G4TheRayTracer::CreateBitMap(), G4GenericTrap::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4TessellatedSolid::CreateVertexList(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4MuonDecayChannelWithSpin::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4PolarizedAnnihilationXS::DefineCoefficients(), G4PolarizedComptonXS::DefineCoefficients(), G4QGSParticipants::DeterminePartonMomenta(), G4QGSMSplitableHadron::DiffractiveSplitUp(), G4VTwistSurface::DistanceToBoundary(), G4Box::DistanceToIn(), G4Cons::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Para::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4Trd::DistanceToIn(), G4Tubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Hype::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4TessellatedSolid::DistanceToInNoVoxels(), G4Orb::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4Box::DistanceToOut(), G4Cons::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Para::DistanceToOut(), G4Sphere::DistanceToOut(), G4Torus::DistanceToOut(), G4Trap::DistanceToOut(), G4Trd::DistanceToOut(), G4Tubs::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4ReplicaNavigation::DistanceToOutPhi(), G4ReplicaNavigation::DistanceToOutRad(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4LatticeLogical::Dump_NMap(), mcscore.MCVertex::dump_vertex(), G4FastStep::DumpInfo(), G4ParticleChange::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChangeForMSC::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), G4SPSEneDistribution::EpnEnergyHisto(), G4VSolid::EstimateSurfaceArea(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), G4FTFModel::FinalizeKinematics(), G4QGSParticipants::FinalizeKinematics(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4DNABoundingBox::G4DNABoundingBox(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4Para::G4Para(), G4PolyPhiFace::G4PolyPhiFace(), G4RandomPointOnEllipsoid(), G4TUniformMagneticField::G4TUniformMagneticField(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VPhysicalVolume::G4VPhysicalVolume(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4SPSAngDistribution::GenerateUserDefFlux(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4Voxelizer::GetCandidatesVoxelArray(), G4MultiUnion::GetCubicVolume(), G4ScaledSolid::GetCubicVolume(), G4CutTubs::GetCubicVolume(), G4Trap::GetCubicVolume(), G4SubtractionSolid::GetCubicVolume(), G4UnionSolid::GetCubicVolume(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4ChannelingECHARM::GetEC(), G4EllipticalCone::GetExtent(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4Tet::GetExtent(), G4TwistedTubs::GetExtent(), G4TwistBoxSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4TwistTrapFlatSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTubsSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4TCachedMagneticField< T_Field >::GetFieldValue(), G4TQuadrupoleMagField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4SextupoleMagField::GetFieldValue(), G4QGSParticipants::GetList(), G4FTFParticipants::GetList(), G4TessellatedSolid::GetMaxXExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TessellatedSolid::GetMinXExtent(), G4TwistTubsHypeSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4CRCoalescence::GetPcm(), G4PolyconeSide::GetPhi(), G4PolyhedraSide::GetPhi(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapAlphaSide::GetPhiUAtX(), G4TwistTrapParallelSide::GetPhiUAtX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4CutTubs::GetPointOnSurface(), G4Polyhedra::GetPointOnSurface(), G4PrimaryParticle::GetPx(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4ScoringBox::GetReplicaPosition(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4ScaledSolid::GetScaleTransform(), G4PolarizationHelper::GetSpinInPRF(), G4CutTubs::GetSurfaceArea(), G4ReactionProduct::GetXPositionInNucleus(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedAnnihilationXS::Initialize(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedComptonXS::Initialize(), G4PolarizedIonisationBhabhaXS::Initialize(), G4PolarizedIonisationMollerXS::Initialize(), G4Box::Inside(), G4Cons::Inside(), G4CutTubs::Inside(), G4Para::Inside(), G4Sphere::Inside(), G4Torus::Inside(), G4Trap::Inside(), G4Trd::Inside(), G4Tubs::Inside(), G4Ellipsoid::Inside(), G4EllipticalCone::Inside(), G4EllipticalTube::Inside(), G4ExtrudedSolid::Inside(), G4Hype::Inside(), G4TwistedTubs::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4ReplicaNavigation::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4TessellatedSolid::InsideNoVoxels(), G4GenericTrap::InsidePolygone(), G4TessellatedSolid::InsideVoxels(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4CutTubs::IsCrossingCutPlanes(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4ReactionProduct::Lorentz(), G4Para::MakePlanes(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4Voxelizer::MinDistanceToBox(), G4GDMLWriteSolids::MultiUnionWrite(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GDMLWriteSolids::G4ThreeVectorCompare::operator()(), CLHEP::operator<<(), G4VoxelLimits::OutCode(), G4TessellatedSolid::OutsideOfExtent(), G4DNABoundingBox::overlap(), p1(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), PolDiv(), PolSqr(), PolSqrt(), G4Channeling::PostStepDoIt(), G4MicroElecSurface::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4PrimaryParticle::Print(), mcscore.MCVertex::printout(), G4MCTSimParticle::PrintSingle(), G4DriverReporter::PrintStat_Aux(), G4MagInt_Driver::PrintStat_Aux(), G4OldMagIntDriver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ExtrudedSolid::ProjectPoint(), G4ErrorFreeTrajState::PropagateError(), G4ErrorFreeTrajState::PropagateErrorMSC(), G4MoleculeShoot::RandomPosInBox(), G4STRead::Read(), G4GDMLReadSolids::ReflectedSolidRead(), G4MicroElecSurface::Reflexion(), G4FTFModel::ReggeonCascade(), G4QGSParticipants::ReggeonCascade(), G4DNABoundingBox::resize(), CLHEP::Hep3Vector::rotate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), G4StatMFChannel::RotateMomentum(), CLHEP::Hep3Vector::rotateUz(), CLHEP::Hep3Vector::rotateY(), CLHEP::Hep3Vector::rotateZ(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4MultiUnion::SafetyFromOutsideNumberNode(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNARelativisticIonisationModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel_new::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4DiffuseElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4AntiNuclElastic::SampleThetaLab(), G4GammaTransition::SampleTransition(), G4DNAIRT::Sampling(), G4DNAIRT_geometries::Sampling(), G4FTFModel::SamplingNucleonKinematics(), G4QGSParticipants::SamplingNucleonKinematics(), G4GDMLWriteDefine::Scale_vectorWrite(), G4GDMLReadSolids::ScaledSolidRead(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), CLHEP::HepBoost::set(), G4Tet::SetBoundingLimits(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylTheta(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4SPSRandomGenerator::SetEnergyBias(), CLHEP::Hep3Vector::setEta(), G4UniformMagField::SetFieldValue(), G4TUniformMagneticField::SetFieldValue(), CLHEP::Hep3Vector::setMag(), G4ScoringMessenger::SetNewValue(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), G4SPSRandomGenerator::SetPhiBias(), G4PrimaryParticle::SetPolarization(), G4SPSRandomGenerator::SetPosPhiBias(), G4SPSRandomGenerator::SetPosThetaBias(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4SPSRandomGenerator::SetThetaBias(), G4VPhysicalVolume::SetTranslation(), G4SPSRandomGenerator::SetXBias(), G4SPSRandomGenerator::SetYBias(), G4SPSRandomGenerator::SetZBias(), G4RayShooter::Shoot(), G4EnclosingCylinder::ShouldMiss(), G4ITSteppingVerbose::ShowStep(), G4SteppingVerbose::ShowStep(), G4SteppingVerboseWithUnits::ShowStep(), G4Torus::SolveNumericJT(), G4LundStringFragmentation::SplitEandP(), G4QGSMFragmentation::SplitEandP(), G4AttCheck::Standard(), G4ITSteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4SteppingVerboseWithUnits::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4ScaledSolid::StreamInfo(), G4QGSDiffractiveExcitation::String(), G4Box::SurfaceNormal(), G4Cons::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Tet::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4Torus::TorusRootsJT(), G4PolarizedIonisationBhabhaXS::TotalXSection(), G4PolarizedIonisationMollerXS::TotalXSection(), G4SteppingVerbose::TrackingStarted(), G4SteppingVerboseWithUnits::TrackingStarted(), G4ITSteppingVerbose::TrackingStarted(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BoundingEnvelope::TransformVertices(), G4DNABoundingBox::translate(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4GDMLWriteStructure::TraverseVolumeTree(), G4Channeling::UpdateIntegrationStep(), G4Channeling::UpdateParameters(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

◆ y()

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

Referenced by G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), G4ReactionProduct::Angle(), G4LFission::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), G4Box::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4CutTubs::ApproxSurfaceNormal(), G4Para::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Ellipsoid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), G4GDMLWriteStructure::AssemblyWrite(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4IntersectionSolid::BoundingLimits(), G4ScaledSolid::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Trap::BoundingLimits(), G4Voxelizer::BuildBoundingBox(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4EllipticalCone::CalculateExtent(), G4BoundingEnvelope::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4NavigationLogger::CheckAndReportBadNormal(), G4BoundingEnvelope::CheckBoundingBox(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChange::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4PVPlacement::CheckOverlaps(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4CRCoalescence::Coalescence(), CLHEP::Hep3Vector::compare(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4PolarizedAnnihilation::ComputeSaturationFactor(), G4PolarizedIonisation::ComputeSaturationFactor(), G4ReplicaNavigation::ComputeTransformation(), G4DNABoundingBox::contains(), G4Qt3DUtils::ConvertToQVector3D(), G4UIcommand::ConvertToString(), G4TheRayTracer::CreateBitMap(), G4GenericTrap::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4TessellatedSolid::CreateVertexList(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4MuonDecayChannelWithSpin::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4PolarizedAnnihilationXS::DefineCoefficients(), G4PolarizedComptonXS::DefineCoefficients(), G4QGSParticipants::DeterminePartonMomenta(), G4QGSMSplitableHadron::DiffractiveSplitUp(), G4VTwistSurface::DistanceToBoundary(), G4Box::DistanceToIn(), G4Cons::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Para::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4Trd::DistanceToIn(), G4Tubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Hype::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4TessellatedSolid::DistanceToInNoVoxels(), G4Orb::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4Box::DistanceToOut(), G4Cons::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Para::DistanceToOut(), G4Sphere::DistanceToOut(), G4Torus::DistanceToOut(), G4Trap::DistanceToOut(), G4Trd::DistanceToOut(), G4Tubs::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4ReplicaNavigation::DistanceToOutPhi(), G4ReplicaNavigation::DistanceToOutRad(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4LatticeLogical::Dump_NMap(), mcscore.MCVertex::dump_vertex(), G4FastStep::DumpInfo(), G4ParticleChange::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChangeForMSC::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), G4SPSEneDistribution::EpnEnergyHisto(), G4VSolid::EstimateSurfaceArea(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), G4FTFModel::FinalizeKinematics(), G4QGSParticipants::FinalizeKinematics(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4DNABoundingBox::G4DNABoundingBox(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4Para::G4Para(), G4PolyPhiFace::G4PolyPhiFace(), G4RandomPointOnEllipsoid(), G4TUniformMagneticField::G4TUniformMagneticField(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VPhysicalVolume::G4VPhysicalVolume(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4SPSAngDistribution::GenerateUserDefFlux(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4Voxelizer::GetCandidatesVoxelArray(), G4MultiUnion::GetCubicVolume(), G4ScaledSolid::GetCubicVolume(), G4CutTubs::GetCubicVolume(), G4Trap::GetCubicVolume(), G4SubtractionSolid::GetCubicVolume(), G4UnionSolid::GetCubicVolume(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4ChannelingECHARM::GetEC(), G4EllipticalCone::GetExtent(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4Tet::GetExtent(), G4TwistedTubs::GetExtent(), G4TwistBoxSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4TwistTrapFlatSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTubsSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4TCachedMagneticField< T_Field >::GetFieldValue(), G4TQuadrupoleMagField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4SextupoleMagField::GetFieldValue(), G4QGSParticipants::GetList(), G4FTFParticipants::GetList(), G4TessellatedSolid::GetMaxYExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TessellatedSolid::GetMinYExtent(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4CRCoalescence::GetPcm(), G4PolyconeSide::GetPhi(), G4PolyhedraSide::GetPhi(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapAlphaSide::GetPhiUAtX(), G4TwistTrapParallelSide::GetPhiUAtX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4CutTubs::GetPointOnSurface(), G4Polyhedra::GetPointOnSurface(), G4PrimaryParticle::GetPy(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4ScoringBox::GetReplicaPosition(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4ScaledSolid::GetScaleTransform(), G4PolarizationHelper::GetSpinInPRF(), G4CutTubs::GetSurfaceArea(), G4ReactionProduct::GetYPositionInNucleus(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedComptonXS::Initialize(), G4PolarizedIonisationBhabhaXS::Initialize(), G4PolarizedIonisationMollerXS::Initialize(), G4Box::Inside(), G4Cons::Inside(), G4CutTubs::Inside(), G4Para::Inside(), G4Sphere::Inside(), G4Torus::Inside(), G4Trap::Inside(), G4Trd::Inside(), G4Tubs::Inside(), G4Ellipsoid::Inside(), G4EllipticalCone::Inside(), G4EllipticalTube::Inside(), G4ExtrudedSolid::Inside(), G4Hype::Inside(), G4TwistedTubs::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4ReplicaNavigation::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4TessellatedSolid::InsideNoVoxels(), G4GenericTrap::InsidePolygone(), G4TessellatedSolid::InsideVoxels(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4CutTubs::IsCrossingCutPlanes(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4ReactionProduct::Lorentz(), G4Para::MakePlanes(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4Voxelizer::MinDistanceToBox(), G4GDMLWriteSolids::MultiUnionWrite(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GDMLWriteSolids::G4ThreeVectorCompare::operator()(), CLHEP::operator<<(), G4VoxelLimits::OutCode(), G4TessellatedSolid::OutsideOfExtent(), G4DNABoundingBox::overlap(), p2(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), PolDiv(), PolSqr(), PolSqrt(), G4MicroElecSurface::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4PrimaryParticle::Print(), mcscore.MCVertex::printout(), G4MCTSimParticle::PrintSingle(), G4DriverReporter::PrintStat_Aux(), G4MagInt_Driver::PrintStat_Aux(), G4OldMagIntDriver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4ExtrudedSolid::ProjectPoint(), G4ErrorFreeTrajState::PropagateError(), G4ErrorFreeTrajState::PropagateErrorMSC(), G4MoleculeShoot::RandomPosInBox(), G4STRead::Read(), G4GDMLReadSolids::ReflectedSolidRead(), G4MicroElecSurface::Reflexion(), G4FTFModel::ReggeonCascade(), G4QGSParticipants::ReggeonCascade(), G4DNABoundingBox::resize(), CLHEP::Hep3Vector::rotate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), G4StatMFChannel::RotateMomentum(), CLHEP::Hep3Vector::rotateUz(), CLHEP::Hep3Vector::rotateX(), CLHEP::Hep3Vector::rotateZ(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4MultiUnion::SafetyFromOutsideNumberNode(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNARelativisticIonisationModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel_new::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4DiffuseElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4AntiNuclElastic::SampleThetaLab(), G4GammaTransition::SampleTransition(), G4DNAIRT::Sampling(), G4DNAIRT_geometries::Sampling(), G4FTFModel::SamplingNucleonKinematics(), G4QGSParticipants::SamplingNucleonKinematics(), G4GDMLWriteDefine::Scale_vectorWrite(), G4GDMLReadSolids::ScaledSolidRead(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), CLHEP::HepBoost::set(), G4Tet::SetBoundingLimits(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylTheta(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4SPSRandomGenerator::SetEnergyBias(), CLHEP::Hep3Vector::setEta(), G4UniformMagField::SetFieldValue(), G4TUniformMagneticField::SetFieldValue(), CLHEP::Hep3Vector::setMag(), G4ScoringMessenger::SetNewValue(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), G4SPSRandomGenerator::SetPhiBias(), G4PrimaryParticle::SetPolarization(), G4SPSRandomGenerator::SetPosPhiBias(), G4SPSRandomGenerator::SetPosThetaBias(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4SPSRandomGenerator::SetThetaBias(), G4VPhysicalVolume::SetTranslation(), G4SPSRandomGenerator::SetXBias(), G4SPSRandomGenerator::SetYBias(), G4SPSRandomGenerator::SetZBias(), G4RayShooter::Shoot(), G4EnclosingCylinder::ShouldMiss(), G4ITSteppingVerbose::ShowStep(), G4SteppingVerbose::ShowStep(), G4SteppingVerboseWithUnits::ShowStep(), G4Torus::SolveNumericJT(), G4LundStringFragmentation::SplitEandP(), G4QGSMFragmentation::SplitEandP(), G4AttCheck::Standard(), G4ITSteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4SteppingVerboseWithUnits::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4ScaledSolid::StreamInfo(), G4QGSDiffractiveExcitation::String(), G4Box::SurfaceNormal(), G4Cons::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Tet::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4Torus::TorusRootsJT(), G4PolarizedIonisationBhabhaXS::TotalXSection(), G4PolarizedIonisationMollerXS::TotalXSection(), G4SteppingVerbose::TrackingStarted(), G4SteppingVerboseWithUnits::TrackingStarted(), G4ITSteppingVerbose::TrackingStarted(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BoundingEnvelope::TransformVertices(), G4DNABoundingBox::translate(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4GDMLWriteStructure::TraverseVolumeTree(), G4Channeling::UpdateIntegrationStep(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

◆ z()

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

Referenced by G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4MagHelicalStepper::AdvanceHelix(), G4ReactionProduct::Angle(), G4LFission::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4Box::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4Para::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Ellipsoid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4GDMLWriteStructure::AssemblyWrite(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4IntersectionSolid::BoundingLimits(), G4ScaledSolid::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Voxelizer::BuildBoundingBox(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4QMDReaction::calcOffSetOfCollision(), G4CutTubs::CalculateExtent(), G4EllipticalCone::CalculateExtent(), G4BoundingEnvelope::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4NavigationLogger::CheckAndReportBadNormal(), G4BoundingEnvelope::CheckBoundingBox(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChange::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4PVPlacement::CheckOverlaps(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4CRCoalescence::Coalescence(), CLHEP::Hep3Vector::compare(), G4PolarizedComptonModel::ComputeCrossSectionPerAtom(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4PolarizedAnnihilation::ComputeSaturationFactor(), G4PolarizedIonisation::ComputeSaturationFactor(), G4ReplicaNavigation::ComputeTransformation(), G4DNABoundingBox::contains(), G4Qt3DUtils::ConvertToQVector3D(), G4UIcommand::ConvertToString(), G4TheRayTracer::CreateBitMap(), G4FastStep::CreateSecondaryTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4GenericTrap::CreateTessellatedSolid(), G4TessellatedSolid::CreateVertexList(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4MuonDecayChannelWithSpin::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4PolarizedAnnihilationXS::DefineCoefficients(), G4PolarizedComptonXS::DefineCoefficients(), G4PolyPhiFace::Distance(), G4PolyconeSide::DistanceAway(), G4VTwistSurface::DistanceToBoundary(), G4Box::DistanceToIn(), G4Cons::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Para::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4Trd::DistanceToIn(), G4Tubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4Hype::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4TessellatedSolid::DistanceToInNoVoxels(), G4Orb::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4Box::DistanceToOut(), G4Cons::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Para::DistanceToOut(), G4Sphere::DistanceToOut(), G4Torus::DistanceToOut(), G4Trap::DistanceToOut(), G4Trd::DistanceToOut(), G4Tubs::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4ReplicaNavigation::DistanceToOutRad(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4LatticeLogical::Dump_NMap(), mcscore.MCVertex::dump_vertex(), G4FastStep::DumpInfo(), G4ParticleChange::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChangeForMSC::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), G4VSolid::EstimateSurfaceArea(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), G4PolyPhiFace::Extent(), G4FTFModel::FinalizeKinematics(), G4QGSParticipants::FinalizeKinematics(), FlipP3(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4DNABoundingBox::G4DNABoundingBox(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4Fancy3DNucleusHelperForSortInZ(), G4Para::G4Para(), G4RandomPointOnEllipsoid(), G4TUniformMagneticField::G4TUniformMagneticField(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VPhysicalVolume::G4VPhysicalVolume(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4SPSAngDistribution::GenerateUserDefFlux(), G4TwistBoxSide::GetAreaCode(), G4TwistTrapAlphaSide::GetAreaCode(), G4TwistTrapParallelSide::GetAreaCode(), G4TwistTubsHypeSide::GetAreaCode(), G4TwistTubsSide::GetAreaCode(), G4VTwistSurface::GetBoundaryAtPZ(), G4ChannelingMaterialData::GetBR(), G4Voxelizer::GetCandidatesVoxelArray(), G4MultiUnion::GetCubicVolume(), G4ScaledSolid::GetCubicVolume(), G4CutTubs::GetCubicVolume(), G4Trap::GetCubicVolume(), G4SubtractionSolid::GetCubicVolume(), G4UnionSolid::GetCubicVolume(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4EllipticalCone::GetExtent(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4Tet::GetExtent(), G4TwistedTubs::GetExtent(), G4TwistBoxSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4TwistTrapFlatSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTubsSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4TCachedMagneticField< T_Field >::GetFieldValue(), G4TQuadrupoleMagField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4SextupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4TessellatedSolid::GetMaxZExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TessellatedSolid::GetMinZExtent(), G4TwistTubsHypeSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4CRCoalescence::GetPcm(), G4PolyconeSide::GetPhi(), G4PolyhedraSide::GetPhi(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapAlphaSide::GetPhiUAtX(), G4TwistTrapParallelSide::GetPhiUAtX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4CutTubs::GetPointOnSurface(), G4Polyhedra::GetPointOnSurface(), G4PrimaryParticle::GetPz(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4ScoringBox::GetReplicaPosition(), G4TwistTubsHypeSide::GetRhoAtPZ(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4ScaledSolid::GetScaleTransform(), G4PolarizationHelper::GetSpinInPRF(), G4CutTubs::GetSurfaceArea(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetZPositionInNucleus(), G4FTFModel::Init(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedAnnihilationXS::Initialize(), G4PolarizedBremsstrahlungXS::Initialize(), G4PolarizedComptonXS::Initialize(), G4PolarizedGammaConversionXS::Initialize(), G4PolarizedIonisationBhabhaXS::Initialize(), G4PolarizedIonisationMollerXS::Initialize(), G4UnionSolid::Inside(), G4Box::Inside(), G4Cons::Inside(), G4Para::Inside(), G4Sphere::Inside(), G4Torus::Inside(), G4Trap::Inside(), G4Trd::Inside(), G4Tubs::Inside(), G4Ellipsoid::Inside(), G4EllipticalCone::Inside(), G4EllipticalTube::Inside(), G4ExtrudedSolid::Inside(), G4GenericTrap::Inside(), G4Hype::Inside(), G4Paraboloid::Inside(), G4TwistedTubs::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4TessellatedSolid::InsideNoVoxels(), G4TessellatedSolid::InsideVoxels(), G4PolyPhiFace::Intersect(), G4Hype::IntersectHype(), G4CutTubs::IsCrossingCutPlanes(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), G4PSFlatSurfaceCurrent::IsSelectedSurface(), G4PSFlatSurfaceFlux::IsSelectedSurface(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4VScoringMesh::List(), G4ReactionProduct::Lorentz(), G4GenericTrap::MakeDownFacet(), G4ExtrudedSolid::MakeDownFacet(), G4Para::MakePlanes(), G4GenericTrap::MakeUpFacet(), G4ExtrudedSolid::MakeUpFacet(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4Voxelizer::MinDistanceToBox(), G4GDMLWriteSolids::MultiUnionWrite(), G4EnclosingCylinder::MustBeOutside(), G4PolyPhiFace::Normal(), G4TessellatedSolid::Normal(), G4GenericTrap::NormalToPlane(), G4GDMLWriteSolids::G4ThreeVectorCompare::operator()(), CLHEP::operator<<(), G4VoxelLimits::OutCode(), G4TessellatedSolid::OutsideOfExtent(), G4DNABoundingBox::overlap(), p3(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), PolDiv(), PolSqr(), PolSqrt(), G4Channeling::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), G4PrimaryParticle::Print(), G4CascadeHistory::PrintEntry(), mcscore.MCVertex::printout(), G4MCTSimParticle::PrintSingle(), G4DriverReporter::PrintStat_Aux(), G4MagInt_Driver::PrintStat_Aux(), G4OldMagIntDriver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ExtrudedSolid::ProjectPoint(), G4ErrorFreeTrajState::PropagateError(), CLHEP::Hep3Vector::pseudoRapidity(), G4MoleculeShoot::RandomPosInBox(), CLHEP::Hep3Vector::rapidity(), G4STRead::Read(), G4GDMLReadSolids::ReflectedSolidRead(), G4MicroElecSurface::Reflexion(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4DNABoundingBox::resize(), CLHEP::Hep3Vector::rotate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), G4StatMFChannel::RotateMomentum(), CLHEP::Hep3Vector::rotateUz(), CLHEP::Hep3Vector::rotateX(), CLHEP::Hep3Vector::rotateY(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4MultiUnion::SafetyFromOutsideNumberNode(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNARelativisticIonisationModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel_new::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4DiffuseElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4AntiNuclElastic::SampleThetaLab(), G4GammaTransition::SampleTransition(), G4DNAIRT::Sampling(), G4DNAIRT_geometries::Sampling(), G4GDMLWriteDefine::Scale_vectorWrite(), G4GDMLReadSolids::ScaledSolidRead(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), CLHEP::HepBoost::set(), G4Tet::SetBoundingLimits(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylTheta(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), CLHEP::Hep3Vector::setEta(), G4UniformMagField::SetFieldValue(), G4TUniformMagneticField::SetFieldValue(), CLHEP::Hep3Vector::setMag(), G4ScoringMessenger::SetNewValue(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), G4PrimaryParticle::SetPolarization(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4VPhysicalVolume::SetTranslation(), G4FTFParticipants::ShiftInteractionTime(), G4RayShooter::Shoot(), G4ITSteppingVerbose::ShowStep(), G4SteppingVerbose::ShowStep(), G4SteppingVerboseWithUnits::ShowStep(), G4Torus::SolveNumericJT(), G4AttCheck::Standard(), G4ITSteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4SteppingVerboseWithUnits::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4ScaledSolid::StreamInfo(), G4Box::SurfaceNormal(), G4Cons::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Hype::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Tet::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4Torus::TorusRootsJT(), G4PolarizedComptonXS::TotalXSection(), G4PolarizedIonisationBhabhaXS::TotalXSection(), G4PolarizedIonisationMollerXS::TotalXSection(), G4SteppingVerbose::TrackingStarted(), G4SteppingVerboseWithUnits::TrackingStarted(), G4ITSteppingVerbose::TrackingStarted(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BoundingEnvelope::TransformVertices(), G4DNABoundingBox::translate(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4GDMLWriteStructure::TraverseVolumeTree(), G4Channeling::UpdateParameters(), G4ITSteppingVerbose::VerboseTrack(), G4SteppingVerbose::VerboseTrack(), and G4SteppingVerboseWithUnits::VerboseTrack().

Field Documentation

◆ data

double CLHEP::Hep3Vector::data[3]
protectedinherited

Definition at line 391 of file ThreeVector.h.

◆ fIsPhoton

G4bool G4StokesVector::fIsPhoton
private

Definition at line 99 of file G4StokesVector.hh.

Referenced by GetBeta(), RotateAz(), and SetPhoton().

◆ M1

const G4StokesVector G4StokesVector::M1
static
Initial value:
=

Definition at line 94 of file G4StokesVector.hh.

◆ M2

const G4StokesVector G4StokesVector::M2
static
Initial value:
=

Definition at line 95 of file G4StokesVector.hh.

◆ M3

const G4StokesVector G4StokesVector::M3
static
Initial value:
=

Definition at line 96 of file G4StokesVector.hh.

◆ P1

const G4StokesVector G4StokesVector::P1
static

◆ P2

const G4StokesVector G4StokesVector::P2
static

◆ P3

const G4StokesVector G4StokesVector::P3
static

◆ tolerance

double CLHEP::Hep3Vector::tolerance = Hep3Vector::ToleranceTicks * 2.22045e-16
staticprotectedinherited

Definition at line 394 of file ThreeVector.h.

Referenced by CLHEP::Hep3Vector::setTolerance().

◆ ZERO

const G4StokesVector G4StokesVector::ZERO
static

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