Geant4.10
|
#include <ThreeVector.h>
Public Types | |
enum | { X =0, Y =1, Z =2, NUM_COORDINATES =3, SIZE =NUM_COORDINATES } |
enum | { ToleranceTicks = 100 } |
Public Member Functions | |
Hep3Vector () | |
Hep3Vector (double x) | |
Hep3Vector (double x, double y) | |
Hep3Vector (double x, double y, double z) | |
Hep3Vector (const Hep3Vector &) | |
~Hep3Vector () | |
double | operator() (int) const |
double | operator[] (int) const |
double & | operator() (int) |
double & | operator[] (int) |
double | x () const |
double | y () const |
double | z () const |
void | setX (double) |
void | setY (double) |
void | setZ (double) |
void | set (double x, double y, double z) |
double | phi () const |
double | theta () const |
double | cosTheta () const |
double | cos2Theta () const |
double | mag2 () const |
double | mag () const |
void | setPhi (double) |
void | setTheta (double) |
void | setMag (double) |
double | perp2 () const |
double | perp () const |
void | setPerp (double) |
void | setCylTheta (double) |
double | perp2 (const Hep3Vector &) const |
double | perp (const Hep3Vector &) const |
Hep3Vector & | operator= (const Hep3Vector &) |
bool | operator== (const Hep3Vector &) const |
bool | operator!= (const Hep3Vector &) const |
bool | isNear (const Hep3Vector &, double epsilon=tolerance) const |
double | howNear (const Hep3Vector &v) const |
double | deltaR (const Hep3Vector &v) const |
Hep3Vector & | operator+= (const Hep3Vector &) |
Hep3Vector & | operator-= (const Hep3Vector &) |
Hep3Vector | operator- () const |
Hep3Vector & | operator*= (double) |
Hep3Vector & | operator/= (double) |
Hep3Vector | unit () const |
Hep3Vector | orthogonal () const |
double | dot (const Hep3Vector &) const |
Hep3Vector | cross (const Hep3Vector &) const |
double | angle (const Hep3Vector &) const |
double | pseudoRapidity () const |
void | setEta (double p) |
void | setCylEta (double p) |
Hep3Vector & | rotateX (double) |
Hep3Vector & | rotateY (double) |
Hep3Vector & | rotateZ (double) |
Hep3Vector & | rotateUz (const Hep3Vector &) |
Hep3Vector & | rotate (double, const Hep3Vector &) |
Hep3Vector & | operator*= (const HepRotation &) |
Hep3Vector & | transform (const HepRotation &) |
void | setRThetaPhi (double r, double theta, double phi) |
void | setREtaPhi (double r, double eta, double phi) |
void | setRhoPhiZ (double rho, double phi, double z) |
void | setRhoPhiTheta (double rho, double phi, double theta) |
void | setRhoPhiEta (double rho, double phi, double eta) |
double | getX () const |
double | getY () const |
double | getZ () const |
double | getR () const |
double | getTheta () const |
double | getPhi () const |
double | r () const |
double | rho () const |
double | getRho () const |
double | eta () const |
double | getEta () const |
void | setR (double s) |
void | setRho (double s) |
int | compare (const Hep3Vector &v) const |
bool | operator> (const Hep3Vector &v) const |
bool | operator< (const Hep3Vector &v) const |
bool | operator>= (const Hep3Vector &v) const |
bool | operator<= (const Hep3Vector &v) const |
double | diff2 (const Hep3Vector &v) const |
bool | isParallel (const Hep3Vector &v, double epsilon=tolerance) const |
bool | isOrthogonal (const Hep3Vector &v, double epsilon=tolerance) const |
double | howParallel (const Hep3Vector &v) const |
double | howOrthogonal (const Hep3Vector &v) const |
double | beta () const |
double | gamma () const |
double | coLinearRapidity () const |
double | angle () const |
double | theta (const Hep3Vector &v2) const |
double | cosTheta (const Hep3Vector &v2) const |
double | cos2Theta (const Hep3Vector &v2) const |
Hep3Vector | project () const |
Hep3Vector | project (const Hep3Vector &v2) const |
Hep3Vector | perpPart () const |
Hep3Vector | perpPart (const Hep3Vector &v2) const |
double | rapidity () const |
double | rapidity (const Hep3Vector &v2) const |
double | eta (const Hep3Vector &v2) const |
double | polarAngle (const Hep3Vector &v2) const |
double | deltaPhi (const Hep3Vector &v2) const |
double | azimAngle (const Hep3Vector &v2) const |
double | polarAngle (const Hep3Vector &v2, const Hep3Vector &ref) const |
double | azimAngle (const Hep3Vector &v2, const Hep3Vector &ref) const |
Hep3Vector & | rotate (const Hep3Vector &axis, double delta) |
Hep3Vector & | rotate (const HepAxisAngle &ax) |
Hep3Vector & | rotate (const HepEulerAngles &e) |
Hep3Vector & | rotate (double phi, double theta, double psi) |
Static Public Member Functions | |
static double | setTolerance (double tol) |
static double | getTolerance () |
Protected Member Functions | |
void | setSpherical (double r, double theta, double phi) |
void | setCylindrical (double r, double phi, double z) |
double | negativeInfinity () const |
Protected Attributes | |
double | dx |
double | dy |
double | dz |
Static Protected Attributes | |
static DLL_API double | tolerance = Hep3Vector::ToleranceTicks * 2.22045e-16 |
Definition at line 41 of file ThreeVector.h.
anonymous enum |
Enumerator | |
---|---|
X | |
Y | |
Z | |
NUM_COORDINATES | |
SIZE |
Definition at line 47 of file ThreeVector.h.
anonymous enum |
CLHEP::Hep3Vector::Hep3Vector | ( | ) |
|
explicit |
CLHEP::Hep3Vector::Hep3Vector | ( | double | x, |
double | y | ||
) |
CLHEP::Hep3Vector::Hep3Vector | ( | double | x, |
double | y, | ||
double | z | ||
) |
|
inline |
|
inline |
double CLHEP::Hep3Vector::angle | ( | const Hep3Vector & | ) | const |
|
inline |
Referenced by polarAngle().
double CLHEP::Hep3Vector::azimAngle | ( | const Hep3Vector & | v2 | ) | const |
double CLHEP::Hep3Vector::azimAngle | ( | const Hep3Vector & | v2, |
const Hep3Vector & | ref | ||
) | const |
Definition at line 40 of file SpaceVectorD.cc.
References angle(), cross(), dot(), mag2(), and perpPart().
double CLHEP::Hep3Vector::beta | ( | ) | const |
Definition at line 30 of file SpaceVectorP.cc.
References test::b, and mag2().
Referenced by G4QMDReaction::ApplyYourself(), coLinearRapidity(), CLHEP::HepRotationZ::distance2(), CLHEP::HepRotationY::distance2(), CLHEP::HepRotationX::distance2(), and CLHEP::HepRotation::distance2().
double CLHEP::Hep3Vector::coLinearRapidity | ( | ) | const |
int CLHEP::Hep3Vector::compare | ( | const Hep3Vector & | v | ) | const |
Definition at line 122 of file SpaceVector.cc.
Referenced by CLHEP::HepLorentzVector::compare(), operator<(), operator<=(), operator>(), and operator>=().
|
inline |
double CLHEP::Hep3Vector::cos2Theta | ( | const Hep3Vector & | v2 | ) | const |
Definition at line 201 of file ThreeVector.cc.
|
inline |
Referenced by G4PenelopeBremsstrahlungModel::SampleSecondaries().
double CLHEP::Hep3Vector::cosTheta | ( | const Hep3Vector & | v2 | ) | const |
Definition at line 188 of file ThreeVector.cc.
|
inline |
Referenced by G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), azimAngle(), G4PolyconeSide::CalculateExtent(), G4NucleiModel::choosePointAlongTraj(), G4tgbVolume::ConstructG4PhysVol(), G4SPSAngDistribution::DefineAngRefAxes(), ExGflashEventAction::EndOfEventAction(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4gsrotm(), G4PlaneVectorRand(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4TriangularFacet::G4TriangularFacet(), G4PrimaryTransformer::GenerateSingleTrack(), G4PolarizationHelper::GetFrame(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), howOrthogonal(), howParallel(), G4TriangularFacet::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), G4StokesVector::InvRotateAz(), isOrthogonal(), isParallel(), G4Trap::MakePlane(), G4PolyconeSide::PointOnCone(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4QuasiElRatios::RelDecayIn2(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), G4StokesVector::RotateAz(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), OpNovicePrimaryGeneratorAction::SetOptPhotonPolar(), WLSPrimaryGeneratorAction::SetOptPhotonPolar(), G4ErrorSurfaceTrajParam::SetParameters(), G4GenericTrap::SurfaceNormal(), G4PolarizationHelper::TestPolarizationTransformations(), and FCALSteppingAction::UserSteppingAction().
double CLHEP::Hep3Vector::deltaPhi | ( | const Hep3Vector & | v2 | ) | const |
Definition at line 172 of file ThreeVector.cc.
References getPhi().
Referenced by deltaR(), and CLHEP::HepLorentzVector::deltaR().
double CLHEP::Hep3Vector::deltaR | ( | const Hep3Vector & | v | ) | const |
Definition at line 182 of file ThreeVector.cc.
References test::a, test::b, deltaPhi(), and eta().
|
inline |
|
inline |
Referenced by G4VIntersectionLocator::AdjustmentOfFoundIntersection(), G4MagHelicalStepper::AdvanceHelix(), azimAngle(), CLHEP::HepLorentzVector::boost(), G4NucleiModel::boundaryTransition(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), cos2Theta(), cosTheta(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4PolyPhiFace::Distance(), G4PolyhedraSide::Distance(), G4PolyhedraSide::DistanceAway(), G4CutTubs::DistanceToIn(), G4Tet::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4Cons::DistanceToIn(), G4PolyhedraSide::DistanceToOneSide(), G4CutTubs::DistanceToOut(), G4Tet::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Cons::DistanceToOut(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), eta(), G4TriangularFacet::Extent(), G4QuadrangularFacet::Extent(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), G4LorentzConvertor::fillKinematics(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4TriangularFacet::G4TriangularFacet(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4MultiNavigator::GetGlobalExitNormal(), G4CascadParticle::getPathToTheNextZone(), G4ClippablePolygon::GetPlanerExtent(), G4RKPropagation::GetSphereIntersectionTimes(), howNear(), CLHEP::HepLorentzVector::howNear(), CLHEP::HepLorentzVector::howNearCM(), howOrthogonal(), howParallel(), G4NucleiModel::initializeCascad(), G4Tet::Inside(), G4PolyPhiFace::Inside(), G4TriangularFacet::Intersect(), G4PolyPhiFace::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), G4VFacet::IsInside(), isNear(), CLHEP::HepLorentzVector::isNear(), CLHEP::HepLorentzVector::isNearCM(), isOrthogonal(), isParallel(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator::LocateGlobalPointAndSetup(), G4GHEKinematicsVector::Lor(), G4Trap::MakePlane(), CLHEP::HepLorentzVector::minus(), G4PolyPhiFace::Normal(), CLHEP::HepLorentzVector::plus(), G4PolyconeSide::PointOnCone(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4MagInt_Driver::PrintStatus(), project(), rapidity(), CLHEP::HepLorentzVector::rapidity(), G4VIntersectionLocator::ReportTrialStep(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), CLHEP::HepRotation::set(), G4ErrorFreeTrajParam::SetParameters(), G4ErrorSurfaceTrajParam::SetParameters(), and G4Tet::SurfaceNormal().
double CLHEP::Hep3Vector::eta | ( | ) | const |
Referenced by deltaR().
double CLHEP::Hep3Vector::eta | ( | const Hep3Vector & | v2 | ) | const |
Definition at line 117 of file SpaceVectorP.cc.
References test::c, dot(), getR(), mag(), and negativeInfinity().
double CLHEP::Hep3Vector::gamma | ( | ) | const |
double CLHEP::Hep3Vector::getEta | ( | ) | const |
|
inline |
Referenced by deltaPhi(), G4StokesVector::GetBeta(), G4LatticeLogical::MapKtoV(), G4LatticeLogical::MapKtoVDir(), setCylEta(), setCylTheta(), and setEta().
|
inline |
Referenced by eta(), G4SynchrotronRadiation::GetMeanFreePath(), and setEta().
|
inline |
|
inline |
Referenced by G4LatticeLogical::MapKtoV(), G4LatticeLogical::MapKtoVDir(), and polarAngle().
|
inlinestatic |
|
inline |
Referenced by CML2ExpVoxels::add(), CLHEP::HepLorentzVector::boostX(), CML2ReadOutGeometry::Build(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), CML2PhantomConstruction::Construct(), CML2AcceleratorConstruction::Construct(), CML2Ph_FullWater::Construct(), CML2Ph_BoxInBox::Construct(), CML2PhaseSpaces::createPlane(), G4GDMLWriteSolids::CutTubeWrite(), G4FissionProductYieldDist::G4GetFission(), CML2PhantomConstruction::getCurrentTranslationString(), HadrontherapyDetectorConstruction::GetDetectorToPhantomPosition(), IORTDetectorConstruction::GetDetectorToPhantomPosition(), G4DecayProducts::IsChecked(), HadrontherapyDetectorConstruction::IsInside(), IORTDetectorConstruction::IsInside(), CML2ExpVoxels::loadData(), HadrontherapyDetectorConstruction::PrintParameters(), IORTDetectorConstruction::PrintParameters(), XAluminumElectrodeSensitivity::ProcessHits(), CML2SDWithVoxels::resetVoxelsSingle(), rotate(), CLHEP::HepRotation::set(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), HadrontherapyDetectorMessenger::SetNewValue(), IORTDetectorMessenger::SetNewValue(), CML2CInputData::setPhaseSpaceCentre(), and CML2CInputData::setPhaseSpaceHalfSize().
|
inline |
Referenced by CML2ExpVoxels::add(), CLHEP::HepLorentzVector::boostY(), CML2ReadOutGeometry::Build(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), CML2PhantomConstruction::Construct(), CML2AcceleratorConstruction::Construct(), CML2Ph_FullWater::Construct(), CML2Ph_BoxInBox::Construct(), CML2PhaseSpaces::createPlane(), G4GDMLWriteSolids::CutTubeWrite(), G4FissionProductYieldDist::G4GetFission(), CML2PhantomConstruction::getCurrentTranslationString(), HadrontherapyDetectorConstruction::GetDetectorToPhantomPosition(), IORTDetectorConstruction::GetDetectorToPhantomPosition(), G4DecayProducts::IsChecked(), HadrontherapyDetectorConstruction::IsInside(), IORTDetectorConstruction::IsInside(), CML2ExpVoxels::loadData(), HadrontherapyDetectorConstruction::PrintParameters(), IORTDetectorConstruction::PrintParameters(), XAluminumElectrodeSensitivity::ProcessHits(), CML2SDWithVoxels::resetVoxelsSingle(), rotate(), CLHEP::HepRotation::set(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), HadrontherapyDetectorMessenger::SetNewValue(), IORTDetectorMessenger::SetNewValue(), CML2CInputData::setPhaseSpaceCentre(), and CML2CInputData::setPhaseSpaceHalfSize().
|
inline |
Referenced by CML2ExpVoxels::add(), G4FTFAnnihilation::Annihilate(), CLHEP::HepLorentzVector::boostZ(), CML2ReadOutGeometry::Build(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), CML2PhantomConstruction::Construct(), CML2AcceleratorConstruction::Construct(), CML2Ph_FullWater::Construct(), CML2Ph_BoxInBox::Construct(), CML2PhaseSpaces::createPlane(), G4GDMLWriteSolids::CutTubeWrite(), G4FissionProductYieldDist::G4GetFission(), CML2PhantomConstruction::getCurrentTranslationString(), HadrontherapyDetectorConstruction::GetDetectorToPhantomPosition(), IORTDetectorConstruction::GetDetectorToPhantomPosition(), G4DecayProducts::IsChecked(), HadrontherapyDetectorConstruction::IsInside(), IORTDetectorConstruction::IsInside(), CML2ExpVoxels::loadData(), HadrontherapyDetectorConstruction::PrintParameters(), IORTDetectorConstruction::PrintParameters(), XAluminumElectrodeSensitivity::ProcessHits(), CLHEP::HepLorentzVector::rapidity(), CML2SDWithVoxels::resetVoxelsSingle(), rotate(), CLHEP::HepRotation::set(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), HadrontherapyDetectorMessenger::SetNewValue(), IORTDetectorMessenger::SetNewValue(), CML2CInputData::setPhaseSpaceCentre(), and CML2CInputData::setPhaseSpaceHalfSize().
double CLHEP::Hep3Vector::howNear | ( | const Hep3Vector & | v | ) | const |
Definition at line 159 of file ThreeVector.cc.
References dot(), mag2(), and test::v.
double CLHEP::Hep3Vector::howOrthogonal | ( | const Hep3Vector & | v | ) | const |
Definition at line 219 of file SpaceVector.cc.
References cross(), dot(), and mag().
Referenced by G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LivermorePolarizedComptonModel::SampleSecondaries(), and G4LivermorePolarizedGammaConversionModel::SampleSecondaries().
double CLHEP::Hep3Vector::howParallel | ( | const Hep3Vector & | v | ) | const |
bool CLHEP::Hep3Vector::isNear | ( | const Hep3Vector & | v, |
double | epsilon = tolerance |
||
) | const |
Definition at line 154 of file ThreeVector.cc.
bool CLHEP::Hep3Vector::isOrthogonal | ( | const Hep3Vector & | v, |
double | epsilon = tolerance |
||
) | const |
Definition at line 237 of file SpaceVector.cc.
References cross(), dot(), dx, dy, dz, and mag2().
Referenced by G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LivermorePolarizedComptonModel::SampleSecondaries(), and G4LivermorePolarizedGammaConversionModel::SampleSecondaries().
bool CLHEP::Hep3Vector::isParallel | ( | const Hep3Vector & | v, |
double | epsilon = tolerance |
||
) | const |
|
inline |
Referenced by G4NeutronHPFinalState::adjust_final_state(), G4MagHelicalStepper::AdvanceHelix(), G4BinaryLightIonReaction::ApplyYourself(), G4RPGKMinusInelastic::ApplyYourself(), G4RPGNeutronInelastic::ApplyYourself(), G4RPGProtonInelastic::ApplyYourself(), G4RPGAntiLambdaInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGSigmaPlusInelastic::ApplyYourself(), G4RPGXiMinusInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiNeutronInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGOmegaMinusInelastic::ApplyYourself(), G4RPGAntiXiZeroInelastic::ApplyYourself(), G4RPGKZeroInelastic::ApplyYourself(), G4RPGLambdaInelastic::ApplyYourself(), G4RPGKPlusInelastic::ApplyYourself(), G4NeutronHPCaptureFS::ApplyYourself(), G4RPGSigmaMinusInelastic::ApplyYourself(), G4RPGXiZeroInelastic::ApplyYourself(), G4RPGAntiKZeroInelastic::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4LENDInelastic::ApplyYourself(), G4LENDCapture::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4NeutronHPInelasticBaseFS::BaseApply(), G4NucleiModel::boundaryTransition(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4RPGInelastic::CalculateMomenta(), G4QMDCollision::CalKinematicsOfBinaryCollisions(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4NucleiModel::choosePointAlongTraj(), CLHEP::HepLorentzVector::coLinearRapidity(), RE01Trajectory::CreateAttValues(), F04Trajectory::CreateAttValues(), WLSTrajectory::CreateAttValues(), G4SmoothTrajectory::CreateAttValues(), G4Trajectory::CreateAttValues(), RE04Trajectory::CreateAttValues(), G4VPhononProcess::CreateSecondary(), G4DiffractiveExcitation::CreateStrings(), G4AdjointCrossSurfChecker::CrossingASphere(), G4AblaInterface::DeExcite(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4Ellipsoid::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4TwistTubsHypeSide::DistanceToSurface(), ExGflashEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4MultiLevelLocator::EstimateIntersectionPoint(), eta(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4FissionProductYieldDist::G4GetFission(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4tgbPlaceParamLinear::G4tgbPlaceParamLinear(), G4tgbPlaceParamSquare::G4tgbPlaceParamSquare(), G4TriangularFacet::G4TriangularFacet(), G4NucleiModel::generateInteractionPartners(), DicomPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4ReactionDynamics::GenerateXandPt(), G4RKFieldIntegrator::GetAntiprotonPotential(), G4Nucleus::GetBiasedThermalNucleus(), G4NeutronHPFissionData::GetCrossSection(), G4NeutronHPCaptureData::GetCrossSection(), G4NeutronHPInelasticData::GetCrossSection(), G4NeutronHPElasticData::GetCrossSection(), G4NuclearShellModelDensity::GetDeriv(), G4NuclearFermiDensity::GetDeriv(), G4ErrorCylSurfaceTarget::GetDistanceFromPoint(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4IonsKoxCrossSection::GetElementCrossSection(), G4SigmaPlusField::GetField(), G4KaonZeroField::GetField(), G4SigmaMinusField::GetField(), G4SigmaZeroField::GetField(), G4AntiProtonField::GetField(), G4KaonPlusField::GetField(), G4KaonMinusField::GetField(), G4PionPlusField::GetField(), G4PionZeroField::GetField(), G4PionMinusField::GetField(), G4NeutronField::GetField(), G4ProtonField::GetField(), G4Navigator::GetGlobalExitNormal(), G4GlauberGribovCrossSection::GetHadronNucleonXsc(), G4GGNuclNuclCrossSection::GetHadronNucleonXsc(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXsc(), G4ComponentGGNuclNuclXsc::GetHadronNucleonXsc(), G4HadronNucleonXsc::GetHadronNucleonXscEL(), G4HadronNucleonXsc::GetHadronNucleonXscNS(), G4GlauberGribovCrossSection::GetHadronNucleonXscNS(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscNS(), G4HadronNucleonXsc::GetHadronNucleonXscPDG(), G4GlauberGribovCrossSection::GetHadronNucleonXscPDG(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscPDG(), G4HadronNucleonXsc::GetHadronNucleonXscVU(), G4GlauberGribovCrossSection::GetHNinelasticXscVU(), G4GGNuclNuclCrossSection::GetHNinelasticXscVU(), G4ComponentGGNuclNuclXsc::GetHNinelasticXscVU(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXscVU(), G4NuclNuclDiffuseElastic::GetInvCoulombElasticXsc(), G4DiffuseElastic::GetInvCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetInvElasticSumXsc(), G4DiffuseElastic::GetInvElasticSumXsc(), G4NuclNuclDiffuseElastic::GetInvElasticXsc(), G4DiffuseElastic::GetInvElasticXsc(), G4IonsShenCrossSection::GetIsoCrossSection(), G4HadronNucleonXsc::GetKaonNucleonXscGG(), G4RKFieldIntegrator::GetKaonPotential(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4FermiMomentum::GetMomentum(), G4RKFieldIntegrator::GetNeutronPotential(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4RKFieldIntegrator::GetPionPotential(), G4RKFieldIntegrator::GetProtonPotential(), G4NuclearFermiDensity::GetRelativeDensity(), G4tgrUtils::GetRotationFromDirection(), G4VIntersectionLocator::GetSurfaceNormal(), G4HadProjectile::GetTotalMomentum(), howOrthogonal(), howParallel(), G4NucleiModel::initializeCascad(), G4TwistTubsHypeSide::Inside(), G4TriangularFacet::Intersect(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4DecayProducts::IsChecked(), G4GHEKinematicsVector::Length(), G4Trap::MakePlane(), CLHEP::HepLorentzVector::minus(), G4RPGReaction::MomentumCheck(), G4RPGReaction::NuclearReaction(), G4ReactionDynamics::NuclearReaction(), operator<<(), CLHEP::HepLorentzVector::plus(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), CLHEP::HepBoost::print(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), G4IntraNucleiCascader::processSecondary(), G4GeneratorPrecompoundInterface::Propagate(), G4BinaryCascade::Propagate(), G4ErrorFreeTrajState::PropagateError(), pseudoRapidity(), rapidity(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), CexmcReconstructor::ReconstructEntryPoints(), CLHEP::HepBoost::rectify(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), G4CoupledTransportation::ReportMove(), G4PathFinder::ReportMove(), G4VIntersectionLocator::ReportTrialStep(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotate(), rotate(), G4StokesVector::RotateAz(), G4AntiNuclElastic::SampleInvariantT(), G4NuclNuclDiffuseElastic::SampleInvariantT(), G4DiffuseElastic::SampleInvariantT(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), CLHEP::HepBoost::set(), G4ReactionProduct::SetDefinitionAndUpdateE(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4HadFinalState::SetMomentumChange(), G4ParticleGun::SetParticleMomentum(), G4RPGInelastic::SetUpChange(), G4QMDSystem::ShowParticipants(), G4HelixMixedStepper::Stepper(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4PolarizationHelper::TestPolarizationTransformations(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4ReactionDynamics::TwoBody(), G4ReactionDynamics::TwoCluster(), G4ParticleChangeForTransport::UpdateStepForAlongStep(), G4ParticleChange::UpdateStepForAlongStep(), and FCALSteppingAction::UserSteppingAction().
|
inline |
Referenced by G4GHEKinematicsVector::Add(), G4VMultipleScattering::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4GHEKinematicsVector::Ang(), G4FTFAnnihilation::Annihilate(), G4WilsonAbrasionModel::ApplyYourself(), azimAngle(), G4NeutronHPInelasticBaseFS::BaseApply(), beta(), CLHEP::HepLorentzVector::beta(), CLHEP::HepLorentzVector::boost(), G4KineticTrackVector::BoostBeam(), CLHEP::HepLorentzVector::boostVector(), G4StatMF::BreakItUp(), G4CompetitiveFission::BreakUp(), CalculatePointInside(), CalculatePointSafety(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4NucleiModel::choosePointAlongTraj(), G4NeutronHPInelasticCompFS::CompositeApply(), G4PathFinder::ComputeStep(), cos2Theta(), G4GHEKinematicsVector::CosAng(), cosTheta(), G4DecayWithSpin::DecayIt(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4Fancy3DNucleus::DoLorentzContraction(), G4PathFinder::DoNextLinearStep(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4LorentzConvertor::fillKinematics(), G4VElasticCollision::FinalState(), G4VScatteringCollision::FinalState(), CLHEP::HepLorentzVector::findBoostToCM(), G4VKinkyStringDecay::FragmentString(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4LineSection::G4LineSection(), G4QuadrangularFacet::G4QuadrangularFacet(), G4TriangularFacet::G4TriangularFacet(), gamma(), CLHEP::HepLorentzVector::gamma(), G4PrimaryTransformer::GenerateSingleTrack(), G4MesonAbsorption::GetFinalState(), G4StatMFFragment::GetFragment(), G4MultiNavigator::GetGlobalExitNormal(), G4Navigator::GetGlobalExitNormal(), G4VIntersectionLocator::GetGlobalSurfaceNormal(), G4Navigator::GetLocalExitNormal(), G4CascadParticle::getPathToTheNextZone(), G4NuclearShellModelDensity::GetRelativeDensity(), G4RKPropagation::GetSphereIntersectionTimes(), G4VIntersectionLocator::GetSurfaceNormal(), G4Scatterer::GetTimeToInteraction(), howNear(), CLHEP::HepLorentzVector::howNearCM(), howParallel(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), isNear(), CLHEP::HepLorentzVector::isNearCM(), isOrthogonal(), isParallel(), G4VLongitudinalStringDecay::LightFragmentationTest(), G4PathFinder::Locate(), G4GHEKinematicsVector::Lor(), G4GHEKinematicsVector::Norz(), G4MagInt_Driver::OneGoodStep(), G4MagInt_Driver::PrintStat_Aux(), project(), G4GeneratorPrecompoundInterface::Propagate(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), G4MagInt_Driver::QuickAdvance(), CLHEP::HepLorentzVector::rapidity(), CexmcChargeExchangeReconstructor::Reconstruct(), CLHEP::HepBoost::rectify(), G4QuasiElRatios::RelDecayIn2(), G4PathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4VIntersectionLocator::ReportTrialStep(), CLHEP::HepRotation::rotateAxes(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4QuasiElasticChannel::Scatter(), G4DynamicParticle::Set4Momentum(), G4DynamicParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4KineticTrack::SetTrackingMomentum(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub(), G4Paraboloid::SurfaceNormal(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4KineticTrack::Update4Momentum(), and G4KineticTrack::UpdateTrackingMomentum().
|
protected |
|
inline |
double CLHEP::Hep3Vector::operator() | ( | int | i | ) | const |
Definition at line 38 of file ThreeVector.cc.
References X, x(), Y, y(), Z, and z().
double & CLHEP::Hep3Vector::operator() | ( | int | i | ) |
Definition at line 54 of file ThreeVector.cc.
|
inline |
Referenced by rotate().
Hep3Vector & CLHEP::Hep3Vector::operator*= | ( | const HepRotation & | m1 | ) |
Definition at line 20 of file ThreeVectorR.cc.
|
inline |
|
inline |
|
inline |
Hep3Vector & CLHEP::Hep3Vector::operator/= | ( | double | c | ) |
bool CLHEP::Hep3Vector::operator< | ( | const Hep3Vector & | v | ) | const |
bool CLHEP::Hep3Vector::operator<= | ( | const Hep3Vector & | v | ) | const |
|
inline |
|
inline |
bool CLHEP::Hep3Vector::operator> | ( | const Hep3Vector & | v | ) | const |
bool CLHEP::Hep3Vector::operator>= | ( | const Hep3Vector & | v | ) | const |
|
inline |
|
inline |
|
inline |
|
inline |
Referenced by G4PolyconeSide::DistanceAway(), G4Hype::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), H02MuonHit::Draw(), G4PolyconeSide::Extent(), G4ErrorCylSurfaceTarget::GetDistanceFromPoint(), G4ErrorCylSurfaceTarget::GetTangentPlane(), G4PolyconeSide::Intersect(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4PolyconeSide::PointOnCone(), H02MuonHit::Print(), G4ErrorFreeTrajState::PropagateError(), G4EnclosingCylinder::ShouldMiss(), and G4StokesVector::Transverse().
|
inline |
|
inline |
|
inline |
|
inline |
Referenced by azimAngle().
|
inline |
|
inline |
Referenced by G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4tgbVolume::BuildSolidForDivision(), G4RadioactiveDecay::ChooseCollimationDirection(), G4ParameterisationParaX::ComputeDimensions(), G4ParameterisationParaY::ComputeDimensions(), G4ParameterisationParaZ::ComputeDimensions(), G4TheRayTracer::CreateBitMap(), G4VParameterisationPara::G4VParameterisationPara(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4PolyconeSide::GetPhi(), G4PolyhedraSide::GetPhi(), and G4MatScanMessenger::SetNewValue().
double CLHEP::Hep3Vector::polarAngle | ( | const Hep3Vector & | v2 | ) | const |
double CLHEP::Hep3Vector::polarAngle | ( | const Hep3Vector & | v2, |
const Hep3Vector & | ref | ||
) | const |
|
inline |
Referenced by project().
Hep3Vector CLHEP::Hep3Vector::project | ( | const Hep3Vector & | v2 | ) | const |
Definition at line 89 of file SpaceVectorP.cc.
References dot(), mag2(), and project().
double CLHEP::Hep3Vector::pseudoRapidity | ( | ) | const |
Definition at line 92 of file ThreeVector.cc.
|
inline |
double CLHEP::Hep3Vector::rapidity | ( | ) | const |
double CLHEP::Hep3Vector::rapidity | ( | const Hep3Vector & | v2 | ) | const |
Definition at line 100 of file SpaceVectorP.cc.
|
inline |
Hep3Vector & CLHEP::Hep3Vector::rotate | ( | double | aangle, |
const Hep3Vector & | aaxis | ||
) |
Definition at line 28 of file ThreeVectorR.cc.
References operator*=(), and CLHEP::HepRotation::rotate().
Referenced by G4NucleiModel::choosePointAlongTraj(), G4tgbPlaceParamCircle::ComputeTransformation(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4LatticePhysical::MapKtoV(), G4LatticePhysical::MapKtoVDir(), G4HadronElasticProcess::PostStepDoIt(), G4RPGReaction::Rotate(), CLHEP::HepLorentzVector::rotate(), rotate(), CLHEP::rotationOf(), and G4RPGInelastic::SetUpChange().
Hep3Vector & CLHEP::Hep3Vector::rotate | ( | const Hep3Vector & | axis, |
double | delta | ||
) |
Hep3Vector & CLHEP::Hep3Vector::rotate | ( | const HepAxisAngle & | ax | ) |
Definition at line 112 of file SpaceVectorR.cc.
References CLHEP::HepAxisAngle::delta(), CLHEP::HepAxisAngle::getAxis(), and rotate().
Hep3Vector & CLHEP::Hep3Vector::rotate | ( | const HepEulerAngles & | e | ) |
Definition at line 116 of file SpaceVectorR.cc.
References CLHEP::HepEulerAngles::phi(), CLHEP::HepEulerAngles::psi(), rotate(), and CLHEP::HepEulerAngles::theta().
Hep3Vector & CLHEP::Hep3Vector::rotate | ( | double | phi, |
double | theta, | ||
double | psi | ||
) |
Definition at line 74 of file SpaceVectorR.cc.
Hep3Vector & CLHEP::Hep3Vector::rotateUz | ( | const Hep3Vector & | NewUzVector | ) |
Definition at line 72 of file ThreeVector.cc.
References dx, dy, dz, x(), y(), and z().
Referenced by G4eplusAnnihilation::AtRestDoIt(), G4GEMChannel::BreakUp(), G4TheRayTracer::CreateBitMap(), G4MuonDecayChannelWithSpin::DecayIt(), G4PionRadiativeDecayChannel::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4SingleScatter::DoCollisionStep(), G4FissionProductYieldDist::G4GetFission(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), PrimaryGeneratorAction3::GeneratePrimaries(), PrimaryGeneratorAction4::GeneratePrimaries(), G4RDPhotoElectricAngularGeneratorSauterGavrila::GetPhotoElectronDirection(), G4HadronElasticProcess::PostStepDoIt(), G4LowEnergyRayleigh::PostStepDoIt(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyGammaConversion::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), CLHEP::HepLorentzVector::rotateUz(), G4DeltaAngleFreeScat::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4DeltaAngle::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4Generator2BN::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BS::SampleDirection(), G4WentzelVIModel::SampleScattering(), G4WentzelVIRelModel::SampleScattering(), G4GoudsmitSaundersonMscModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), MyKleinNishinaCompton::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4DNARuddIonisationExtendedModel::SampleSecondaries(), G4DNARuddIonisationModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4DNABornIonisationModel::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4ee2KNeutralModel::SampleSecondaries(), G4ee2KChargedModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4eeToTwoPiModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4eeToPGammaModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4PAIPhotonModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4PolarizationHelper::TestInteractionFrame(), and G4PAIPhotonModel::TestSecondaries().
Hep3Vector & CLHEP::Hep3Vector::rotateX | ( | double | phi1 | ) |
Definition at line 124 of file ThreeVector.cc.
Referenced by CLHEP::HepLorentzVector::rotateX(), and CLHEP::rotationXOf().
Hep3Vector & CLHEP::Hep3Vector::rotateY | ( | double | phi1 | ) |
Definition at line 134 of file ThreeVector.cc.
Referenced by CLHEP::HepLorentzVector::rotateY(), and CLHEP::rotationYOf().
Hep3Vector & CLHEP::Hep3Vector::rotateZ | ( | double | phi1 | ) |
Definition at line 144 of file ThreeVector.cc.
Referenced by H02DetectorConstruction::Construct(), G4TheRayTracer::CreateBitMap(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), CLHEP::HepLorentzVector::rotateZ(), and CLHEP::rotationZOf().
|
inline |
Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4NucleiModel::choosePointAlongTraj(), G4HadFinalState::Clear(), CML2ExpVoxels::CML2ExpVoxels(), CML2Ph_BoxInBox::CML2Ph_BoxInBox(), CML2Ph_FullWater::CML2Ph_FullWater(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), CML2AcceleratorConstruction::Construct(), CML2Ph_BoxInBox::Construct(), G4DiffractiveExcitation::CreateStrings(), G4VTwistSurface::CurrentStatus::CurrentStatus(), CLHEP::HepRotationY::decompose(), CLHEP::HepRotationZ::decompose(), CLHEP::HepRotationX::decompose(), CLHEP::HepRotation::decompose(), G4VTwistSurface::DistanceToBoundary(), G4VTwistedFaceted::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4FissionProductYieldDist::G4GetFission(), G4LatticeLogical::G4LatticeLogical(), G4TessellatedSolid::G4TessellatedSolid(), G4TriangularFacet::G4TriangularFacet(), G4TwistBoxSide::G4TwistBoxSide(), G4TwistTrapAlphaSide::G4TwistTrapAlphaSide(), G4TwistTrapFlatSide::G4TwistTrapFlatSide(), G4TwistTrapParallelSide::G4TwistTrapParallelSide(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4TwistTubsHypeSide::G4TwistTubsHypeSide(), G4TwistTubsSide::G4TwistTubsSide(), G4VEmAngularDistribution::G4VEmAngularDistribution(), G4VTwistSurface::G4VTwistSurface(), G4InuclSpecialFunctions::generateWithFixedTheta(), G4InuclSpecialFunctions::generateWithRandomAngles(), G4ScreeningMottCrossSection::GetNewDirection(), G4NucleiModel::initializeCascad(), G4VTwistedFaceted::Inside(), G4TwistedTubs::Inside(), G4TriangularFacet::Intersect(), G4QuadrangularFacet::Intersect(), G4LatticeLogical::Load_NMap(), CLHEP::operator>>(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4VTwistSurface::CurrentStatus::ResetfDone(), CML2SDWithVoxels::resetVoxelsSingle(), G4DeltaAngleFreeScat::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4DeltaAngle::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4Generator2BN::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BS::SampleDirection(), G4WentzelVIRelModel::SampleScattering(), G4WentzelVIModel::SampleScattering(), G4GoudsmitSaundersonMscModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4DNABornIonisationModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4WentzelVIRelXSection::SampleSingleScattering(), G4VTwistSurface::SetCorner(), G4SurfaceVoxelizer::SetMaxVoxels(), G4HadFinalState::SetMomentumChange(), CML2CInputData::setPhaseSpaceCentre(), CML2CInputData::setPhaseSpaceHalfSize(), G4VTwistedFaceted::SurfaceNormal(), and G4TwistedTubs::SurfaceNormal().
void CLHEP::Hep3Vector::setCylEta | ( | double | p | ) |
|
protected |
Definition at line 56 of file SpaceVector.cc.
void CLHEP::Hep3Vector::setCylTheta | ( | double | theta1 | ) |
void CLHEP::Hep3Vector::setEta | ( | double | p | ) |
void CLHEP::Hep3Vector::setMag | ( | double | ma | ) |
Definition at line 25 of file ThreeVector.cc.
References mag(), setX(), setY(), setZ(), x(), y(), and z().
Referenced by G4EMDissociation::ApplyYourself(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), and CexmcChargeExchangeReconstructor::Reconstruct().
|
inline |
|
inline |
|
inline |
Referenced by G4FissionProductYieldDist::G4GetFission().
|
inline |
|
inline |
void CLHEP::Hep3Vector::setRhoPhiEta | ( | double | rho, |
double | phi, | ||
double | eta | ||
) |
Definition at line 98 of file SpaceVector.cc.
void CLHEP::Hep3Vector::setRhoPhiTheta | ( | double | rho, |
double | phi, | ||
double | theta | ||
) |
Definition at line 71 of file SpaceVector.cc.
|
inline |
|
inline |
|
protected |
Definition at line 35 of file SpaceVector.cc.
|
inline |
|
static |
|
inline |
Referenced by G4GHEKinematicsVector::Add3(), G4FTFAnnihilation::Annihilate(), G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), CLHEP::HepLorentzVector::boostX(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParameterisationBoxX::ComputeTransformation(), G4ParameterisationParaX::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G3Division::CreatePVReplica(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4DecayWithSpin::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceP1(), G4StokesVector::DiceP2(), G4StokesVector::DiceP3(), G4StokesVector::DiceUniform(), CexmcTrackPointsDigitizer::Digitize(), G4USolid::DistanceToOut(), Par01EnergySpot::Draw(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), DMXParticleSource::GenerateIsotropicFlux(), DMXParticleSource::GeneratePointsInVolume(), RE02PrimaryGeneratorAction::GeneratePrimaries(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4GDMLReadDefine::PositionRead(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4StokesVector::RotateAz(), G4GDMLReadDefine::RotationRead(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), and G4GDMLReadDefine::VectorRead().
|
inline |
Referenced by G4GHEKinematicsVector::Add3(), G4FTFAnnihilation::Annihilate(), G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), CLHEP::HepLorentzVector::boostY(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxY::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4DecayWithSpin::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceP1(), G4StokesVector::DiceP2(), G4StokesVector::DiceP3(), G4StokesVector::DiceUniform(), CexmcTrackPointsDigitizer::Digitize(), G4USolid::DistanceToOut(), Par01EnergySpot::Draw(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), DMXParticleSource::GenerateIsotropicFlux(), DMXParticleSource::GeneratePointsInVolume(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), RE02PrimaryGeneratorAction::GeneratePrimaries(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4GDMLReadDefine::PositionRead(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4StokesVector::RotateAz(), G4GDMLReadDefine::RotationRead(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), and G4GDMLReadDefine::VectorRead().
|
inline |
Referenced by G4GHEKinematicsVector::Add3(), G4FTFAnnihilation::Annihilate(), G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), CLHEP::HepLorentzVector::boostZ(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationTrdZ::ComputeTransformation(), RE02DetectorConstruction::Construct(), CML2WorldConstruction::create(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4DecayWithSpin::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceP1(), G4StokesVector::DiceP2(), G4StokesVector::DiceP3(), G4StokesVector::DiceUniform(), G4USolid::DistanceToOut(), Par01PiModel::DoIt(), Par01EnergySpot::Draw(), G4StokesVector::FlipP3(), G4VKinkyStringDecay::FragmentString(), G4CutTubs::G4CutTubs(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), DMXParticleSource::GenerateIsotropicFlux(), DMXParticleSource::GeneratePointsInVolume(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), G4GDecay3::GetThreeBodyMomenta(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4GDMLReadDefine::PositionRead(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4GDMLReadDefine::RotationRead(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4FTFParticipants::ShiftInteractionTime(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), and G4GDMLReadDefine::VectorRead().
|
inline |
Referenced by G4LENDModel::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4tgbVolume::BuildSolidForDivision(), G4RadioactiveDecay::ChooseCollimationDirection(), G4ParameterisationParaX::ComputeDimensions(), G4ParameterisationParaY::ComputeDimensions(), G4ParameterisationParaZ::ComputeDimensions(), G4TheRayTracer::CreateBitMap(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4VParameterisationPara::G4VParameterisationPara(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4SynchrotronRadiation::GetMeanFreePath(), G4tgbGeometryDumper::GetSolidParams(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4MatScanMessenger::SetNewValue(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), and G4DiffuseElastic::ThetaLabToThetaCMS().
|
inline |
Hep3Vector & CLHEP::Hep3Vector::transform | ( | const HepRotation & | m1 | ) |
Definition at line 24 of file ThreeVectorR.cc.
Referenced by G4GMocrenFileSceneHandler::AddPrimitive(), and G4GMocrenFileSceneHandler::EndSavingGdd().
|
inline |
Referenced by G4BinaryLightIonReaction::ApplyYourself(), G4RPGPiMinusInelastic::ApplyYourself(), G4RPGPiPlusInelastic::ApplyYourself(), G4RPGKMinusInelastic::ApplyYourself(), G4RPGProtonInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGSigmaPlusInelastic::ApplyYourself(), G4RPGXiMinusInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGOmegaMinusInelastic::ApplyYourself(), G4NeutronHPCaptureFS::ApplyYourself(), G4RPGKPlusInelastic::ApplyYourself(), G4RPGSigmaMinusInelastic::ApplyYourself(), G4RPGXiZeroInelastic::ApplyYourself(), G4LENDModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4NeutronHPElasticFS::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4MuonVDNuclearModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4ElectroVDNuclearModel::ApplyYourself(), G4TheoFSGenerator::ApplyYourself(), CexmcChargeExchangeProductionModel< OutputParticle >::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4BinaryCascade::ApplyYourself(), G4MuonMinusBoundDecay::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4INCLXXInterface::ApplyYourself(), CLHEP::HepRotation::axis(), G4NeutronHPInelasticBaseFS::BaseApply(), CLHEP::HepLorentzVector::boost(), G4GEMChannel::BreakUp(), G4PolyconeSide::CalculateExtent(), G4NucleiModel::choosePointAlongTraj(), G4TheRayTracer::CreateBitMap(), G4PionDecayMakeSpin::DaughterPolarization(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4IntraNucleiCascader::decayTrappedParticle(), G4SPSAngDistribution::DefineAngRefAxes(), G4Tet::DistanceToIn(), G4Tet::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4Cons::DistanceToOut(), G4MuMinusCaptureCascade::DoBoundMuonMinusDecay(), G4SingleScatter::DoCollisionStep(), G4LorentzConvertor::fillKinematics(), G4HadronicProcess::FillResult(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4PolyhedraSide::G4PolyhedraSide(), G4PolyPhiFace::G4PolyPhiFace(), G4QuadrangularFacet::G4QuadrangularFacet(), G4RandomDirection(), G4Tet::G4Tet(), G4TheRayTracer::G4TheRayTracer(), G4TriangularFacet::G4TriangularFacet(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4Navigator::GetGlobalExitNormal(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4Scatterer::GetTimeToInteraction(), G4TriangularFacet::Intersect(), G4LatticeLogical::Load_NMap(), G4CascadeInterface::makeDynamicParticle(), G4LatticeManager::MapKtoVDir(), Par01PiModel::ModelTrigger(), G4PolyconeSide::Normal(), G4SynchrotronRadiation::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4CascadeHistory::PrintEntry(), G4CascadParticle::propagateAlongThePath(), G4FastStep::ProposePrimaryTrackFinalKineticEnergyAndDirection(), G4FastStep::ProposePrimaryTrackFinalMomentumDirection(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), CLHEP::HepRotation::rectify(), G4QuasiElRatios::RelDecayIn2(), G4LorentzConvertor::rotate(), G4DeltaAngle::SampleDirection(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), MyKleinNishinaCompton::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4DNABornIonisationModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4PenelopeBremsstrahlungModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4PAIPhotonModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), G4DynamicParticle::Set4Momentum(), G4FastTrack::SetCurrentTrack(), G4RadioactiveDecay::SetDecayDirection(), G4TheRayTracer::SetLightDirection(), G4DynamicParticle::SetMomentum(), G4VisCommandsViewerSet::SetNewValue(), G4ParticleGun::SetParticleMomentum(), DMXParticleSource::SetParticleMomentumDirection(), G4ParticleGun::SetParticleMomentumDirection(), G4SPSAngDistribution::SetParticleMomentumDirection(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Tet::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Para::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4PAIPhotonModel::TestSecondaries(), G4TheRayTracer::Trace(), G4TheMTRayTracer::Trace(), G4RKPropagation::Transport(), G4KineticTrack::Update4Momentum(), and G4KineticTrack::UpdateTrackingMomentum().
|
inline |
Referenced by G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4OTubs::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), G4eplusAnnihilation::AtRestDoIt(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4EvaporationChannel::BreakUp(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4CutTubs::CalculateExtent(), G4VTwistedFaceted::CalculateExtent(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4OTubs::CalculateExtent(), G4Ellipsoid::CalculateExtent(), G4Paraboloid::CalculateExtent(), G4Trd::CalculateExtent(), G4GenericTrap::CalculateExtent(), G4Para::CalculateExtent(), G4Tubs::CalculateExtent(), G4Cons::CalculateExtent(), G4Sphere::CalculateExtent(), G4Torus::CalculateExtent(), G4Trap::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4ReplicaNavigation::ComputeTransformation(), ExG4DetectorConstruction01::Construct(), ExG4DetectorConstruction02::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4GenericTrap::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), CexmcTrackPointsDigitizer::Digitize(), G4VTwistSurface::DistanceToBoundary(), G4USolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4OTubs::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Hype::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4USolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4OTubs::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Orb::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Trd::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Para::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), ExGflashEventAction::EndOfEventAction(), B5EventAction::EndOfEventAction(), CCalEndOfEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4SPSEneDistribution::EpnEnergyHisto(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), Analysis::FillDose(), Analysis::FillIncident(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4PolyPhiFace::G4PolyPhiFace(), G4PrimaryVertex::G4PrimaryVertex(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4ReactionDynamics::GenerateXandPt(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4SurfaceVoxelizer::GetCandidatesVoxelArray(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4CutTubs::GetMaxMinZ(), G4TessellatedSolid::GetMaxXExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4TessellatedSolid::GetMinXExtent(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPx(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4tgbGeometryDumper::GetSolidParams(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetXPositionInNucleus(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4USolid::Inside(), G4EllipticalTube::Inside(), G4CutTubs::Inside(), G4Orb::Inside(), G4OTubs::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4Hype::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4EllipticalCone::Inside(), G4Trd::Inside(), G4ExtrudedSolid::Inside(), G4Para::Inside(), G4TwistedTubs::Inside(), G4ReplicaNavigation::Inside(), G4Torus::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EllipticalTube::IntersectXY(), F04SimpleSolenoid::IsOutside(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4SurfaceVoxelizer::MinDistanceToBox(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GHEKinematicsVector::Norz(), operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4StokesVector::p1(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), G4StokesVector::PolDiv(), G4StokesVector::PolSqr(), G4StokesVector::PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), B5DriftChamberHit::Print(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), UltraPMTSD::ProcessHits(), PhantomSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ErrorFreeTrajState::PropagateError(), G4DNAChemistryManager::PushMolecule(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4GDMLReadSolids::ReflectedSolidRead(), G4PathFinder::ReLocate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4DNABornIonisationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GDMLWriteDefine::Scale_vectorWrite(), G4Scatterer::Scatter(), G4QGSParticipants::SelectInteractions(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4SPSRandomGenerator::SetEnergyBias(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), ExG4DetectorConstruction01Messenger::SetNewValue(), ExG4DetectorConstruction02Messenger::SetNewValue(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4SPSRandomGenerator::SetPhiBias(), G4PrimaryParticle::SetPolarization(), G4SPSRandomGenerator::SetPosPhiBias(), G4SPSRandomGenerator::SetPosThetaBias(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4SPSRandomGenerator::SetThetaBias(), G4RPGInelastic::SetUpChange(), G4SPSRandomGenerator::SetXBias(), G4SPSRandomGenerator::SetYBias(), G4SPSRandomGenerator::SetZBias(), G4RayShooter::Shoot(), G4EnclosingCylinder::ShouldMiss(), G4SteppingVerbose::ShowStep(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub3(), G4USolid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Orb::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4Trd::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Para::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), FCALSteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().
|
inline |
Referenced by G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddSolid(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4OTubs::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), G4eplusAnnihilation::AtRestDoIt(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4EvaporationChannel::BreakUp(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4CutTubs::CalculateExtent(), G4VTwistedFaceted::CalculateExtent(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4OTubs::CalculateExtent(), G4Ellipsoid::CalculateExtent(), G4Paraboloid::CalculateExtent(), G4Trd::CalculateExtent(), G4GenericTrap::CalculateExtent(), G4Para::CalculateExtent(), G4Tubs::CalculateExtent(), G4Cons::CalculateExtent(), G4Sphere::CalculateExtent(), G4Torus::CalculateExtent(), G4Trap::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4ReplicaNavigation::ComputeTransformation(), ExG4DetectorConstruction01::Construct(), ExG4DetectorConstruction02::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4GenericTrap::CreatePolyhedron(), G3Division::CreatePVReplica(), G4FastStep::CreateSecondaryTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), CexmcTrackPointsDigitizer::Digitize(), G4VTwistSurface::DistanceToBoundary(), G4USolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4OTubs::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Hype::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4USolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4OTubs::DistanceToOut(), G4Orb::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Trd::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Para::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), ExGflashEventAction::EndOfEventAction(), B5EventAction::EndOfEventAction(), CCalEndOfEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4SPSEneDistribution::EpnEnergyHisto(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), Analysis::FillDose(), Analysis::FillIncident(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4PolyPhiFace::G4PolyPhiFace(), G4PrimaryVertex::G4PrimaryVertex(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4ReactionDynamics::GenerateXandPt(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4SurfaceVoxelizer::GetCandidatesVoxelArray(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4GenericTrap::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4CutTubs::GetMaxMinZ(), G4TessellatedSolid::GetMaxYExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4TessellatedSolid::GetMinYExtent(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPy(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4tgbGeometryDumper::GetSolidParams(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetYPositionInNucleus(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4USolid::Inside(), G4EllipticalTube::Inside(), G4CutTubs::Inside(), G4Orb::Inside(), G4OTubs::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4Hype::Inside(), G4VTwistedFaceted::Inside(), G4PolyPhiFace::Inside(), G4Trd::Inside(), G4EllipticalCone::Inside(), G4ExtrudedSolid::Inside(), G4Para::Inside(), G4TwistedTubs::Inside(), G4ReplicaNavigation::Inside(), G4Torus::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EllipticalTube::IntersectXY(), F04SimpleSolenoid::IsOutside(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4SurfaceVoxelizer::MinDistanceToBox(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GHEKinematicsVector::Norz(), operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4StokesVector::p2(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), G4StokesVector::PolDiv(), G4StokesVector::PolSqr(), G4StokesVector::PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), B5DriftChamberHit::Print(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), UltraPMTSD::ProcessHits(), PhantomSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4ErrorFreeTrajState::PropagateError(), G4DNAChemistryManager::PushMolecule(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4GDMLReadSolids::ReflectedSolidRead(), G4PathFinder::ReLocate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4DNABornIonisationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GDMLWriteDefine::Scale_vectorWrite(), G4Scatterer::Scatter(), G4QGSParticipants::SelectInteractions(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4SPSRandomGenerator::SetEnergyBias(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), ExG4DetectorConstruction01Messenger::SetNewValue(), ExG4DetectorConstruction02Messenger::SetNewValue(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4SPSRandomGenerator::SetPhiBias(), G4PrimaryParticle::SetPolarization(), G4SPSRandomGenerator::SetPosPhiBias(), G4SPSRandomGenerator::SetPosThetaBias(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4SPSRandomGenerator::SetThetaBias(), G4RPGInelastic::SetUpChange(), G4SPSRandomGenerator::SetXBias(), G4SPSRandomGenerator::SetYBias(), G4SPSRandomGenerator::SetZBias(), G4RayShooter::Shoot(), G4EnclosingCylinder::ShouldMiss(), G4SteppingVerbose::ShowStep(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub3(), G4USolid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Orb::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Trd::SurfaceNormal(), G4Para::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), CCalSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().
|
inline |
Referenced by G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), F04FocusSolenoid::AddFieldValue(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddSolid(), HistoManager::AddTargetStep(), G4MagHelicalStepper::AdvanceHelix(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4OTubs::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4eplusAnnihilation::AtRestDoIt(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4EvaporationChannel::BreakUp(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4CutTubs::CalculateExtent(), G4VTwistedFaceted::CalculateExtent(), G4Tet::CalculateExtent(), G4Orb::CalculateExtent(), G4OTubs::CalculateExtent(), G4Ellipsoid::CalculateExtent(), G4Paraboloid::CalculateExtent(), G4Trd::CalculateExtent(), G4GenericTrap::CalculateExtent(), G4Para::CalculateExtent(), G4Tubs::CalculateExtent(), G4Cons::CalculateExtent(), G4Sphere::CalculateExtent(), G4Torus::CalculateExtent(), G4Trap::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedComptonModel::ComputeCrossSectionPerAtom(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationParaZ::ComputeTransformation(), ExG4DetectorConstruction01::Construct(), ExG4DetectorConstruction02::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4DNAChemistryManager::CreateSolvatedElectron(), G4DNAChemistryManager::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4PolyPhiFace::Distance(), G4PolyconeSide::DistanceAway(), G4VTwistSurface::DistanceToBoundary(), G4USolid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4OTubs::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Hype::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4USolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4OTubs::DistanceToOut(), G4Orb::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4Trd::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Para::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), ExGflashEventAction::EndOfEventAction(), CCalEndOfEventAction::EndOfEventAction(), exGPSEventAction::EndOfEventAction(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4PolyPhiFace::Extent(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), Analysis::FillDose(), G4StokesVector::FlipP3(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4Fancy3DNucleusHelperForSortInZ(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4PrimaryVertex::G4PrimaryVertex(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4VGammaDeexcitation::GenerateGamma(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4VTwistSurface::GetBoundaryAtPZ(), G4SurfaceVoxelizer::GetCandidatesVoxelArray(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4TessellatedSolid::GetMaxZExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4TessellatedSolid::GetMinZExtent(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPz(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4TwistTubsHypeSide::GetRhoAtPZ(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4tgbGeometryDumper::GetSolidParams(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetZPositionInNucleus(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4FTFModel::Init(), G4PolarizedPEEffectCrossSection::Initialize(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4USolid::Inside(), G4EllipticalTube::Inside(), G4Orb::Inside(), G4OTubs::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4Hype::Inside(), G4Paraboloid::Inside(), G4VTwistedFaceted::Inside(), G4GenericTrap::Inside(), G4PolyPhiFace::Inside(), G4Trd::Inside(), G4EllipticalCone::Inside(), G4ExtrudedSolid::Inside(), G4Para::Inside(), G4TwistedTubs::Inside(), G4Torus::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4PolyPhiFace::Intersect(), G4Hype::IntersectHype(), F04SimpleSolenoid::IsOutside(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSFlatSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSFlatSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4SurfaceVoxelizer::MinDistanceToBox(), G4EnclosingCylinder::MustBeOutside(), G4PolyPhiFace::Normal(), G4TessellatedSolid::Normal(), G4GHEKinematicsVector::Norz(), operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4StokesVector::p3(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), G4StokesVector::PolDiv(), G4StokesVector::PolSqr(), G4StokesVector::PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), F04TrackingAction::PreUserTrackingAction(), WLSTrackingAction::PreUserTrackingAction(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4CascadeHistory::PrintEntry(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4VIntersectionLocator::printStatus(), G4PropagatorInField::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), UltraPMTSD::ProcessHits(), PhantomSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ErrorFreeTrajState::PropagateError(), pseudoRapidity(), G4DNAChemistryManager::PushMolecule(), G4DNAChemistryManager::PushMoleculeAtParentTimeAndPlace(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4GDMLReadSolids::ReflectedSolidRead(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4DNABornIonisationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GDMLWriteDefine::Scale_vectorWrite(), G4Scatterer::Scatter(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), ExG4DetectorConstruction01Messenger::SetNewValue(), ExG4DetectorConstruction02Messenger::SetNewValue(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4PrimaryParticle::SetPolarization(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4RPGInelastic::SetUpChange(), G4FTFParticipants::ShiftInteractionTime(), G4RayShooter::Shoot(), G4SteppingVerbose::ShowStep(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4AttCheck::Standard(), LXeSteppingVerbose::StepInfo(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4GHEKinematicsVector::Sub3(), G4USolid::SurfaceNormal(), G4EllipticalTube::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4Orb::SurfaceNormal(), G4OTubs::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Trd::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Para::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Trap::SurfaceNormal(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4PolarizedComptonCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), LXeSteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), CCalSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), and G4SteppingVerbose::VerboseTrack().
|
protected |
Definition at line 394 of file ThreeVector.h.
Referenced by compare(), isOrthogonal(), isParallel(), operator()(), operator/=(), rotate(), rotateUz(), rotateY(), rotateZ(), setCylEta(), setCylindrical(), setCylTheta(), setEta(), setRhoPhiEta(), setRhoPhiTheta(), and setSpherical().
|
protected |
Definition at line 395 of file ThreeVector.h.
Referenced by compare(), isOrthogonal(), isParallel(), operator()(), operator/=(), rotate(), rotateUz(), rotateX(), rotateZ(), setCylEta(), setCylindrical(), setCylTheta(), setEta(), setRhoPhiEta(), setRhoPhiTheta(), and setSpherical().
|
protected |
Definition at line 396 of file ThreeVector.h.
Referenced by compare(), isOrthogonal(), isParallel(), operator()(), operator/=(), rapidity(), rotate(), rotateUz(), rotateX(), rotateY(), setCylEta(), setCylindrical(), setCylTheta(), setEta(), setRhoPhiEta(), setRhoPhiTheta(), and setSpherical().
|
staticprotected |
Definition at line 399 of file ThreeVector.h.
Referenced by setTolerance().