Geant4.10
 All Data Structures Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Static Public Member Functions | Protected Member Functions | Protected Attributes | Static Protected Attributes
G4VPhysicalVolume Class Referenceabstract

#include <G4VPhysicalVolume.hh>

Inheritance diagram for G4VPhysicalVolume:
G4PVDivision G4PVPlacement G4PVReplica G4ReplicatedSlice LXeMainVolume LXeWLSFiber LXeWLSSlab G4PVParameterised

Public Member Functions

 G4VPhysicalVolume (G4RotationMatrix *pRot, const G4ThreeVector &tlate, const G4String &pName, G4LogicalVolume *pLogical, G4VPhysicalVolume *pMother)
 
virtual ~G4VPhysicalVolume ()
 
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
 
void SetTranslation (const G4ThreeVector &v)
 
G4RotationMatrixGetRotation ()
 
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
 
virtual G4int GetMultiplicity () const
 
virtual G4bool IsMany () const =0
 
virtual G4int GetCopyNo () const =0
 
virtual void SetCopyNo (G4int CopyNo)=0
 
virtual G4bool IsReplicated () const =0
 
virtual G4bool IsParameterised () const =0
 
virtual G4VPVParameterisationGetParameterisation () const =0
 
virtual void GetReplicationData (EAxis &axis, G4int &nReplicas, G4double &width, G4double &offset, G4bool &consuming) const =0
 
virtual G4bool IsRegularStructure () const =0
 
virtual G4int GetRegularStructureId () const =0
 
virtual G4bool CheckOverlaps (G4int res=1000, G4double tol=0., G4bool verbose=true, G4int errMax=1)
 
 G4VPhysicalVolume (__void__ &)
 
G4int GetInstanceID () const
 

Static Public Member Functions

static const G4PVManagerGetSubInstanceManager ()
 

Protected Member Functions

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

Protected Attributes

G4int instanceID
 

Static Protected Attributes

static G4GEOM_DLL G4PVManager subInstanceManager
 

Detailed Description

Definition at line 80 of file G4VPhysicalVolume.hh.

Constructor & Destructor Documentation

G4VPhysicalVolume::G4VPhysicalVolume ( G4RotationMatrix pRot,
const G4ThreeVector tlate,
const G4String pName,
G4LogicalVolume pLogical,
G4VPhysicalVolume pMother 
)

Definition at line 84 of file G4VPhysicalVolume.cc.

References G4GeomSplitter< T >::CreateSubInstance(), instanceID, G4PhysicalVolumeStore::Register(), SetRotation(), SetTranslation(), and subInstanceManager.

89  : flogical(pLogical),
90  fname(pName), flmother(0)
91 {
93 
94  this->SetRotation( pRot ); // G4MT_rot = pRot;
95  this->SetTranslation( tlate ); // G4MT_trans = tlate;
97 }
static void Register(G4VPhysicalVolume *pSolid)
G4int CreateSubInstance()
static G4GEOM_DLL G4PVManager subInstanceManager
void SetRotation(G4RotationMatrix *)
void SetTranslation(const G4ThreeVector &v)
G4VPhysicalVolume::~G4VPhysicalVolume ( )
virtual

Definition at line 117 of file G4VPhysicalVolume.cc.

References G4PhysicalVolumeStore::DeRegister().

118 {
120 }
static void DeRegister(G4VPhysicalVolume *pSolid)
G4VPhysicalVolume::G4VPhysicalVolume ( __void__ &  )

Definition at line 102 of file G4VPhysicalVolume.cc.

References G4GeomSplitter< T >::CreateSubInstance(), instanceID, G4PhysicalVolumeStore::Register(), SetRotation(), SetTranslation(), and subInstanceManager.

103  : flogical(0), fname(""), flmother(0)
104 {
105  // Register to store
106  //
108 
109  this->SetRotation( 0 ); // G4MT_rot = 0;
110  this->SetTranslation( G4ThreeVector(0., 0., 0.) ); // G4MT_trans = ...
111 
113 }
CLHEP::Hep3Vector G4ThreeVector
static void Register(G4VPhysicalVolume *pSolid)
G4int CreateSubInstance()
static G4GEOM_DLL G4PVManager subInstanceManager
void SetRotation(G4RotationMatrix *)
void SetTranslation(const G4ThreeVector &v)

Member Function Documentation

G4bool G4VPhysicalVolume::CheckOverlaps ( G4int  res = 1000,
G4double  tol = 0.,
G4bool  verbose = true,
G4int  errMax = 1 
)
virtual

Reimplemented in G4PVPlacement, and G4PVParameterised.

Definition at line 146 of file G4VPhysicalVolume.cc.

Referenced by CML2WorldConstruction::checkVolumeOverlap(), G4Navigator::ComputeStep(), and G4ITNavigator::ComputeStep().

147 {
148  return false;
149 }
virtual G4int G4VPhysicalVolume::GetCopyNo ( ) const
pure virtual
const G4RotationMatrix* G4VPhysicalVolume::GetFrameRotation ( ) const
inline
G4ThreeVector G4VPhysicalVolume::GetFrameTranslation ( ) const
inline
G4int G4VPhysicalVolume::GetInstanceID ( ) const
inline
G4LogicalVolume* G4VPhysicalVolume::GetLogicalVolume ( ) const
inline

Referenced by CML2ExpVoxels::add(), G4AdjointCrossSurfChecker::AddanExtSurfaceOfAvolume(), G4GMocrenFileSceneHandler::AddSolid(), G4RayTrajectory::AppendStep(), CML2PhantomConstruction::applyNewCentre(), G4ParallelWorldProcess::AtRestDoIt(), G4ParallelWorldScoringProcess::AtRestDoIt(), G4FastSimulationManagerProcess::AtRestGetPhysicalInteractionLength(), G4ReplicaNavigation::BackLocate(), G4Region::BelongsTo(), G4PhantomParameterisation::BuildContainerSolid(), G4SmartVoxelHeader::BuildNodes(), G4Track::CalculateVelocityForOpticalPhoton(), G4PVPlacement::CheckOverlaps(), G4VReadOutGeometry::CheckROVolume(), CML2WorldConstruction::checkVolumeOverlap(), G4GeometryWorkspace::CloneParameterisedSolids(), G4GeometryWorkspace::CloneReplicaSolid(), DicomPhantomParameterisationColour::ComputeMaterial(), DicomNestedPhantomParameterisation::ComputeMaterial(), G4VPVParameterisation::ComputeMaterial(), CellParameterisation::ComputeMaterial(), G4VoxelSafety::ComputeSafety(), G4ParameterisedNavigation::ComputeSafety(), G4NormalNavigation::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4ReplicaNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator::ComputeSafety(), G4PhantomParameterisation::ComputeSolid(), G4VPVParameterisation::ComputeSolid(), G4VNestedParameterisation::ComputeSolid(), G4RegularNavigation::ComputeStep(), G4PropagatorInField::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator::ComputeStep(), G4RegularNavigation::ComputeStepSkippingEqualMaterials(), G4PSDoseDeposit::ComputeVolume(), G4PSPassageCellFlux::ComputeVolume(), G4PSCellFlux::ComputeVolume(), RE05CalorimeterROGeometry::Construct(), ExTGDetectorConstructionWithCpp::Construct(), RE04ParallelWorldConstruction::Construct(), HadrontherapyDetectorROGeometry::Construct(), G02DetectorConstruction::Construct(), B02ImportanceDetectorConstruction::Construct(), G4tgbVolume::ConstructG4Volumes(), CCalG4Ecal::constructIn(), G4TheRayTracer::CreateBitMap(), ElectronBenchmarkDetector::CreateGeometry(), G4AdjointCrossSurfChecker::CrossingAnInterfaceBetweenTwoVolumes(), G4RadioactiveDecay::DecayIt(), G4AdjointPosOnPhysVolGenerator::DefinePhysicalVolume(), G4RunManagerKernel::DefineWorldVolume(), G4MagneticFieldModel::DescribeYourselfTo(), G4GeometryWorkspace::DestroyWorkspace(), G4GDMLWriteStructure::DivisionvolWrite(), G4TrajectoryDrawByOriginVolume::Draw(), G4VisManager::Draw(), G4tgbGeometryDumper::DumpPhysVol(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4TrajectoryOriginVolumeFilter::Evaluate(), export_G4VPhysicalVolume(), G4PropagatorInField::FindAndSetFieldManager(), G4VReadOutGeometry::FindROTouchable(), G4PVPlacement::G4PVPlacement(), G4PVReplica::G4PVReplica(), G4ReplicatedSlice::G4ReplicatedSlice(), G4GDMLRead::GeneratePhysvolName(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4Navigator::GetLocalExitNormal(), G4ITNavigator::GetLocalExitNormal(), G4LogicalVolume::GetMass(), G4VTransitionRadiation::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4VXTRenergyLoss::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4TransportationManager::GetParallelWorld(), PhysicsList::GetRange(), G4tgbGeometryDumper::GetTopPhysVol(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolumeByExtSurface(), G4GeometryWorkspace::InitialisePhysicalVolumes(), G4BOptnForceCommonTruncatedExp::Initialize(), G4RegularNavigation::LevelLocate(), G4ParameterisedNavigation::LevelLocate(), G4LatticeManager::LoadLattice(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator::LocateGlobalPointAndSetup(), G4Navigator::LocateGlobalPointWithinVolume(), G4ITNavigator::LocateGlobalPointWithinVolume(), GFlashHitMaker::make(), RE06SteppingVerbose::NewStep(), G4GDMLWriteParamvol::ParametersWrite(), G4GDMLWriteParamvol::ParamvolAlgorithmWrite(), G4GDMLWriteParamvol::ParamvolWrite(), G4GDMLWriteStructure::PhysvolWrite(), G4VTransitionRadiation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), G4MonopoleTransportation::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4ParallelWorldProcess::PostStepDoIt(), G4ScoreSplittingProcess::PostStepDoIt(), G4ParallelWorldScoringProcess::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4StepLimiter::PostStepGetPhysicalInteractionLength(), G4MinEkineCuts::PostStepGetPhysicalInteractionLength(), DMXMinEkineCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4MaxTimeCuts::PostStepGetPhysicalInteractionLength(), DMXMaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4ElectronCapture::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::PostStepGetPhysicalInteractionLength(), G4BiasingProcessInterface::PostStepGetPhysicalInteractionLength(), G4NavigationLogger::PreComputeStepLog(), Par01CalorimeterSD::ProcessHits(), ExN04CalorimeterSD::ProcessHits(), RE05CalorimeterSD::ProcessHits(), B5HodoscopeSD::ProcessHits(), G4HumanPhantomSD::ProcessHits(), RE01CalorimeterSD::ProcessHits(), B5EmCalorimeterSD::ProcessHits(), CML2SDWithVoxels::ProcessHits(), G4PSSphereSurfaceCurrent::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSCylinderSurfaceCurrent::ProcessHits(), G4PSFlatSurfaceCurrent::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4LatticeManager::RegisterLattice(), G4GDMLWriteStructure::ReplicavolWrite(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4Region::ScanVolumeTree(), G4LogicalVolume::SetFieldManager(), G4ITStepProcessor::SetInitialStep(), G4SteppingManager::SetInitialStep(), G4VVisCommandGeometrySet::SetLVVisAtts(), G4RTPrimaryGeneratorAction::SetUp(), G4Navigator::SetupHierarchy(), G4ITNavigator::SetupHierarchy(), G4GlobalFastSimulationManager::ShowSetup(), G4SteppingManager::Stepping(), G4GeomTestVolume::TestRecursiveOverlap(), G4LogicalVolume::TotalVolumeEntities(), G4GDMLWriteStructure::TraverseVolumeTree(), RE01SteppingAction::UserSteppingAction(), F04SteppingAction::UserSteppingAction(), B1SteppingAction::UserSteppingAction(), SteppingAction::UserSteppingAction(), G4MSSteppingAction::UserSteppingAction(), and G4RTSteppingAction::UserSteppingAction().

G4LogicalVolume* G4VPhysicalVolume::GetMotherLogical ( ) const
inline
G4int G4VPhysicalVolume::GetMultiplicity ( ) const
virtual
const G4String& G4VPhysicalVolume::GetName ( ) const
inline

Referenced by G4TransportationManager::ActivateNavigator(), G4GDMLWrite::AddModule(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4GDMLWriteStructure::BorderSurfaceCache(), G4SmartVoxelHeader::BuildNodes(), G4PVParameterised::CheckOverlaps(), G4PVPlacement::CheckOverlaps(), DMXStackingAction::ClassifyNewTrack(), G4VoxelSafety::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator::ComputeSafety(), G4PropagatorInField::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator::ComputeStep(), G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), G4WeightWindowConfigurator::Configure(), G4WeightCutOffConfigurator::Configure(), G4ImportanceConfigurator::Configure(), DMXParticleSource::ConfineSourceToVolume(), G4SPSPosDistribution::ConfineSourceToVolume(), G4VoxelRightBreast::Construct(), G4MIRDLiver::Construct(), G4ScoringCylinder::Construct(), G4MIRDLeftAdrenal::Construct(), G4MIRDLeftClavicle::Construct(), G4MIRDLeftKidney::Construct(), G4MIRDLeftLeg::Construct(), G4MIRDLeftScapula::Construct(), G4MIRDLeftLegBone::Construct(), G4MIRDLeftOvary::Construct(), G4MIRDLeftTeste::Construct(), G4MIRDLowerLargeIntestine::Construct(), G4MIRDMaleGenitalia::Construct(), G4MIRDPelvis::Construct(), G4MIRDRightAdrenal::Construct(), G4MIRDRightClavicle::Construct(), G4MIRDRightKidney::Construct(), G4MIRDRightLeg::Construct(), G4MIRDRightLegBone::Construct(), G4MIRDRightScapula::Construct(), G4MIRDSkull::Construct(), G4MIRDSmallIntestine::Construct(), G4MIRDThyroid::Construct(), G4MIRDUpperLargeIntestine::Construct(), G4MIRDUterus::Construct(), G4MIRDBrain::Construct(), G4MIRDHeart::Construct(), G4MIRDLeftBreast::Construct(), G4MIRDLeftLung::Construct(), G4MIRDMiddleLowerSpine::Construct(), G4MIRDPancreas::Construct(), G4MIRDRibCage::Construct(), G4MIRDRightBreast::Construct(), G4MIRDRightLung::Construct(), G4MIRDRightOvary::Construct(), G4MIRDRightTeste::Construct(), G4MIRDSpleen::Construct(), G4MIRDStomach::Construct(), G4MIRDThymus::Construct(), G4MIRDTrunk::Construct(), G4MIRDUpperSpine::Construct(), G4MIRDUrinaryBladder::Construct(), G4ScoringBox::Construct(), G4MIRDHead::Construct(), G4MIRDLeftArmBone::Construct(), G4MIRDRightArmBone::Construct(), G4tgbDetectorConstruction::Construct(), B02ImportanceDetectorConstruction::Construct(), G4tgbDetectorBuilder::ConstructDetector(), G4tgbVolume::ConstructG4PhysVol(), CCalG4Hall::constructIn(), CCalG4Hcal::constructIn(), CCalG4Ecal::constructIn(), B02ImportanceDetectorConstruction::CreateImportanceStore(), G4PathFinder::CreateTouchableHandle(), B02ImportanceDetectorConstruction::CreateWeightWindowStore(), G4AdjointCrossSurfChecker::CrossingAnInterfaceBetweenTwoVolumes(), G4TransportationManager::DeActivateNavigator(), G4TransportationManager::DeRegisterNavigator(), G4LogicalVolumeModel::DescribeYourselfTo(), CCalVOrganization::DetectorLevel(), G4GDMLWriteStructure::DivisionvolWrite(), G4TrajectoryDrawByOriginVolume::Draw(), G4tgbVolumeMgr::DumpG4PhysVolLeaf(), G4LogicalBorderSurface::DumpInfo(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4tgbGeometryDumper::DumpPVReplica(), G4RunManagerKernel::DumpRegion(), G4HadronicProcess::DumpState(), G4tgbVolumeMgr::DumpSummary(), G4ASCIITreeSceneHandler::EndModeling(), G4TrajectoryOriginVolumeFilter::Evaluate(), export_G4VPhysicalVolume(), F04TrajectoryPoint::F04TrajectoryPoint(), G4FastSimulationManagerProcess::G4FastSimulationManagerProcess(), G4IStore::G4IStore(), G4PVParameterised::G4PVParameterised(), G4PVReplica::G4PVReplica(), G4PSEnergyDeposit3D::GetIndex(), G4PSDoseDeposit3D::GetIndex(), G4LatticeManager::GetLattice(), G4Navigator::GetLocalExitNormal(), G4ITNavigator::GetLocalExitNormal(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4TransportationManager::GetNavigator(), B03PVolumeStore::GetPNames(), B02PVolumeStore::GetPNames(), B02PVolumeStore::GetPVolume(), B03PVolumeStore::GetPVolume(), G4tgbVolumeMgr::GetTopPhysVol(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolume(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolumeByExtSurface(), DMXParticleSource::IsSourceConfined(), G4LatticeManager::LoadLattice(), G4MultiNavigator::LocateGlobalPointAndSetup(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator::LocateGlobalPointAndSetup(), main(), operator<<(), G4GDMLWriteParamvol::ParametersWrite(), CCalG4Able::PhysicalVolume(), G4GDMLWriteStructure::PhysvolWrite(), G4OpBoundaryProcess::PostStepDoIt(), Em10StepCut::PostStepGetPhysicalInteractionLength(), F01StepCut::PostStepGetPhysicalInteractionLength(), F02StepCut::PostStepGetPhysicalInteractionLength(), F03StepCut::PostStepGetPhysicalInteractionLength(), HadrontherapyStepMax::PostStepGetPhysicalInteractionLength(), IORTStepMax::PostStepGetPhysicalInteractionLength(), ML2StepMax::PostStepGetPhysicalInteractionLength(), XrayTelStepCut::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4NavigationLogger::PreComputeStepLog(), G4MultiNavigator::PrepareNavigators(), Em10TrackingAction::PreUserTrackingAction(), WLSTrackingAction::PreUserTrackingAction(), G4MultiNavigator::PrintLimited(), G4PathFinder::PrintLimited(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4PropagatorInField::printStatus(), JA::PrintTree(), FCALTestbeamSetupSD::ProcessHits(), FCALHadModuleSD::ProcessHits(), FCALEMModuleSD::ProcessHits(), GammaRayTelAnticoincidenceSD::ProcessHits(), GammaRayTelCalorimeterSD::ProcessHits(), GammaRayTelTrackerSD::ProcessHits(), UltraPMTSD::ProcessHits(), G4tgbVolumeMgr::RegisterMe(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4VoxelSafety::SafetyForVoxelHeader(), G4Region::ScanVolumeTree(), G4VisCommandSceneAddVolume::SetNewValue(), G4WeightCutOffProcess::SetParallelWorld(), G4ParallelWorldScoringProcess::SetParallelWorld(), G4WeightWindowProcess::SetParallelWorld(), G4ParallelWorldProcess::SetParallelWorld(), G4IStore::SetParallelWorldVolume(), G4WeightWindowStore::SetWorldVolume(), G4IStore::SetWorldVolume(), G4FastSimulationManagerProcess::SetWorldVolume(), G4GlobalFastSimulationManager::ShowSetup(), G4SteppingVerbose::ShowStep(), F04SteppingVerbose::StepInfo(), LXeSteppingVerbose::StepInfo(), WLSSteppingVerbose::StepInfo(), OpNoviceSteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), Em10SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), G4GDMLRead::StripNames(), G4ErrorGeomVolumeTarget::TargetReached(), LXeSteppingVerbose::TrackingStarted(), F04SteppingVerbose::TrackingStarted(), WLSSteppingVerbose::TrackingStarted(), OpNoviceSteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), Em10SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), ExN04SteppingAction::UserSteppingAction(), RE05SteppingAction::UserSteppingAction(), exrdmSteppingAction::UserSteppingAction(), FCALSteppingAction::UserSteppingAction(), LXeSteppingAction::UserSteppingAction(), XrayFluoSteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), Em10SteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), IORTSteppingAction::UserSteppingAction(), XrayTelSteppingAction::UserSteppingAction(), G4ScoreSplittingProcess::Verbose(), G4ParallelWorldScoringProcess::Verbose(), G4SteppingVerbose::VerboseTrack(), WLSTrajectoryPoint::WLSTrajectoryPoint(), G4VScoringMesh::WorkerConstruct(), and G4RunManagerKernel::WorkerUpdateWorldVolume().

G4RotationMatrix * G4VPhysicalVolume::GetObjectRotation ( ) const

Definition at line 127 of file G4VPhysicalVolume.cc.

References GetRotation(), and CLHEP::HepRotation::inverse().

128 {
129  static G4RotationMatrix aRotM;
130  static G4RotationMatrix IdentityRM;
131 
132  G4RotationMatrix* retval = &IdentityRM;
133 
134  // Insure against frot being a null pointer
135  if(this->GetRotation())
136  {
137  aRotM = GetRotation()->inverse();
138  retval= &aRotM;
139  }
140  return retval;
141 }
HepRotation inverse() const
const G4RotationMatrix * GetRotation() const
G4RotationMatrix G4VPhysicalVolume::GetObjectRotationValue ( ) const
inline
G4ThreeVector G4VPhysicalVolume::GetObjectTranslation ( ) const
inline
virtual G4VPVParameterisation* G4VPhysicalVolume::GetParameterisation ( ) const
pure virtual
virtual G4int G4VPhysicalVolume::GetRegularStructureId ( ) const
pure virtual
virtual void G4VPhysicalVolume::GetReplicationData ( EAxis axis,
G4int nReplicas,
G4double width,
G4double offset,
G4bool consuming 
) const
pure virtual
const G4RotationMatrix* G4VPhysicalVolume::GetRotation ( ) const
inline
G4RotationMatrix* G4VPhysicalVolume::GetRotation ( )
inline
const G4PVManager & G4VPhysicalVolume::GetSubInstanceManager ( )
static

Definition at line 77 of file G4VPhysicalVolume.cc.

References subInstanceManager.

Referenced by G4GeometryWorkspace::G4GeometryWorkspace().

78 {
79  return subInstanceManager;
80 }
static G4GEOM_DLL G4PVManager subInstanceManager
const G4ThreeVector& G4VPhysicalVolume::GetTranslation ( ) const
inline
void G4VPhysicalVolume::InitialiseWorker ( G4VPhysicalVolume pMasterObject,
G4RotationMatrix pRot,
const G4ThreeVector tlate 
)
protected

Definition at line 56 of file G4VPhysicalVolume.cc.

References SetRotation(), SetTranslation(), G4GeomSplitter< T >::SlaveCopySubInstanceArray(), and subInstanceManager.

Referenced by G4PVReplica::InitialiseWorker().

59 {
61 
62  this->SetRotation( pRot ); // G4MT_rot = pRot;
63  this->SetTranslation( tlate ); // G4MT_trans = tlate;
64  // G4PhysicalVolumeStore::Register(this);
65 }
static G4GEOM_DLL G4PVManager subInstanceManager
void SetRotation(G4RotationMatrix *)
void SlaveCopySubInstanceArray()
void SetTranslation(const G4ThreeVector &v)
virtual G4bool G4VPhysicalVolume::IsMany ( ) const
pure virtual
virtual G4bool G4VPhysicalVolume::IsParameterised ( ) const
pure virtual
virtual G4bool G4VPhysicalVolume::IsRegularStructure ( ) const
pure virtual
virtual G4bool G4VPhysicalVolume::IsReplicated ( ) const
pure virtual
G4bool G4VPhysicalVolume::operator== ( const G4VPhysicalVolume p) const
inline
virtual void G4VPhysicalVolume::SetCopyNo ( G4int  CopyNo)
pure virtual
void G4VPhysicalVolume::SetLogicalVolume ( G4LogicalVolume pLogical)
inline
void G4VPhysicalVolume::SetMotherLogical ( G4LogicalVolume pMother)
inline
void G4VPhysicalVolume::SetName ( const G4String pName)
inline
void G4VPhysicalVolume::SetRotation ( G4RotationMatrix )
inline
void G4VPhysicalVolume::SetTranslation ( const G4ThreeVector v)
inline

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

void G4VPhysicalVolume::TerminateWorker ( G4VPhysicalVolume pMasterObject)
protected

Definition at line 71 of file G4VPhysicalVolume.cc.

72 {
73 }
EVolume G4VPhysicalVolume::VolumeType ( ) const
inline

Field Documentation

G4int G4VPhysicalVolume::instanceID
protected

Definition at line 226 of file G4VPhysicalVolume.hh.

Referenced by G4VPhysicalVolume().

G4PVManager G4VPhysicalVolume::subInstanceManager
staticprotected

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