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

#include <G4PVParameterised.hh>

G4PVParameterised에 대한 상속 다이어그램 :
G4PVReplica G4VPhysicalVolume

Public 멤버 함수

 G4PVParameterised (const G4String &pName, G4LogicalVolume *pLogical, G4LogicalVolume *pMotherLogical, const EAxis pAxis, const G4int nReplicas, G4VPVParameterisation *pParam, G4bool pSurfChk=false)
 
 G4PVParameterised (const G4String &pName, G4LogicalVolume *pLogical, G4VPhysicalVolume *pMother, const EAxis pAxis, const G4int nReplicas, G4VPVParameterisation *pParam, G4bool pSurfChk=false)
 
 G4PVParameterised (__void__ &)
 
virtual ~G4PVParameterised ()
 
G4bool IsParameterised () const
 
G4VPVParameterisationGetParameterisation () const
 
void GetReplicationData (EAxis &axis, G4int &nReplicas, G4double &width, G4double &offset, G4bool &consuming) const
 
virtual void SetRegularStructureId (G4int Code)
 
G4bool CheckOverlaps (G4int res=1000, G4double tol=0., G4bool verbose=true, G4int maxErr=1)
 
G4bool IsMany () const
 
G4bool IsReplicated () const
 
virtual G4int GetCopyNo () const
 
virtual void SetCopyNo (G4int CopyNo)
 
virtual G4int GetMultiplicity () const
 
G4bool IsRegularStructure () const
 
G4int GetRegularStructureId () const
 
G4int GetInstanceID () const
 
void InitialiseWorker (G4PVReplica *pMasterObject)
 
void TerminateWorker (G4PVReplica *pMasterObject)
 
G4bool operator== (const G4VPhysicalVolume &p) const
 
G4RotationMatrixGetObjectRotation () const
 
G4RotationMatrix GetObjectRotationValue () const
 
G4ThreeVector GetObjectTranslation () const
 
const G4RotationMatrixGetFrameRotation () const
 
G4ThreeVector GetFrameTranslation () const
 
const G4ThreeVectorGetTranslation () const
 
const G4RotationMatrixGetRotation () const
 
G4RotationMatrixGetRotation ()
 
void SetTranslation (const G4ThreeVector &v)
 
void SetRotation (G4RotationMatrix *)
 
G4LogicalVolumeGetLogicalVolume () const
 
void SetLogicalVolume (G4LogicalVolume *pLogical)
 
G4LogicalVolumeGetMotherLogical () const
 
void SetMotherLogical (G4LogicalVolume *pMother)
 
const G4StringGetName () const
 
void SetName (const G4String &pName)
 
EVolume VolumeType () const
 

정적 Public 멤버 함수

static const G4PVRManagerGetSubInstanceManager ()
 
static void Clean ()
 

Protected 멤버 함수

void InitialiseWorker (G4VPhysicalVolume *pMasterObject, G4RotationMatrix *pRot, const G4ThreeVector &tlate)
 
void TerminateWorker (G4VPhysicalVolume *pMasterObject)
 

Protected 속성

EAxis faxis
 
G4int fnReplicas
 
G4double fwidth
 
G4double foffset
 

Private 속성

G4VPVParameterisationfparam
 

상세한 설명

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

생성자 & 소멸자 문서화

G4PVParameterised::G4PVParameterised ( const G4String pName,
G4LogicalVolume pLogical,
G4LogicalVolume pMotherLogical,
const EAxis  pAxis,
const G4int  nReplicas,
G4VPVParameterisation pParam,
G4bool  pSurfChk = false 
)

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

다음을 참조함 : CheckOverlaps().

G4PVParameterised::G4PVParameterised ( const G4String pName,
G4LogicalVolume pLogical,
G4VPhysicalVolume pMother,
const EAxis  pAxis,
const G4int  nReplicas,
G4VPVParameterisation pParam,
G4bool  pSurfChk = false 
)
G4PVParameterised::G4PVParameterised ( __void__ &  a)

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

G4PVParameterised::~G4PVParameterised ( )
virtual

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

멤버 함수 문서화

G4bool G4PVParameterised::CheckOverlaps ( G4int  res = 1000,
G4double  tol = 0.,
G4bool  verbose = true,
G4int  maxErr = 1 
)
virtual
void G4VPhysicalVolume::Clean ( )
staticinherited

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

다음을 참조함 : G4GeomSplitter< T >::FreeSlave(), G4VPhysicalVolume::subInstanceManager.

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

G4int G4PVReplica::GetCopyNo ( ) const
virtualinherited

G4VPhysicalVolume를 구현.

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

다음을 참조함 : G4MT_copyNo.

const G4RotationMatrix * G4VPhysicalVolume::GetFrameRotation ( ) const
inherited
G4ThreeVector G4VPhysicalVolume::GetFrameTranslation ( ) const
inherited

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

다음을 참조함 : G4MT_trans.

다음에 의해서 참조됨 : CML2Ph_FullWater::Construct(), CML2Ph_BoxInBox::Construct(), DicomIntersectVolume::SetNewValue().

G4int G4PVReplica::GetInstanceID ( ) const
inlineinherited

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

다음을 참조함 : G4PVReplica::instanceID.

G4LogicalVolume* G4VPhysicalVolume::GetLogicalVolume ( ) const
inlineinherited

다음에 의해서 참조됨 : CML2ExpVoxels::add(), G4AdjointCrossSurfChecker::AddanExtSurfaceOfAvolume(), G4LogicalVolume::AddDaughter(), G4GMocrenFileSceneHandler::AddSolid(), XrayFluoAnalysisManager::analyseStepping(), CML2PhantomConstruction::applyNewCentre(), Par01PionShowerModel::AssignSpotAndCallHit(), Par01EMShowerModel::AssignSpotAndCallHit(), G4ParallelWorldProcess::AtRestDoIt(), G4ParallelWorldScoringProcess::AtRestDoIt(), G4FastSimulationManagerProcess::AtRestGetPhysicalInteractionLength(), G4ReplicaNavigation::BackLocate(), G4Region::BelongsTo(), G4PhantomParameterisation::BuildContainerSolid(), UltraFresnelLens::BuildLens(), G4SmartVoxelHeader::BuildNodes(), G4GeometryManager::BuildOptimisations(), G4Track::CalculateVelocityForOpticalPhoton(), G4PVDivision::CheckAndSetParameters(), G4PVPlacement::CheckOverlaps(), G4VReadOutGeometry::CheckROVolume(), CML2WorldConstruction::checkVolumeOverlap(), G4GeometryWorkspace::CloneParameterisedSolids(), G4GeometryWorkspace::CloneReplicaSolid(), G4AdjointPrimaryGenerator::ComputeAccumulatedDepthVectorAlongBackRay(), DicomPhantomParameterisationColour::ComputeMaterial(), DicomNestedPhantomParameterisation::ComputeMaterial(), G4VPVParameterisation::ComputeMaterial(), CellParameterisation::ComputeMaterial(), G4VoxelSafety::ComputeSafety(), G4ParameterisedNavigation::ComputeSafety(), G4NormalNavigation::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4ReplicaNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator1::ComputeSafety(), G4ITNavigator2::ComputeSafety(), G4eplusPolarizedAnnihilation::ComputeSaturationFactor(), G4ePolarizedIonisation::ComputeSaturationFactor(), G4PolarizedCompton::ComputeSaturationFactor(), G4PhantomParameterisation::ComputeSolid(), G4VPVParameterisation::ComputeSolid(), G4VNestedParameterisation::ComputeSolid(), G4RegularNavigation::ComputeStep(), G4PropagatorInField::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4VoxelNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator1::ComputeStep(), G4ITNavigator2::ComputeStep(), G4RegularNavigation::ComputeStepSkippingEqualMaterials(), G4PSDoseDeposit::ComputeVolume(), G4PSPassageCellFlux::ComputeVolume(), G4PSCellFlux::ComputeVolume(), GB06ParallelWorldForSlices::Construct(), Par01ParallelWorldForPion::Construct(), RE01CalorimeterROGeometry::Construct(), RE05CalorimeterParallelWorld::Construct(), ExTGDetectorConstructionWithCpp::Construct(), RE04ParallelWorldConstruction::Construct(), HadrontherapyDetectorROGeometry::Construct(), B02ImportanceDetectorConstruction::Construct(), G02DetectorConstruction::Construct(), B03ImportanceDetectorConstruction::Construct(), F04ElementField::Construct(), G4tgbVolume::ConstructG4Volumes(), CCalG4Ecal::constructIn(), UltraDetectorConstruction::ConstructUVscope(), G4TheRayTracer::CreateBitMap(), ElectronBenchmarkDetector::CreateGeometry(), CML2PhantomConstruction::createPhysicalVolumeNamesList(), G4AdjointCrossSurfChecker::CrossingAnInterfaceBetweenTwoVolumes(), G4Radioactivation::DecayIt(), G4RadioactiveDecayBase::DecayIt(), G4RadioactiveDecay::DecayIt(), G4AdjointPosOnPhysVolGenerator::DefinePhysicalVolume(), DetectorConstruction::DefineVolumes(), G4RunManagerKernel::DefineWorldVolume(), G4GeometryManager::DeleteOptimisations(), G4MagneticFieldModel::DescribeYourselfTo(), G4GeometryWorkspace::DestroyWorkspace(), G4GlobalFastSimulationManager::DisplayRegion(), G4GDMLWriteStructure::DivisionvolWrite(), G4TrajectoryDrawByOriginVolume::Draw(), G4VisManager::Draw(), G4tgbGeometryDumper::DumpPhysVol(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4TrajectoryOriginVolumeFilter::Evaluate(), export_G4VPhysicalVolume(), G4PropagatorInField::FindAndSetFieldManager(), G4VReadOutGeometry::FindROTouchable(), G4FastTrack::FRecordsAffineTransformation(), G4PVPlacement::G4PVPlacement(), G4PVReplica::G4PVReplica(), G4ReplicatedSlice::G4ReplicatedSlice(), G4GDMLRead::GeneratePhysvolName(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4Navigator::GetGlobalExitNormal(), G4Navigator::GetLocalExitNormal(), G4ITNavigator1::GetLocalExitNormal(), G4VIntersectionLocator::GetLocalSurfaceNormal(), G4LogicalVolume::GetMass(), G4Channeling::GetMatData(), G4Channeling::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator1::GetMotherToDaughterTransform(), G4ITNavigator2::GetMotherToDaughterTransform(), G4ITTransportationManager::GetParallelWorld(), G4TransportationManager::GetParallelWorld(), PhysicsList::GetRange(), G4tgbGeometryDumper::GetTopPhysVol(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolumeByExtSurface(), G4GeometryWorkspace::InitialisePhysicalVolumes(), G4BOptnForceCommonTruncatedExp::Initialize(), G4WeightWindowStore::IsInWorld(), G4IStore::IsInWorld(), G4RegularNavigation::LevelLocate(), G4ParameterisedNavigation::LevelLocate(), G4LatticeManager::LoadLattice(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator1::LocateGlobalPointAndSetup(), G4ITNavigator2::LocateGlobalPointAndSetup(), G4Navigator::LocateGlobalPointWithinVolume(), G4ITNavigator1::LocateGlobalPointWithinVolume(), G4ITNavigator2::LocateGlobalPointWithinVolume(), GFlashHitMaker::make(), RE06SteppingVerbose::NewStep(), G4GDMLWriteParamvol::ParametersWrite(), G4GDMLWriteParamvol::ParamvolAlgorithmWrite(), G4GDMLWriteParamvol::ParamvolWrite(), G4GDMLWriteStructure::PhysvolWrite(), SplitProcess::PostStepDoIt(), G4Channeling::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4MonopoleTransportation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4ParallelWorldProcess::PostStepDoIt(), G4ScoreSplittingProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4ParallelWorldScoringProcess::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4StepLimiter::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), DMXMinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), DMXMaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4ElectronCapture::PostStepGetPhysicalInteractionLength(), G4LowECapture::PostStepGetPhysicalInteractionLength(), G4AdjointForcedInteractionForGamma::PostStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::PostStepGetPhysicalInteractionLength(), G4BiasingProcessInterface::PostStepGetPhysicalInteractionLength(), G4NavigationLogger::PreComputeStepLog(), ExN04CalorimeterSD::ProcessHits(), RE05CalorimeterSD::ProcessHits(), Par01CalorimeterSD::ProcessHits(), G4HumanPhantomSD::ProcessHits(), RE01CalorimeterSD::ProcessHits(), CML2SDWithVoxels::ProcessHits(), G4PSSphereSurfaceCurrent::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSFlatSurfaceCurrent::ProcessHits(), G4PSCylinderSurfaceCurrent::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4ErrorFreeTrajState::PropagateErrorIoni(), G4ErrorFreeTrajState::PropagateErrorMSC(), G4Navigator::RecheckDistanceToCurrentBoundary(), G4ITNavigator2::RecheckDistanceToCurrentBoundary(), G4ReflectionFactory::ReflectPVDivision(), G4ReflectionFactory::ReflectPVPlacement(), G4ReflectionFactory::ReflectPVReplica(), G4LatticeManager::RegisterLattice(), G4GDMLWriteStructure::ReplicavolWrite(), G4PropagatorInField::ReportLoopingParticle(), G4TransportationLogger::ReportLoopingTrack(), G4NavigationLogger::ReportOutsideMother(), G4NavigationLogger::ReportVolumeAndIntersection(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4ProductionCutsTable::ScanAndSetCouple(), G4Region::ScanVolumeTree(), G4LogicalVolume::SetFieldManager(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4VVisCommandGeometrySet::SetLVVisAtts(), G4RTPrimaryGeneratorAction::SetUp(), G4ScoringCylinder::SetupGeometry(), G4ScoringBox::SetupGeometry(), RE06ParallelWorld::SetupGeometry(), G4Navigator::SetupHierarchy(), G4ITNavigator1::SetupHierarchy(), G4ITNavigator2::SetupHierarchy(), G4GlobalFastSimulationManager::ShowSetup(), G4SteppingManager::Stepping(), G4ParallelWorldProcess::SwitchMaterial(), G4LogicalVolume::TotalVolumeEntities(), G4GDMLWriteStructure::TraverseVolumeTree(), G4Channeling::UpdateParameters(), RE01SteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), B1SteppingAction::UserSteppingAction(), G4MSSteppingAction::UserSteppingAction().

G4LogicalVolume* G4VPhysicalVolume::GetMotherLogical ( ) const
inlineinherited
G4int G4PVReplica::GetMultiplicity ( ) const
virtualinherited

G4VPhysicalVolume(으)로부터 재구현되었습니다.

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

다음을 참조함 : G4PVReplica::fnReplicas.

다음에 의해서 참조됨 : CheckOverlaps(), GB06ParallelWorldForSlices::ConstructSD(), export_G4PVReplica().

const G4String& G4VPhysicalVolume::GetName ( ) const
inlineinherited

다음에 의해서 참조됨 : G4TransportationManager::ActivateNavigator(), G4LogicalVolume::AddDaughter(), G4HepRepFileSceneHandler::AddHepRepInstance(), G4GDMLWrite::AddModule(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4DNABrownianTransportation::AlongStepGetPhysicalInteractionLength(), XrayFluoAnalysisManager::analyseStepping(), G4GDMLWriteStructure::BorderSurfaceCache(), G4SmartVoxelHeader::BuildNodes(), G4PVDivision::CheckAndSetParameters(), G4ReplicatedSlice::CheckAndSetParameters(), CheckOverlaps(), G4PVPlacement::CheckOverlaps(), DMXStackingAction::ClassifyNewTrack(), G4VoxelSafety::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator1::ComputeSafety(), G4ITNavigator2::ComputeSafety(), G4eplusPolarizedAnnihilation::ComputeSaturationFactor(), G4ePolarizedIonisation::ComputeSaturationFactor(), G4PolarizedCompton::ComputeSaturationFactor(), G4PropagatorInField::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator1::ComputeStep(), G4ITNavigator2::ComputeStep(), G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), G4WeightWindowConfigurator::Configure(), G4WeightCutOffConfigurator::Configure(), G4ImportanceConfigurator::Configure(), DMXParticleSource::ConfineSourceToVolume(), G4SPSPosDistribution::ConfineSourceToVolume(), G4VoxelRightBreast::Construct(), G4MIRDLiver::Construct(), G4MIRDRightLegBone::Construct(), G4MIRDRightScapula::Construct(), G4MIRDSkull::Construct(), G4MIRDSmallIntestine::Construct(), G4MIRDThyroid::Construct(), G4MIRDUpperLargeIntestine::Construct(), G4MIRDLeftAdrenal::Construct(), G4MIRDLeftClavicle::Construct(), G4MIRDLeftKidney::Construct(), G4MIRDLeftLeg::Construct(), G4MIRDLeftLegBone::Construct(), G4MIRDLeftOvary::Construct(), G4MIRDLeftScapula::Construct(), G4MIRDLeftTeste::Construct(), G4MIRDLowerLargeIntestine::Construct(), G4MIRDMaleGenitalia::Construct(), G4MIRDPelvis::Construct(), G4MIRDRightAdrenal::Construct(), G4MIRDRightClavicle::Construct(), G4MIRDRightKidney::Construct(), G4MIRDRightLeg::Construct(), G4MIRDRightTeste::Construct(), G4MIRDSpleen::Construct(), G4MIRDThymus::Construct(), G4MIRDStomach::Construct(), G4MIRDTrunk::Construct(), G4MIRDUpperSpine::Construct(), G4MIRDUterus::Construct(), G4MIRDBrain::Construct(), G4MIRDHeart::Construct(), G4MIRDLeftBreast::Construct(), G4MIRDLeftLung::Construct(), G4MIRDMiddleLowerSpine::Construct(), G4MIRDPancreas::Construct(), G4MIRDRibCage::Construct(), G4MIRDRightBreast::Construct(), G4MIRDRightLung::Construct(), G4MIRDRightOvary::Construct(), G4MIRDUrinaryBladder::Construct(), G4MIRDHead::Construct(), G4MIRDLeftArmBone::Construct(), G4MIRDRightArmBone::Construct(), G4tgbDetectorConstruction::Construct(), G4VScoringMesh::Construct(), B02ImportanceDetectorConstruction::Construct(), B03ImportanceDetectorConstruction::Construct(), G4tgbDetectorBuilder::ConstructDetector(), G4tgbVolume::ConstructG4PhysVol(), CCalG4Hall::constructIn(), CCalG4Hcal::constructIn(), CCalG4Ecal::constructIn(), G4FastSimulationPhysics::ConstructProcess(), B02ImportanceDetectorConstruction::CreateImportanceStore(), CCaloSD::createNewHit(), CML2PhantomConstruction::createPhysicalVolumeNamesList(), G4PathFinder::CreateTouchableHandle(), G4ITPathFinder::CreateTouchableHandle(), B02ImportanceDetectorConstruction::CreateWeightWindowStore(), G4AdjointCrossSurfChecker::CrossingAnInterfaceBetweenTwoVolumes(), G4TransportationManager::DeActivateNavigator(), G4DNAMolecularDissociation::DecayIt(), G4TransportationManager::DeRegisterNavigator(), G4ITTransportationManager::DeRegisterWorld(), G4TransportationManager::DeRegisterWorld(), G4LogicalVolumeModel::DescribeYourselfTo(), CCalVOrganization::DetectorLevel(), G4GDMLWriteStructure::DivisionvolWrite(), G4TrajectoryDrawByOriginVolume::Draw(), G4tgbVolumeMgr::DumpG4PhysVolLeaf(), G4LogicalBorderSurface::DumpInfo(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4tgbGeometryDumper::DumpPVReplica(), G4RunManagerKernel::DumpRegion(), G4MuonicAtomDecay::DumpState(), G4HadronicProcess::DumpState(), G4tgbVolumeMgr::DumpSummary(), G4ExceptionHandler::DumpTrackInfo(), G4ASCIITreeSceneHandler::EndModeling(), G4TrajectoryOriginVolumeFilter::Evaluate(), export_G4VPhysicalVolume(), F04TrajectoryPoint::F04TrajectoryPoint(), G4FastTrack::FRecordsAffineTransformation(), G4FastSimulationManagerProcess::G4FastSimulationManagerProcess(), G4IStore::G4IStore(), G4PVParameterised(), G4PVReplica::G4PVReplica(), G4Navigator::GetGlobalExitNormal(), G4PSEnergyDeposit3D::GetIndex(), G4PSDoseDeposit3D::GetIndex(), G4LatticeManager::GetLattice(), G4Navigator::GetLocalExitNormal(), G4ITNavigator1::GetLocalExitNormal(), G4ModelingParameters::PVPointerCopyNo::GetName(), G4ITTransportationManager::GetNavigator(), G4TransportationManager::GetNavigator(), B03PVolumeStore::GetPNames(), B02PVolumeStore::GetPNames(), B03PVolumeStore::GetPVolume(), B02PVolumeStore::GetPVolume(), CCaloSD::getStepInfo(), G4tgbVolumeMgr::GetTopPhysVol(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolume(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolumeByExtSurface(), DMXParticleSource::IsSourceConfined(), G4SPSPosDistribution::IsSourceConfined(), G4LatticeManager::LoadLattice(), G4MultiNavigator::LocateGlobalPointAndSetup(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator1::LocateGlobalPointAndSetup(), G4ITNavigator2::LocateGlobalPointAndSetup(), G4ITMultiNavigator::LocateGlobalPointAndSetup(), main(), operator<<(), G4GDMLWriteParamvol::ParametersWrite(), Path(), CCalG4Able::PhysicalVolume(), G4GDMLWriteStructure::PhysvolWrite(), G4UCNAbsorption::PostStepDoIt(), G4UCNMultiScattering::PostStepDoIt(), G4UCNBoundaryProcess::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), HadrontherapyStepMax::PostStepGetPhysicalInteractionLength(), IORTStepMax::PostStepGetPhysicalInteractionLength(), ML2StepMax::PostStepGetPhysicalInteractionLength(), XrayTelStepCut::PostStepGetPhysicalInteractionLength(), G4ITSteppingVerbose::PostStepVerbose(), G4NavigationLogger::PreComputeStepLog(), G4MultiNavigator::PrepareNavigators(), G4ITMultiNavigator::PrepareNavigators(), G4ITSteppingVerbose::PreStepVerbose(), WLSTrackingAction::PreUserTrackingAction(), G4MultiNavigator::PrintLimited(), G4PathFinder::PrintLimited(), G4ITMultiNavigator::PrintLimited(), G4ITPathFinder::PrintLimited(), G4Navigator::PrintState(), G4ITNavigator1::PrintState(), G4PropagatorInField::printStatus(), JA::PrintTree(), HadrontherapyDetectorSD::ProcessHits(), FCALHadModuleSD::ProcessHits(), FCALEMModuleSD::ProcessHits(), FCALTestbeamSetupSD::ProcessHits(), GammaRayTelCalorimeterSD::ProcessHits(), GammaRayTelAnticoincidenceSD::ProcessHits(), GammaRayTelTrackerSD::ProcessHits(), UltraPMTSD::ProcessHits(), G4PhysicalVolumeMassScene::ProcessVolume(), G4ReflectionFactory::ReflectPVDivision(), G4ReflectionFactory::ReflectPVParameterised(), G4ReflectionFactory::ReflectPVPlacement(), G4ReflectionFactory::ReflectPVReplica(), G4tgbVolumeMgr::RegisterMe(), G4PropagatorInField::ReportLoopingParticle(), G4PropagatorInField::ReportStuckParticle(), G4NavigationLogger::ReportVolumeAndIntersection(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4VoxelSafety::SafetyForVoxelHeader(), G4Region::ScanVolumeTree(), G4VisCommandSceneAddVolume::SetNewValue(), G4WeightCutOffProcess::SetParallelWorld(), G4WeightWindowProcess::SetParallelWorld(), G4ParallelWorldScoringProcess::SetParallelWorld(), G4ParallelWorldProcess::SetParallelWorld(), G4IStore::SetParallelWorldVolume(), G4WeightWindowStore::SetWorldVolume(), G4IStore::SetWorldVolume(), G4FastSimulationManagerProcess::SetWorldVolume(), G4GlobalFastSimulationManager::ShowSetup(), G4SteppingVerbose::ShowStep(), F04SteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), G4GDMLRead::StripNames(), G4ErrorGeomVolumeTarget::TargetReached(), G4ITSteppingVerbose::TrackingEnded(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), ExN04SteppingAction::UserSteppingAction(), RE05SteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), LXeSteppingAction::UserSteppingAction(), XrayFluoSteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), XrayTelSteppingAction::UserSteppingAction(), G4ScoreSplittingProcess::Verbose(), G4ParallelWorldScoringProcess::Verbose(), G4SteppingVerbose::VerboseTrack(), WLSTrajectoryPoint::WLSTrajectoryPoint(), G4VScoringMesh::WorkerConstruct(), G4RunManagerKernel::WorkerUpdateWorldVolume().

G4RotationMatrix * G4VPhysicalVolume::GetObjectRotation ( ) const
inherited

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

다음을 참조함 : G4VPhysicalVolume::GetRotation(), CLHEP::HepRotation::inverse().

G4RotationMatrix G4VPhysicalVolume::GetObjectRotationValue ( ) const
inherited
G4ThreeVector G4VPhysicalVolume::GetObjectTranslation ( ) const
inherited
G4VPVParameterisation * G4PVParameterised::GetParameterisation ( ) const
virtual

G4PVReplica(으)로부터 재구현되었습니다.

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

다음을 참조함 : fparam.

다음에 의해서 참조됨 : G4tgbGeometryDumper::DumpPVParameterised(), DicomIntersectVolume::GetPhantomParam(), G4EnergySplitter::GetPhantomParam().

G4int G4PVReplica::GetRegularStructureId ( ) const
virtualinherited

G4VPhysicalVolume를 구현.

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

다음을 참조함 : G4PVReplica::fRegularVolsId.

void G4PVParameterised::GetReplicationData ( EAxis axis,
G4int nReplicas,
G4double width,
G4double offset,
G4bool consuming 
) const
virtual

G4PVReplica(으)로부터 재구현되었습니다.

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

다음을 참조함 : G4PVReplica::faxis, G4PVReplica::fnReplicas, G4PVReplica::foffset, G4PVReplica::fwidth.

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

const G4RotationMatrix * G4VPhysicalVolume::GetRotation ( ) const
inherited
G4RotationMatrix * G4VPhysicalVolume::GetRotation ( )
inherited

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

다음을 참조함 : G4MT_rot.

const G4PVRManager & G4PVReplica::GetSubInstanceManager ( )
staticinherited

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

다음을 참조함 : G4PVReplica::subInstanceManager.

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

const G4ThreeVector & G4VPhysicalVolume::GetTranslation ( ) const
inherited
void G4PVReplica::InitialiseWorker ( G4PVReplica pMasterObject)
inherited
void G4VPhysicalVolume::InitialiseWorker ( G4VPhysicalVolume pMasterObject,
G4RotationMatrix pRot,
const G4ThreeVector tlate 
)
protectedinherited
G4bool G4PVReplica::IsMany ( ) const
virtualinherited

G4VPhysicalVolume를 구현.

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

G4bool G4PVParameterised::IsParameterised ( ) const
virtual

G4PVReplica(으)로부터 재구현되었습니다.

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

G4bool G4PVReplica::IsRegularStructure ( ) const
virtualinherited

G4VPhysicalVolume를 구현.

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

다음을 참조함 : G4PVReplica::fRegularVolsId.

G4bool G4PVReplica::IsReplicated ( ) const
virtualinherited

G4VPhysicalVolume를 구현.

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

G4bool G4VPhysicalVolume::operator== ( const G4VPhysicalVolume p) const
inlineinherited
void G4PVReplica::SetCopyNo ( G4int  CopyNo)
virtualinherited

G4VPhysicalVolume를 구현.

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

다음을 참조함 : G4MT_copyNo.

void G4VPhysicalVolume::SetLogicalVolume ( G4LogicalVolume pLogical)
inlineinherited
void G4VPhysicalVolume::SetMotherLogical ( G4LogicalVolume pMother)
inlineinherited
void G4VPhysicalVolume::SetName ( const G4String pName)
inlineinherited
void G4PVParameterised::SetRegularStructureId ( G4int  Code)
virtual

G4PVReplica(으)로부터 재구현되었습니다.

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

다음을 참조함 : G4PVReplica::SetRegularStructureId().

다음에 의해서 참조됨 : DicomPartialDetectorConstruction::ConstructPhantom(), DicomRegularDetectorConstruction::ConstructPhantom().

void G4VPhysicalVolume::SetRotation ( G4RotationMatrix pRot)
inherited
void G4VPhysicalVolume::SetTranslation ( const G4ThreeVector v)
inherited

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

다음을 참조함 : G4MT_trans.

다음에 의해서 참조됨 : CML2PhantomConstruction::applyNewCentre(), B5CellParameterisation::ComputeTransformation(), CellParameterisation::ComputeTransformation(), G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), RE01TrackerParametrisation::ComputeTransformation(), RE05CalorimeterParametrisation::ComputeTransformation(), RE05TrackerParametrisation::ComputeTransformation(), RE01CalorimeterParametrisation::ComputeTransformation(), G4PartialPhantomParameterisation::ComputeTransformation(), B2bChamberParameterisation::ComputeTransformation(), ExN02ChamberParameterisation::ComputeTransformation(), UltraFresnelLensParameterisation::ComputeTransformation(), G4PhantomParameterisation::ComputeTransformation(), RE04ParallelWorldParam::ComputeTransformation(), ExP01ChamberParameterisation::ComputeTransformation(), G02ChamberParameterisation::ComputeTransformation(), ChromosomeParameterisation::ComputeTransformation(), G4GDMLParameterisation::ComputeTransformation(), G4ParameterisationTubsRho::ComputeTransformation(), G4ParameterisationParaX::ComputeTransformation(), G4ParameterisationBoxX::ComputeTransformation(), G4ParameterisationConsRho::ComputeTransformation(), DicomNestedPhantomParameterisation::ComputeTransformation(), G4ParameterisationPolyconeRho::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), NeuronLoadDataFile::ComputeTransformation(), G4ParameterisationPolyhedraRho::ComputeTransformation(), RE02NestedPhantomParameterisation::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4ParameterisationBoxY::ComputeTransformation(), G4ParameterisationTubsPhi::ComputeTransformation(), G4ParameterisationConsPhi::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationPolyconePhi::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), G4ParameterisationPolyhedraPhi::ComputeTransformation(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationConsZ::ComputeTransformation(), G4ParameterisationTubsZ::ComputeTransformation(), G4ParameterisationParaZ::ComputeTransformation(), G4ParameterisationPolyconeZ::ComputeTransformation(), G4ParameterisationTrdZ::ComputeTransformation(), G4ParameterisationPolyhedraZ::ComputeTransformation(), export_G4VPhysicalVolume(), G4VPhysicalVolume::G4VPhysicalVolume(), G4VPhysicalVolume::InitialiseWorker(), CML2AcceleratorConstruction::rotateAccelerator(), B5DetectorConstruction::SetArmAngle(), GB03DetectorConstruction::SetNumberOfLayers(), RE06DetectorConstruction::SetNumberOfLayers(), RE06ParallelWorld::SetSerialGeometry(), RE06DetectorConstruction::SetSerialGeometry().

void G4PVReplica::TerminateWorker ( G4PVReplica pMasterObject)
inherited

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

다음을 참조함 : G4PVReplica::faxis, G4VPhysicalVolume::GetRotation(), kPhi.

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

void G4VPhysicalVolume::TerminateWorker ( G4VPhysicalVolume pMasterObject)
protectedinherited

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

EVolume G4VPhysicalVolume::VolumeType ( ) const
inlineinherited

멤버 데이타 문서화

EAxis G4PVReplica::faxis
protectedinherited
G4int G4PVReplica::fnReplicas
protectedinherited

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

다음에 의해서 참조됨 : G4PVReplica::CheckAndSetParameters(), G4PVReplica::GetMultiplicity(), GetReplicationData(), G4PVReplica::GetReplicationData().

G4double G4PVReplica::foffset
protectedinherited

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

다음에 의해서 참조됨 : G4PVReplica::CheckAndSetParameters(), GetReplicationData(), G4PVReplica::GetReplicationData().

G4VPVParameterisation* G4PVParameterised::fparam
private

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

다음에 의해서 참조됨 : CheckOverlaps(), GetParameterisation().

G4double G4PVReplica::fwidth
protectedinherited

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

다음에 의해서 참조됨 : G4PVReplica::CheckAndSetParameters(), GetReplicationData(), G4PVReplica::GetReplicationData().


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