Geant4 11.3.0
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4TwistedTubs Class Reference

#include <G4TwistedTubs.hh>

+ Inheritance diagram for G4TwistedTubs:

Public Member Functions

 G4TwistedTubs (const G4String &pname, G4double twistedangle, G4double endinnerrad, G4double endouterrad, G4double halfzlen, G4double dphi)
 
 G4TwistedTubs (const G4String &pname, G4double twistedangle, G4double endinnerrad, G4double endouterrad, G4double halfzlen, G4int nseg, G4double totphi)
 
 G4TwistedTubs (const G4String &pname, G4double twistedangle, G4double innerrad, G4double outerrad, G4double negativeEndz, G4double positiveEndz, G4double dphi)
 
 G4TwistedTubs (const G4String &pname, G4double twistedangle, G4double innerrad, G4double outerrad, G4double negativeEndz, G4double positiveEndz, G4int nseg, G4double totphi)
 
 ~G4TwistedTubs () override
 
void ComputeDimensions (G4VPVParameterisation *, const G4int, const G4VPhysicalVolume *) override
 
void BoundingLimits (G4ThreeVector &pMin, G4ThreeVector &pMax) const override
 
G4bool CalculateExtent (const EAxis pAxis, const G4VoxelLimits &pVoxelLimit, const G4AffineTransform &pTransform, G4double &pMin, G4double &pMax) const override
 
G4double DistanceToIn (const G4ThreeVector &p, const G4ThreeVector &v) const override
 
G4double DistanceToIn (const G4ThreeVector &p) const override
 
G4double DistanceToOut (const G4ThreeVector &p, const G4ThreeVector &v, const G4bool calcnorm=false, G4bool *validnorm=nullptr, G4ThreeVector *n=nullptr) const override
 
G4double DistanceToOut (const G4ThreeVector &p) const override
 
EInside Inside (const G4ThreeVector &p) const override
 
G4ThreeVector SurfaceNormal (const G4ThreeVector &p) const override
 
void DescribeYourselfTo (G4VGraphicsScene &scene) const override
 
G4PolyhedronCreatePolyhedron () const override
 
G4PolyhedronGetPolyhedron () const override
 
std::ostream & StreamInfo (std::ostream &os) const override
 
G4double GetDPhi () const
 
G4double GetPhiTwist () const
 
G4double GetInnerRadius () const
 
G4double GetOuterRadius () const
 
G4double GetInnerStereo () const
 
G4double GetOuterStereo () const
 
G4double GetZHalfLength () const
 
G4double GetKappa () const
 
G4double GetTanInnerStereo () const
 
G4double GetTanInnerStereo2 () const
 
G4double GetTanOuterStereo () const
 
G4double GetTanOuterStereo2 () const
 
G4double GetEndZ (G4int i) const
 
G4double GetEndPhi (G4int i) const
 
G4double GetEndInnerRadius (G4int i) const
 
G4double GetEndOuterRadius (G4int i) const
 
G4double GetEndInnerRadius () const
 
G4double GetEndOuterRadius () const
 
G4VisExtent GetExtent () const override
 
G4GeometryType GetEntityType () const override
 
G4VSolidClone () const override
 
G4double GetCubicVolume () override
 
G4double GetSurfaceArea () override
 
G4ThreeVector GetPointOnSurface () const override
 
 G4TwistedTubs (__void__ &)
 
 G4TwistedTubs (const G4TwistedTubs &rhs)
 
G4TwistedTubsoperator= (const G4TwistedTubs &rhs)
 
- Public Member Functions inherited from G4VSolid
 G4VSolid (const G4String &name)
 
virtual ~G4VSolid ()
 
G4bool operator== (const G4VSolid &s) const
 
G4String GetName () const
 
void SetName (const G4String &name)
 
G4double GetTolerance () const
 
virtual G4int GetNumOfConstituents () const
 
virtual G4bool IsFaceted () const
 
void DumpInfo () const
 
virtual const G4VSolidGetConstituentSolid (G4int no) const
 
virtual G4VSolidGetConstituentSolid (G4int no)
 
virtual const G4DisplacedSolidGetDisplacedSolidPtr () const
 
virtual G4DisplacedSolidGetDisplacedSolidPtr ()
 
 G4VSolid (__void__ &)
 
 G4VSolid (const G4VSolid &rhs)
 
G4VSolidoperator= (const G4VSolid &rhs)
 
G4double EstimateCubicVolume (G4int nStat, G4double epsilon) const
 
G4double EstimateSurfaceArea (G4int nStat, G4double ell) const
 

Additional Inherited Members

- Protected Member Functions inherited from G4VSolid
void CalculateClippedPolygonExtent (G4ThreeVectorList &pPolygon, const G4VoxelLimits &pVoxelLimit, const EAxis pAxis, G4double &pMin, G4double &pMax) const
 
void ClipCrossSection (G4ThreeVectorList *pVertices, const G4int pSectionIndex, const G4VoxelLimits &pVoxelLimit, const EAxis pAxis, G4double &pMin, G4double &pMax) const
 
void ClipBetweenSections (G4ThreeVectorList *pVertices, const G4int pSectionIndex, const G4VoxelLimits &pVoxelLimit, const EAxis pAxis, G4double &pMin, G4double &pMax) const
 
void ClipPolygon (G4ThreeVectorList &pPolygon, const G4VoxelLimits &pVoxelLimit, const EAxis pAxis) const
 
- Protected Attributes inherited from G4VSolid
G4double kCarTolerance
 

Detailed Description

Definition at line 55 of file G4TwistedTubs.hh.

Constructor & Destructor Documentation

◆ G4TwistedTubs() [1/6]

G4TwistedTubs::G4TwistedTubs ( const G4String & pname,
G4double twistedangle,
G4double endinnerrad,
G4double endouterrad,
G4double halfzlen,
G4double dphi )

Definition at line 63 of file G4TwistedTubs.cc.

69 : G4VSolid(pname), fDPhi(dphi),
70 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
71 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
72{
73 if (endinnerrad < DBL_MIN)
74 {
75 G4Exception("G4TwistedTubs::G4TwistedTubs()", "GeomSolids0002",
76 FatalErrorInArgument, "Invalid end-inner-radius!");
77 }
78
79 G4double sinhalftwist = std::sin(0.5 * twistedangle);
80
81 G4double endinnerradX = endinnerrad * sinhalftwist;
82 G4double innerrad = std::sqrt( endinnerrad * endinnerrad
83 - endinnerradX * endinnerradX );
84
85 G4double endouterradX = endouterrad * sinhalftwist;
86 G4double outerrad = std::sqrt( endouterrad * endouterrad
87 - endouterradX * endouterradX );
88
89 // temporary treatment!!
90 SetFields(twistedangle, innerrad, outerrad, -halfzlen, halfzlen);
91 CreateSurfaces();
92}
@ FatalErrorInArgument
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
double G4double
Definition G4Types.hh:83
G4VSolid(const G4String &name)
Definition G4VSolid.cc:57
#define DBL_MIN
Definition templates.hh:54

Referenced by Clone(), G4TwistedTubs(), and operator=().

◆ G4TwistedTubs() [2/6]

G4TwistedTubs::G4TwistedTubs ( const G4String & pname,
G4double twistedangle,
G4double endinnerrad,
G4double endouterrad,
G4double halfzlen,
G4int nseg,
G4double totphi )

Definition at line 94 of file G4TwistedTubs.cc.

101 : G4VSolid(pname),
102 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
103 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
104{
105
106 if (nseg == 0)
107 {
108 std::ostringstream message;
109 message << "Invalid number of segments." << G4endl
110 << " nseg = " << nseg;
111 G4Exception("G4TwistedTubs::G4TwistedTubs()", "GeomSolids0002",
112 FatalErrorInArgument, message);
113 }
114 if (totphi == DBL_MIN || endinnerrad < DBL_MIN)
115 {
116 G4Exception("G4TwistedTubs::G4TwistedTubs()", "GeomSolids0002",
117 FatalErrorInArgument, "Invalid total-phi or end-inner-radius!");
118 }
119
120 G4double sinhalftwist = std::sin(0.5 * twistedangle);
121
122 G4double endinnerradX = endinnerrad * sinhalftwist;
123 G4double innerrad = std::sqrt( endinnerrad * endinnerrad
124 - endinnerradX * endinnerradX );
125
126 G4double endouterradX = endouterrad * sinhalftwist;
127 G4double outerrad = std::sqrt( endouterrad * endouterrad
128 - endouterradX * endouterradX );
129
130 // temporary treatment!!
131 fDPhi = totphi / nseg;
132 SetFields(twistedangle, innerrad, outerrad, -halfzlen, halfzlen);
133 CreateSurfaces();
134}
#define G4endl
Definition G4ios.hh:67

◆ G4TwistedTubs() [3/6]

G4TwistedTubs::G4TwistedTubs ( const G4String & pname,
G4double twistedangle,
G4double innerrad,
G4double outerrad,
G4double negativeEndz,
G4double positiveEndz,
G4double dphi )

Definition at line 136 of file G4TwistedTubs.cc.

143 : G4VSolid(pname), fDPhi(dphi),
144 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
145 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
146{
147 if (innerrad < DBL_MIN)
148 {
149 G4Exception("G4TwistedTubs::G4TwistedTubs()", "GeomSolids0002",
150 FatalErrorInArgument, "Invalid end-inner-radius!");
151 }
152
153 SetFields(twistedangle, innerrad, outerrad, negativeEndz, positiveEndz);
154 CreateSurfaces();
155}

◆ G4TwistedTubs() [4/6]

G4TwistedTubs::G4TwistedTubs ( const G4String & pname,
G4double twistedangle,
G4double innerrad,
G4double outerrad,
G4double negativeEndz,
G4double positiveEndz,
G4int nseg,
G4double totphi )

Definition at line 157 of file G4TwistedTubs.cc.

165 : G4VSolid(pname),
166 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
167 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
168{
169 if (nseg == 0)
170 {
171 std::ostringstream message;
172 message << "Invalid number of segments." << G4endl
173 << " nseg = " << nseg;
174 G4Exception("G4TwistedTubs::G4TwistedTubs()", "GeomSolids0002",
175 FatalErrorInArgument, message);
176 }
177 if (totphi == DBL_MIN || innerrad < DBL_MIN)
178 {
179 G4Exception("G4TwistedTubs::G4TwistedTubs()", "GeomSolids0002",
180 FatalErrorInArgument, "Invalid total-phi or end-inner-radius!");
181 }
182
183 fDPhi = totphi / nseg;
184 SetFields(twistedangle, innerrad, outerrad, negativeEndz, positiveEndz);
185 CreateSurfaces();
186}

◆ ~G4TwistedTubs()

G4TwistedTubs::~G4TwistedTubs ( )
override

Definition at line 202 of file G4TwistedTubs.cc.

203{
204 delete fLowerEndcap;
205 delete fUpperEndcap;
206 delete fLatterTwisted;
207 delete fFormerTwisted;
208 delete fInnerHype;
209 delete fOuterHype;
210 delete fpPolyhedron; fpPolyhedron = nullptr;
211}

◆ G4TwistedTubs() [5/6]

G4TwistedTubs::G4TwistedTubs ( __void__ & a)

Definition at line 191 of file G4TwistedTubs.cc.

192 : G4VSolid(a),
193 fLowerEndcap(nullptr), fUpperEndcap(nullptr),
194 fLatterTwisted(nullptr), fFormerTwisted(nullptr),
195 fInnerHype(nullptr), fOuterHype(nullptr)
196{
197}

◆ G4TwistedTubs() [6/6]

G4TwistedTubs::G4TwistedTubs ( const G4TwistedTubs & rhs)

Definition at line 216 of file G4TwistedTubs.cc.

217 : G4VSolid(rhs), fPhiTwist(rhs.fPhiTwist),
218 fInnerRadius(rhs.fInnerRadius), fOuterRadius(rhs.fOuterRadius),
219 fDPhi(rhs.fDPhi), fZHalfLength(rhs.fZHalfLength),
220 fInnerStereo(rhs.fInnerStereo), fOuterStereo(rhs.fOuterStereo),
221 fTanInnerStereo(rhs.fTanInnerStereo), fTanOuterStereo(rhs.fTanOuterStereo),
222 fKappa(rhs.fKappa), fInnerRadius2(rhs.fInnerRadius2),
223 fOuterRadius2(rhs.fOuterRadius2), fTanInnerStereo2(rhs.fTanInnerStereo2),
224 fTanOuterStereo2(rhs.fTanOuterStereo2),
225 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr), fFormerTwisted(nullptr),
226 fInnerHype(nullptr), fOuterHype(nullptr),
227 fCubicVolume(rhs.fCubicVolume), fSurfaceArea(rhs.fSurfaceArea)
228{
229 for (auto i=0; i<2; ++i)
230 {
231 fEndZ[i] = rhs.fEndZ[i];
232 fEndInnerRadius[i] = rhs.fEndInnerRadius[i];
233 fEndOuterRadius[i] = rhs.fEndOuterRadius[i];
234 fEndPhi[i] = rhs.fEndPhi[i];
235 fEndZ2[i] = rhs.fEndZ2[i];
236 }
237 CreateSurfaces();
238}

Member Function Documentation

◆ BoundingLimits()

void G4TwistedTubs::BoundingLimits ( G4ThreeVector & pMin,
G4ThreeVector & pMax ) const
overridevirtual

Reimplemented from G4VSolid.

Definition at line 299 of file G4TwistedTubs.cc.

301{
302 // Find bounding tube
303 G4double rmin = GetInnerRadius();
305
306 G4double zmin = std::min(GetEndZ(0), GetEndZ(1));
307 G4double zmax = std::max(GetEndZ(0), GetEndZ(1));
308
309 G4double dphi = 0.5*GetDPhi();
310 G4double sphi = std::min(GetEndPhi(0), GetEndPhi(1)) - dphi;
311 G4double ephi = std::max(GetEndPhi(0), GetEndPhi(1)) + dphi;
312 G4double totalphi = ephi - sphi;
313
314 // Find bounding box
315 if (dphi <= 0 || totalphi >= CLHEP::twopi)
316 {
317 pMin.set(-rmax,-rmax, zmin);
318 pMax.set( rmax, rmax, zmax);
319 }
320 else
321 {
322 G4TwoVector vmin,vmax;
323 G4GeomTools::DiskExtent(rmin, rmax, sphi, totalphi, vmin, vmax);
324 pMin.set(vmin.x(), vmin.y(), zmin);
325 pMax.set(vmax.x(), vmax.y(), zmax);
326 }
327
328 // Check correctness of the bounding box
329 //
330 if (pMin.x() >= pMax.x() || pMin.y() >= pMax.y() || pMin.z() >= pMax.z())
331 {
332 std::ostringstream message;
333 message << "Bad bounding box (min >= max) for solid: "
334 << GetName() << " !"
335 << "\npMin = " << pMin
336 << "\npMax = " << pMax;
337 G4Exception("G4TwistedTubs::BoundingLimits()", "GeomMgt0001",
338 JustWarning, message);
339 DumpInfo();
340 }
341}
@ JustWarning
CLHEP::Hep2Vector G4TwoVector
double x() const
double y() const
double z() const
double x() const
double y() const
void set(double x, double y, double z)
static G4bool DiskExtent(G4double rmin, G4double rmax, G4double startPhi, G4double delPhi, G4TwoVector &pmin, G4TwoVector &pmax)
G4double GetEndOuterRadius() const
G4double GetEndPhi(G4int i) const
G4double GetEndZ(G4int i) const
G4double GetInnerRadius() const
G4double GetDPhi() const
G4String GetName() const
void DumpInfo() const

Referenced by CalculateExtent(), and GetExtent().

◆ CalculateExtent()

G4bool G4TwistedTubs::CalculateExtent ( const EAxis pAxis,
const G4VoxelLimits & pVoxelLimit,
const G4AffineTransform & pTransform,
G4double & pMin,
G4double & pMax ) const
overridevirtual

Implements G4VSolid.

Definition at line 347 of file G4TwistedTubs.cc.

351{
352 G4ThreeVector bmin, bmax;
353
354 // Get bounding box
355 BoundingLimits(bmin,bmax);
356
357 // Find extent
358 G4BoundingEnvelope bbox(bmin,bmax);
359 return bbox.CalculateExtent(pAxis,pVoxelLimit,pTransform,pMin,pMax);
360}
CLHEP::Hep3Vector G4ThreeVector
void BoundingLimits(G4ThreeVector &pMin, G4ThreeVector &pMax) const override

◆ Clone()

G4VSolid * G4TwistedTubs::Clone ( ) const
overridevirtual

Reimplemented from G4VSolid.

Definition at line 900 of file G4TwistedTubs.cc.

901{
902 return new G4TwistedTubs(*this);
903}
G4TwistedTubs(const G4String &pname, G4double twistedangle, G4double endinnerrad, G4double endouterrad, G4double halfzlen, G4double dphi)

◆ ComputeDimensions()

void G4TwistedTubs::ComputeDimensions ( G4VPVParameterisation * ,
const G4int ,
const G4VPhysicalVolume *  )
overridevirtual

Reimplemented from G4VSolid.

Definition at line 287 of file G4TwistedTubs.cc.

290{
291 G4Exception("G4TwistedTubs::ComputeDimensions()",
292 "GeomSolids0001", FatalException,
293 "G4TwistedTubs does not support Parameterisation.");
294}
@ FatalException

◆ CreatePolyhedron()

G4Polyhedron * G4TwistedTubs::CreatePolyhedron ( ) const
overridevirtual

Reimplemented from G4VSolid.

Definition at line 775 of file G4TwistedTubs.cc.

776{
777 // number of meshes
778 //
779 G4double absPhiTwist = std::abs(fPhiTwist);
780 G4double dA = std::max(fDPhi,absPhiTwist);
781 const G4int k =
783 const G4int n =
784 G4int(G4Polyhedron::GetNumberOfRotationSteps() * absPhiTwist / twopi) + 2;
785
786 const G4int nnodes = 4*(k-1)*(n-2) + 2*k*k ;
787 const G4int nfaces = 4*(k-1)*(n-1) + 2*(k-1)*(k-1) ;
788
789 auto ph = new G4Polyhedron;
790 typedef G4double G4double3[3];
791 typedef G4int G4int4[4];
792 auto xyz = new G4double3[nnodes]; // number of nodes
793 auto faces = new G4int4[nfaces] ; // number of faces
794 fLowerEndcap->GetFacets(k,k,xyz,faces,0) ;
795 fUpperEndcap->GetFacets(k,k,xyz,faces,1) ;
796 fInnerHype->GetFacets(k,n,xyz,faces,2) ;
797 fFormerTwisted->GetFacets(k,n,xyz,faces,3) ;
798 fOuterHype->GetFacets(k,n,xyz,faces,4) ;
799 fLatterTwisted->GetFacets(k,n,xyz,faces,5) ;
800
801 ph->createPolyhedron(nnodes,nfaces,xyz,faces);
802
803 delete[] xyz;
804 delete[] faces;
805
806 return ph;
807}
int G4int
Definition G4Types.hh:85
static G4int GetNumberOfRotationSteps()

Referenced by GetPolyhedron().

◆ DescribeYourselfTo()

void G4TwistedTubs::DescribeYourselfTo ( G4VGraphicsScene & scene) const
overridevirtual

Implements G4VSolid.

Definition at line 753 of file G4TwistedTubs.cc.

754{
755 scene.AddSolid (*this);
756}
virtual void AddSolid(const G4Box &)=0

◆ DistanceToIn() [1/2]

G4double G4TwistedTubs::DistanceToIn ( const G4ThreeVector & p) const
overridevirtual

Implements G4VSolid.

Definition at line 513 of file G4TwistedTubs.cc.

514{
515 // DistanceToIn(p):
516 // Calculate distance to surface of shape from `outside',
517 // allowing for tolerance
518
519 //
520 // Calculate DistanceToIn(p)
521 //
522
523 EInside currentside = Inside(p);
524
525 switch (currentside)
526 {
527 case (kInside) :
528 {}
529 case (kSurface) :
530 {
531 return 0;
532 }
533 case (kOutside) :
534 {
535 // Initialize
536 G4double distance = kInfinity;
537
538 // find intersections and choose nearest one.
539 G4VTwistSurface *surfaces[6];
540 surfaces[0] = fLowerEndcap;
541 surfaces[1] = fUpperEndcap;
542 surfaces[2] = fLatterTwisted;
543 surfaces[3] = fFormerTwisted;
544 surfaces[4] = fInnerHype;
545 surfaces[5] = fOuterHype;
546
547 G4ThreeVector xx;
548 G4ThreeVector bestxx;
549 for (const auto & surface : surfaces)
550 {
551 G4double tmpdistance = surface->DistanceTo(p, xx);
552 if (tmpdistance < distance)
553 {
554 distance = tmpdistance;
555 bestxx = xx;
556 }
557 }
558 return distance;
559 }
560 default :
561 {
562 G4Exception("G4TwistedTubs::DistanceToIn(p)", "GeomSolids0003",
563 FatalException, "Unknown point location!");
564 }
565 } // switch end
566
567 return kInfinity;
568}
EInside Inside(const G4ThreeVector &p) const override
EInside
Definition geomdefs.hh:67
@ kInside
Definition geomdefs.hh:70
@ kOutside
Definition geomdefs.hh:68
@ kSurface
Definition geomdefs.hh:69

◆ DistanceToIn() [2/2]

G4double G4TwistedTubs::DistanceToIn ( const G4ThreeVector & p,
const G4ThreeVector & v ) const
overridevirtual

Implements G4VSolid.

Definition at line 446 of file G4TwistedTubs.cc.

448{
449
450 // DistanceToIn (p, v):
451 // Calculate distance to surface of shape from `outside'
452 // along with the v, allowing for tolerance.
453 // The function returns kInfinity if no intersection or
454 // just grazing within tolerance.
455
456 //
457 // Calculate DistanceToIn(p,v)
458 //
459
460 EInside currentside = Inside(p);
461
462 if (currentside == kInside)
463 {
464 }
465 else
466 {
467 if (currentside == kSurface)
468 {
469 // particle is just on a boundary.
470 // If the particle is entering to the volume, return 0.
471 //
472 G4ThreeVector normal = SurfaceNormal(p);
473 if (normal*v < 0)
474 {
475 return 0;
476 }
477 }
478 }
479
480 // now, we can take smallest positive distance.
481
482 // Initialize
483 //
484 G4double distance = kInfinity;
485
486 // find intersections and choose nearest one.
487 //
488 G4VTwistSurface* surfaces[6];
489 surfaces[0] = fLowerEndcap;
490 surfaces[1] = fUpperEndcap;
491 surfaces[2] = fLatterTwisted;
492 surfaces[3] = fFormerTwisted;
493 surfaces[4] = fInnerHype;
494 surfaces[5] = fOuterHype;
495
496 G4ThreeVector xx;
497 G4ThreeVector bestxx;
498 for (const auto & surface : surfaces)
499 {
500 G4double tmpdistance = surface->DistanceToIn(p, v, xx);
501 if (tmpdistance < distance)
502 {
503 distance = tmpdistance;
504 bestxx = xx;
505 }
506 }
507 return distance;
508}
G4ThreeVector SurfaceNormal(const G4ThreeVector &p) const override

◆ DistanceToOut() [1/2]

G4double G4TwistedTubs::DistanceToOut ( const G4ThreeVector & p) const
overridevirtual

Implements G4VSolid.

Definition at line 659 of file G4TwistedTubs.cc.

660{
661 // DistanceToOut(p):
662 // Calculate distance to surface of shape from `inside',
663 // allowing for tolerance
664
665 //
666 // Calculate DistanceToOut(p)
667 //
668
669 EInside currentside = Inside(p);
670
671 switch (currentside)
672 {
673 case (kOutside) :
674 {
675 }
676 case (kSurface) :
677 {
678 return 0;
679 }
680 case (kInside) :
681 {
682 // Initialize
683 G4double distance = kInfinity;
684
685 // find intersections and choose nearest one.
686 G4VTwistSurface* surfaces[6];
687 surfaces[0] = fLatterTwisted;
688 surfaces[1] = fFormerTwisted;
689 surfaces[2] = fInnerHype;
690 surfaces[3] = fOuterHype;
691 surfaces[4] = fLowerEndcap;
692 surfaces[5] = fUpperEndcap;
693
694 G4ThreeVector xx;
695 G4ThreeVector bestxx;
696 for (const auto & surface : surfaces)
697 {
698 G4double tmpdistance = surface->DistanceTo(p, xx);
699 if (tmpdistance < distance)
700 {
701 distance = tmpdistance;
702 bestxx = xx;
703 }
704 }
705 return distance;
706 }
707 default :
708 {
709 G4Exception("G4TwistedTubs::DistanceToOut(p)", "GeomSolids0003",
710 FatalException, "Unknown point location!");
711 }
712 } // switch end
713
714 return 0.;
715}

◆ DistanceToOut() [2/2]

G4double G4TwistedTubs::DistanceToOut ( const G4ThreeVector & p,
const G4ThreeVector & v,
const G4bool calcnorm = false,
G4bool * validnorm = nullptr,
G4ThreeVector * n = nullptr ) const
overridevirtual

Implements G4VSolid.

Definition at line 573 of file G4TwistedTubs.cc.

578{
579 // DistanceToOut (p, v):
580 // Calculate distance to surface of shape from `inside'
581 // along with the v, allowing for tolerance.
582 // The function returns kInfinity if no intersection or
583 // just grazing within tolerance.
584
585 //
586 // Calculate DistanceToOut(p,v)
587 //
588
589 EInside currentside = Inside(p);
590 if (currentside == kOutside)
591 {
592 }
593 else
594 {
595 if (currentside == kSurface)
596 {
597 // particle is just on a boundary.
598 // If the particle is exiting from the volume, return 0.
599 //
600 G4ThreeVector normal = SurfaceNormal(p);
601 if (normal*v > 0)
602 {
603 if (calcNorm)
604 {
605 *norm = normal;
606 *validNorm = true;
607 }
608 return 0;
609 }
610 }
611 }
612
613 // now, we can take smallest positive distance.
614
615 // Initialize
616 //
617 G4double distance = kInfinity;
618
619 // find intersections and choose nearest one.
620 //
621 G4VTwistSurface* surfaces[6];
622 surfaces[0] = fLatterTwisted;
623 surfaces[1] = fFormerTwisted;
624 surfaces[2] = fInnerHype;
625 surfaces[3] = fOuterHype;
626 surfaces[4] = fLowerEndcap;
627 surfaces[5] = fUpperEndcap;
628
629 G4int besti = -1;
630 G4ThreeVector xx;
631 G4ThreeVector bestxx;
632 for (auto i=0; i<6; ++i)
633 {
634 G4double tmpdistance = surfaces[i]->DistanceToOut(p, v, xx);
635 if (tmpdistance < distance)
636 {
637 distance = tmpdistance;
638 bestxx = xx;
639 besti = i;
640 }
641 }
642
643 if (calcNorm)
644 {
645 if (besti != -1)
646 {
647 *norm = (surfaces[besti]->GetNormal(p, true));
648 *validNorm = surfaces[besti]->IsValidNorm();
649 }
650 }
651
652 return distance;
653}
G4bool IsValidNorm() const
virtual G4double DistanceToOut(const G4ThreeVector &gp, const G4ThreeVector &gv, G4ThreeVector &gxxbest)
virtual G4ThreeVector GetNormal(const G4ThreeVector &xx, G4bool isGlobal)=0

◆ GetCubicVolume()

G4double G4TwistedTubs::GetCubicVolume ( )
overridevirtual

Reimplemented from G4VSolid.

Definition at line 908 of file G4TwistedTubs.cc.

909{
910 if (fCubicVolume == 0.)
911 {
912 G4double DPhi = GetDPhi();
913 G4double Z0 = GetEndZ(0);
914 G4double Z1 = GetEndZ(1);
915 G4double Ain = GetInnerRadius();
916 G4double Aout = GetOuterRadius();
917 G4double R0in = GetEndInnerRadius(0);
918 G4double R1in = GetEndInnerRadius(1);
919 G4double R0out = GetEndOuterRadius(0);
920 G4double R1out = GetEndOuterRadius(1);
921
922 // V_hyperboloid = pi*h*(2*a*a + R*R)/3
923 fCubicVolume = (2.*(Z1 - Z0)*(Aout + Ain)*(Aout - Ain)
924 + Z1*(R1out + R1in)*(R1out - R1in)
925 - Z0*(R0out + R0in)*(R0out - R0in))*DPhi/6.;
926 }
927 return fCubicVolume;
928}
G4double GetOuterRadius() const
G4double GetEndInnerRadius() const

◆ GetDPhi()

G4double G4TwistedTubs::GetDPhi ( ) const
inline

◆ GetEndInnerRadius() [1/2]

G4double G4TwistedTubs::GetEndInnerRadius ( ) const
inline

Definition at line 150 of file G4TwistedTubs.hh.

151 { return (fEndInnerRadius[0] > fEndInnerRadius[1] ?
152 fEndInnerRadius[0] : fEndInnerRadius[1]); }

Referenced by GetCubicVolume(), GetPointOnSurface(), and GetSurfaceArea().

◆ GetEndInnerRadius() [2/2]

G4double G4TwistedTubs::GetEndInnerRadius ( G4int i) const
inline

Definition at line 146 of file G4TwistedTubs.hh.

147 { return fEndInnerRadius[i]; }

◆ GetEndOuterRadius() [1/2]

G4double G4TwistedTubs::GetEndOuterRadius ( ) const
inline

Definition at line 153 of file G4TwistedTubs.hh.

154 { return (fEndOuterRadius[0] > fEndOuterRadius[1] ?
155 fEndOuterRadius[0] : fEndOuterRadius[1]); }

Referenced by BoundingLimits(), GetCubicVolume(), GetPointOnSurface(), and GetSurfaceArea().

◆ GetEndOuterRadius() [2/2]

G4double G4TwistedTubs::GetEndOuterRadius ( G4int i) const
inline

Definition at line 148 of file G4TwistedTubs.hh.

149 { return fEndOuterRadius[i]; }

◆ GetEndPhi()

G4double G4TwistedTubs::GetEndPhi ( G4int i) const
inline

Definition at line 145 of file G4TwistedTubs.hh.

145{ return fEndPhi[i]; }

Referenced by BoundingLimits().

◆ GetEndZ()

G4double G4TwistedTubs::GetEndZ ( G4int i) const
inline

Definition at line 144 of file G4TwistedTubs.hh.

144{ return fEndZ[i] ; }

Referenced by BoundingLimits(), GetCubicVolume(), GetSurfaceArea(), and G4GDMLWriteSolids::TwistedtubsWrite().

◆ GetEntityType()

G4GeometryType G4TwistedTubs::GetEntityType ( ) const
overridevirtual

Implements G4VSolid.

Definition at line 892 of file G4TwistedTubs.cc.

893{
894 return {"G4TwistedTubs"};
895}

◆ GetExtent()

G4VisExtent G4TwistedTubs::GetExtent ( ) const
overridevirtual

Reimplemented from G4VSolid.

Definition at line 761 of file G4TwistedTubs.cc.

762{
763 // Define the sides of the box into which the G4Tubs instance would fit.
764 //
765 G4ThreeVector pmin,pmax;
766 BoundingLimits(pmin,pmax);
767 return { pmin.x(),pmax.x(),
768 pmin.y(),pmax.y(),
769 pmin.z(),pmax.z() };
770}

◆ GetInnerRadius()

G4double G4TwistedTubs::GetInnerRadius ( ) const
inline

◆ GetInnerStereo()

G4double G4TwistedTubs::GetInnerStereo ( ) const
inline

Definition at line 134 of file G4TwistedTubs.hh.

134{ return fInnerStereo; }

◆ GetKappa()

G4double G4TwistedTubs::GetKappa ( ) const
inline

Definition at line 137 of file G4TwistedTubs.hh.

137{ return fKappa ; }

◆ GetOuterRadius()

G4double G4TwistedTubs::GetOuterRadius ( ) const
inline

Definition at line 133 of file G4TwistedTubs.hh.

133{ return fOuterRadius; }

Referenced by GetCubicVolume(), G4tgbGeometryDumper::GetSolidParams(), GetSurfaceArea(), and G4GDMLWriteSolids::TwistedtubsWrite().

◆ GetOuterStereo()

G4double G4TwistedTubs::GetOuterStereo ( ) const
inline

Definition at line 135 of file G4TwistedTubs.hh.

135{ return fOuterStereo; }

◆ GetPhiTwist()

G4double G4TwistedTubs::GetPhiTwist ( ) const
inline

Definition at line 131 of file G4TwistedTubs.hh.

131{ return fPhiTwist ; }

Referenced by G4tgbGeometryDumper::GetSolidParams(), and G4GDMLWriteSolids::TwistedtubsWrite().

◆ GetPointOnSurface()

G4ThreeVector G4TwistedTubs::GetPointOnSurface ( ) const
overridevirtual

Reimplemented from G4VSolid.

Definition at line 1024 of file G4TwistedTubs.cc.

1025{
1026
1027 G4double z = G4RandFlat::shoot(fEndZ[0],fEndZ[1]);
1028 G4double phi , phimin, phimax ;
1029 G4double x , xmin, xmax ;
1030 G4double r , rmin, rmax ;
1031
1032 G4double a1 = fOuterHype->GetSurfaceArea() ;
1033 G4double a2 = fInnerHype->GetSurfaceArea() ;
1034 G4double a3 = fLatterTwisted->GetSurfaceArea() ;
1035 G4double a4 = fFormerTwisted->GetSurfaceArea() ;
1036 G4double a5 = fLowerEndcap->GetSurfaceArea() ;
1037 G4double a6 = fUpperEndcap->GetSurfaceArea() ;
1038
1039 G4double chose = G4RandFlat::shoot(0.,a1 + a2 + a3 + a4 + a5 + a6) ;
1040
1041 if(chose < a1)
1042 {
1043
1044 phimin = fOuterHype->GetBoundaryMin(z) ;
1045 phimax = fOuterHype->GetBoundaryMax(z) ;
1046 phi = G4RandFlat::shoot(phimin,phimax) ;
1047
1048 return fOuterHype->SurfacePoint(phi,z,true) ;
1049
1050 }
1051 else if ( (chose >= a1) && (chose < a1 + a2 ) )
1052 {
1053
1054 phimin = fInnerHype->GetBoundaryMin(z) ;
1055 phimax = fInnerHype->GetBoundaryMax(z) ;
1056 phi = G4RandFlat::shoot(phimin,phimax) ;
1057
1058 return fInnerHype->SurfacePoint(phi,z,true) ;
1059
1060 }
1061 else if ( (chose >= a1 + a2 ) && (chose < a1 + a2 + a3 ) )
1062 {
1063
1064 xmin = fLatterTwisted->GetBoundaryMin(z) ;
1065 xmax = fLatterTwisted->GetBoundaryMax(z) ;
1066 x = G4RandFlat::shoot(xmin,xmax) ;
1067
1068 return fLatterTwisted->SurfacePoint(x,z,true) ;
1069
1070 }
1071 else if ( (chose >= a1 + a2 + a3 ) && (chose < a1 + a2 + a3 + a4 ) )
1072 {
1073
1074 xmin = fFormerTwisted->GetBoundaryMin(z) ;
1075 xmax = fFormerTwisted->GetBoundaryMax(z) ;
1076 x = G4RandFlat::shoot(xmin,xmax) ;
1077
1078 return fFormerTwisted->SurfacePoint(x,z,true) ;
1079 }
1080 else if( (chose >= a1 + a2 + a3 + a4 )&&(chose < a1 + a2 + a3 + a4 + a5 ) )
1081 {
1082 rmin = GetEndInnerRadius(0) ;
1083 rmax = GetEndOuterRadius(0) ;
1084 r = std::sqrt(G4RandFlat::shoot()*(sqr(rmax)-sqr(rmin))+sqr(rmin));
1085
1086 phimin = fLowerEndcap->GetBoundaryMin(r) ;
1087 phimax = fLowerEndcap->GetBoundaryMax(r) ;
1088 phi = G4RandFlat::shoot(phimin,phimax) ;
1089
1090 return fLowerEndcap->SurfacePoint(phi,r,true) ;
1091 }
1092 else
1093 {
1094 rmin = GetEndInnerRadius(1) ;
1095 rmax = GetEndOuterRadius(1) ;
1096 r = rmin + (rmax-rmin)*std::sqrt(G4RandFlat::shoot());
1097
1098 phimin = fUpperEndcap->GetBoundaryMin(r) ;
1099 phimax = fUpperEndcap->GetBoundaryMax(r) ;
1100 phi = G4RandFlat::shoot(phimin,phimax) ;
1101
1102 return fUpperEndcap->SurfacePoint(phi,r,true) ;
1103 }
1104}
T sqr(const T &x)
Definition templates.hh:128

◆ GetPolyhedron()

G4Polyhedron * G4TwistedTubs::GetPolyhedron ( ) const
overridevirtual

Reimplemented from G4VSolid.

Definition at line 812 of file G4TwistedTubs.cc.

813{
814 if (fpPolyhedron == nullptr ||
815 fRebuildPolyhedron ||
816 fpPolyhedron->GetNumberOfRotationStepsAtTimeOfCreation() !=
817 fpPolyhedron->GetNumberOfRotationSteps())
818 {
819 G4AutoLock l(&polyhedronMutex);
820 delete fpPolyhedron;
821 fpPolyhedron = CreatePolyhedron();
822 fRebuildPolyhedron = false;
823 l.unlock();
824 }
825 return fpPolyhedron;
826}
G4TemplateAutoLock< G4Mutex > G4AutoLock
G4Polyhedron * CreatePolyhedron() const override

◆ GetSurfaceArea()

G4double G4TwistedTubs::GetSurfaceArea ( )
overridevirtual

Reimplemented from G4VSolid.

Definition at line 981 of file G4TwistedTubs.cc.

982{
983 if (fSurfaceArea == 0.)
984 {
985 G4double dphi = GetDPhi();
986 G4double Ainn = GetInnerRadius();
987 G4double Aout = GetOuterRadius();
988 G4double Rinn0 = GetEndInnerRadius(0);
989 G4double Rout0 = GetEndOuterRadius(0);
990 G4double Rinn1 = GetEndInnerRadius(1);
991 G4double Rout1 = GetEndOuterRadius(1);
992 G4double z0 = GetEndZ(0);
993 G4double z1 = GetEndZ(1);
994
995 G4double base0 = 0.5*dphi*(Rout0*Rout0 - Rinn0*Rinn0); // lower base
996 G4double inner0 = GetLateralArea(Ainn, Rinn0, z0); // lower inner surface
997 G4double outer0 = GetLateralArea(Aout, Rout0, z0); // lower outer surface
998 G4double cut0 = // lower phi cut
999 GetPhiCutArea(Aout, Rout0, z0) - GetPhiCutArea(Ainn, Rinn0, z0);
1000
1001 G4double base1 = base0;
1002 G4double inner1 = inner0;
1003 G4double outer1 = outer0;
1004 G4double cut1 = cut0;
1005 if (std::abs(z0) != std::abs(z1))
1006 {
1007 base1 = 0.5*dphi*(Rout1*Rout1 - Rinn1*Rinn1); // upper base
1008 inner1 = GetLateralArea(Ainn, Rinn1, z1); // upper inner surface
1009 outer1 = GetLateralArea(Aout, Rout1, z1); // upper outer surface
1010 cut1 = // upper phi cut
1011 GetPhiCutArea(Aout, Rout1, z1) - GetPhiCutArea(Ainn, Rinn1, z1);
1012 }
1013 fSurfaceArea = base0 + base1 +
1014 ((z0*z1 < 0) ?
1015 (inner0 + inner1 + outer0 + outer1 + 2.*(cut0 + cut1)) :
1016 std::abs(inner0 - inner1 + outer0 - outer1 + 2.*(cut0 - cut1)));
1017 }
1018 return fSurfaceArea;
1019}

◆ GetTanInnerStereo()

G4double G4TwistedTubs::GetTanInnerStereo ( ) const
inline

Definition at line 139 of file G4TwistedTubs.hh.

139{ return fTanInnerStereo ; }

◆ GetTanInnerStereo2()

G4double G4TwistedTubs::GetTanInnerStereo2 ( ) const
inline

Definition at line 140 of file G4TwistedTubs.hh.

140{ return fTanInnerStereo2 ; }

◆ GetTanOuterStereo()

G4double G4TwistedTubs::GetTanOuterStereo ( ) const
inline

Definition at line 141 of file G4TwistedTubs.hh.

141{ return fTanOuterStereo ; }

◆ GetTanOuterStereo2()

G4double G4TwistedTubs::GetTanOuterStereo2 ( ) const
inline

Definition at line 142 of file G4TwistedTubs.hh.

142{ return fTanOuterStereo2 ; }

◆ GetZHalfLength()

G4double G4TwistedTubs::GetZHalfLength ( ) const
inline

Definition at line 136 of file G4TwistedTubs.hh.

136{ return fZHalfLength; }

Referenced by G4tgbGeometryDumper::GetSolidParams().

◆ Inside()

EInside G4TwistedTubs::Inside ( const G4ThreeVector & p) const
overridevirtual

Implements G4VSolid.

Definition at line 366 of file G4TwistedTubs.cc.

367{
368
369 const G4double halftol
371 // static G4int timerid = -1;
372 // G4Timer timer(timerid, "G4TwistedTubs", "Inside");
373 // timer.Start();
374
375
376 EInside outerhypearea = ((G4TwistTubsHypeSide *)fOuterHype)->Inside(p);
377 G4double innerhyperho = ((G4TwistTubsHypeSide *)fInnerHype)->GetRhoAtPZ(p);
378 G4double distanceToOut = p.getRho() - innerhyperho; // +ve: inside
379 EInside tmpinside;
380 if ((outerhypearea == kOutside) || (distanceToOut < -halftol))
381 {
382 tmpinside = kOutside;
383 }
384 else if (outerhypearea == kSurface)
385 {
386 tmpinside = kSurface;
387 }
388 else
389 {
390 if (distanceToOut <= halftol)
391 {
392 tmpinside = kSurface;
393 }
394 else
395 {
396 tmpinside = kInside;
397 }
398 }
399
400 return tmpinside;
401}
double getRho() const
G4double GetRadialTolerance() const
static G4GeometryTolerance * GetInstance()

Referenced by DistanceToIn(), DistanceToIn(), DistanceToOut(), and DistanceToOut().

◆ operator=()

G4TwistedTubs & G4TwistedTubs::operator= ( const G4TwistedTubs & rhs)

Definition at line 244 of file G4TwistedTubs.cc.

245{
246 // Check assignment to self
247 //
248 if (this == &rhs) { return *this; }
249
250 // Copy base class data
251 //
253
254 // Copy data
255 //
256 fPhiTwist= rhs.fPhiTwist;
257 fInnerRadius= rhs.fInnerRadius; fOuterRadius= rhs.fOuterRadius;
258 fDPhi= rhs.fDPhi; fZHalfLength= rhs.fZHalfLength;
259 fInnerStereo= rhs.fInnerStereo; fOuterStereo= rhs.fOuterStereo;
260 fTanInnerStereo= rhs.fTanInnerStereo; fTanOuterStereo= rhs.fTanOuterStereo;
261 fKappa= rhs.fKappa; fInnerRadius2= rhs.fInnerRadius2;
262 fOuterRadius2= rhs.fOuterRadius2; fTanInnerStereo2= rhs.fTanInnerStereo2;
263 fTanOuterStereo2= rhs.fTanOuterStereo2;
264 fLowerEndcap= fUpperEndcap= fLatterTwisted= fFormerTwisted= nullptr;
265 fInnerHype= fOuterHype= nullptr;
266 fCubicVolume= rhs.fCubicVolume; fSurfaceArea= rhs.fSurfaceArea;
267
268 for (auto i=0; i<2; ++i)
269 {
270 fEndZ[i] = rhs.fEndZ[i];
271 fEndInnerRadius[i] = rhs.fEndInnerRadius[i];
272 fEndOuterRadius[i] = rhs.fEndOuterRadius[i];
273 fEndPhi[i] = rhs.fEndPhi[i];
274 fEndZ2[i] = rhs.fEndZ2[i];
275 }
276
277 CreateSurfaces();
278 fRebuildPolyhedron = false;
279 delete fpPolyhedron; fpPolyhedron = nullptr;
280
281 return *this;
282}
G4VSolid & operator=(const G4VSolid &rhs)
Definition G4VSolid.cc:107

◆ StreamInfo()

std::ostream & G4TwistedTubs::StreamInfo ( std::ostream & os) const
overridevirtual

Implements G4VSolid.

Definition at line 720 of file G4TwistedTubs.cc.

721{
722 //
723 // Stream object contents to an output stream
724 //
725 G4long oldprc = os.precision(16);
726 os << "-----------------------------------------------------------\n"
727 << " *** Dump for solid - " << GetName() << " ***\n"
728 << " ===================================================\n"
729 << " Solid type: G4TwistedTubs\n"
730 << " Parameters: \n"
731 << " -ve end Z : " << fEndZ[0]/mm << " mm \n"
732 << " +ve end Z : " << fEndZ[1]/mm << " mm \n"
733 << " inner end radius(-ve z): " << fEndInnerRadius[0]/mm << " mm \n"
734 << " inner end radius(+ve z): " << fEndInnerRadius[1]/mm << " mm \n"
735 << " outer end radius(-ve z): " << fEndOuterRadius[0]/mm << " mm \n"
736 << " outer end radius(+ve z): " << fEndOuterRadius[1]/mm << " mm \n"
737 << " inner radius (z=0) : " << fInnerRadius/mm << " mm \n"
738 << " outer radius (z=0) : " << fOuterRadius/mm << " mm \n"
739 << " twisted angle : " << fPhiTwist/degree << " degrees \n"
740 << " inner stereo angle : " << fInnerStereo/degree << " degrees \n"
741 << " outer stereo angle : " << fOuterStereo/degree << " degrees \n"
742 << " phi-width of a piece : " << fDPhi/degree << " degrees \n"
743 << "-----------------------------------------------------------\n";
744 os.precision(oldprc);
745
746 return os;
747}
long G4long
Definition G4Types.hh:87

◆ SurfaceNormal()

G4ThreeVector G4TwistedTubs::SurfaceNormal ( const G4ThreeVector & p) const
overridevirtual

Implements G4VSolid.

Definition at line 406 of file G4TwistedTubs.cc.

407{
408 //
409 // return the normal unit vector to the Hyperbolical Surface at a point
410 // p on (or nearly on) the surface
411 //
412 // Which of the three or four surfaces are we closest to?
413 //
414
415
416 G4double distance = kInfinity;
417
418 G4VTwistSurface *surfaces[6];
419 surfaces[0] = fLatterTwisted;
420 surfaces[1] = fFormerTwisted;
421 surfaces[2] = fInnerHype;
422 surfaces[3] = fOuterHype;
423 surfaces[4] = fLowerEndcap;
424 surfaces[5] = fUpperEndcap;
425
426 G4ThreeVector xx;
427 G4ThreeVector bestxx;
428 G4int besti = -1;
429 for (auto i=0; i<6; ++i)
430 {
431 G4double tmpdistance = surfaces[i]->DistanceTo(p, xx);
432 if (tmpdistance < distance)
433 {
434 distance = tmpdistance;
435 bestxx = xx;
436 besti = i;
437 }
438 }
439
440 return surfaces[besti]->GetNormal(bestxx, true);
441}
virtual G4double DistanceTo(const G4ThreeVector &gp, G4ThreeVector &gxx)

Referenced by DistanceToIn(), and DistanceToOut().


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