75 fLowerEndcap(nullptr), fUpperEndcap(nullptr), fSide0(nullptr),
76 fSide90(nullptr), fSide180(nullptr), fSide270(nullptr)
96 fDxDown = ( fDx1 > fDx2 ? fDx1 : fDx2 ) ;
97 fDxUp = ( fDx3 > fDx4 ? fDx3 : fDx4 ) ;
98 fDx = ( fDxUp > fDxDown ? fDxUp : fDxDown ) ;
99 fDy = ( fDy1 > fDy2 ? fDy1 : fDy2 ) ;
103 if ( fDx1 != fDx2 && fDx3 != fDx4 )
105 pDytmp = fDy1 * ( fDx3 - fDx4 ) / ( fDx1 - fDx2 ) ;
108 std::ostringstream message;
109 message <<
"Not planar surface in untwisted Trapezoid: "
111 <<
"fDy2 is " << fDy2 <<
" but should be "
113 G4Exception(
"G4VTwistedFaceted::G4VTwistedFaceted()",
"GeomSolids0002",
119 if ( fDx1 == fDx2 && fDx3 == fDx4 )
126 if ( ( fDx1 == fDx2 && fDx3 != fDx4 ) || ( fDx1 != fDx2 && fDx3 == fDx4 ) )
128 std::ostringstream message;
129 message <<
"Not planar surface in untwisted Trapezoid: "
131 <<
"One endcap is rectangular, the other is a trapezoid." <<
G4endl
132 <<
"For planarity reasons they have to be rectangles or trapezoids "
134 G4Exception(
"G4VTwistedFaceted::G4VTwistedFaceted()",
"GeomSolids0002",
140 fPhiTwist = PhiTwist ;
145 fTAlph = std::tan(fAlph) ;
152 fdeltaX = 2 * fDz * std::tan(fTheta) * std::cos(fPhi) ;
156 fdeltaY = 2 * fDz * std::tan(fTheta) * std::sin(fPhi) ;
165 || ( std::fabs(fPhiTwist) <= 2*kAngTolerance )
166 || ( std::fabs(fPhiTwist) >= pi/2 )
167 || ( std::fabs(fAlph) >= pi/2 )
168 || fTheta >= pi/2 || fTheta < 0
171 std::ostringstream message;
172 message <<
"Invalid dimensions. Too small, or twist angle too big: "
174 <<
"fDx 1-4 = " << fDx1/cm <<
", " << fDx2/cm <<
", "
175 << fDx3/cm <<
", " << fDx4/cm <<
" cm" <<
G4endl
176 <<
"fDy 1-2 = " << fDy1/cm <<
", " << fDy2/cm <<
", "
178 <<
"fDz = " << fDz/cm <<
" cm" <<
G4endl
179 <<
" twistangle " << fPhiTwist/deg <<
" deg" <<
G4endl
180 <<
" phi,theta = " << fPhi/deg <<
", " << fTheta/deg <<
" deg";
193 fLowerEndcap(nullptr), fUpperEndcap(nullptr),
194 fSide0(nullptr), fSide90(nullptr), fSide180(nullptr), fSide270(nullptr)
204 delete fLowerEndcap ;
205 delete fUpperEndcap ;
221 fTheta(rhs.fTheta), fPhi(rhs.fPhi),
222 fDy1(rhs.fDy1), fDx1(rhs.fDx1), fDx2(rhs.fDx2), fDy2(rhs.fDy2),
223 fDx3(rhs.fDx3), fDx4(rhs.fDx4), fDz(rhs.fDz), fDx(rhs.fDx), fDy(rhs.fDy),
224 fAlph(rhs.fAlph), fTAlph(rhs.fTAlph), fdeltaX(rhs.fdeltaX),
225 fdeltaY(rhs.fdeltaY), fPhiTwist(rhs.fPhiTwist), fLowerEndcap(nullptr),
226 fUpperEndcap(nullptr), fSide0(nullptr), fSide90(nullptr), fSide180(nullptr), fSide270(nullptr)
239 if (
this == &rhs) {
return *
this; }
247 fTheta = rhs.fTheta; fPhi = rhs.fPhi;
248 fDy1= rhs.fDy1; fDx1= rhs.fDx1; fDx2= rhs.fDx2; fDy2= rhs.fDy2;
249 fDx3= rhs.fDx3; fDx4= rhs.fDx4; fDz= rhs.fDz; fDx= rhs.fDx; fDy= rhs.fDy;
250 fAlph= rhs.fAlph; fTAlph= rhs.fTAlph; fdeltaX= rhs.fdeltaX;
251 fdeltaY= rhs.fdeltaY; fPhiTwist= rhs.fPhiTwist; fLowerEndcap=
nullptr;
252 fUpperEndcap=
nullptr; fSide0=
nullptr; fSide90=
nullptr; fSide180=
nullptr; fSide270=
nullptr;
270 G4Exception(
"G4VTwistedFaceted::ComputeDimensions()",
272 "G4VTwistedFaceted does not support Parameterisation.");
284 G4double tanTheta = std::tan(fTheta);
288 G4double x1 = std::abs(xmid1 + fDx1);
289 G4double x2 = std::abs(xmid1 - fDx1);
290 G4double x3 = std::abs(xmid1 + fDx2);
291 G4double x4 = std::abs(xmid1 - fDx2);
292 G4double xmax1 = std::max(std::max(std::max(x1, x2), x3), x4);
293 G4double rmax1 = std::sqrt(xmax1*xmax1 + fDy1*fDy1);
296 G4double x5 = std::abs(xmid2 + fDx3);
297 G4double x6 = std::abs(xmid2 - fDx3);
298 G4double x7 = std::abs(xmid2 + fDx4);
299 G4double x8 = std::abs(xmid2 - fDx4);
300 G4double xmax2 = std::max(std::max(std::max(x5, x6), x7), x8);
301 G4double rmax2 = std::sqrt(xmax2*xmax2 + fDy2*fDy2);
305 G4double xmin = std::min(-x0 - rmax1, x0 - rmax2);
306 G4double ymin = std::min(-y0 - rmax1, y0 - rmax2);
307 G4double xmax = std::max(-x0 + rmax1, x0 + rmax2);
308 G4double ymax = std::max(-y0 + rmax1, y0 + rmax2);
309 pMin.
set(xmin, ymin,-fDz);
310 pMax.
set(xmax, ymax, fDz);
343 G4double phi = p.
z()/(2*fDz) * fPhiTwist ;
347 G4double px = p.
x() + fdeltaX * ( -phi/fPhiTwist) ;
348 G4double py = p.
y() + fdeltaY * ( -phi/fPhiTwist) ;
351 G4double posx = px * cphi - py * sphi ;
352 G4double posy = px * sphi + py * cphi ;
375 G4cout <<
"phi,theta = " << fPhi <<
" , " << fTheta <<
G4endl ;
440 surfaces[0] = fSide0 ;
441 surfaces[1] = fSide90 ;
442 surfaces[2] = fSide180 ;
443 surfaces[3] = fSide270 ;
444 surfaces[4] = fLowerEndcap;
445 surfaces[5] = fUpperEndcap;
454 if (tmpdistance < distance)
456 distance = tmpdistance;
462 return surfaces[besti]->
GetNormal(bestxx,
true);
510 surfaces[0] = fSide0;
511 surfaces[1] = fSide90 ;
512 surfaces[2] = fSide180 ;
513 surfaces[3] = fSide270 ;
514 surfaces[4] = fLowerEndcap;
515 surfaces[5] = fUpperEndcap;
519 for (
const auto & surface : surfaces)
524 G4double tmpdistance = surface->DistanceToIn(p, v, xx);
526 G4cout <<
"Solid DistanceToIn : distance = " << tmpdistance <<
G4endl ;
529 if (tmpdistance < distance)
531 distance = tmpdistance;
582 surfaces[0] = fSide0;
583 surfaces[1] = fSide90 ;
584 surfaces[2] = fSide180 ;
585 surfaces[3] = fSide270 ;
586 surfaces[4] = fLowerEndcap;
587 surfaces[5] = fUpperEndcap;
591 for (
const auto & surface : surfaces)
593 G4double tmpdistance = surface->DistanceTo(p, xx);
594 if (tmpdistance < distance)
596 distance = tmpdistance;
605 G4Exception(
"G4VTwistedFaceted::DistanceToIn(p)",
"GeomSolids0003",
665 surfaces[0] = fSide0;
666 surfaces[1] = fSide90 ;
667 surfaces[2] = fSide180 ;
668 surfaces[3] = fSide270 ;
669 surfaces[4] = fLowerEndcap;
670 surfaces[5] = fUpperEndcap;
675 for (
auto i=0; i<6 ; ++i)
678 if (tmpdistance < distance)
680 distance = tmpdistance;
690 *norm = (surfaces[besti]->
GetNormal(p,
true));
727 G4cout.precision(oldprc) ;
728 G4Exception(
"G4VTwistedFaceted::DistanceToOut(p)",
"GeomSolids1002",
749 surfaces[0] = fSide0;
750 surfaces[1] = fSide90 ;
751 surfaces[2] = fSide180 ;
752 surfaces[3] = fSide270 ;
753 surfaces[4] = fLowerEndcap;
754 surfaces[5] = fUpperEndcap;
758 for (
const auto & surface : surfaces)
760 G4double tmpdistance = surface->DistanceTo(p, xx);
761 if (tmpdistance < distance)
763 distance = tmpdistance;
773 G4Exception(
"G4VTwistedFaceted::DistanceToOut(p)",
"GeomSolids0003",
791 G4long oldprc = os.precision(16);
792 os <<
"-----------------------------------------------------------\n"
793 <<
" *** Dump for solid - " <<
GetName() <<
" ***\n"
794 <<
" ===================================================\n"
795 <<
" Solid type: G4VTwistedFaceted\n"
797 <<
" polar angle theta = " << fTheta/degree <<
" deg" <<
G4endl
798 <<
" azimuthal angle phi = " << fPhi/degree <<
" deg" <<
G4endl
799 <<
" tilt angle alpha = " << fAlph/degree <<
" deg" <<
G4endl
800 <<
" TWIST angle = " << fPhiTwist/degree <<
" deg" <<
G4endl
801 <<
" Half length along y (lower endcap) = " << fDy1/cm <<
" cm"
803 <<
" Half length along x (lower endcap, bottom) = " << fDx1/cm <<
" cm"
805 <<
" Half length along x (lower endcap, top) = " << fDx2/cm <<
" cm"
807 <<
" Half length along y (upper endcap) = " << fDy2/cm <<
" cm"
809 <<
" Half length along x (upper endcap, bottom) = " << fDx3/cm <<
" cm"
811 <<
" Half length along x (upper endcap, top) = " << fDx4/cm <<
" cm"
813 <<
"-----------------------------------------------------------\n";
814 os.precision(oldprc);
834 G4double maxRad = std::sqrt( fDx*fDx + fDy*fDy);
836 return { -maxRad, maxRad ,
845void G4VTwistedFaceted::CreateSurfaces()
850 if ( fDx1 == fDx2 && fDx3 == fDx4 )
853 fDy1, fDx1, fDx1, fDy2, fDx3, fDx3, fAlph, 0.*deg);
854 fSide180 =
new G4TwistBoxSide(
"180deg", fPhiTwist, fDz, fTheta, fPhi+pi,
855 fDy1, fDx1, fDx1, fDy2, fDx3, fDx3, fAlph, 180.*deg);
859 fSide0 =
new G4TwistTrapAlphaSide(
"0deg" ,fPhiTwist, fDz, fTheta,
860 fPhi, fDy1, fDx1, fDx2, fDy2, fDx3, fDx4, fAlph, 0.*deg);
861 fSide180 =
new G4TwistTrapAlphaSide(
"180deg", fPhiTwist, fDz, fTheta,
862 fPhi+pi, fDy1, fDx2, fDx1, fDy2, fDx4, fDx3, fAlph, 180.*deg);
867 fSide90 =
new G4TwistTrapParallelSide(
"90deg", fPhiTwist, fDz, fTheta,
868 fPhi, fDy1, fDx1, fDx2, fDy2, fDx3, fDx4, fAlph, 0.*deg);
869 fSide270 =
new G4TwistTrapParallelSide(
"270deg", fPhiTwist, fDz, fTheta,
870 fPhi+pi, fDy1, fDx2, fDx1, fDy2, fDx4, fDx3, fAlph, 180.*deg);
874 fUpperEndcap =
new G4TwistTrapFlatSide(
"UpperCap",fPhiTwist, fDx3, fDx4, fDy2,
875 fDz, fAlph, fPhi, fTheta, 1 );
876 fLowerEndcap =
new G4TwistTrapFlatSide(
"LowerCap",fPhiTwist, fDx1, fDx2, fDy1,
877 fDz, fAlph, fPhi, fTheta, -1 );
881 fSide0->SetNeighbours( fSide270 , fLowerEndcap , fSide90 , fUpperEndcap );
882 fSide90->SetNeighbours( fSide0 , fLowerEndcap , fSide180 , fUpperEndcap );
883 fSide180->SetNeighbours(fSide90 , fLowerEndcap , fSide270 , fUpperEndcap );
884 fSide270->SetNeighbours(fSide180 , fLowerEndcap , fSide0 , fUpperEndcap );
885 fUpperEndcap->SetNeighbours( fSide180, fSide270 , fSide0 , fSide90 );
886 fLowerEndcap->SetNeighbours( fSide180, fSide270 , fSide0 , fSide90 );
897 fCubicVolume = ((fDx1 + fDx2 + fDx3 + fDx4)*(fDy1 + fDy2) +
898 (fDx4 + fDx3 - fDx2 - fDx1)*(fDy2 - fDy1)/3)*fDz;
907G4VTwistedFaceted::GetLateralFaceArea(
const G4TwoVector& p1,
912 constexpr G4int NSTEP = 100;
917 G4double hTanTheta = h*std::tan(fTheta);
930 G4double lmax = std::max(std::max(std::abs(x21),std::abs(y21)),
931 std::max(std::abs(x43),std::abs(y43)));
934 std::abs(x21*y43 - y21*x43) < eps)
936 G4double x0 = hTanTheta*std::cos(fPhi);
937 G4double y0 = hTanTheta*std::sin(fPhi);
940 return (
A.cross(B)).mag()*0.5;
945 for (
G4int i = 0; i < NSTEP; ++i)
954 G4double ang = fPhi + fPhiTwist*(0.5 - t);
955 G4double A = fPhiTwist*(II + JJ) + x21*y43 - x43*y21;
956 G4double B = fPhiTwist*(I*(x1 + x31*t) + J*(y1 + y31*t)) +
957 hTanTheta*(I*std::sin(ang) - J*std::cos(ang)) +
968 G4double R1 = std::sqrt(aa + bb + cc);
970 G4double log1 = std::log(std::abs(sqrtAA*R1 + 2.*aa + bb));
971 G4double log0 = std::log(std::abs(sqrtAA*R0 + bb));
973 area += 0.5*R1 + 0.25*bb*invAA*(R1 - R0) + IIJJ*invSqrtAA*(log1 - log0);
994 fSurfaceArea = 2.*(fDy1*(fDx1 + fDx2) + fDy2*(fDx3 + fDx4)) +
995 GetLateralFaceArea(vv[0], vv[1], vv[4], vv[5]) +
996 GetLateralFaceArea(vv[1], vv[3], vv[5], vv[7]) +
997 GetLateralFaceArea(vv[3], vv[2], vv[7], vv[6]) +
998 GetLateralFaceArea(vv[2], vv[0], vv[6], vv[4]);
1008 return {
"G4VTwistedFaceted"};
1019 fpPolyhedron->GetNumberOfRotationStepsAtTimeOfCreation() !=
1043 if ( z == fDz ) z -= 0.1*fDz ;
1044 if ( z == -fDz ) z += 0.1*fDz ;
1046 G4double phi = z/(2*fDz)*fPhiTwist ;
1048 return { fdeltaX * phi/fPhiTwist, fdeltaY * phi/fPhiTwist, z };
1058 G4double phi = G4RandFlat::shoot(-fPhiTwist/2.,fPhiTwist/2.);
1067 G4double a1 = fSide0->GetSurfaceArea();
1068 G4double a2 = fSide90->GetSurfaceArea();
1069 G4double a3 = fSide180->GetSurfaceArea() ;
1070 G4double a4 = fSide270->GetSurfaceArea() ;
1071 G4double a5 = fLowerEndcap->GetSurfaceArea() ;
1072 G4double a6 = fUpperEndcap->GetSurfaceArea() ;
1083 G4double chose = G4RandFlat::shoot(0.,a1 + a2 + a3 + a4 + a5 + a6) ;
1087 umin = fSide0->GetBoundaryMin(phi) ;
1088 umax = fSide0->GetBoundaryMax(phi) ;
1089 u = G4RandFlat::shoot(umin,umax) ;
1091 return fSide0->SurfacePoint(phi, u,
true) ;
1094 else if( (chose >= a1) && (chose < a1 + a2 ) )
1096 umin = fSide90->GetBoundaryMin(phi) ;
1097 umax = fSide90->GetBoundaryMax(phi) ;
1099 u = G4RandFlat::shoot(umin,umax) ;
1101 return fSide90->SurfacePoint(phi, u,
true);
1103 else if( (chose >= a1 + a2 ) && (chose < a1 + a2 + a3 ) )
1105 umin = fSide180->GetBoundaryMin(phi) ;
1106 umax = fSide180->GetBoundaryMax(phi) ;
1107 u = G4RandFlat::shoot(umin,umax) ;
1109 return fSide180->SurfacePoint(phi, u,
true);
1111 else if( (chose >= a1 + a2 + a3 ) && (chose < a1 + a2 + a3 + a4 ) )
1113 umin = fSide270->GetBoundaryMin(phi) ;
1114 umax = fSide270->GetBoundaryMax(phi) ;
1115 u = G4RandFlat::shoot(umin,umax) ;
1116 return fSide270->SurfacePoint(phi, u,
true);
1118 else if( (chose >= a1 + a2 + a3 + a4 ) && (chose < a1 + a2 + a3 + a4 + a5 ) )
1120 y = G4RandFlat::shoot(-fDy1,fDy1) ;
1121 umin = fLowerEndcap->GetBoundaryMin(y) ;
1122 umax = fLowerEndcap->GetBoundaryMax(y) ;
1123 u = G4RandFlat::shoot(umin,umax) ;
1125 return fLowerEndcap->SurfacePoint(u,y,
true);
1129 y = G4RandFlat::shoot(-fDy2,fDy2) ;
1130 umin = fUpperEndcap->GetBoundaryMin(y) ;
1131 umax = fUpperEndcap->GetBoundaryMax(y) ;
1132 u = G4RandFlat::shoot(umin,umax) ;
1134 return fUpperEndcap->SurfacePoint(u,y,
true) ;
1148 std::abs(fPhiTwist) / twopi) + 2;
1151 const G4int nnodes = 4*(k-1)*(n-2) + 2*k*k ;
1152 const G4int nfaces = 4*(k-1)*(n-1) + 2*(k-1)*(k-1) ;
1156 typedef G4int G4int4[4];
1157 auto xyz =
new G4double3[nnodes];
1158 auto faces =
new G4int4[nfaces] ;
1160 fLowerEndcap->GetFacets(k,k,xyz,faces,0) ;
1161 fUpperEndcap->GetFacets(k,k,xyz,faces,1) ;
1162 fSide270->GetFacets(k,n,xyz,faces,2) ;
1163 fSide0->GetFacets(k,n,xyz,faces,3) ;
1164 fSide90->GetFacets(k,n,xyz,faces,4) ;
1165 fSide180->GetFacets(k,n,xyz,faces,5) ;
1167 ph->createPolyhedron(nnodes,nfaces,xyz,faces);
G4TemplateAutoLock< G4Mutex > G4AutoLock
const G4double kCarTolerance
G4double B(G4double temperature)
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
#define G4MUTEX_INITIALIZER
CLHEP::Hep3Vector G4ThreeVector
CLHEP::Hep2Vector G4TwoVector
G4GLOB_DLL std::ostream G4cout
void set(double x, double y, double z)
G4bool CalculateExtent(const EAxis pAxis, const G4VoxelLimits &pVoxelLimits, const G4Transform3D &pTransform3D, G4double &pMin, G4double &pMax) const
static G4GeometryTolerance * GetInstance()
G4double GetAngularTolerance() const
virtual void AddSolid(const G4Box &)=0
G4VSolid(const G4String &name)
G4VSolid & operator=(const G4VSolid &rhs)
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
G4Polyhedron * GetPolyhedron() const override
void DescribeYourselfTo(G4VGraphicsScene &scene) const override
G4ThreeVector GetPointOnSurface() const override
G4VTwistedFaceted & operator=(const G4VTwistedFaceted &rhs)
G4Polyhedron * fpPolyhedron
void BoundingLimits(G4ThreeVector &pMin, G4ThreeVector &pMax) const override
G4double GetCubicVolume() override
G4double DistanceToIn(const G4ThreeVector &p, const G4ThreeVector &v) const override
G4bool fRebuildPolyhedron
G4ThreeVector GetPointInSolid(G4double z) const
EInside Inside(const G4ThreeVector &p) const override
void ComputeDimensions(G4VPVParameterisation *, const G4int, const G4VPhysicalVolume *) override
G4Polyhedron * CreatePolyhedron() const override
std::ostream & StreamInfo(std::ostream &os) const override
G4GeometryType GetEntityType() const override
G4double DistanceToOut(const G4ThreeVector &p, const G4ThreeVector &v, const G4bool calcnorm=false, G4bool *validnorm=nullptr, G4ThreeVector *n=nullptr) const override
~G4VTwistedFaceted() override
G4VTwistedFaceted(const G4String &pname, G4double PhiTwist, G4double pDz, G4double pTheta, G4double pPhi, G4double pDy1, G4double pDx1, G4double pDx2, G4double pDy2, G4double pDx3, G4double pDx4, G4double pAlph)
G4bool CalculateExtent(const EAxis pAxis, const G4VoxelLimits &pVoxelLimit, const G4AffineTransform &pTransform, G4double &pMin, G4double &pMax) const override
G4VisExtent GetExtent() const override
G4ThreeVector SurfaceNormal(const G4ThreeVector &p) const override
G4double GetValueB(G4double phi) const
G4double Xcoef(G4double u, G4double phi, G4double ftg) const
G4double GetSurfaceArea() override
static G4int GetNumberOfRotationSteps()