G4VPhysicalVolume Class Reference

#include <G4VPhysicalVolume.hh>

Inheritance diagram for G4VPhysicalVolume:

G4PVDivision G4PVPlacement G4PVReplica G4ReplicatedSlice 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)
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)
 G4VPhysicalVolume (__void__ &)

Protected Attributes

G4RotationMatrixfrot
G4ThreeVector ftrans

Detailed Description

Definition at line 59 of file G4VPhysicalVolume.hh.


Constructor & Destructor Documentation

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

Definition at line 41 of file G4VPhysicalVolume.cc.

References G4PhysicalVolumeStore::Register().

00046   : frot(pRot), ftrans(tlate), flogical(pLogical),
00047     fname(pName), flmother(0)
00048 {
00049   G4PhysicalVolumeStore::Register(this);
00050 }

G4VPhysicalVolume::~G4VPhysicalVolume (  )  [virtual]

Definition at line 65 of file G4VPhysicalVolume.cc.

References G4PhysicalVolumeStore::DeRegister().

00066 {
00067   G4PhysicalVolumeStore::DeRegister(this);
00068 }

G4VPhysicalVolume::G4VPhysicalVolume ( __void__ &   ) 

Definition at line 55 of file G4VPhysicalVolume.cc.

References G4PhysicalVolumeStore::Register().

00056   : frot(0), flogical(0), fname(""), flmother(0)
00057 {
00058   // Register to store
00059   //
00060   G4PhysicalVolumeStore::Register(this);
00061 }


Member Function Documentation

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

Reimplemented in G4PVParameterised, and G4PVPlacement.

Definition at line 97 of file G4VPhysicalVolume.cc.

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

00098 {
00099   return false;
00100 }

virtual G4int G4VPhysicalVolume::GetCopyNo (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVPlacement, and G4PVReplica.

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4VoxelSafety::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4Navigator::ComputeStep(), G4tgbGeometryDumper::DumpPVPlacement(), JA::Insert(), G4MultiNavigator::LocateGlobalPointAndSetup(), G4GeomTestStreamLogger::VolumeNameAndCopy::Print(), G4ASCIITreeSceneHandler::RequestPrimitives(), and G4NavigationHistory::SetFirstEntry().

const G4RotationMatrix * G4VPhysicalVolume::GetFrameRotation (  )  const [inline]

Definition at line 126 of file G4VPhysicalVolume.icc.

References frot.

Referenced by G4AdjointCrossSurfChecker::AddaSphericalSurfaceWithCenterAtTheCenterOfAVolume(), and G4GeomTestErrorList::GetOneDaughtPoints().

00127 {
00128   return frot;
00129 }

G4ThreeVector G4VPhysicalVolume::GetFrameTranslation (  )  const [inline]

Definition at line 132 of file G4VPhysicalVolume.icc.

References ftrans.

Referenced by G4GeomTestErrorList::GetOneDaughtPoints().

00133 {
00134   return -ftrans;
00135 }

G4LogicalVolume * G4VPhysicalVolume::GetLogicalVolume (  )  const [inline]

Definition at line 71 of file G4VPhysicalVolume.icc.

Referenced by G4AdjointCrossSurfChecker::AddanExtSurfaceOfAvolume(), G4LogicalVolume::AddDaughter(), G4GMocrenFileSceneHandler::AddSolid(), G4RayTrajectory::AppendStep(), G4FastSimulationManagerProcess::AtRestGetPhysicalInteractionLength(), G4ReplicaNavigation::BackLocate(), G4Region::BelongsTo(), G4PhantomParameterisation::BuildContainerSolid(), G4SmartVoxelHeader::BuildNodes(), G4PVPlacement::CheckOverlaps(), G4VPVParameterisation::ComputeMaterial(), G4VoxelSafety::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4ReplicaNavigation::ComputeSafety(), G4ParameterisedNavigation::ComputeSafety(), G4NormalNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator::ComputeSafety(), G4VPVParameterisation::ComputeSolid(), G4VNestedParameterisation::ComputeSolid(), G4PhantomParameterisation::ComputeSolid(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4RegularNavigation::ComputeStep(), G4PropagatorInField::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ITNavigator::ComputeStep(), G4RegularNavigation::ComputeStepSkippingEqualMaterials(), G4PSPassageCellFlux::ComputeVolume(), G4PSDoseDeposit::ComputeVolume(), G4PSCellFlux::ComputeVolume(), G4tgbVolume::ConstructG4Volumes(), G4TheRayTracer::CreateBitMap(), G4Navigator::CreateGRSSolid(), G4ITNavigator::CreateGRSSolid(), G4AdjointCrossSurfChecker::CrossingAnInterfaceBetweenTwoVolumes(), G4RadioactiveDecay::DecayIt(), G4AdjointPosOnPhysVolGenerator::DefinePhysicalVolume(), G4RunManagerKernel::DefineWorldVolume(), G4GDMLWriteStructure::DivisionvolWrite(), G4VisManager::Draw(), G4TrajectoryDrawByOriginVolume::Draw(), G4tgbGeometryDumper::DumpPhysVol(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4TrajectoryOriginVolumeFilter::Evaluate(), G4PropagatorInField::FindAndSetFieldManager(), G4VReadOutGeometry::FindROTouchable(), G4PVPlacement::G4PVPlacement(), G4PVReplica::G4PVReplica(), G4ReplicatedSlice::G4ReplicatedSlice(), G4GDMLRead::GeneratePhysvolName(), G4GeomTestOvershootList::GetDaughter(), G4GeomTestOverlapList::GetDaughter1(), G4GeomTestOverlapList::GetDaughter2(), G4Navigator::GetLocalExitNormal(), G4ITNavigator::GetLocalExitNormal(), G4VXTRenergyLoss::GetMeanFreePath(), G4VTransitionRadiation::GetMeanFreePath(), G4PolarizedCompton::GetMeanFreePath(), G4ePolarizedIonisation::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4TransportationManager::GetParallelWorld(), G4TouchableHistory::GetSolid(), G4GRSVolume::GetSolid(), G4tgbGeometryDumper::GetTopPhysVol(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolumeByExtSurface(), G4Step::InitializeStep(), G4VoxelNavigation::LevelLocate(), G4ReplicaNavigation::LevelLocate(), G4RegularNavigation::LevelLocate(), G4ParameterisedNavigation::LevelLocate(), G4NormalNavigation::LevelLocate(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator::LocateGlobalPointAndSetup(), G4Navigator::LocateGlobalPointWithinVolume(), G4ITNavigator::LocateGlobalPointWithinVolume(), GFlashHitMaker::make(), G4GDMLWriteParamvol::ParamvolAlgorithmWrite(), G4GDMLWriteParamvol::ParamvolWrite(), G4GDMLWriteStructure::PhysvolWrite(), G4VXTRenergyLoss::PostStepDoIt(), G4VTransitionRadiation::PostStepDoIt(), G4Transportation::PostStepDoIt(), G4ScoreSplittingProcess::PostStepDoIt(), G4OpBoundaryProcess::PostStepDoIt(), G4ITTransportation::PostStepDoIt(), G4CoupledTransportation::PostStepDoIt(), MinEkineCuts::PostStepGetPhysicalInteractionLength(), MaxTimeCuts::PostStepGetPhysicalInteractionLength(), G4UserSpecialCuts::PostStepGetPhysicalInteractionLength(), G4StepLimiter::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4FastSimulationManagerProcess::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4NavigationLogger::PreComputeStepLog(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSSphereSurfaceCurrent::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4PSFlatSurfaceCurrent::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSCylinderSurfaceCurrent::ProcessHits(), G4GDMLWriteStructure::ReplicavolWrite(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4Region::ScanVolumeTree(), G4LogicalVolume::SetFieldManager(), G4SteppingManager::SetInitialStep(), G4ITStepProcessor::SetInitialStep(), G4Navigator::SetupHierarchy(), G4ITNavigator::SetupHierarchy(), G4SteppingManager::Stepping(), G4GeomTestVolume::TestOneLine(), G4GeomTestVolume::TestRecursiveCartGrid(), G4GeomTestVolume::TestRecursiveCylinder(), G4GeomTestVolume::TestRecursiveLine(), G4RTSteppingAction::UserSteppingAction(), G4MSSteppingAction::UserSteppingAction(), and G4GDMLParser::Write().

00072 {
00073   return flogical;
00074 }

G4LogicalVolume * G4VPhysicalVolume::GetMotherLogical (  )  const [inline]

Definition at line 83 of file G4VPhysicalVolume.icc.

Referenced by G4AdjointCrossSurfChecker::AddanExtSurfaceOfAvolume(), G4AdjointCrossSurfChecker::AddaSphericalSurfaceWithCenterAtTheCenterOfAVolume(), G4PVPlacement::CheckOverlaps(), G4PVParameterised::CheckOverlaps(), G4PhysicalVolumeStore::DeRegister(), G4tgbGeometryDumper::DumpPhysVol(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4tgbGeometryDumper::DumpPVReplica(), G4tgbGeometryDumper::GetTopPhysVol(), G4OpBoundaryProcess::PostStepDoIt(), and G4RunManager::ReOptimizeMotherOf().

00084 {
00085   return flmother;
00086 }

G4int G4VPhysicalVolume::GetMultiplicity (  )  const [virtual]

Reimplemented in G4PVReplica.

Definition at line 70 of file G4VPhysicalVolume.cc.

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4GDMLWriteParamvol::ParamvolAlgorithmWrite(), G4GDMLWriteParamvol::ParamvolWrite(), and G4Region::ScanVolumeTree().

00071 {
00072   return 1;
00073 }

const G4String & G4VPhysicalVolume::GetName (  )  const [inline]

Definition at line 95 of file G4VPhysicalVolume.icc.

Referenced by G4TransportationManager::ActivateNavigator(), G4LogicalVolume::AddDaughter(), G4GDMLWrite::AddModule(), G4GMocrenFileSceneHandler::AddPrimitive(), G4GMocrenFileSceneHandler::AddSolid(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4GDMLWriteStructure::BorderSurfaceCache(), G4SmartVoxelHeader::BuildNodes(), G4PVPlacement::CheckOverlaps(), G4PVParameterised::CheckOverlaps(), G4VoxelSafety::ComputeSafety(), G4VoxelNavigation::ComputeSafety(), G4Navigator::ComputeSafety(), G4ITNavigator::ComputeSafety(), G4ReplicaNavigation::ComputeStep(), G4PropagatorInField::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ITNavigator::ComputeStep(), G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), G4SPSPosDistribution::ConfineSourceToVolume(), G4tgbDetectorConstruction::Construct(), G4ScoringCylinder::Construct(), G4ScoringBox::Construct(), G4tgbDetectorBuilder::ConstructDetector(), G4tgbVolume::ConstructG4PhysVol(), G4PathFinder::CreateTouchableHandle(), G4AdjointCrossSurfChecker::CrossingAnInterfaceBetweenTwoVolumes(), G4TransportationManager::DeActivateNavigator(), G4TransportationManager::DeRegisterNavigator(), G4LogicalVolumeModel::DescribeYourselfTo(), G4GDMLWriteStructure::DivisionvolWrite(), G4TrajectoryDrawByOriginVolume::Draw(), G4tgbVolumeMgr::DumpG4PhysVolLeaf(), G4tgbGeometryDumper::DumpPVParameterised(), G4tgbGeometryDumper::DumpPVPlacement(), G4tgbGeometryDumper::DumpPVReplica(), G4RunManagerKernel::DumpRegion(), G4HadronicProcess::DumpState(), G4tgbVolumeMgr::DumpSummary(), G4TrajectoryOriginVolumeFilter::Evaluate(), G4FastSimulationManagerProcess::G4FastSimulationManagerProcess(), G4PVParameterised::G4PVParameterised(), G4PVReplica::G4PVReplica(), G4PSEnergyDeposit3D::GetIndex(), G4PSDoseDeposit3D::GetIndex(), G4Navigator::GetLocalExitNormal(), G4ITNavigator::GetLocalExitNormal(), G4PolarizedCompton::GetMeanFreePath(), G4eplusPolarizedAnnihilation::GetMeanFreePath(), G4TransportationManager::GetNavigator(), G4tgbVolumeMgr::GetTopPhysVol(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolume(), G4AdjointCrossSurfChecker::GoingInOrOutOfaVolumeByExtSurface(), G4Navigator::LocateGlobalPointAndSetup(), G4MultiNavigator::LocateGlobalPointAndSetup(), G4ITNavigator::LocateGlobalPointAndSetup(), operator<<(), G4GDMLWriteStructure::PhysvolWrite(), G4OpBoundaryProcess::PostStepDoIt(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4NavigationLogger::PreComputeStepLog(), G4MultiNavigator::PrepareNavigators(), G4GeomTestStreamLogger::VolumeNameAndCopy::Print(), G4PathFinder::PrintLimited(), G4MultiNavigator::PrintLimited(), G4Navigator::PrintState(), G4ITNavigator::PrintState(), G4PropagatorInField::printStatus(), JA::PrintTree(), G4tgbVolumeMgr::RegisterMe(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4VoxelSafety::SafetyForVoxelHeader(), G4Region::ScanVolumeTree(), G4VisCommandSceneAddVolume::SetNewValue(), G4WeightWindowProcess::SetParallelWorld(), G4WeightCutOffProcess::SetParallelWorld(), G4ParallelWorldScoringProcess::SetParallelWorld(), G4ParallelWorldProcess::SetParallelWorld(), G4ImportanceProcess::SetParallelWorld(), G4FastSimulationManagerProcess::SetWorldVolume(), G4SteppingVerbose::ShowStep(), G4SteppingVerbose::StepInfo(), G4ErrorGeomVolumeTarget::TargetReached(), G4SteppingVerbose::TrackingStarted(), G4ScoreSplittingProcess::Verbose(), G4ParallelWorldScoringProcess::Verbose(), and G4SteppingVerbose::VerboseTrack().

00096 {
00097   return fname;
00098 }

G4RotationMatrix * G4VPhysicalVolume::GetObjectRotation (  )  const

Definition at line 75 of file G4VPhysicalVolume.cc.

References frot.

00076 {
00077   static G4RotationMatrix  aRotM; 
00078   static G4RotationMatrix  IdentityRM;  // Never changed (from "1")
00079   G4RotationMatrix* retval; 
00080 
00081   // Insure against frot being a null pointer
00082   if(frot)
00083   {
00084     aRotM= frot->inverse();
00085     retval= &aRotM;
00086   }
00087   else
00088   {
00089     retval= &IdentityRM;
00090   }
00091   return retval;
00092 }

G4RotationMatrix G4VPhysicalVolume::GetObjectRotationValue (  )  const [inline]

Definition at line 107 of file G4VPhysicalVolume.icc.

References frot.

00108 {
00109   G4RotationMatrix  aRotM;   // Initialised to identity
00110 
00111   // Insure against frot being a null pointer
00112   if(frot)
00113   {
00114      aRotM= frot->inverse();
00115   }
00116   return aRotM;
00117 }

G4ThreeVector G4VPhysicalVolume::GetObjectTranslation (  )  const [inline]

Definition at line 120 of file G4VPhysicalVolume.icc.

References ftrans.

Referenced by G4AdjointCrossSurfChecker::AddaSphericalSurfaceWithCenterAtTheCenterOfAVolume(), and G4GMocrenFileSceneHandler::AddSolid().

00121 {
00122   return  ftrans;
00123 }

virtual G4VPVParameterisation* G4VPhysicalVolume::GetParameterisation (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVParameterised, G4PVPlacement, and G4PVReplica.

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4SmartVoxelHeader::BuildNodes(), G4ParameterisedNavigation::ComputeSafety(), G4RegularNavigation::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4RegularNavigation::ComputeStepSkippingEqualMaterials(), G4PSPassageCellFlux::ComputeVolume(), G4PSDoseDeposit::ComputeVolume(), G4PSCellFlux::ComputeVolume(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4RegularNavigation::LevelLocate(), G4ParameterisedNavigation::LevelLocate(), G4GDMLWriteParamvol::ParametersWrite(), G4PSSphereSurfaceFlux::ProcessHits(), G4PSSphereSurfaceCurrent::ProcessHits(), G4PSFlatSurfaceFlux::ProcessHits(), G4PSFlatSurfaceCurrent::ProcessHits(), G4PSCylinderSurfaceFlux::ProcessHits(), G4PSCylinderSurfaceCurrent::ProcessHits(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4Region::ScanVolumeTree(), G4Navigator::SetupHierarchy(), and G4ITNavigator::SetupHierarchy().

virtual G4int G4VPhysicalVolume::GetRegularStructureId (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVPlacement, and G4PVReplica.

Referenced by G4Navigator::ComputeStep(), G4ITNavigator::ComputeStep(), G4Navigator::GetDaughtersRegularStructureId(), G4ITNavigator::GetDaughtersRegularStructureId(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4ITStepProcessor::InitDefineStep(), G4SteppingManager::SetInitialStep(), and G4ITStepProcessor::SetInitialStep().

virtual void G4VPhysicalVolume::GetReplicationData ( EAxis axis,
G4int nReplicas,
G4double width,
G4double offset,
G4bool consuming 
) const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVParameterised, G4PVPlacement, and G4PVReplica.

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4SmartVoxelHeader::BuildReplicaVoxels(), G4Navigator::CharacteriseDaughters(), G4ITNavigator::CharacteriseDaughters(), G4ParameterisedNavigation::ComputeSafety(), G4ParameterisedNavigation::ComputeStep(), G4ReplicaNavigation::ComputeTransformation(), G4ReplicaNavigation::DistanceToOut(), G4ReplicaNavigation::Inside(), G4GDMLWriteStructure::ReplicavolWrite(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4Navigator::VolumeType(), and G4ITNavigator::VolumeType().

G4RotationMatrix * G4VPhysicalVolume::GetRotation (  )  [inline]

Definition at line 59 of file G4VPhysicalVolume.icc.

References frot.

00060 {
00061   return frot;
00062 }

const G4RotationMatrix * G4VPhysicalVolume::GetRotation (  )  const [inline]

Definition at line 53 of file G4VPhysicalVolume.icc.

References frot.

Referenced by G4SmartVoxelHeader::BuildNodes(), G4VDivisionParameterisation::ChangeRotMatrix(), G4PVPlacement::CheckOverlaps(), G4PVParameterised::CheckOverlaps(), G4VoxelNavigation::ComputeSafety(), G4ReplicaNavigation::ComputeSafety(), G4ParameterisedNavigation::ComputeSafety(), G4NormalNavigation::ComputeSafety(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4Navigator::ComputeStep(), G4ITNavigator::ComputeStep(), G4tgbPlaceParamCircle::ComputeTransformation(), G4tgbGeometryDumper::DumpPVPlacement(), G4PVPlacement::G4PVPlacement(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4Navigator::LocateGlobalPointAndSetup(), G4NavigationHistory::NewLevel(), G4VoxelSafety::SafetyForVoxelNode(), G4Navigator::SetWorldVolume(), G4ITNavigator::SetWorldVolume(), G4PVDivision::~G4PVDivision(), G4PVReplica::~G4PVReplica(), and G4ReplicatedSlice::~G4ReplicatedSlice().

00054 {
00055   return frot;
00056 }

const G4ThreeVector & G4VPhysicalVolume::GetTranslation (  )  const [inline]

Definition at line 41 of file G4VPhysicalVolume.icc.

References ftrans.

Referenced by G4SmartVoxelHeader::BuildNodes(), G4PVPlacement::CheckOverlaps(), G4PVParameterised::CheckOverlaps(), G4VoxelNavigation::ComputeSafety(), G4ReplicaNavigation::ComputeSafety(), G4ParameterisedNavigation::ComputeSafety(), G4NormalNavigation::ComputeSafety(), G4VoxelNavigation::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ParameterisedNavigation::ComputeStep(), G4NormalNavigation::ComputeStep(), G4tgbGeometryDumper::DumpPVPlacement(), G4Navigator::GetMotherToDaughterTransform(), G4ITNavigator::GetMotherToDaughterTransform(), G4NavigationHistory::NewLevel(), G4VoxelSafety::SafetyForVoxelNode(), G4NavigationHistory::SetFirstEntry(), G4Navigator::SetWorldVolume(), and G4ITNavigator::SetWorldVolume().

00042 {
00043   return ftrans;
00044 }

virtual G4bool G4VPhysicalVolume::IsMany (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVPlacement, and G4PVReplica.

virtual G4bool G4VPhysicalVolume::IsParameterised (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVParameterised, G4PVPlacement, and G4PVReplica.

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4tgbGeometryDumper::DumpPhysVol(), G4PVParameterised::G4PVParameterised(), G4ASCIITreeSceneHandler::RequestPrimitives(), and G4Region::ScanVolumeTree().

virtual G4bool G4VPhysicalVolume::IsRegularStructure (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVPlacement, and G4PVReplica.

Referenced by G4ScoreSplittingProcess::PostStepDoIt().

virtual G4bool G4VPhysicalVolume::IsReplicated (  )  const [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVPlacement, and G4PVReplica.

Referenced by G4GMocrenFileSceneHandler::AddSolid(), G4SmartVoxelHeader::BuildNodes(), G4SmartVoxelHeader::BuildReplicaVoxels(), G4Navigator::CharacteriseDaughters(), G4ITNavigator::CharacteriseDaughters(), G4tgbGeometryDumper::DumpPhysVol(), G4SmartVoxelHeader::G4SmartVoxelHeader(), G4ASCIITreeSceneHandler::RequestPrimitives(), G4GeomTestVolume::TestRecursiveCartGrid(), G4GeomTestVolume::TestRecursiveCylinder(), G4GeomTestVolume::TestRecursiveLine(), G4Navigator::VolumeType(), and G4ITNavigator::VolumeType().

G4bool G4VPhysicalVolume::operator== ( const G4VPhysicalVolume p  )  const [inline]

Definition at line 35 of file G4VPhysicalVolume.icc.

00036 {
00037   return (this==&right) ? true : false;
00038 }

virtual void G4VPhysicalVolume::SetCopyNo ( G4int  CopyNo  )  [pure virtual]

Implemented in G4PVDivision, G4ReplicatedSlice, G4PVPlacement, and G4PVReplica.

Referenced by G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), G4ReplicaNavigation::LevelLocate(), G4RegularNavigation::LevelLocate(), and G4ParameterisedNavigation::LevelLocate().

void G4VPhysicalVolume::SetLogicalVolume ( G4LogicalVolume pLogical  )  [inline]

Definition at line 77 of file G4VPhysicalVolume.icc.

00078 {
00079   flogical=pLogical;
00080 }

void G4VPhysicalVolume::SetMotherLogical ( G4LogicalVolume pMother  )  [inline]

Definition at line 89 of file G4VPhysicalVolume.icc.

Referenced by G4PVDivision::G4PVDivision(), G4PVPlacement::G4PVPlacement(), and G4PVReplica::G4PVReplica().

00090 {
00091   flmother=pMother;
00092 }

void G4VPhysicalVolume::SetName ( const G4String pName  )  [inline]

Definition at line 101 of file G4VPhysicalVolume.icc.

Referenced by G4RunManager::ConstructScoringWorlds(), G4GDMLRead::GeneratePhysvolName(), and G4VUserParallelWorld::GetWorld().

00102 {
00103   fname=pName;
00104 }

void G4VPhysicalVolume::SetRotation ( G4RotationMatrix  )  [inline]

Definition at line 65 of file G4VPhysicalVolume.icc.

References frot.

Referenced by G4VDivisionParameterisation::ChangeRotMatrix(), G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), and G4PVPlacement::G4PVPlacement().

00066 {
00067   frot=pRot;
00068 }

void G4VPhysicalVolume::SetTranslation ( const G4ThreeVector v  )  [inline]

Definition at line 47 of file G4VPhysicalVolume.icc.

References ftrans.

Referenced by G4tgbPlaceParamSquare::ComputeTransformation(), G4tgbPlaceParamLinear::ComputeTransformation(), G4tgbPlaceParamCircle::ComputeTransformation(), G4ReplicaNavigation::ComputeTransformation(), G4PhantomParameterisation::ComputeTransformation(), G4PartialPhantomParameterisation::ComputeTransformation(), G4ParameterisationTubsZ::ComputeTransformation(), G4ParameterisationTubsPhi::ComputeTransformation(), G4ParameterisationTubsRho::ComputeTransformation(), G4ParameterisationTrdZ::ComputeTransformation(), G4ParameterisationTrdY::ComputeTransformation(), G4ParameterisationTrdX::ComputeTransformation(), G4ParameterisationPolyhedraZ::ComputeTransformation(), G4ParameterisationPolyhedraPhi::ComputeTransformation(), G4ParameterisationPolyhedraRho::ComputeTransformation(), G4ParameterisationPolyconeZ::ComputeTransformation(), G4ParameterisationPolyconePhi::ComputeTransformation(), G4ParameterisationPolyconeRho::ComputeTransformation(), G4ParameterisationParaZ::ComputeTransformation(), G4ParameterisationParaY::ComputeTransformation(), G4ParameterisationParaX::ComputeTransformation(), G4ParameterisationConsZ::ComputeTransformation(), G4ParameterisationConsPhi::ComputeTransformation(), G4ParameterisationConsRho::ComputeTransformation(), G4ParameterisationBoxZ::ComputeTransformation(), G4ParameterisationBoxY::ComputeTransformation(), and G4ParameterisationBoxX::ComputeTransformation().

00048 {
00049   ftrans=vec;
00050 }


Field Documentation

G4RotationMatrix* G4VPhysicalVolume::frot [protected]

Definition at line 190 of file G4VPhysicalVolume.hh.

Referenced by GetFrameRotation(), GetObjectRotation(), GetObjectRotationValue(), GetRotation(), SetRotation(), and G4PVPlacement::~G4PVPlacement().

G4ThreeVector G4VPhysicalVolume::ftrans [protected]

Definition at line 191 of file G4VPhysicalVolume.hh.

Referenced by GetFrameTranslation(), GetObjectTranslation(), GetTranslation(), and SetTranslation().


The documentation for this class was generated from the following files:
Generated on Mon May 27 17:53:53 2013 for Geant4 by  doxygen 1.4.7