Geant4  v4-10.4-release
 모두 클래스 네임스페이스들 파일들 함수 변수 타입정의 열거형 타입 열거형 멤버 Friends 매크로 그룹들 페이지들
Public 타입 | Public 멤버 함수 | 정적 Public 멤버 함수 | 정적 Public 속성 | Protected 멤버 함수 | Protected 속성 | 정적 Protected 속성 | Private 속성 | 모든 멤버 목록
G4StokesVector 클래스 참조

#include <G4StokesVector.hh>

G4StokesVector에 대한 상속 다이어그램 :
CLHEP::Hep3Vector

Public 타입

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

Public 멤버 함수

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

정적 Public 멤버 함수

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

정적 Public 속성

static const G4StokesVector ZERO =G4ThreeVector(0.,0.,0.)
 
static const G4StokesVector P1 =G4ThreeVector(1.,0.,0.)
 
static const G4StokesVector P2 =G4ThreeVector(0.,1.,0.)
 
static const G4StokesVector P3 =G4ThreeVector(0.,0.,1.)
 
static const G4StokesVector M1 =G4ThreeVector(-1.,0.,0.)
 
static const G4StokesVector M2 =G4ThreeVector(0.,-1.,0.)
 
static const G4StokesVector M3 =G4ThreeVector(0.,0.,-1.)
 

Protected 멤버 함수

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

Protected 속성

double dx
 
double dy
 
double dz
 

정적 Protected 속성

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

Private 속성

G4bool isPhoton
 

상세한 설명

G4StokesVector.hh 파일의 58 번째 라인에서 정의되었습니다.

멤버 열거형 문서화

anonymous enum
inherited
열거형 멤버
X 
Y 
Z 
NUM_COORDINATES 
SIZE 

ThreeVector.h 파일의 47 번째 라인에서 정의되었습니다.

anonymous enum
inherited
열거형 멤버
ToleranceTicks 

ThreeVector.h 파일의 298 번째 라인에서 정의되었습니다.

생성자 & 소멸자 문서화

G4StokesVector::G4StokesVector ( )

G4StokesVector.cc 파일의 57 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : PolError().

G4StokesVector::G4StokesVector ( const G4ThreeVector v)

G4StokesVector.cc 파일의 62 번째 라인에서 정의되었습니다.

G4StokesVector::~G4StokesVector ( )
default

멤버 함수 문서화

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

다음에 의해서 참조됨 : CLHEP::Hep3Vector::polarAngle().

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

SpaceVectorP.cc 파일의 69 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::beta().

int CLHEP::Hep3Vector::compare ( const Hep3Vector v) const
inherited
double CLHEP::Hep3Vector::cos2Theta ( ) const
inlineinherited
double CLHEP::Hep3Vector::cos2Theta ( const Hep3Vector v2) const
inherited

ThreeVector.cc 파일의 167 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag2().

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

ThreeVector.cc 파일의 154 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag2().

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

다음에 의해서 참조됨 : G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), CLHEP::Hep3Vector::azimAngle(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4PolyconeSide::CalculateExtent(), G4OpBoundaryProcess::CalculateReflectivity(), GFlashShowerModel::CheckContainment(), G4NucleiModel::choosePointAlongTraj(), G4tgbVolume::ConstructG4PhysVol(), G4SPSAngDistribution::DefineAngRefAxes(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricLUT(), G4OpBoundaryProcess::DielectricLUTDAVIS(), G4OpBoundaryProcess::DielectricMetal(), GFlashShowerModel::ElectronDoIt(), ExGflashEventAction::EndOfEventAction(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), Par01PionShowerModel::Explode(), Par01EMShowerModel::Explode(), G4gsrotm(), G4PlaneVectorRand(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4TriangularFacet::G4TriangularFacet(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4SPSPosDistribution::GenerateRotationMatrices(), G4PrimaryTransformer::GenerateSingleTrack(), G4PolarizationHelper::GetFrame(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4Tet::GetPointOnFace(), G4Para::GetPointOnSurface(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4BinaryCascade::GetSpherePoint(), G4Para::GetSurfaceArea(), CLHEP::Hep3Vector::howOrthogonal(), CLHEP::Hep3Vector::howParallel(), G4TriangularFacet::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), InvRotateAz(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4Para::MakePlanes(), G4GenericTrap::NormalToPlane(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4PolyconeSide::PointOnCone(), G4GeomTools::PolygonAreaNormal(), G4SynchrotronRadiation::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4ErrorFreeTrajState::PropagateError(), G4QuasiElRatios::RelDecayIn2(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), RotateAz(), G4StatMFChannel::RotateMomentum(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), G4DNAPTBElasticModel::SampleSecondaries(), CLHEP::HepRotation::setArbitrarily(), CLHEP::HepRotation::setCols(), OpNovicePrimaryGeneratorAction::SetOptPhotonPolar(), PrimaryGeneratorAction::SetOptPhotonPolar(), WLSPrimaryGeneratorAction::SetOptPhotonPolar(), G4ErrorSurfaceTrajParam::SetParameters(), G4GenericTrap::SurfaceNormal(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LivermorePolarizedPhotoElectricGDModel::SystemOfRefChange(), G4LowEnergyPolarizedCompton::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), G4PolarizationHelper::TestPolarizationTransformations(), FCALSteppingAction::UserSteppingAction().

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

ThreeVector.cc 파일의 138 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::getPhi(), CLHEP::pi, CLHEP::twopi.

다음에 의해서 참조됨 : CLHEP::Hep3Vector::deltaR(), CLHEP::HepLorentzVector::deltaR().

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

ThreeVector.cc 파일의 148 번째 라인에서 정의되었습니다.

다음을 참조함 : a, CLHEP::Hep3Vector::deltaPhi(), CLHEP::Hep3Vector::eta().

void G4StokesVector::DiceP1 ( )

G4StokesVector.cc 파일의 169 번째 라인에서 정의되었습니다.

다음을 참조함 : G4UniformRand, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ().

void G4StokesVector::DiceP2 ( )

G4StokesVector.cc 파일의 177 번째 라인에서 정의되었습니다.

다음을 참조함 : G4UniformRand, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ().

void G4StokesVector::DiceP3 ( )

G4StokesVector.cc 파일의 185 번째 라인에서 정의되었습니다.

다음을 참조함 : G4UniformRand, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ().

void G4StokesVector::DiceUniform ( )

G4StokesVector.cc 파일의 159 번째 라인에서 정의되었습니다.

다음을 참조함 : G4UniformRand, pi, CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY(), CLHEP::Hep3Vector::setZ().

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

다음에 의해서 참조됨 : G4QMDGroundStateNucleus::samplingMomentum().

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

다음에 의해서 참조됨 : G4VIntersectionLocator::AdjustmentOfFoundIntersection(), G4MagHelicalStepper::AdvanceHelix(), CLHEP::Hep3Vector::azimAngle(), CLHEP::HepLorentzVector::boost(), G4NucleiModel::boundaryTransition(), G4GeomTools::ClosestPointOnSegment(), G4GeomTools::ClosestPointOnTriangle(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), CLHEP::Hep3Vector::cos2Theta(), CLHEP::Hep3Vector::cosTheta(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4PolyPhiFace::Distance(), G4PolyhedraSide::Distance(), G4PolyhedraSide::DistanceAway(), G4GeomTools::DistancePointSegment(), G4Ellipsoid::DistanceToIn(), G4Tet::DistanceToIn(), G4Orb::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Cons::DistanceToIn(), G4PolyhedraSide::DistanceToOneSide(), G4Tet::DistanceToOut(), G4Orb::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4CutTubs::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Cons::DistanceToOut(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), CLHEP::Hep3Vector::eta(), G4TriangularFacet::Extent(), G4QuadrangularFacet::Extent(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), G4LorentzConvertor::fillKinematics(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4TriangularFacet::G4TriangularFacet(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4TessellatedSolid::GetCubicVolume(), G4MultiNavigator::GetGlobalExitNormal(), G4ITMultiNavigator::GetGlobalExitNormal(), G4CascadParticle::getPathToTheNextZone(), G4LivermorePolarizedComptonModel::GetPerpendicularPolarization(), G4LivermorePolarizedGammaConversionModel::GetPerpendicularPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetPerpendicularPolarization(), G4LowEnergyPolarizedCompton::GetPerpendicularPolarization(), G4LowEPPolarizedComptonModel::GetPerpendicularPolarization(), G4ClippablePolygon::GetPlanerExtent(), G4RKPropagation::GetSphereIntersectionTimes(), CLHEP::Hep3Vector::howNear(), CLHEP::HepLorentzVector::howNear(), CLHEP::HepLorentzVector::howNearCM(), CLHEP::Hep3Vector::howOrthogonal(), CLHEP::Hep3Vector::howParallel(), G4NucleiModel::initializeCascad(), G4Tet::Inside(), G4PolyPhiFace::Inside(), G4TessellatedSolid::InsideNoVoxels(), G4TessellatedSolid::InsideVoxels(), G4TriangularFacet::Intersect(), G4PolyPhiFace::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), G4VFacet::IsInside(), CLHEP::Hep3Vector::isNear(), CLHEP::HepLorentzVector::isNear(), CLHEP::HepLorentzVector::isNearCM(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4GenericTrap::IsSegCrossingZ(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator1::LocateGlobalPointAndSetup(), G4ITNavigator2::LocateGlobalPointAndSetup(), G4GHEKinematicsVector::Lor(), G4Trap::MakePlane(), G4Trap::MakePlanes(), CLHEP::HepLorentzVector::minus(), G4PolyPhiFace::Normal(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), CLHEP::HepLorentzVector::plus(), G4PolyconeSide::PointOnCone(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4MagInt_Driver::PrintStatus(), CLHEP::Hep3Vector::project(), CLHEP::Hep3Vector::rapidity(), CLHEP::HepLorentzVector::rapidity(), G4VIntersectionLocator::ReportTrialStep(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotateAxes(), G4BetheHeitler5DModel::SampleSecondaries(), CLHEP::HepRotation::set(), CLHEP::HepRotation::setCols(), G4ErrorFreeTrajParam::SetParameters(), G4ErrorSurfaceTrajParam::SetParameters(), G4Tet::SurfaceNormal().

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

다음에 의해서 참조됨 : CLHEP::Hep3Vector::deltaR().

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

SpaceVectorP.cc 파일의 117 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::getR(), CLHEP::Hep3Vector::mag(), CLHEP::Hep3Vector::negativeInfinity().

void G4StokesVector::FlipP3 ( )

G4StokesVector.cc 파일의 193 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::setZ(), CLHEP::Hep3Vector::z().

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

SpaceVectorP.cc 파일의 39 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::mag2().

다음에 의해서 참조됨 : G4QMDReaction::calcOffSetOfCollision().

G4double G4StokesVector::GetBeta ( )

G4StokesVector.cc 파일의 152 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::getPhi(), isPhoton.

double CLHEP::Hep3Vector::getEta ( ) const
inherited
double CLHEP::Hep3Vector::getPhi ( ) const
inlineinherited
double CLHEP::Hep3Vector::getR ( ) const
inlineinherited
double CLHEP::Hep3Vector::getRho ( ) const
inlineinherited
double CLHEP::Hep3Vector::getTheta ( ) const
inlineinherited
static double CLHEP::Hep3Vector::getTolerance ( )
inlinestaticinherited
double CLHEP::Hep3Vector::getX ( ) const
inlineinherited

다음에 의해서 참조됨 : 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(), CML2Acc1::Jaw1X(), CML2Acc1::Jaw1Y(), CML2Acc1::Jaw2X(), CML2Acc1::Jaw2Y(), CML2ExpVoxels::loadData(), CML2Acc1::MLC(), HadrontherapyDetectorConstruction::PrintParameters(), IORTDetectorConstruction::PrintParameters(), CML2SDWithVoxels::resetVoxelsSingle(), CLHEP::Hep3Vector::rotate(), G4LundStringFragmentation::Sample4Momentum(), G4DNAPTBIonisationModel::SampleSecondaries(), CML2SDWithVoxels::saveData(), CML2SDWithParticle::saveDataParticles(), CLHEP::HepRotation::set(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), CML2Acc1::SetJawAperture(), HadrontherapyDetectorMessenger::SetNewValue(), IORTDetectorMessenger::SetNewValue(), CML2CInputData::setPhaseSpaceCentre(), CML2CInputData::setPhaseSpaceHalfSize(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LivermorePolarizedPhotoElectricGDModel::SystemOfRefChange(), G4LowEnergyPolarizedCompton::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), XAluminumElectrodeSensitivity::WriteHitInfo(), CLHEP::ZMpvAxisAngleRep().

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

다음에 의해서 참조됨 : 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(), CML2Acc1::Jaw1X(), CML2Acc1::Jaw1Y(), CML2Acc1::Jaw2X(), CML2Acc1::Jaw2Y(), CML2ExpVoxels::loadData(), CML2Acc1::MLC(), HadrontherapyDetectorConstruction::PrintParameters(), IORTDetectorConstruction::PrintParameters(), CML2SDWithVoxels::resetVoxelsSingle(), CLHEP::Hep3Vector::rotate(), G4LundStringFragmentation::Sample4Momentum(), G4DNAPTBIonisationModel::SampleSecondaries(), CML2SDWithVoxels::saveData(), CML2SDWithParticle::saveDataParticles(), CLHEP::HepRotation::set(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), CML2Acc1::SetJawAperture(), HadrontherapyDetectorMessenger::SetNewValue(), IORTDetectorMessenger::SetNewValue(), CML2CInputData::setPhaseSpaceCentre(), CML2CInputData::setPhaseSpaceHalfSize(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LivermorePolarizedPhotoElectricGDModel::SystemOfRefChange(), G4LowEnergyPolarizedCompton::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), XAluminumElectrodeSensitivity::WriteHitInfo(), CLHEP::ZMpvAxisAngleRep().

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

다음에 의해서 참조됨 : CML2ExpVoxels::add(), CLHEP::HepLorentzVector::boostZ(), CML2ReadOutGeometry::Build(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), CML2PhantomConstruction::Construct(), CML2AcceleratorConstruction::Construct(), CML2Ph_FullWater::Construct(), CML2Ph_BoxInBox::Construct(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), CML2PhaseSpaces::createPlane(), G4GDMLWriteSolids::CutTubeWrite(), G4FissionProductYieldDist::G4GetFission(), CML2PhantomConstruction::getCurrentTranslationString(), HadrontherapyDetectorConstruction::GetDetectorToPhantomPosition(), IORTDetectorConstruction::GetDetectorToPhantomPosition(), G4DecayProducts::IsChecked(), HadrontherapyDetectorConstruction::IsInside(), IORTDetectorConstruction::IsInside(), CML2Acc1::Jaw1X(), CML2Acc1::Jaw1Y(), CML2Acc1::Jaw2X(), CML2Acc1::Jaw2Y(), CML2ExpVoxels::loadData(), CML2Acc1::MLC(), HadrontherapyDetectorConstruction::PrintParameters(), IORTDetectorConstruction::PrintParameters(), CLHEP::HepLorentzVector::rapidity(), CML2SDWithVoxels::resetVoxelsSingle(), CLHEP::Hep3Vector::rotate(), G4DNAPTBIonisationModel::SampleSecondaries(), CML2SDWithVoxels::saveData(), CML2SDWithParticle::saveDataParticles(), CLHEP::HepRotation::set(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), CML2Acc1::SetJawAperture(), HadrontherapyDetectorMessenger::SetNewValue(), IORTDetectorMessenger::SetNewValue(), CML2CInputData::setPhaseSpaceCentre(), CML2CInputData::setPhaseSpaceHalfSize(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LivermorePolarizedPhotoElectricGDModel::SystemOfRefChange(), G4LowEnergyPolarizedCompton::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), XAluminumElectrodeSensitivity::WriteHitInfo(), CLHEP::ZMpvAxisAngleRep().

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

ThreeVector.cc 파일의 125 번째 라인에서 정의되었습니다.

다음을 참조함 : d, CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag2().

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

SpaceVector.cc 파일의 168 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::cross(), CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag(), CLHEP::Hep3Vector::mag2().

void G4StokesVector::InvRotateAz ( G4ThreeVector  nInteractionFrame,
G4ThreeVector  particleDirection 
)
bool CLHEP::Hep3Vector::isNear ( const Hep3Vector v,
double  epsilon = tolerance 
) const
inherited

ThreeVector.cc 파일의 120 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dot(), epsilon(), CLHEP::Hep3Vector::mag2().

bool CLHEP::Hep3Vector::isOrthogonal ( const Hep3Vector v,
double  epsilon = tolerance 
) const
inherited
bool CLHEP::Hep3Vector::isParallel ( const Hep3Vector v,
double  epsilon = tolerance 
) const
inherited
G4bool G4StokesVector::IsZero ( ) const
double CLHEP::Hep3Vector::mag ( ) const
inlineinherited

다음에 의해서 참조됨 : G4ParticleHPFinalState::adjust_final_state(), G4MagHelicalStepper::AdvanceHelix(), G4BinaryLightIonReaction::ApplyYourself(), G4RPGNeutronInelastic::ApplyYourself(), G4RPGProtonInelastic::ApplyYourself(), G4RPGAntiLambdaInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGSigmaPlusInelastic::ApplyYourself(), G4RPGXiMinusInelastic::ApplyYourself(), G4RPGAntiNeutronInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGAntiXiZeroInelastic::ApplyYourself(), G4RPGKZeroInelastic::ApplyYourself(), G4RPGLambdaInelastic::ApplyYourself(), G4RPGSigmaMinusInelastic::ApplyYourself(), G4RPGXiZeroInelastic::ApplyYourself(), G4ParticleHPCaptureFS::ApplyYourself(), G4RPGAntiKZeroInelastic::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LENDInelastic::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4ParticleHPInelasticBaseFS::BaseApply(), G4NucleiModel::boundaryTransition(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4RPGInelastic::CalculateMomenta(), G4OpBoundaryProcess::CalculateReflectivity(), G4QMDCollision::CalKinematicsOfBinaryCollisions(), G4BinaryCascade::Capture(), G4RPGAntiKZeroInelastic::Cascade(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4NucleiModel::choosePointAlongTraj(), CLHEP::HepLorentzVector::coLinearRapidity(), G4DNABrownianTransportation::ComputeStep(), RE01Trajectory::CreateAttValues(), F04Trajectory::CreateAttValues(), WLSTrajectory::CreateAttValues(), G4SmoothTrajectory::CreateAttValues(), G4Trajectory::CreateAttValues(), RE04Trajectory::CreateAttValues(), G4VPhononProcess::CreateSecondary(), G4DiffractiveExcitation::CreateStrings(), G4AdjointCrossSurfChecker::CrossingASphere(), G4DNAMolecularDissociation::DecayIt(), G4AblaInterface::DeExcite(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricLUT(), G4OpBoundaryProcess::DielectricLUTDAVIS(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4GeomTools::DistancePointSegment(), G4ScaledSolid::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Orb::DistanceToIn(), G4ScaledSolid::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Orb::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4TwistTubsHypeSide::DistanceToSurface(), Par02FastSimModelHCal::DoIt(), Par02FastSimModelEMCal::DoIt(), Par02FastSimModelTracker::DoIt(), G4PathFinder::DoNextCurvedStep(), ExGflashEventAction::EndOfEventAction(), RMC01AnalysisManager::EndOfEventForForwardSimulation(), G4MultiLevelLocator::EstimateIntersectionPoint(), CLHEP::Hep3Vector::eta(), G4BinaryCascade::FillVoidNucleusProducts(), G4StatMFChannel::FragmentsMomenta(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4FissionProductYieldDist::G4GetFission(), G4PolyhedraSide::G4PolyhedraSide(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4tgbPlaceParamCircle::G4tgbPlaceParamCircle(), G4tgbPlaceParamLinear::G4tgbPlaceParamLinear(), G4tgbPlaceParamSquare::G4tgbPlaceParamSquare(), G4TriangularFacet::G4TriangularFacet(), G4NucleiModel::generateInteractionPartners(), TSPrimaryGeneratorAction::GeneratePrimaries(), DicomPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4RKFieldIntegrator::GetAntiprotonPotential(), G4Nucleus::GetBiasedThermalNucleus(), G4ParticleHPFissionData::GetCrossSection(), G4ParticleHPCaptureData::GetCrossSection(), G4ParticleHPElasticData::GetCrossSection(), G4ParticleHPInelasticData::GetCrossSection(), G4NuclearShellModelDensity::GetDeriv(), G4NuclearFermiDensity::GetDeriv(), G4ErrorCylSurfaceTarget::GetDistanceFromPoint(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4IonsKoxCrossSection::GetElementCrossSection(), G4OpBoundaryProcess::GetFacetNormal(), G4SigmaPlusField::GetField(), G4KaonZeroField::GetField(), G4SigmaMinusField::GetField(), G4SigmaZeroField::GetField(), G4AntiProtonField::GetField(), G4PionPlusField::GetField(), G4PionZeroField::GetField(), G4KaonMinusField::GetField(), G4KaonPlusField::GetField(), G4PionMinusField::GetField(), G4ProtonField::GetField(), G4NeutronField::GetField(), G4BinaryCascade::GetFinalNucleusMomentum(), G4Navigator::GetGlobalExitNormal(), G4ITNavigator1::GetGlobalExitNormal(), G4ITNavigator2::GetGlobalExitNormal(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXsc(), G4ComponentGGNuclNuclXsc::GetHadronNucleonXsc(), G4HadronNucleonXsc::GetHadronNucleonXscEL(), G4HadronNucleonXsc::GetHadronNucleonXscNS(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscNS(), G4HadronNucleonXsc::GetHadronNucleonXscPDG(), G4ComponentGGHadronNucleusXsc::GetHadronNucleonXscPDG(), G4HadronNucleonXsc::GetHadronNucleonXscVU(), G4ComponentGGNuclNuclXsc::GetHNinelasticXscVU(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXscVU(), G4OpBoundaryProcess::GetIncidentAngle(), G4NuclNuclDiffuseElastic::GetInvCoulombElasticXsc(), G4DiffuseElastic::GetInvCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetInvElasticSumXsc(), G4DiffuseElastic::GetInvElasticSumXsc(), G4NuclNuclDiffuseElastic::GetInvElasticXsc(), G4DiffuseElastic::GetInvElasticXsc(), G4IonsShenCrossSection::GetIsoCrossSection(), G4HadronNucleonXsc::GetKaonNucleonXscGG(), G4RKFieldIntegrator::GetKaonPotential(), G4QGSParticipants::GetList(), G4VIntersectionLocator::GetLocalSurfaceNormal(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4FermiMomentum::GetMomentum(), G4RKFieldIntegrator::GetNeutronPotential(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4RKFieldIntegrator::GetPionPotential(), G4Trd::GetPointOnSurface(), G4Trap::GetPointOnSurface(), G4RKFieldIntegrator::GetProtonPotential(), G4NuclearFermiDensity::GetRelativeDensity(), G4tgrUtils::GetRotationFromDirection(), G4Trap::GetSurfaceArea(), G4VIntersectionLocator::GetSurfaceNormal(), G4HadProjectile::GetTotalMomentum(), CLHEP::Hep3Vector::howOrthogonal(), CLHEP::Hep3Vector::howParallel(), G4NucleiModel::initializeCascad(), G4TwistTubsHypeSide::Inside(), G4BinaryLightIonReaction::Interact(), G4TriangularFacet::Intersect(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4DecayProducts::IsChecked(), G4GenericTrap::IsSegCrossingZ(), G4GHEKinematicsVector::Length(), CLHEP::HepLorentzVector::minus(), G4RPGReaction::MomentumCheck(), G4RPGReaction::NuclearReaction(), operator<<(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), CLHEP::HepLorentzVector::plus(), G4SynchrotronRadiation::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), CLHEP::HepBoost::print(), G4BinaryCascade::PrintKTVector(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), G4IntraNucleiCascader::processSecondary(), G4BinaryCascade::Propagate(), G4ErrorFreeTrajState::PropagateError(), G4ErrorFreeTrajState::PropagateErrorIoni(), G4ErrorFreeTrajState::PropagateErrorMSC(), CLHEP::Hep3Vector::pseudoRapidity(), CLHEP::Hep3Vector::rapidity(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), CexmcReconstructor::ReconstructEntryPoints(), CLHEP::HepBoost::rectify(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), G4Fancy3DNucleus::ReduceSum(), G4VIntersectionLocator::ReEstimateEndpoint(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4PropagatorInField::ReportLoopingParticle(), G4TransportationLogger::ReportLoopingTrack(), G4CoupledTransportation::ReportMove(), G4PathFinder::ReportMove(), G4ITPathFinder::ReportMove(), G4VIntersectionLocator::ReportTrialStep(), G4RPGReaction::Rotate(), G4LorentzConvertor::rotate(), CLHEP::HepRotation::rotate(), CLHEP::Hep3Vector::rotate(), RotateAz(), G4AntiNuclElastic::SampleInvariantT(), G4NuclNuclDiffuseElastic::SampleInvariantT(), G4DiffuseElasticV2::SampleInvariantT(), G4DiffuseElastic::SampleInvariantT(), G4LEPTSIonisationModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricGDModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), CLHEP::HepBoost::set(), G4Fragment::SetAngularMomentum(), G4ReactionProduct::SetDefinitionAndUpdateE(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4HadFinalState::SetMomentumChange(), G4ParticleGun::SetParticleMomentum(), G4RPGInelastic::SetUpChange(), G4QMDSystem::ShowParticipants(), G4RPGNeutronInelastic::SlowNeutron(), G4StatMFChannel::SolveEqOfMotion(), G4BinaryCascade::StepParticlesOut(), G4HelixMixedStepper::Stepper(), G4ScaledSolid::SurfaceNormal(), G4Orb::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4PolarizationHelper::TestPolarizationTransformations(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4ParticleChangeForTransport::UpdateStepForAlongStep(), G4ParticleChange::UpdateStepForAlongStep(), FCALSteppingAction::UserSteppingAction().

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

다음에 의해서 참조됨 : G4GHEKinematicsVector::Add(), G4FTFModel::AdjustNucleonsAlgorithm_afterSampling(), G4FTFModel::AdjustNucleonsAlgorithm_Sampling(), G4VMultipleScattering::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4MonopoleTransportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4ITTransportation::AlongStepGetPhysicalInteractionLength(), G4GHEKinematicsVector::Ang(), G4LMsdGenerator::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::Hep3Vector::azimAngle(), G4ParticleHPInelasticBaseFS::BaseApply(), CLHEP::Hep3Vector::beta(), CLHEP::HepLorentzVector::beta(), CLHEP::HepLorentzVector::boost(), G4KineticTrackVector::BoostBeam(), CLHEP::HepLorentzVector::boostVector(), G4StatMF::BreakItUp(), G4BinaryCascade::BuildTargetList(), CalculatePointInside(), CalculatePointSafety(), G4NavigationLogger::CheckAndReportBadNormal(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChange::CheckIt(), G4FastStep::CheckIt(), G4Fancy3DNucleus::ChooseFermiMomenta(), G4NucleiModel::choosePointAlongTraj(), G4Fancy3DNucleus::ChoosePositions(), G4GeomTools::ClosestPointOnSegment(), G4GeomTools::ClosestPointOnTriangle(), G4ParticleHPInelasticCompFS::CompositeApply(), G4PathFinder::ComputeStep(), G4ITPathFinder::ComputeStep(), CLHEP::Hep3Vector::cos2Theta(), G4GHEKinematicsVector::CosAng(), CLHEP::Hep3Vector::cosTheta(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4BinaryCascade::DecayVoidNucleus(), G4QGSParticipants::DeterminePartonMomenta(), G4LineSection::Dist(), G4TriangularFacet::Distance(), G4QuadrangularFacet::Distance(), G4GeomTools::DistancePointSegment(), G4Orb::DistanceToIn(), G4Orb::DistanceToOut(), G4Fancy3DNucleus::DoLorentzContraction(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4BinaryLightIonReaction::EnergyAndMomentumCorrector(), G4ExcitedStringDecay::EnergyAndMomentumCorrector(), G4BrentLocator::EstimateIntersectionPoint(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4SimpleLocator::EstimateIntersectionPoint(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4RKPropagation::FieldTransport(), G4LorentzConvertor::fillKinematics(), G4VElasticCollision::FinalState(), G4VScatteringCollision::FinalState(), CLHEP::HepLorentzVector::findBoostToCM(), G4StatMFChannel::FragmentsMomenta(), G4VKinkyStringDecay::FragmentString(), G4ExcitedStringDecay::FragmentStrings(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4LineSection::G4LineSection(), G4QuadrangularFacet::G4QuadrangularFacet(), G4TriangularFacet::G4TriangularFacet(), CLHEP::Hep3Vector::gamma(), CLHEP::HepLorentzVector::gamma(), G4PrimaryTransformer::GenerateSingleTrack(), G4WilsonAbrasionModel::GetAbradedNucleons(), G4BinaryCascade::GetFinalNucleusMomentum(), G4MesonAbsorption::GetFinalState(), G4StatMFFragment::GetFragment(), G4MultiNavigator::GetGlobalExitNormal(), G4ITMultiNavigator::GetGlobalExitNormal(), G4Navigator::GetGlobalExitNormal(), G4ITNavigator1::GetGlobalExitNormal(), G4ITNavigator2::GetGlobalExitNormal(), G4VIntersectionLocator::GetGlobalSurfaceNormal(), G4Navigator::GetLocalExitNormal(), G4ITNavigator1::GetLocalExitNormal(), G4ITNavigator2::GetLocalExitNormal(), G4VIntersectionLocator::GetLocalSurfaceNormal(), G4CascadParticle::getPathToTheNextZone(), G4NuclearShellModelDensity::GetRelativeDensity(), G4QGSParticipants::GetResiduals(), G4FTFModel::GetResiduals(), G4RKPropagation::GetSphereIntersectionTimes(), G4VIntersectionLocator::GetSurfaceNormal(), G4Scatterer::GetTimeToInteraction(), CLHEP::Hep3Vector::howNear(), CLHEP::HepLorentzVector::howNearCM(), CLHEP::Hep3Vector::howParallel(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4Orb::Inside(), CLHEP::Hep3Vector::isNear(), CLHEP::HepLorentzVector::isNearCM(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep3Vector::isParallel(), G4VLongitudinalStringDecay::LightFragmentationTest(), G4FieldTrack::LoadFromArray(), G4PathFinder::Locate(), G4ITPathFinder::Locate(), G4GHEKinematicsVector::Lor(), G4GHEKinematicsVector::Norz(), G4MagInt_Driver::OneGoodStep(), operator<<(), G4StatMFChannel::PlaceFragments(), G4MagInt_Driver::PrintStat_Aux(), CLHEP::Hep3Vector::project(), G4GeneratorPrecompoundInterface::Propagate(), G4GeneratorPrecompoundInterface::PropagateNuclNucl(), G4MagInt_Driver::QuickAdvance(), CLHEP::HepLorentzVector::rapidity(), CexmcChargeExchangeReconstructor::Reconstruct(), CLHEP::HepBoost::rectify(), G4QuasiElRatios::RelDecayIn2(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4SafetyHelper::ReLocateWithinVolume(), G4ITSafetyHelper::ReLocateWithinVolume(), G4MultiLevelLocator::ReportFieldValue(), G4VIntersectionLocator::ReportTrialStep(), CLHEP::HepRotation::rotateAxes(), G4LundStringFragmentation::Sample4Momentum(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4QuasiElasticChannel::Scatter(), G4DynamicParticle::Set4Momentum(), CLHEP::HepRotation::setArbitrarily(), G4DynamicParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4VisCommandsViewerSet::SetNewValue(), G4KineticTrack::SetTrackingMomentum(), G4GHEKinematicsVector::SmulAndUpdate(), G4StatMFChannel::SolveEqOfMotion(), G4QGSMFragmentation::SplitEandP(), G4LundStringFragmentation::SplitEandP(), G4GHEKinematicsVector::Sub(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4FieldTrackUpdator::Update(), G4KineticTrack::Update4Momentum(), G4KineticTrack::UpdateTrackingMomentum().

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

SpaceVector.cc 파일의 283 번째 라인에서 정의되었습니다.

다음을 참조함 : d.

다음에 의해서 참조됨 : CLHEP::Hep3Vector::eta().

bool CLHEP::Hep3Vector::operator!= ( const Hep3Vector ) const
inlineinherited
double CLHEP::Hep3Vector::operator() ( int  ) const
inlineinherited
double& CLHEP::Hep3Vector::operator() ( int  )
inlineinherited
Hep3Vector& CLHEP::Hep3Vector::operator*= ( double  )
inlineinherited

다음에 의해서 참조됨 : CLHEP::Hep3Vector::rotate().

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

ThreeVectorR.cc 파일의 20 번째 라인에서 정의되었습니다.

Hep3Vector& CLHEP::Hep3Vector::operator+= ( const Hep3Vector )
inlineinherited
Hep3Vector CLHEP::Hep3Vector::operator- ( ) const
inlineinherited
Hep3Vector& CLHEP::Hep3Vector::operator-= ( const Hep3Vector )
inlineinherited
Hep3Vector & CLHEP::Hep3Vector::operator/= ( double  c)
inherited

ThreeVector.cc 파일의 313 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

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

SpaceVector.cc 파일의 144 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::compare().

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

SpaceVector.cc 파일의 150 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::compare().

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

SpaceVector.cc 파일의 141 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::compare().

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

SpaceVector.cc 파일의 147 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::compare().

double CLHEP::Hep3Vector::operator[] ( int  ) const
inlineinherited
double& CLHEP::Hep3Vector::operator[] ( int  )
inlineinherited
Hep3Vector CLHEP::Hep3Vector::orthogonal ( ) const
inlineinherited
G4double G4StokesVector::p1 ( ) const
inline
G4double G4StokesVector::p2 ( ) const
inline
G4double G4StokesVector::p3 ( ) const
inline
double CLHEP::Hep3Vector::perp ( ) const
inlineinherited
double CLHEP::Hep3Vector::perp ( const Hep3Vector ) const
inlineinherited
double CLHEP::Hep3Vector::perp2 ( ) const
inlineinherited
double CLHEP::Hep3Vector::perp2 ( const Hep3Vector ) const
inlineinherited
Hep3Vector CLHEP::Hep3Vector::perpPart ( ) const
inlineinherited
Hep3Vector CLHEP::Hep3Vector::perpPart ( const Hep3Vector v2) const
inlineinherited
double CLHEP::Hep3Vector::phi ( ) const
inlineinherited
double CLHEP::Hep3Vector::polarAngle ( const Hep3Vector v2) const
inherited

SpaceVectorD.cc 파일의 28 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::getTheta().

다음에 의해서 참조됨 : G4UCNBoundaryProcess::MRDiffRefl(), G4UCNBoundaryProcess::MRDiffTrans().

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

SpaceVectorD.cc 파일의 32 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::angle().

G4ThreeVector G4StokesVector::PolDiv ( const G4StokesVector b)

G4StokesVector.cc 파일의 205 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), CLHEP::Hep3Vector::z().

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

G4StokesVector.cc 파일의 198 번째 라인에서 정의되었습니다.

다음을 참조함 : G4StokesVector(), n, PolSqr(), PolSqrt().

G4ThreeVector G4StokesVector::PolSqr ( ) const
inline

G4StokesVector.hh 파일의 82 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), CLHEP::Hep3Vector::z().

다음에 의해서 참조됨 : PolError().

G4ThreeVector G4StokesVector::PolSqrt ( ) const
inline

G4StokesVector.hh 파일의 85 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), CLHEP::Hep3Vector::z().

다음에 의해서 참조됨 : PolError().

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

다음에 의해서 참조됨 : CLHEP::Hep3Vector::project().

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

SpaceVectorP.cc 파일의 89 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag2(), CLHEP::Hep3Vector::project().

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

ThreeVector.cc 파일의 58 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::mag(), CLHEP::Hep3Vector::z().

다음에 의해서 참조됨 : Par02TrackingAction::PreUserTrackingAction().

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

다음에 의해서 참조됨 : XrayFluoPrimaryGeneratorAction::ActivatePhaseSpace().

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

SpaceVectorP.cc 파일의 54 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dz.

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

SpaceVectorP.cc 파일의 100 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dot(), CLHEP::Hep3Vector::mag().

double CLHEP::Hep3Vector::rho ( ) const
inlineinherited
Hep3Vector & CLHEP::Hep3Vector::rotate ( double  angle1,
const Hep3Vector aaxis 
)
inherited
Hep3Vector & CLHEP::Hep3Vector::rotate ( const Hep3Vector axis,
double  delta 
)
inherited
Hep3Vector & CLHEP::Hep3Vector::rotate ( const HepAxisAngle ax)
inherited

SpaceVectorR.cc 파일의 112 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::HepAxisAngle::delta(), CLHEP::HepAxisAngle::getAxis(), CLHEP::Hep3Vector::rotate().

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

SpaceVectorR.cc 파일의 74 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

void G4StokesVector::RotateAz ( G4ThreeVector  nInteractionFrame,
G4ThreeVector  particleDirection 
)
void G4StokesVector::RotateAz ( G4double  cosphi,
G4double  sinphi 
)

G4StokesVector.cc 파일의 133 번째 라인에서 정의되었습니다.

다음을 참조함 : isPhoton, p1(), p2(), CLHEP::Hep3Vector::setX(), CLHEP::Hep3Vector::setY().

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

ThreeVector.cc 파일의 38 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz, CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), CLHEP::Hep3Vector::z().

다음에 의해서 참조됨 : G4PreCompoundEmission::AngularDistribution(), G4MuonVDNuclearModel::CalculateEMVertex(), G4TheRayTracer::CreateBitMap(), G4MuonDecayChannelWithSpin::DecayIt(), G4PionRadiativeDecayChannel::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4SingleScatter::DoCollisionStep(), G4FissionProductYieldDist::G4GetFission(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), PrimaryGeneratorGun2::GeneratePrimaries(), PrimaryGeneratorAction3::GeneratePrimaries(), PrimaryGeneratorAction4::GeneratePrimaries(), G4OpBoundaryProcess::GetFacetNormal(), G4RDPhotoElectricAngularGeneratorSauterGavrila::GetPhotoElectronDirection(), G4UCNBoundaryProcess::LDiffRefl(), G4HadronElasticProcess::PostStepDoIt(), G4NeutrinoElectronProcess::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(), G4DNABornAngle::SampleDirectionForShell(), G4DNARuddAngle::SampleDirectionForShell(), G4VLEPTSModel::SampleNewDirection(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4WentzelVIModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4UrbanAdjointMscModel::SampleScattering(), G4GoudsmitSaundersonMscModel::SampleScattering(), G4LEPTSIonisationModel::SampleSecondaries(), MyKleinNishinaCompton::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4ee2KNeutralModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4ee2KChargedModel::SampleSecondaries(), G4eeToTwoPiModel::SampleSecondaries(), G4eeToPGammaModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4PolarizationHelper::TestInteractionFrame().

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

ThreeVector.cc 파일의 90 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

다음에 의해서 참조됨 : G4CrystalUnitCell::G4CrystalUnitCell(), CLHEP::HepLorentzVector::rotateX(), CLHEP::rotationXOf().

Hep3Vector & CLHEP::Hep3Vector::rotateY ( double  phi1)
inherited
Hep3Vector & CLHEP::Hep3Vector::rotateZ ( double  phi1)
inherited
void CLHEP::Hep3Vector::set ( double  x,
double  y,
double  z 
)
inlineinherited

다음에 의해서 참조됨 : G4GMocrenFileSceneHandler::AddSolid(), G4PreCompoundEmission::AngularDistribution(), G4ScaledSolid::BoundingLimits(), G4ReflectedSolid::BoundingLimits(), G4EllipticalTube::BoundingLimits(), G4Box::BoundingLimits(), G4DisplacedSolid::BoundingLimits(), G4VTwistedFaceted::BoundingLimits(), G4Tet::BoundingLimits(), G4Orb::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4IntersectionSolid::BoundingLimits(), G4Ellipsoid::BoundingLimits(), G4GenericPolycone::BoundingLimits(), G4Hype::BoundingLimits(), G4Paraboloid::BoundingLimits(), G4TwistedTubs::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Polycone::BoundingLimits(), G4VSolid::BoundingLimits(), G4Polyhedra::BoundingLimits(), G4EllipticalCone::BoundingLimits(), G4Trd::BoundingLimits(), G4Para::BoundingLimits(), G4Tubs::BoundingLimits(), G4Cons::BoundingLimits(), G4Torus::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Sphere::BoundingLimits(), G4Trap::BoundingLimits(), G4Voxelizer::BuildVoxelLimits(), G4NucleiModel::choosePointAlongTraj(), G4Fancy3DNucleus::ChoosePositions(), G4HadFinalState::Clear(), CML2ExpVoxels::CML2ExpVoxels(), CML2Ph_BoxInBox::CML2Ph_BoxInBox(), CML2Ph_FullWater::CML2Ph_FullWater(), CML2ReadOutGeometry::CML2ReadOutGeometry(), CML2SDWithVoxels::CML2SDWithVoxels(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), FFDetectorConstruction::Construct(), 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(), G4Box::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), CML2PrimaryGenerationAction::fillParticlesContainer(), CML2Acc1::flatteningFilter(), G4BoundingEnvelope::G4BoundingEnvelope(), G4FissionProductYieldDist::G4GetFission(), G4GoudsmitSaundersonMscModel::G4GoudsmitSaundersonMscModel(), G4LatticeLogical::G4LatticeLogical(), G4Para::G4Para(), G4TessellatedSolid::G4TessellatedSolid(), G4TriangularFacet::G4TriangularFacet(), G4TwistBoxSide::G4TwistBoxSide(), G4TwistTrapAlphaSide::G4TwistTrapAlphaSide(), G4TwistTrapFlatSide::G4TwistTrapFlatSide(), G4TwistTrapParallelSide::G4TwistTrapParallelSide(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4TwistTubsHypeSide::G4TwistTubsHypeSide(), G4TwistTubsSide::G4TwistTubsSide(), G4VTwistSurface::G4VTwistSurface(), G4eeToHadronsModel::GenerateCMPhoton(), CML2PrimaryGenerationAction::GenerateFromRandom(), G4InuclSpecialFunctions::generateWithFixedTheta(), G4InuclSpecialFunctions::generateWithRandomAngles(), G4EllipticalCone::GetPointOnSurface(), G4Trd::GetPointOnSurface(), G4Para::GetPointOnSurface(), G4Trap::GetVertices(), G4TessellatedSolid::Initialize(), G4NucleiModel::initializeCascad(), G4VTwistedFaceted::Inside(), G4TwistedTubs::Inside(), G4TriangularFacet::Intersect(), G4QuadrangularFacet::Intersect(), CML2Acc1::ionizationChamber(), CML2Acc1::Jaw1X(), CML2Acc1::Jaw1Y(), CML2Acc1::Jaw2X(), CML2Acc1::Jaw2Y(), G4VTwistedFaceted::LastState::LastState(), G4TwistedTubs::LastState::LastState(), G4VTwistedFaceted::LastValue::LastValue(), G4TwistedTubs::LastValue::LastValue(), G4VTwistedFaceted::LastValueWithDoubleVector::LastValueWithDoubleVector(), G4TwistedTubs::LastValueWithDoubleVector::LastValueWithDoubleVector(), G4VTwistedFaceted::LastVector::LastVector(), G4TwistedTubs::LastVector::LastVector(), G4LatticeLogical::Load_NMap(), CML2Acc1::MLC(), CLHEP::operator>>(), G4OpMieHG::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), CML2SDWithVoxels::resetVoxelsSingle(), G4DeltaAngleFreeScat::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4PhotoElectricAngularGeneratorSauterGavrila::SampleDirection(), G4DeltaAngle::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4Generator2BN::SampleDirection(), G4GammaTransition::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BS::SampleDirection(), G4DNARuddAngle::SampleDirectionForShell(), G4DNABornAngle::SampleDirectionForShell(), G4UrbanMscModel::SampleDisplacement(), G4UrbanAdjointMscModel::SampleDisplacement(), G4UrbanMscModel::SampleDisplacementNew(), G4UrbanAdjointMscModel::SampleDisplacementNew(), G4GoudsmitSaundersonMscModel::SampleMSC(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4WentzelVIModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4UrbanAdjointMscModel::SampleScattering(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4VTwistSurface::SetCorner(), G4VTwistSurface::CurrentStatus::SetCurrentStatus(), CML2Acc1::SetJawAperture(), G4Voxelizer::SetMaxVoxels(), G4HadFinalState::SetMomentumChange(), CML2CInputData::setPhaseSpaceCentre(), CML2CInputData::setPhaseSpaceHalfSize(), G4Voxelizer::SetReductionRatio(), G4StatMFChannel::SolveEqOfMotion(), G4GeomTools::SphereExtent(), G4VTwistedFaceted::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits().

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

SpaceVector.cc 파일의 56 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

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

ThreeVector.cc 파일의 183 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz, CLHEP::Hep3Vector::getPhi(), CLHEP::Hep3Vector::getR().

void CLHEP::Hep3Vector::setMag ( double  ma)
inherited
void CLHEP::Hep3Vector::setPerp ( double  )
inlineinherited
void CLHEP::Hep3Vector::setPhi ( double  )
inlineinherited
void G4StokesVector::SetPhoton ( )
inline
void CLHEP::Hep3Vector::setR ( double  s)
inlineinherited
void CLHEP::Hep3Vector::setREtaPhi ( double  r,
double  eta,
double  phi 
)
inlineinherited
void CLHEP::Hep3Vector::setRho ( double  s)
inlineinherited
void CLHEP::Hep3Vector::setRhoPhiEta ( double  rho,
double  phi,
double  eta 
)
inherited

SpaceVector.cc 파일의 98 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

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

SpaceVector.cc 파일의 71 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

void CLHEP::Hep3Vector::setRhoPhiZ ( double  rho,
double  phi,
double  z 
)
inlineinherited
void CLHEP::Hep3Vector::setRThetaPhi ( double  r,
double  theta,
double  phi 
)
inlineinherited
void CLHEP::Hep3Vector::setSpherical ( double  r,
double  theta,
double  phi 
)
protectedinherited

SpaceVector.cc 파일의 35 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::dx, CLHEP::Hep3Vector::dy, CLHEP::Hep3Vector::dz.

void CLHEP::Hep3Vector::setTheta ( double  )
inlineinherited
double CLHEP::Hep3Vector::setTolerance ( double  tol)
staticinherited

SpaceVector.cc 파일의 271 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::tolerance.

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

다음에 의해서 참조됨 : G4GHEKinematicsVector::Add3(), G4LENDModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::HepLorentzVector::boostX(), G4Torus::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ParameterisationBoxX::ComputeTransformation(), G4ParameterisationParaX::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G3Division::CreatePVReplica(), G4TessellatedSolid::CreateVertexList(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4BetaMinusDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), DiceP1(), DiceP2(), DiceP3(), DiceUniform(), CexmcTrackPointsDigitizer::Digitize(), Par01EnergySpot::Draw(), G4StatMFChannel::FragmentsMomenta(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), CML2PrimaryGenerationAction::GenerateFromRandom(), DMXParticleSource::GenerateIsotropicFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), DMXParticleSource::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), RE02PrimaryGeneratorAction::GeneratePrimaries(), G4SPSAngDistribution::GenerateUserDefFlux(), G4OpBoundaryProcess::GetFacetNormal(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4GDecay3::GetThreeBodyMomenta(), TrentoPassiveProtonBeamLine::HadrontherapyBeamMonitoring(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), CML2Acc1::MLC(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadDefine::PositionRead(), G4DecayWithSpin::PostStepDoIt(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), RotateAz(), G4GDMLReadDefine::RotationRead(), G4LEPTSIonisationModel::SampleSecondaries(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEnergyPolarizedCompton::SetNewPolarization(), G4LowEPPolarizedComptonModel::SetNewPolarization(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4Box::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4Channeling::UpdateParameters(), G4GDMLReadDefine::VectorRead().

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

다음에 의해서 참조됨 : G4GHEKinematicsVector::Add3(), G4LENDModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::HepLorentzVector::boostY(), G4Torus::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxY::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), RE02DetectorConstruction::Construct(), CexmcSetup::ConvertToCrystalGeometry(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4TessellatedSolid::CreateVertexList(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4BetaMinusDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), DiceP1(), DiceP2(), DiceP3(), DiceUniform(), CexmcTrackPointsDigitizer::Digitize(), Par01EnergySpot::Draw(), G4StatMFChannel::FragmentsMomenta(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), CML2PrimaryGenerationAction::GenerateFromRandom(), DMXParticleSource::GenerateIsotropicFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), DMXParticleSource::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), RE02PrimaryGeneratorAction::GeneratePrimaries(), G4SPSAngDistribution::GenerateUserDefFlux(), G4OpBoundaryProcess::GetFacetNormal(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4GDecay3::GetThreeBodyMomenta(), TrentoPassiveProtonBeamLine::HadrontherapyBeamMonitoring(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), CML2Acc1::MLC(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadDefine::PositionRead(), G4DecayWithSpin::PostStepDoIt(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), RotateAz(), G4GDMLReadDefine::RotationRead(), G4LEPTSIonisationModel::SampleSecondaries(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEnergyPolarizedCompton::SetNewPolarization(), G4LowEPPolarizedComptonModel::SetNewPolarization(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4GHEKinematicsVector::Sub3(), G4Box::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4GDMLReadDefine::VectorRead().

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

다음에 의해서 참조됨 : G4GHEKinematicsVector::Add3(), G4LENDModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), CLHEP::HepLorentzVector::boostZ(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationTrdZ::ComputeTransformation(), FFDetectorConstruction::Construct(), RE02DetectorConstruction::Construct(), CML2WorldConstruction::create(), G4FTFAnnihilation::Create2QuarkAntiQuarkStrings(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4TessellatedSolid::CreateVertexList(), G4GHEKinematicsVector::Cross(), G4GDMLReadSolids::CutTubeRead(), G4BetaMinusDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4KL3DecayChannel::DecayIt(), G4GHEKinematicsVector::Defs(), G4GHEKinematicsVector::Defs1(), DiceP1(), DiceP2(), DiceP3(), DiceUniform(), Par01PiModel::DoIt(), Par01EnergySpot::Draw(), CML2Acc1::flatteningFilter(), FlipP3(), G4StatMFChannel::FragmentsMomenta(), G4VKinkyStringDecay::FragmentString(), G4CutTubs::G4CutTubs(), G4FragmentingString::G4FragmentingString(), G4FissionProductYieldDist::G4GetFission(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), CML2PrimaryGenerationAction::GenerateFromRandom(), DMXParticleSource::GenerateIsotropicFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), DMXParticleSource::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), FFPrimaryGeneratorAction::GeneratePrimaries(), G4SPSAngDistribution::GenerateUserDefFlux(), G4OpBoundaryProcess::GetFacetNormal(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4GDecay3::GetThreeBodyMomenta(), TrentoPassiveProtonBeamLine::HadrontherapyBeamMonitoring(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), CML2ExpVoxels::loadData(), G4GHEKinematicsVector::Lor(), G4FragmentingString::LorentzRotate(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4GHEKinematicsVector::Norz(), G4GHEKinematicsVector::operator=(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadDefine::PositionRead(), G4DecayWithSpin::PostStepDoIt(), G4ParticleChangeForGamma::ProposeMomentumDirection(), G4ParticleChangeForLoss::ProposeMomentumDirection(), G4ParticleChangeForGamma::ProposePolarization(), G4ParticleChangeForDecay::ProposePolarization(), G4ParticleChangeForLoss::ProposePolarization(), RE02DetectorConstruction::RE02DetectorConstruction(), CexmcReconstructor::ReconstructEntryPoints(), CexmcReconstructor::ReconstructTargetPoint(), G4GDMLReadSolids::ReflectedSolidRead(), G4GDMLReadDefine::RotationRead(), G4LundStringFragmentation::Sample4Momentum(), G4LEPTSIonisationModel::SampleSecondaries(), G4GDMLReadDefine::ScaleRead(), G4PrimaryParticle::Set4Momentum(), G4PSDoseDepositForCylinder3D::SetCylinderSize(), G4PSPassageCellFluxForCylinder3D::SetCylinderSize(), G4PSCellFluxForCylinder3D::SetCylinderSize(), HadrontherapyDetectorConstruction::SetDetectorPosition(), IORTDetectorConstruction::SetDetectorPosition(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), G4ReactionProduct::SetMomentum(), G4GHEKinematicsVector::SetMomentum(), G4PrimaryParticle::SetMomentum(), G4GHEKinematicsVector::SetMomentumAndUpdate(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEnergyPolarizedCompton::SetNewPolarization(), G4LowEPPolarizedComptonModel::SetNewPolarization(), G4ReactionProduct::SetPositionInNucleus(), G4GHEKinematicsVector::SetZero(), G4FTFParticipants::ShiftInteractionTime(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4QGSMFragmentation::SplitEandP(), G4LundStringFragmentation::SplitEandP(), G4GHEKinematicsVector::Sub3(), G4Box::SurfaceNormal(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GHEKinematicsVector::Trac(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4FragmentingString::TransformToCenterOfMass(), G4GDMLReadDefine::VectorRead().

double CLHEP::Hep3Vector::theta ( ) const
inlineinherited
double CLHEP::Hep3Vector::theta ( const Hep3Vector v2) const
inlineinherited
Hep3Vector & CLHEP::Hep3Vector::transform ( const HepRotation m1)
inherited
G4double G4StokesVector::Transverse ( ) const
inline

G4StokesVector.hh 파일의 80 번째 라인에서 정의되었습니다.

다음을 참조함 : CLHEP::Hep3Vector::perp().

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

다음에 의해서 참조됨 : G4PreCompoundEmission::AngularDistribution(), 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(), G4RPGKPlusInelastic::ApplyYourself(), G4RPGSigmaMinusInelastic::ApplyYourself(), G4RPGXiZeroInelastic::ApplyYourself(), G4ElectroVDNuclearModel::ApplyYourself(), G4MuonVDNuclearModel::ApplyYourself(), G4ParticleHPCaptureFS::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4LEpp::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4TheoFSGenerator::ApplyYourself(), G4QMDReaction::ApplyYourself(), CexmcChargeExchangeProductionModel< OutputParticle >::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4MuonMinusBoundDecay::ApplyYourself(), G4BinaryCascade::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4WilsonAbrasionModel::ApplyYourself(), G4INCLXXInterface::ApplyYourself(), CLHEP::HepRotation::axis(), G4ParticleHPInelasticBaseFS::BaseApply(), CLHEP::HepLorentzVector::boost(), G4ExcitationHandler::BreakItUp(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4MuonVDNuclearModel::CalculateEMVertex(), G4PolyconeSide::CalculateExtent(), G4OpBoundaryProcess::CalculateReflectivity(), G4NucleiModel::choosePointAlongTraj(), G4BinaryCascade::CorrectFinalPandE(), G4BinaryCascade::CorrectShortlivedFinalsForFermi(), G4TheRayTracer::CreateBitMap(), G4PionDecayMakeSpin::DaughterPolarization(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4IntraNucleiCascader::decayTrappedParticle(), G4SPSAngDistribution::DefineAngRefAxes(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricMetal(), G4MultiUnion::DistanceToIn(), G4Tet::DistanceToIn(), G4TessellatedSolid::DistanceToInCore(), G4MultiUnion::DistanceToInNoVoxels(), G4Tet::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4Hype::DistanceToOut(), G4Cons::DistanceToOut(), G4TessellatedSolid::DistanceToOutCore(), G4MultiUnion::DistanceToOutNoVoxels(), G4MultiUnion::DistanceToOutVoxels(), G4NRESP71M03::DKINMA(), G4SingleScatter::DoCollisionStep(), G4RKPropagation::FieldTransport(), G4LorentzConvertor::fillKinematics(), G4MuonicAtomDecay::FillResult(), G4HadronicProcess::FillResult(), G4CrystalUnitCell::G4CrystalUnitCell(), G4CutTubs::G4CutTubs(), G4DynamicParticle::G4DynamicParticle(), G4PolyhedraSide::G4PolyhedraSide(), G4PolyPhiFace::G4PolyPhiFace(), G4QuadrangularFacet::G4QuadrangularFacet(), G4Tet::G4Tet(), G4TheRayTracer::G4TheRayTracer(), G4TriangularFacet::G4TriangularFacet(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4SPSPosDistribution::GenerateRotationMatrices(), G4OpBoundaryProcess::GetFacetNormal(), G4Navigator::GetGlobalExitNormal(), G4ITNavigator1::GetGlobalExitNormal(), G4ITNavigator2::GetGlobalExitNormal(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4BinaryCascade::GetSpherePoint(), G4Scatterer::GetTimeToInteraction(), G4CrystalUnitCell::GetUnitBasisTrigonal(), G4TessellatedSolid::InsideVoxels(), G4TriangularFacet::Intersect(), G4UCNBoundaryProcess::LDiffRefl(), G4LatticeLogical::Load_NMap(), G4FieldTrack::LoadFromArray(), G4CascadeInterface::makeDynamicParticle(), G4Trap::MakePlane(), G4LatticeManager::MapKtoVDir(), Par01PiModel::ModelTrigger(), G4UCNBoundaryProcess::MRDiffRefl(), G4UCNBoundaryProcess::MRDiffTrans(), G4UCNBoundaryProcess::MRreflect(), G4UCNBoundaryProcess::MRreflectHigh(), G4PolyconeSide::Normal(), G4GenericTrap::NormalToPlane(), G4TwistTrapParallelSide::NormAng(), G4TwistTrapAlphaSide::NormAng(), G4TwistBoxSide::NormAng(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4Channeling::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4OpRayleigh::PostStepDoIt(), G4UCNBoundaryProcess::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(), G4Fancy3DNucleus::ReduceSum(), G4UCNBoundaryProcess::Reflect(), G4QuasiElRatios::RelDecayIn2(), G4LENDModel::returnUnchanged(), G4LorentzConvertor::rotate(), G4StatMFChannel::RotateMomentum(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), MyKleinNishinaCompton::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4HeatedKleinNishinaCompton::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4PenelopeBremsstrahlungModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4DNAPTBElasticModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4Scatterer::Scatter(), CLHEP::HepRotation::set(), G4DynamicParticle::Set4Momentum(), CLHEP::HepRotation::setArbitrarily(), G4TwistBoxSide::SetBoundaries(), G4TwistTrapParallelSide::SetBoundaries(), G4TwistTrapAlphaSide::SetBoundaries(), G4TwistTrapFlatSide::SetBoundaries(), G4TwistTubsFlatSide::SetBoundaries(), G4TwistTubsHypeSide::SetBoundaries(), G4TwistTubsSide::SetBoundaries(), CLHEP::HepRotation::setCols(), G4FastTrack::SetCurrentTrack(), G4RadioactiveDecayBase::SetDecayDirection(), G4RadioactiveDecay::SetDecayDirection(), G4TheRayTracer::SetLightDirection(), G4DynamicParticle::SetMomentum(), G4VisCommandsViewerSet::SetNewValue(), G4ParticleGun::SetParticleMomentum(), DMXParticleSource::SetParticleMomentumDirection(), G4ParticleGun::SetParticleMomentumDirection(), G4SPSAngDistribution::SetParticleMomentumDirection(), G4DecayWithSpin::Spin_Precession(), G4EllipticalTube::SurfaceNormal(), G4Tet::SurfaceNormal(), G4UnionSolid::SurfaceNormal(), G4Box::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4MultiUnion::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Trd::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4Para::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Trap::SurfaceNormal(), G4LivermorePolarizedGammaConversionModel::SystemOfRefChange(), G4LivermorePolarizedComptonModel::SystemOfRefChange(), G4LivermorePolarizedPhotoElectricGDModel::SystemOfRefChange(), G4LowEnergyPolarizedCompton::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChange(), G4LowEPPolarizedComptonModel::SystemOfRefChangeElect(), G4AblaInterface::toG4Particle(), G4INCLXXInterface::toG4Particle(), G4TheRayTracer::Trace(), G4TheMTRayTracer::Trace(), G4RKPropagation::Transport(), G4ParticleHPInelasticCompFS::two_body_reaction(), G4KineticTrack::Update4Momentum(), G4KineticTrack::UpdateTrackingMomentum().

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

다음에 의해서 참조됨 : G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4FTFModel::AdjustNucleonsAlgorithm_afterSampling(), G4FTFModel::AdjustNucleonsAlgorithm_Sampling(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4Box::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4CutTubs::ApproxSurfaceNormal(), G4Para::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), ClusteringAlgo::AreOnTheSameCluster(), AreOnTheSameCluster(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4ScaledSolid::BoundingLimits(), G4ReflectedSolid::BoundingLimits(), G4Box::BoundingLimits(), G4DisplacedSolid::BoundingLimits(), G4Tet::BoundingLimits(), G4Orb::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4Ellipsoid::BoundingLimits(), G4SubtractionSolid::BoundingLimits(), G4IntersectionSolid::BoundingLimits(), G4GenericPolycone::BoundingLimits(), G4Hype::BoundingLimits(), G4Paraboloid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4TwistedTubs::BoundingLimits(), G4Polycone::BoundingLimits(), G4Polyhedra::BoundingLimits(), G4EllipticalCone::BoundingLimits(), G4Trd::BoundingLimits(), G4GenericTrap::BoundingLimits(), G4Para::BoundingLimits(), G4Tubs::BoundingLimits(), G4Cons::BoundingLimits(), G4Torus::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Sphere::BoundingLimits(), G4TessellatedSolid::BoundingLimits(), G4Trap::BoundingLimits(), G4Voxelizer::BuildBoundingBox(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4BoundingEnvelope::CalculateExtent(), G4EllipticalCone::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4NavigationLogger::CheckAndReportBadNormal(), G4BoundingEnvelope::CheckBoundingBox(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4eplusPolarizedAnnihilation::ComputeSaturationFactor(), G4ePolarizedIonisation::ComputeSaturationFactor(), G4ReplicaNavigation::ComputeTransformation(), DetectorConstruction0::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), TSDetectorConstruction::ConstructWorld(), CexmcSetup::ConvertToCrystalGeometry(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4GenericTrap::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4TessellatedSolid::CreateVertexList(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4PolarizedAnnihilationCrossSection::DefineCoefficients(), G4PolarizedComptonCrossSection::DefineCoefficients(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4QGSParticipants::DeterminePartonMomenta(), G4QGSMSplitableHadron::DiffractiveSplitUp(), CexmcTrackPointsDigitizer::Digitize(), G4VTwistSurface::DistanceToBoundary(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Hype::DistanceToIn(), G4CutTubs::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Trd::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Torus::DistanceToIn(), G4Sphere::DistanceToIn(), G4Trap::DistanceToIn(), G4TessellatedSolid::DistanceToInNoVoxels(), G4EllipticalTube::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Orb::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4CutTubs::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Tubs::DistanceToOut(), G4Torus::DistanceToOut(), G4Cons::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4ReplicaNavigation::DistanceToOutPhi(), G4ReplicaNavigation::DistanceToOutRad(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), DicomBeamControlPoint::DumpToFile(), TrackerSD::EndOfEvent(), ExGflashEventAction::EndOfEventAction(), CCalEventAction::EndOfEventAction(), G4SPSEneDistribution::EpnEnergyHisto(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4MultiUnion::Extent(), G4PolyPhiFace::Extent(), Analysis::FillDose(), Analysis::FillIncident(), G4QGSParticipants::FinalizeKinematics(), G4FTFModel::FinalizeKinematics(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4Para::G4Para(), G4PolyPhiFace::G4PolyPhiFace(), G4PrimaryVertex::G4PrimaryVertex(), G4RandomPointOnEllipsoid(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), TSPrimaryGeneratorAction::GeneratePrimaries(), FFPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4SPSAngDistribution::GenerateUserDefFlux(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4Voxelizer::GetCandidatesVoxelArray(), G4MultiUnion::GetCubicVolume(), G4Trap::GetCubicVolume(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4ChannelingECHARM::GetEC(), G4GenericTrap::GetExtent(), G4EllipticalCone::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4QGSParticipants::GetList(), G4CutTubs::GetMaxMinZ(), G4TessellatedSolid::GetMaxXExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TessellatedSolid::GetMinXExtent(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4TwistTrapParallelSide::GetPhiUAtX(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapAlphaSide::GetPhiUAtX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPx(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4ScoringBox::GetReplicaPosition(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4ScaledSolid::GetScaleTransform(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetXPositionInNucleus(), ClusterSBPoints::HasInBarycenter(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4EllipticalTube::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4VTwistedFaceted::Inside(), G4Hype::Inside(), G4PolyPhiFace::Inside(), G4CutTubs::Inside(), G4EllipticalCone::Inside(), G4Trd::Inside(), G4ExtrudedSolid::Inside(), G4TwistedTubs::Inside(), G4ReplicaNavigation::Inside(), G4Torus::Inside(), G4Para::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4TessellatedSolid::InsideNoVoxels(), G4GenericTrap::InsidePolygone(), G4TessellatedSolid::InsideVoxels(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EllipticalTube::IntersectXY(), F04SimpleSolenoid::IsOutside(), G4GenericTrap::IsSegCrossingZ(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4Para::MakePlanes(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4Voxelizer::MinDistanceToBox(), G4GDMLWriteSolids::MultiUnionWrite(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GHEKinematicsVector::Norz(), G4GDMLWriteSolids::G4ThreeVectorCompare::operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4TessellatedSolid::OutsideOfExtent(), p1(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), PolDiv(), PolSqr(), PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4Channeling::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), B5DriftChamberHit::Print(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), ExN04MuonSD::ProcessHits(), ScreenSD::ProcessHits(), RE05MuonSD::ProcessHits(), PhantomSD::ProcessHits(), UltraPMTSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ExtrudedSolid::ProjectPoint(), G4ErrorFreeTrajState::PropagateError(), G4ErrorFreeTrajState::PropagateErrorMSC(), G4MoleculeShoot::RandomPosInBox(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), G4GDMLReadSolids::ReflectedSolidRead(), G4QGSParticipants::ReggeonCascade(), G4FTFModel::ReggeonCascade(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4MultiLevelLocator::ReportFieldValue(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), CexmcSetup::RotateMatrix(), G4StatMFChannel::RotateMomentum(), CLHEP::Hep3Vector::rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4MultiUnion::SafetyFromOutsideNumberNode(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GammaTransition::SampleTransition(), G4QGSParticipants::SamplingNucleonKinematics(), G4FTFModel::SamplingNucleonKinematics(), Par02Output::SaveTrack(), G4GDMLWriteDefine::Scale_vectorWrite(), G4GDMLReadSolids::ScaledSolidRead(), G4Scatterer::Scatter(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4SPSRandomGenerator::SetEnergyBias(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::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(), NeuronLoadDataFile::SingleNeuronSWCfile(), Par02Smearer::SmearGaussian(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4Torus::SolveNumericJT(), G4QGSMFragmentation::SplitEandP(), G4LundStringFragmentation::SplitEandP(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4ScaledSolid::StreamInfo(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub3(), G4EllipticalTube::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Trd::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Trap::SurfaceNormal(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4Torus::TorusRootsJT(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BoundingEnvelope::TransformVertices(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4Channeling::UpdateIntegrationStep(), G4Channeling::UpdateParameters(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), FCALSteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), G4SteppingVerbose::VerboseTrack().

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

다음에 의해서 참조됨 : G4GHEKinematicsVector::Add3(), G4HepRepFileSceneHandler::AddCompound(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4HepRepFileXMLWriter::addPoint(), G4GMocrenFileSceneHandler::AddSolid(), G4FTFModel::AdjustNucleonsAlgorithm_afterSampling(), G4MagHelicalStepper::AdvanceHelix(), G4VTwistSurface::AmIOnLeftSide(), XrayTelAnalysis::analyseStepping(), G4GHEKinematicsVector::Ang(), G4ReactionProduct::Angle(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4Box::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4CutTubs::ApproxSurfaceNormal(), G4Para::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), G4SPSEneDistribution::ArbEnergyHisto(), ClusteringAlgo::AreOnTheSameCluster(), AreOnTheSameCluster(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4ScaledSolid::BoundingLimits(), G4ReflectedSolid::BoundingLimits(), G4Box::BoundingLimits(), G4DisplacedSolid::BoundingLimits(), G4Tet::BoundingLimits(), G4Orb::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4Ellipsoid::BoundingLimits(), G4SubtractionSolid::BoundingLimits(), G4IntersectionSolid::BoundingLimits(), G4GenericPolycone::BoundingLimits(), G4Hype::BoundingLimits(), G4Paraboloid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4TwistedTubs::BoundingLimits(), G4Polycone::BoundingLimits(), G4Polyhedra::BoundingLimits(), G4EllipticalCone::BoundingLimits(), G4Trd::BoundingLimits(), G4GenericTrap::BoundingLimits(), G4Para::BoundingLimits(), G4Tubs::BoundingLimits(), G4Cons::BoundingLimits(), G4Torus::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Sphere::BoundingLimits(), G4TessellatedSolid::BoundingLimits(), G4Trap::BoundingLimits(), G4Voxelizer::BuildBoundingBox(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4BoundingEnvelope::CalculateExtent(), G4EllipticalCone::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4NavigationLogger::CheckAndReportBadNormal(), G4BoundingEnvelope::CheckBoundingBox(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4eplusPolarizedAnnihilation::ComputeSaturationFactor(), G4ePolarizedIonisation::ComputeSaturationFactor(), G4ReplicaNavigation::ComputeTransformation(), DetectorConstruction0::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), TSDetectorConstruction::ConstructWorld(), CexmcSetup::ConvertToCrystalGeometry(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4GenericTrap::CreatePolyhedron(), G3Division::CreatePVReplica(), G4FastStep::CreateSecondaryTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4TessellatedSolid::CreateVertexList(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4PolarizedAnnihilationCrossSection::DefineCoefficients(), G4PolarizedComptonCrossSection::DefineCoefficients(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4QGSParticipants::DeterminePartonMomenta(), G4QGSMSplitableHadron::DiffractiveSplitUp(), CexmcTrackPointsDigitizer::Digitize(), G4VTwistSurface::DistanceToBoundary(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Hype::DistanceToIn(), G4CutTubs::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Trd::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Torus::DistanceToIn(), G4Sphere::DistanceToIn(), G4Trap::DistanceToIn(), G4TessellatedSolid::DistanceToInNoVoxels(), G4EllipticalTube::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Orb::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4CutTubs::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4ReplicaNavigation::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Tubs::DistanceToOut(), G4Torus::DistanceToOut(), G4Cons::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4ReplicaNavigation::DistanceToOutPhi(), G4ReplicaNavigation::DistanceToOutRad(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), DicomBeamControlPoint::DumpToFile(), TrackerSD::EndOfEvent(), ExGflashEventAction::EndOfEventAction(), CCalEventAction::EndOfEventAction(), G4SPSEneDistribution::EpnEnergyHisto(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4MultiUnion::Extent(), G4PolyPhiFace::Extent(), Analysis::FillDose(), Analysis::FillIncident(), G4QGSParticipants::FinalizeKinematics(), G4FTFModel::FinalizeKinematics(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4Para::G4Para(), G4PolyPhiFace::G4PolyPhiFace(), G4PrimaryVertex::G4PrimaryVertex(), G4RandomPointOnEllipsoid(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4SPSAngDistribution::GenerateBeamFlux(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), TSPrimaryGeneratorAction::GeneratePrimaries(), FFPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4SPSAngDistribution::GenerateUserDefFlux(), G4TwistTrapFlatSide::GetAreaCode(), G4TwistTubsFlatSide::GetBoundaryMax(), G4TwistTubsHypeSide::GetBoundaryMax(), G4TwistTubsFlatSide::GetBoundaryMin(), G4TwistTubsHypeSide::GetBoundaryMin(), G4Voxelizer::GetCandidatesVoxelArray(), G4MultiUnion::GetCubicVolume(), G4Trap::GetCubicVolume(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4ChannelingECHARM::GetEC(), G4GenericTrap::GetExtent(), G4EllipticalCone::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4QGSParticipants::GetList(), G4CutTubs::GetMaxMinZ(), G4TessellatedSolid::GetMaxYExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TessellatedSolid::GetMinYExtent(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4PolarizationHelper::GetParticleFrameY(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapParallelSide::GetPhiUAtX(), G4TwistTrapAlphaSide::GetPhiUAtX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPy(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4ScoringBox::GetReplicaPosition(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4ScaledSolid::GetScaleTransform(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetYPositionInNucleus(), ClusterSBPoints::HasInBarycenter(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4EllipticalTube::Inside(), G4Ellipsoid::Inside(), G4Box::Inside(), G4VTwistedFaceted::Inside(), G4Hype::Inside(), G4PolyPhiFace::Inside(), G4CutTubs::Inside(), G4EllipticalCone::Inside(), G4Trd::Inside(), G4ExtrudedSolid::Inside(), G4TwistedTubs::Inside(), G4ReplicaNavigation::Inside(), G4Torus::Inside(), G4Para::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4TessellatedSolid::InsideNoVoxels(), G4GenericTrap::InsidePolygone(), G4TessellatedSolid::InsideVoxels(), G4PolyconeSide::Intersect(), G4Hype::IntersectHype(), G4ErrorCylSurfaceTarget::IntersectLocal(), G4EllipticalTube::IntersectXY(), F04SimpleSolenoid::IsOutside(), G4GenericTrap::IsSegCrossingZ(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4PolyhedraSide::LineHitsSegments(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4Trap::MakePlane(), G4Para::MakePlanes(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4Voxelizer::MinDistanceToBox(), G4GDMLWriteSolids::MultiUnionWrite(), G4EnclosingCylinder::MustBeOutside(), G4PolyconeSide::Normal(), G4GHEKinematicsVector::Norz(), G4GDMLWriteSolids::G4ThreeVectorCompare::operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4TessellatedSolid::OutsideOfExtent(), p2(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), PolDiv(), PolSqr(), PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), B5DriftChamberHit::Print(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), ScreenSD::ProcessHits(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), PhantomSD::ProcessHits(), UltraPMTSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4ExtrudedSolid::ProjectPoint(), G4ErrorFreeTrajState::PropagateError(), G4ErrorFreeTrajState::PropagateErrorMSC(), G4MoleculeShoot::RandomPosInBox(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), G4GDMLReadSolids::ReflectedSolidRead(), G4QGSParticipants::ReggeonCascade(), G4FTFModel::ReggeonCascade(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4MultiLevelLocator::ReportFieldValue(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), CexmcSetup::RotateMatrix(), G4StatMFChannel::RotateMomentum(), CLHEP::Hep3Vector::rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4MultiUnion::SafetyFromOutsideNumberNode(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GammaTransition::SampleTransition(), G4QGSParticipants::SamplingNucleonKinematics(), G4FTFModel::SamplingNucleonKinematics(), Par02Output::SaveTrack(), G4GDMLWriteDefine::Scale_vectorWrite(), G4GDMLReadSolids::ScaledSolidRead(), G4Scatterer::Scatter(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4SPSRandomGenerator::SetEnergyBias(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::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(), NeuronLoadDataFile::SingleNeuronSWCfile(), Par02Smearer::SmearGaussian(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4Torus::SolveNumericJT(), G4QGSMFragmentation::SplitEandP(), G4LundStringFragmentation::SplitEandP(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), G4ScaledSolid::StreamInfo(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub3(), G4EllipticalTube::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Trd::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Trap::SurfaceNormal(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4Torus::TorusRootsJT(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BoundingEnvelope::TransformVertices(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4Channeling::UpdateIntegrationStep(), G4SPSAngDistribution::UserDefAngPhi(), G4SPSAngDistribution::UserDefAngTheta(), G4SPSEneDistribution::UserEnergyHisto(), CCalSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), G4SteppingVerbose::VerboseTrack().

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

다음에 의해서 참조됨 : 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(), G4NeutronRadCapture::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LFission::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4Box::ApproxSurfaceNormal(), G4EllipticalTube::ApproxSurfaceNormal(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4EllipticalCone::ApproxSurfaceNormal(), G4Trd::ApproxSurfaceNormal(), G4Para::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4Sphere::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), ClusteringAlgo::AreOnTheSameCluster(), AreOnTheSameCluster(), G4GDMLReadSolids::BooleanRead(), G4GDMLWriteSolids::BooleanWrite(), G4DecayProducts::Boost(), G4NucleiModel::boundaryTransition(), G4BoundingEnvelope::BoundingBoxVsVoxelLimits(), G4ScaledSolid::BoundingLimits(), G4ReflectedSolid::BoundingLimits(), G4Box::BoundingLimits(), G4DisplacedSolid::BoundingLimits(), G4Tet::BoundingLimits(), G4Orb::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4SubtractionSolid::BoundingLimits(), G4Ellipsoid::BoundingLimits(), G4IntersectionSolid::BoundingLimits(), G4GenericPolycone::BoundingLimits(), G4Hype::BoundingLimits(), G4Paraboloid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4TwistedTubs::BoundingLimits(), G4Polycone::BoundingLimits(), G4Polyhedra::BoundingLimits(), G4EllipticalCone::BoundingLimits(), G4Trd::BoundingLimits(), G4GenericTrap::BoundingLimits(), G4Para::BoundingLimits(), G4Tubs::BoundingLimits(), G4Cons::BoundingLimits(), G4Torus::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Sphere::BoundingLimits(), G4TessellatedSolid::BoundingLimits(), G4Trap::BoundingLimits(), G4Voxelizer::BuildBoundingBox(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4tgbRotationMatrix::BuildG4RotMatrixFrom6(), G4tgbRotationMatrix::BuildG4RotMatrixFrom9(), G4QMDReaction::calcOffSetOfCollision(), G4BoundingEnvelope::CalculateExtent(), G4CutTubs::CalculateExtent(), G4EllipticalCone::CalculateExtent(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4NavigationLogger::CheckAndReportBadNormal(), G4BoundingEnvelope::CheckBoundingBox(), G4ParticleChangeForGamma::CheckIt(), G4ParticleChangeForMSC::CheckIt(), G4ParticleChangeForLoss::CheckIt(), G4ParticleChangeForDecay::CheckIt(), G4ParticleChange::CheckIt(), G4VParticleChange::CheckSecondary(), G4VoxelLimits::ClipToLimits(), G4PolarizedComptonModel::ComputeCrossSectionPerAtom(), G4PolarizedAnnihilationModel::ComputeCrossSectionPerElectron(), G4eplusPolarizedAnnihilation::ComputeSaturationFactor(), G4ePolarizedIonisation::ComputeSaturationFactor(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationParaZ::ComputeTransformation(), DetectorConstruction0::Construct(), F04ElementField::Construct(), RE02DetectorConstruction::Construct(), TSDetectorConstruction::ConstructWorld(), G4UIcommand::ConvertToString(), G4GHEKinematicsVector::CosAng(), G4TheRayTracer::CreateBitMap(), G4Tet::CreatePolyhedron(), G4FastStep::CreateSecondaryTrack(), G4PhysChemIO::FormattedText::CreateSolvatedElectron(), G4PhysChemIO::G4Analysis::CreateSolvatedElectron(), G4GenericTrap::CreateTessellatedSolid(), G4TessellatedSolid::CreateVertexList(), G4PhysChemIO::FormattedText::CreateWaterMolecule(), G4PhysChemIO::G4Analysis::CreateWaterMolecule(), G4GHEKinematicsVector::Cross(), CCaloSD::curve_LY(), G4PionDecayMakeSpin::DaughterPolarization(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4PolarizedAnnihilationCrossSection::DefineCoefficients(), G4PolarizedComptonCrossSection::DefineCoefficients(), G4GHEKinematicsVector::Defs(), G4RPGReaction::Defs1(), G4GHEKinematicsVector::Defs1(), G4PolyPhiFace::Distance(), G4PolyconeSide::DistanceAway(), G4VTwistSurface::DistanceToBoundary(), G4EllipticalTube::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Box::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4Hype::DistanceToIn(), G4CutTubs::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Trd::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Para::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Torus::DistanceToIn(), G4Sphere::DistanceToIn(), G4Trap::DistanceToIn(), G4TessellatedSolid::DistanceToInNoVoxels(), G4EllipticalTube::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Box::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Orb::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4Hype::DistanceToOut(), G4CutTubs::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Tubs::DistanceToOut(), G4Torus::DistanceToOut(), G4Cons::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4ReplicaNavigation::DistanceToOutRad(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), G4GHEKinematicsVector::Dot(), G4GHEKinematicsVector::Dot4(), Par01EnergySpot::Draw(), G4LatticeLogical::Dump_NMap(), G4tgbGeometryDumper::DumpBooleanVolume(), G4ParticleChangeForMSC::DumpInfo(), G4ParticleChangeForLoss::DumpInfo(), G4ParticleChange::DumpInfo(), G4FastStep::DumpInfo(), G4tgbGeometryDumper::DumpPVPlacement(), DicomBeamControlPoint::DumpToFile(), TrackerSD::EndOfEvent(), ExGflashEventAction::EndOfEventAction(), CCalEventAction::EndOfEventAction(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4MultiUnion::Extent(), G4PolyPhiFace::Extent(), G4PolyconeSide::Extent(), G4PolyhedraSide::Extent(), Analysis::FillDose(), G4QGSParticipants::FinalizeKinematics(), G4FTFModel::FinalizeKinematics(), FlipP3(), G4BestUnit::G4BestUnit(), G4CutTubs::G4CutTubs(), G4ErrorFreeTrajState::G4ErrorFreeTrajState(), G4Fancy3DNucleusHelperForSortInZ(), G4GHEKinematicsVector::G4GHEKinematicsVector(), G4Para::G4Para(), G4PrimaryVertex::G4PrimaryVertex(), G4RandomPointOnEllipsoid(), G4UniformElectricField::G4UniformElectricField(), G4UniformGravityField::G4UniformGravityField(), G4UniformMagField::G4UniformMagField(), G4SPSAngDistribution::GenerateBeamFlux(), GB03BOptnSplitOrKillOnBoundary::GenerateBiasingFinalState(), GB05BOptnSplitAndKillByCrossSection::GenerateBiasingFinalState(), G4SPSAngDistribution::GenerateCosineLawFlux(), G4SPSAngDistribution::GenerateIsotropicFlux(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), TSPrimaryGeneratorAction::GeneratePrimaries(), FFPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), MedicalBeam::GeneratePrimaries(), DMXParticleSource::GeneratePrimaryVertex(), G4ParticleGun::GeneratePrimaryVertex(), G4SingleParticleSource::GeneratePrimaryVertex(), G4PrimaryTransformer::GenerateSingleTrack(), G4CascadeFinalStateAlgorithm::GenerateTwoBody(), G4SPSAngDistribution::GenerateUserDefFlux(), G4TwistBoxSide::GetAreaCode(), G4TwistTrapParallelSide::GetAreaCode(), G4TwistTrapAlphaSide::GetAreaCode(), G4TwistTubsHypeSide::GetAreaCode(), G4TwistTubsSide::GetAreaCode(), G4VTwistSurface::GetBoundaryAtPZ(), G4ChannelingMaterialData::GetBR(), G4Voxelizer::GetCandidatesVoxelArray(), G4MultiUnion::GetCubicVolume(), G4Trap::GetCubicVolume(), G4CutTubs::GetCutZ(), G4ErrorPlaneSurfaceTarget::GetDistanceFromPoint(), G4GenericTrap::GetExtent(), G4EllipticalCone::GetExtent(), G4TessellatedSolid::GetExtent(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), PyG4MagneticField::GetFieldValue(), G4CachedMagneticField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4FTFParticipants::GetList(), G4TessellatedSolid::GetMaxZExtent(), G4SynchrotronRadiation::GetMeanFreePath(), G4SynchrotronRadiationInMat::GetMeanFreePath(), G4TessellatedSolid::GetMinZExtent(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4PolarizationHelper::GetParticleFrameX(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapParallelSide::GetPhiUAtX(), G4TwistTrapAlphaSide::GetPhiUAtX(), G4SynchrotronRadiationInMat::GetPhotonEnergy(), G4PrimaryParticle::GetPz(), G4LivermorePolarizedComptonModel::GetRandomPolarization(), G4LivermorePolarizedGammaConversionModel::GetRandomPolarization(), G4LivermorePolarizedPhotoElectricGDModel::GetRandomPolarization(), G4LowEnergyPolarizedCompton::GetRandomPolarization(), G4LowEPPolarizedComptonModel::GetRandomPolarization(), G4PartialPhantomParameterisation::GetReplicaNo(), G4PhantomParameterisation::GetReplicaNo(), G4ScoringBox::GetReplicaPosition(), G4TwistTubsHypeSide::GetRhoAtPZ(), G4tgrUtils::GetRotationFromDirection(), G4GDMLReadDefine::GetRotationMatrix(), G4ScaledSolid::GetScaleTransform(), G4PolarizationHelper::GetSpinInPRF(), G4Scatterer::GetTimeToInteraction(), G4ReactionProduct::GetZPositionInNucleus(), ClusterSBPoints::HasInBarycenter(), G4Pythia6Decayer::ImportDecayProducts(), G4GHEKinematicsVector::Impu(), G4FTFModel::Init(), G4PolarizedPEEffectCrossSection::Initialize(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBhabhaCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4PolarizedMollerCrossSection::Initialize(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4EllipticalTube::Inside(), G4Ellipsoid::Inside(), G4UnionSolid::Inside(), G4Box::Inside(), G4VTwistedFaceted::Inside(), G4Paraboloid::Inside(), G4GenericTrap::Inside(), G4Hype::Inside(), G4PolyPhiFace::Inside(), G4EllipticalCone::Inside(), G4Trd::Inside(), G4ExtrudedSolid::Inside(), G4TwistedTubs::Inside(), G4Torus::Inside(), G4Para::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4PolyPhiFace::InsideEdgesExact(), G4TessellatedSolid::InsideNoVoxels(), G4TessellatedSolid::InsideVoxels(), G4PolyPhiFace::Intersect(), G4Hype::IntersectHype(), F04SimpleSolenoid::IsOutside(), G4GenericTrap::IsSegCrossingZ(), G4PSSphereSurfaceCurrent::IsSelectedSurface(), G4PSCylinderSurfaceFlux::IsSelectedSurface(), G4PSCylinderSurfaceCurrent::IsSelectedSurface(), G4PSFlatSurfaceCurrent::IsSelectedSurface(), G4PSSphereSurfaceFlux::IsSelectedSurface(), G4PSFlatSurfaceFlux::IsSelectedSurface(), F04SimpleSolenoid::IsWithin(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4VScoringMesh::List(), G4GHEKinematicsVector::Lor(), G4ReactionProduct::Lorentz(), CCalMagneticField::MagneticField(), G4GenericTrap::MakeDownFacet(), G4ExtrudedSolid::MakeDownFacet(), G4Trap::MakePlane(), G4Para::MakePlanes(), G4GenericTrap::MakeUpFacet(), G4ExtrudedSolid::MakeUpFacet(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4Voxelizer::MinDistanceToBox(), G4GDMLWriteSolids::MultiUnionWrite(), G4EnclosingCylinder::MustBeOutside(), G4PolyPhiFace::Normal(), G4TessellatedSolid::Normal(), G4GenericTrap::NormalToPlane(), G4GHEKinematicsVector::Norz(), G4GDMLWriteSolids::G4ThreeVectorCompare::operator()(), operator+(), operator-(), CLHEP::operator/(), operator<<(), CLHEP::operator<<(), G4GHEKinematicsVector::operator=(), G4VoxelLimits::OutCode(), G4TessellatedSolid::OutsideOfExtent(), p3(), G4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadParamvol::ParametersRead(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4STRead::PhysvolRead(), G4GDMLReadStructure::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), G4PolyconeSide::PointOnCone(), PolDiv(), PolSqr(), PolSqrt(), G4GDMLWriteDefine::Position_vectorWrite(), G4Channeling::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4SynchrotronRadiation::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4SynchrotronRadiationInMat::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4ErrorMagFieldLimitProcess::PostStepGetPhysicalInteractionLength(), G4AdjointTrackingAction::PostUserTrackingAction(), F04TrackingAction::PreUserTrackingAction(), WLSTrackingAction::PreUserTrackingAction(), G4PrimaryParticle::Print(), G4GHEKinematicsVector::Print(), G4CascadeHistory::PrintEntry(), G4MagInt_Driver::PrintStat_Aux(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), G4VIntersectionLocator::printStatus(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), PhantomSD::ProcessHits(), UltraPMTSD::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4TwistTubsSide::ProjectAtPXPZ(), G4ExtrudedSolid::ProjectPoint(), G4ErrorFreeTrajState::PropagateError(), CLHEP::Hep3Vector::pseudoRapidity(), G4MoleculeShoot::RandomPosInBox(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4STRead::Read(), CexmcReconstructor::ReconstructEntryPoints(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), G4GDMLReadSolids::ReflectedSolidRead(), G4AdjointSimManager::RegisterAtEndOfAdjointTrack(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4MultiLevelLocator::ReportFieldValue(), CLHEP::HepRotation::rotate(), CLHEP::HepRotation::rotateAxes(), CexmcSetup::RotateMatrix(), G4StatMFChannel::RotateMomentum(), CLHEP::Hep3Vector::rotateUz(), G4GDMLWriteDefine::Rotation_vectorWrite(), G4TessellatedSolid::SafetyFromInside(), G4TessellatedSolid::SafetyFromOutside(), G4MultiUnion::SafetyFromOutsideNumberNode(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4eeTo3PiModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4GammaTransition::SampleTransition(), Par02Output::SaveTrack(), G4GDMLWriteDefine::Scale_vectorWrite(), G4GDMLReadSolids::ScaledSolidRead(), G4Scatterer::Scatter(), CLHEP::HepBoost::set(), CLHEP::HepRotation::set(), G4UIcmdWith3Vector::SetDefaultValue(), G4UIcmdWith3VectorAndUnit::SetDefaultValue(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4UniformMagField::SetFieldValue(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), CLHEP::Hep3Vector::setMag(), G4GHEKinematicsVector::SetMassAndUpdate(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4BlineTracerMessenger::SetNewValue(), G4ScoringMessenger::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), G4PrimaryParticle::SetPolarization(), G4HadronicWhiteBoard::SetProjectile(), G3toG4RotationMatrix::SetRotationMatrixByCol(), G3toG4RotationMatrix::SetRotationMatrixByRow(), G4RPGInelastic::SetUpChange(), G4FTFParticipants::ShiftInteractionTime(), G4RayShooter::Shoot(), G4SteppingVerbose::ShowStep(), NeuronLoadDataFile::SingleNeuronSWCfile(), Par02Smearer::SmearGaussian(), G4GHEKinematicsVector::Smul(), G4GHEKinematicsVector::SmulAndUpdate(), G4Torus::SolveNumericJT(), G4AttCheck::Standard(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4ScaledSolid::StreamInfo(), G4GHEKinematicsVector::Sub3(), G4EllipticalTube::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4Box::SurfaceNormal(), G4VTwistedFaceted::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), G4Paraboloid::SurfaceNormal(), G4Hype::SurfaceNormal(), G4CutTubs::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4Trd::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4TwistedTubs::SurfaceNormal(), G4Para::SurfaceNormal(), G4Tubs::SurfaceNormal(), G4Cons::SurfaceNormal(), G4Torus::SurfaceNormal(), G4Sphere::SurfaceNormal(), G4Trap::SurfaceNormal(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4Torus::TorusRootsJT(), G4PolarizedBhabhaCrossSection::TotalXSection(), G4PolarizedMollerCrossSection::TotalXSection(), G4PolarizedComptonCrossSection::TotalXSection(), G4GHEKinematicsVector::Trac(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BoundingEnvelope::TransformVertices(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), G4Channeling::UpdateParameters(), CCalSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), PurgMagSteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), G4SteppingVerbose::VerboseTrack().

멤버 데이타 문서화

double CLHEP::Hep3Vector::dx
protectedinherited
double CLHEP::Hep3Vector::dy
protectedinherited
double CLHEP::Hep3Vector::dz
protectedinherited
G4bool G4StokesVector::isPhoton
private

G4StokesVector.hh 파일의 109 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : GetBeta(), RotateAz(), SetPhoton().

const G4StokesVector G4StokesVector::M1 =G4ThreeVector(-1.,0.,0.)
static

G4StokesVector.hh 파일의 66 번째 라인에서 정의되었습니다.

const G4StokesVector G4StokesVector::M2 =G4ThreeVector(0.,-1.,0.)
static

G4StokesVector.hh 파일의 67 번째 라인에서 정의되었습니다.

const G4StokesVector G4StokesVector::M3 =G4ThreeVector(0.,0.,-1.)
static

G4StokesVector.hh 파일의 68 번째 라인에서 정의되었습니다.

const G4StokesVector G4StokesVector::P1 =G4ThreeVector(1.,0.,0.)
static
const G4StokesVector G4StokesVector::P2 =G4ThreeVector(0.,1.,0.)
static
const G4StokesVector G4StokesVector::P3 =G4ThreeVector(0.,0.,1.)
static
double CLHEP::Hep3Vector::tolerance = Hep3Vector::ToleranceTicks * 2.22045e-16
staticprotectedinherited

ThreeVector.h 파일의 399 번째 라인에서 정의되었습니다.

다음에 의해서 참조됨 : CLHEP::Hep3Vector::setTolerance().

const G4StokesVector G4StokesVector::ZERO =G4ThreeVector(0.,0.,0.)
static

이 클래스에 대한 문서화 페이지는 다음의 파일들로부터 생성되었습니다.: