70 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
71 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
75 G4Exception(
"G4TwistedTubs::G4TwistedTubs()",
"GeomSolids0002",
79 G4double sinhalftwist = std::sin(0.5 * twistedangle);
81 G4double endinnerradX = endinnerrad * sinhalftwist;
82 G4double innerrad = std::sqrt( endinnerrad * endinnerrad
83 - endinnerradX * endinnerradX );
85 G4double endouterradX = endouterrad * sinhalftwist;
86 G4double outerrad = std::sqrt( endouterrad * endouterrad
87 - endouterradX * endouterradX );
90 SetFields(twistedangle, innerrad, outerrad, -halfzlen, halfzlen);
102 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
103 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
108 std::ostringstream message;
109 message <<
"Invalid number of segments." <<
G4endl
110 <<
" nseg = " << nseg;
111 G4Exception(
"G4TwistedTubs::G4TwistedTubs()",
"GeomSolids0002",
116 G4Exception(
"G4TwistedTubs::G4TwistedTubs()",
"GeomSolids0002",
120 G4double sinhalftwist = std::sin(0.5 * twistedangle);
122 G4double endinnerradX = endinnerrad * sinhalftwist;
123 G4double innerrad = std::sqrt( endinnerrad * endinnerrad
124 - endinnerradX * endinnerradX );
126 G4double endouterradX = endouterrad * sinhalftwist;
127 G4double outerrad = std::sqrt( endouterrad * endouterrad
128 - endouterradX * endouterradX );
131 fDPhi = totphi / nseg;
132 SetFields(twistedangle, innerrad, outerrad, -halfzlen, halfzlen);
144 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
145 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
149 G4Exception(
"G4TwistedTubs::G4TwistedTubs()",
"GeomSolids0002",
153 SetFields(twistedangle, innerrad, outerrad, negativeEndz, positiveEndz);
166 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fLatterTwisted(nullptr),
167 fFormerTwisted(nullptr), fInnerHype(nullptr), fOuterHype(nullptr)
171 std::ostringstream message;
172 message <<
"Invalid number of segments." <<
G4endl
173 <<
" nseg = " << nseg;
174 G4Exception(
"G4TwistedTubs::G4TwistedTubs()",
"GeomSolids0002",
179 G4Exception(
"G4TwistedTubs::G4TwistedTubs()",
"GeomSolids0002",
183 fDPhi = totphi / nseg;
184 SetFields(twistedangle, innerrad, outerrad, negativeEndz, positiveEndz);
193 fLowerEndcap(nullptr), fUpperEndcap(nullptr),
194 fLatterTwisted(nullptr), fFormerTwisted(nullptr),
195 fInnerHype(nullptr), fOuterHype(nullptr)
206 delete fLatterTwisted;
207 delete fFormerTwisted;
210 delete fpPolyhedron; fpPolyhedron =
nullptr;
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)
229 for (
auto i=0; i<2; ++i)
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];
248 if (
this == &rhs) {
return *
this; }
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;
268 for (
auto i=0; i<2; ++i)
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];
278 fRebuildPolyhedron =
false;
279 delete fpPolyhedron; fpPolyhedron =
nullptr;
293 "G4TwistedTubs does not support Parameterisation.");
315 if (dphi <= 0 || totalphi >= CLHEP::twopi)
317 pMin.
set(-rmax,-rmax, zmin);
318 pMax.
set( rmax, rmax, zmax);
324 pMin.
set(vmin.
x(), vmin.
y(), zmin);
325 pMax.
set(vmax.
x(), vmax.
y(), zmax);
330 if (pMin.
x() >= pMax.
x() || pMin.
y() >= pMax.
y() || pMin.
z() >= pMax.
z())
332 std::ostringstream message;
333 message <<
"Bad bounding box (min >= max) for solid: "
335 <<
"\npMin = " << pMin
336 <<
"\npMax = " << pMax;
337 G4Exception(
"G4TwistedTubs::BoundingLimits()",
"GeomMgt0001",
380 if ((outerhypearea ==
kOutside) || (distanceToOut < -halftol))
390 if (distanceToOut <= halftol)
419 surfaces[0] = fLatterTwisted;
420 surfaces[1] = fFormerTwisted;
421 surfaces[2] = fInnerHype;
422 surfaces[3] = fOuterHype;
423 surfaces[4] = fLowerEndcap;
424 surfaces[5] = fUpperEndcap;
429 for (
auto i=0; i<6; ++i)
432 if (tmpdistance < distance)
434 distance = tmpdistance;
440 return surfaces[besti]->
GetNormal(bestxx,
true);
489 surfaces[0] = fLowerEndcap;
490 surfaces[1] = fUpperEndcap;
491 surfaces[2] = fLatterTwisted;
492 surfaces[3] = fFormerTwisted;
493 surfaces[4] = fInnerHype;
494 surfaces[5] = fOuterHype;
498 for (
const auto & surface : surfaces)
500 G4double tmpdistance = surface->DistanceToIn(p, v, xx);
501 if (tmpdistance < distance)
503 distance = tmpdistance;
540 surfaces[0] = fLowerEndcap;
541 surfaces[1] = fUpperEndcap;
542 surfaces[2] = fLatterTwisted;
543 surfaces[3] = fFormerTwisted;
544 surfaces[4] = fInnerHype;
545 surfaces[5] = fOuterHype;
549 for (
const auto & surface : surfaces)
551 G4double tmpdistance = surface->DistanceTo(p, xx);
552 if (tmpdistance < distance)
554 distance = tmpdistance;
562 G4Exception(
"G4TwistedTubs::DistanceToIn(p)",
"GeomSolids0003",
622 surfaces[0] = fLatterTwisted;
623 surfaces[1] = fFormerTwisted;
624 surfaces[2] = fInnerHype;
625 surfaces[3] = fOuterHype;
626 surfaces[4] = fLowerEndcap;
627 surfaces[5] = fUpperEndcap;
632 for (
auto i=0; i<6; ++i)
635 if (tmpdistance < distance)
637 distance = tmpdistance;
647 *norm = (surfaces[besti]->
GetNormal(p,
true));
687 surfaces[0] = fLatterTwisted;
688 surfaces[1] = fFormerTwisted;
689 surfaces[2] = fInnerHype;
690 surfaces[3] = fOuterHype;
691 surfaces[4] = fLowerEndcap;
692 surfaces[5] = fUpperEndcap;
696 for (
const auto & surface : surfaces)
698 G4double tmpdistance = surface->DistanceTo(p, xx);
699 if (tmpdistance < distance)
701 distance = tmpdistance;
709 G4Exception(
"G4TwistedTubs::DistanceToOut(p)",
"GeomSolids0003",
725 G4long oldprc = os.precision(16);
726 os <<
"-----------------------------------------------------------\n"
727 <<
" *** Dump for solid - " <<
GetName() <<
" ***\n"
728 <<
" ===================================================\n"
729 <<
" Solid type: G4TwistedTubs\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);
767 return { pmin.
x(),pmax.
x(),
779 G4double absPhiTwist = std::abs(fPhiTwist);
780 G4double dA = std::max(fDPhi,absPhiTwist);
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) ;
791 typedef G4int G4int4[4];
792 auto xyz =
new G4double3[nnodes];
793 auto faces =
new G4int4[nfaces] ;
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) ;
801 ph->createPolyhedron(nnodes,nfaces,xyz,faces);
814 if (fpPolyhedron ==
nullptr ||
815 fRebuildPolyhedron ||
816 fpPolyhedron->GetNumberOfRotationStepsAtTimeOfCreation() !=
817 fpPolyhedron->GetNumberOfRotationSteps())
822 fRebuildPolyhedron =
false;
831void G4TwistedTubs::CreateSurfaces()
839 fEndInnerRadius, fEndOuterRadius,
840 fDPhi, fEndPhi, fEndZ, -1) ;
843 fEndInnerRadius, fEndOuterRadius,
844 fDPhi, fEndPhi, fEndZ, 1) ;
847 rotHalfDPhi.
rotateZ(0.5*fDPhi);
850 fEndInnerRadius, fEndOuterRadius,
851 fDPhi, fEndPhi, fEndZ,
852 fInnerRadius, fOuterRadius, fKappa,
855 fEndInnerRadius, fEndOuterRadius,
856 fDPhi, fEndPhi, fEndZ,
857 fInnerRadius, fOuterRadius, fKappa,
861 fEndInnerRadius, fEndOuterRadius,
862 fDPhi, fEndPhi, fEndZ,
863 fInnerRadius, fOuterRadius,fKappa,
864 fTanInnerStereo, fTanOuterStereo, -1) ;
866 fEndInnerRadius, fEndOuterRadius,
867 fDPhi, fEndPhi, fEndZ,
868 fInnerRadius, fOuterRadius,fKappa,
869 fTanInnerStereo, fTanOuterStereo, 1) ;
875 fOuterHype, fFormerTwisted);
877 fOuterHype, fFormerTwisted);
879 fOuterHype, fUpperEndcap);
881 fOuterHype, fUpperEndcap);
883 fFormerTwisted, fUpperEndcap);
885 fFormerTwisted, fUpperEndcap);
894 return {
"G4TwistedTubs"};
910 if (fCubicVolume == 0.)
923 fCubicVolume = (2.*(Z1 - Z0)*(Aout + Ain)*(Aout - Ain)
924 + Z1*(R1out + R1in)*(R1out - R1in)
925 - Z0*(R0out + R0in)*(R0out - R0in))*DPhi/6.;
936 if (z == 0)
return 0.;
947 area = 0.5*a*(h*std::sqrt(1. + kh*kh) + std::asinh(kh)/k);
958 if (
GetDPhi() >= CLHEP::twopi || r <= 0 || z == 0)
return 0.;
969 G4double sqroot = std::sqrt(pp + qq + 1);
971 0.5*p*(
pp + 3.)*std::atanh(q/sqroot) +
972 0.5*q*(qq + 3.)*std::atanh(p/sqroot) +
973 std::atan(sqroot/(pq)) - CLHEP::halfpi)*h*a/(3.*pq);
983 if (fSurfaceArea == 0.)
995 G4double base0 = 0.5*dphi*(Rout0*Rout0 - Rinn0*Rinn0);
996 G4double inner0 = GetLateralArea(Ainn, Rinn0, z0);
997 G4double outer0 = GetLateralArea(Aout, Rout0, z0);
999 GetPhiCutArea(Aout, Rout0, z0) - GetPhiCutArea(Ainn, Rinn0, z0);
1005 if (std::abs(z0) != std::abs(z1))
1007 base1 = 0.5*dphi*(Rout1*Rout1 - Rinn1*Rinn1);
1008 inner1 = GetLateralArea(Ainn, Rinn1, z1);
1009 outer1 = GetLateralArea(Aout, Rout1, z1);
1011 GetPhiCutArea(Aout, Rout1, z1) - GetPhiCutArea(Ainn, Rinn1, z1);
1013 fSurfaceArea = base0 + base1 +
1015 (inner0 + inner1 + outer0 + outer1 + 2.*(cut0 + cut1)) :
1016 std::abs(inner0 - inner1 + outer0 - outer1 + 2.*(cut0 - cut1)));
1018 return fSurfaceArea;
1027 G4double z = G4RandFlat::shoot(fEndZ[0],fEndZ[1]);
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() ;
1039 G4double chose = G4RandFlat::shoot(0.,a1 + a2 + a3 + a4 + a5 + a6) ;
1044 phimin = fOuterHype->GetBoundaryMin(z) ;
1045 phimax = fOuterHype->GetBoundaryMax(z) ;
1046 phi = G4RandFlat::shoot(phimin,phimax) ;
1048 return fOuterHype->SurfacePoint(phi,z,
true) ;
1051 else if ( (chose >= a1) && (chose < a1 + a2 ) )
1054 phimin = fInnerHype->GetBoundaryMin(z) ;
1055 phimax = fInnerHype->GetBoundaryMax(z) ;
1056 phi = G4RandFlat::shoot(phimin,phimax) ;
1058 return fInnerHype->SurfacePoint(phi,z,
true) ;
1061 else if ( (chose >= a1 + a2 ) && (chose < a1 + a2 + a3 ) )
1064 xmin = fLatterTwisted->GetBoundaryMin(z) ;
1065 xmax = fLatterTwisted->GetBoundaryMax(z) ;
1066 x = G4RandFlat::shoot(xmin,xmax) ;
1068 return fLatterTwisted->SurfacePoint(x,z,
true) ;
1071 else if ( (chose >= a1 + a2 + a3 ) && (chose < a1 + a2 + a3 + a4 ) )
1074 xmin = fFormerTwisted->GetBoundaryMin(z) ;
1075 xmax = fFormerTwisted->GetBoundaryMax(z) ;
1076 x = G4RandFlat::shoot(xmin,xmax) ;
1078 return fFormerTwisted->SurfacePoint(x,z,
true) ;
1080 else if( (chose >= a1 + a2 + a3 + a4 )&&(chose < a1 + a2 + a3 + a4 + a5 ) )
1084 r = std::sqrt(G4RandFlat::shoot()*(
sqr(rmax)-
sqr(rmin))+
sqr(rmin));
1086 phimin = fLowerEndcap->GetBoundaryMin(r) ;
1087 phimax = fLowerEndcap->GetBoundaryMax(r) ;
1088 phi = G4RandFlat::shoot(phimin,phimax) ;
1090 return fLowerEndcap->SurfacePoint(phi,r,
true) ;
1096 r = rmin + (rmax-rmin)*std::sqrt(G4RandFlat::shoot());
1098 phimin = fUpperEndcap->GetBoundaryMin(r) ;
1099 phimax = fUpperEndcap->GetBoundaryMax(r) ;
1100 phi = G4RandFlat::shoot(phimin,phimax) ;
1102 return fUpperEndcap->SurfacePoint(phi,r,
true) ;
G4TemplateAutoLock< G4Mutex > G4AutoLock
const G4double kCarTolerance
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
CLHEP::HepRotation G4RotationMatrix
#define G4MUTEX_INITIALIZER
CLHEP::Hep3Vector G4ThreeVector
CLHEP::Hep2Vector G4TwoVector
void set(double x, double y, double z)
HepRotation & rotateZ(double delta)
G4bool CalculateExtent(const EAxis pAxis, const G4VoxelLimits &pVoxelLimits, const G4Transform3D &pTransform3D, G4double &pMin, G4double &pMax) const
G4double GetRadialTolerance() const
static G4GeometryTolerance * GetInstance()
G4double DistanceToOut(const G4ThreeVector &p, const G4ThreeVector &v, const G4bool calcnorm=false, G4bool *validnorm=nullptr, G4ThreeVector *n=nullptr) const override
G4double GetOuterRadius() const
G4bool CalculateExtent(const EAxis pAxis, const G4VoxelLimits &pVoxelLimit, const G4AffineTransform &pTransform, G4double &pMin, G4double &pMax) const override
G4double GetZHalfLength() const
G4double GetPhiTwist() const
G4Polyhedron * CreatePolyhedron() const override
G4double DistanceToIn(const G4ThreeVector &p, const G4ThreeVector &v) const override
G4TwistedTubs & operator=(const G4TwistedTubs &rhs)
G4double GetEndInnerRadius() const
G4double GetEndOuterRadius() const
G4VSolid * Clone() const override
G4Polyhedron * GetPolyhedron() const override
~G4TwistedTubs() override
G4GeometryType GetEntityType() const override
G4double GetEndPhi(G4int i) const
G4TwistedTubs(const G4String &pname, G4double twistedangle, G4double endinnerrad, G4double endouterrad, G4double halfzlen, G4double dphi)
std::ostream & StreamInfo(std::ostream &os) const override
G4double GetSurfaceArea() override
G4double GetCubicVolume() override
void ComputeDimensions(G4VPVParameterisation *, const G4int, const G4VPhysicalVolume *) override
void BoundingLimits(G4ThreeVector &pMin, G4ThreeVector &pMax) const override
G4VisExtent GetExtent() const override
G4ThreeVector GetPointOnSurface() const override
void DescribeYourselfTo(G4VGraphicsScene &scene) const override
G4double GetEndZ(G4int i) const
G4ThreeVector SurfaceNormal(const G4ThreeVector &p) const override
G4double GetInnerRadius() const
EInside Inside(const G4ThreeVector &p) const override
virtual void AddSolid(const G4Box &)=0
G4VSolid(const G4String &name)
G4VSolid & operator=(const G4VSolid &rhs)
void SetNeighbours(G4VTwistSurface *ax0min, G4VTwistSurface *ax1min, G4VTwistSurface *ax0max, G4VTwistSurface *ax1max)
G4bool IsValidNorm() const
virtual G4double DistanceTo(const G4ThreeVector &gp, G4ThreeVector &gxx)
virtual G4double DistanceToOut(const G4ThreeVector &gp, const G4ThreeVector &gv, G4ThreeVector &gxxbest)
virtual G4ThreeVector GetNormal(const G4ThreeVector &xx, G4bool isGlobal)=0
static G4int GetNumberOfRotationSteps()