46#if !defined(G4GEOM_USE_UEXTRUDEDSOLID)
67 const std::vector<G4TwoVector>& polygon,
68 const std::vector<ZSection>& zsections)
71 fNz(zsections.size()),
73 fGeometryType(
"G4ExtrudedSolid"),
82 std::ostringstream message;
83 message <<
"Number of vertices in polygon < 3 - " << pName;
84 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0002",
90 std::ostringstream message;
91 message <<
"Number of z-sides < 2 - " << pName;
92 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0002",
96 for ( std::size_t i=0; i<fNz-1; ++i )
98 if ( zsections[i].fZ > zsections[i+1].fZ )
100 std::ostringstream message;
101 message <<
"Z-sections have to be ordered by z value (z0 < z1 < z2...) - "
103 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0002",
108 std::ostringstream message;
109 message <<
"Z-sections with the same z position are not supported - "
111 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0001",
122 std::vector<G4int> removedVertices;
125 if (!removedVertices.empty())
127 std::size_t nremoved = removedVertices.size();
128 std::ostringstream message;
129 message <<
"The following "<< nremoved
130 <<
" vertices have been removed from polygon in " << pName
131 <<
"\nas collinear or coincident with other vertices: "
132 << removedVertices[0];
133 for (std::size_t i=1; i<nremoved; ++i) message <<
", " << removedVertices[i];
134 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids1001",
138 fNv = fPolygon.size();
141 std::ostringstream message;
142 message <<
"Number of vertices in polygon after removal < 3 - " << pName;
143 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0002",
156 std::reverse(fPolygon.begin(),fPolygon.end());
161 fZSections = zsections;
163 G4bool result = MakeFacets();
166 std::ostringstream message;
167 message <<
"Making facets failed - " << pName;
168 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0003",
173 ComputeProjectionParameters();
178 && (fZSections[0].fScale == 1) && (fZSections[1].fScale == 1)
182 fSolidType = (fIsConvex) ? 1 : 2;
183 ComputeLateralPlanes();
190 const std::vector<G4TwoVector>& polygon,
197 fGeometryType(
"G4ExtrudedSolid")
205 std::ostringstream message;
206 message <<
"Number of vertices in polygon < 3 - " << pName;
207 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0002",
217 std::vector<G4int> removedVertices;
220 if (!removedVertices.empty())
222 std::size_t nremoved = removedVertices.size();
223 std::ostringstream message;
224 message <<
"The following "<< nremoved
225 <<
" vertices have been removed from polygon in " << pName
226 <<
"\nas collinear or coincident with other vertices: "
227 << removedVertices[0];
228 for (std::size_t i=1; i<nremoved; ++i) message <<
", " << removedVertices[i];
229 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids1001",
233 fNv = fPolygon.size();
236 std::ostringstream message;
237 message <<
"Number of vertices in polygon after removal < 3 - " << pName;
238 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0002",
251 std::reverse(fPolygon.begin(),fPolygon.end());
256 fZSections.emplace_back(-dz, off1, scale1);
257 fZSections.emplace_back( dz, off2, scale2);
259 G4bool result = MakeFacets();
262 std::ostringstream message;
263 message <<
"Making facets failed - " << pName;
264 G4Exception(
"G4ExtrudedSolid::G4ExtrudedSolid()",
"GeomSolids0003",
269 ComputeProjectionParameters();
273 if ((scale1 == 1) && (scale2 == 1)
276 fSolidType = (fIsConvex) ? 1 : 2;
277 ComputeLateralPlanes();
300 if (
this == &rhs) {
return *
this; }
308 fNv = rhs.fNv; fNz = rhs.fNz;
309 fPolygon = rhs.fPolygon; fZSections = rhs.fZSections;
310 fTriangles = rhs.fTriangles; fIsConvex = rhs.fIsConvex;
311 fGeometryType = rhs.fGeometryType;
312 fSolidType = rhs.fSolidType; fPlanes = rhs.fPlanes;
313 fLines = rhs.fLines; fLengths = rhs.fLengths;
314 fKScales = rhs.fKScales; fScale0s = rhs.fScale0s;
315 fKOffsets = rhs.fKOffsets; fOffset0s = rhs.fOffset0s;
329void G4ExtrudedSolid::ComputeProjectionParameters()
339 for (std::size_t iz=0; iz<fNz-1; ++iz)
343 G4double scale1 = fZSections[iz].fScale;
344 G4double scale2 = fZSections[iz+1].fScale;
348 G4double kscale = (scale2 - scale1)/(z2 - z1);
349 G4double scale0 = scale2 - kscale*(z2 - z1)/2.0;
353 fKScales.push_back(kscale);
354 fScale0s.push_back(scale0);
355 fKOffsets.push_back(koff);
356 fOffset0s.push_back(off0);
362void G4ExtrudedSolid::ComputeLateralPlanes()
366 std::size_t Nv = fPolygon.size();
368 for (std::size_t i=0, k=Nv-1; i<Nv; k=i++)
370 G4TwoVector norm = (fPolygon[i] - fPolygon[k]).unit();
371 fPlanes[i].a = -norm.
y();
372 fPlanes[i].b = norm.
x();
374 fPlanes[i].d = norm.
y()*fPolygon[i].x() - norm.
x()*fPolygon[i].y();
382 for (std::size_t i=0, k=Nv-1; i<Nv; k=i++)
384 if (fPolygon[k].y() == fPolygon[i].y())
387 fLines[i].m = fPolygon[i].x();
391 G4double ctg = (fPolygon[k].x()-fPolygon[i].x())/(fPolygon[k].y()-fPolygon[i].y());
393 fLines[i].m = fPolygon[i].x() - ctg*fPolygon[i].y();
395 fLengths[i] = (fPolygon[i] - fPolygon[k]).mag();
405 return { fPolygon[ind].x() * fZSections[iz].fScale
406 + fZSections[iz].fOffset.x(),
407 fPolygon[ind].y() * fZSections[iz].fScale
408 + fZSections[iz].fOffset.y(),
425 while ( point.
z() > fZSections[iz+1].fZ && iz < fNz-2 ) { ++iz; }
428 G4double z0 = ( fZSections[iz+1].fZ + fZSections[iz].fZ )/2.0;
430 G4double pscale = fKScales[iz]*(point.
z()-z0) + fScale0s[iz];
431 G4TwoVector poffset = fKOffsets[iz]*(point.
z()-z0) + fOffset0s[iz];
440 return (p2 - poffset)/pscale;
451 if ( l1.
x() == l2.
x() )
466 G4bool squareComp = (dy*dy < (1+slope*slope)
490 return IsSameLine(p, l1, l2);
502 return ( (p1.
x() - l1.
x()) * (l2.
y() - l1.
y())
503 - (l2.
x() - l1.
x()) * (p1.
y() - l1.
y()) )
504 * ( (p2.
x() - l1.
x()) * (l2.
y() - l1.
y())
505 - (l2.
x() - l1.
x()) * (p2.
y() - l1.
y()) ) > 0;
520 if ( ( p.
x() < a.
x() && p.
x() < b.
x() && p.
x() < c.
x() ) ||
521 ( p.
x() > a.
x() && p.
x() > b.
x() && p.
x() > c.
x() ) ||
522 ( p.
y() < a.
y() && p.
y() < b.
y() && p.
y() < c.
y() ) ||
523 ( p.
y() > a.
y() && p.
y() > b.
y() && p.
y() > c.
y() ) )
return false;
526 = IsSameSide(p, a, b, c)
527 && IsSameSide(p, b, a, c)
528 && IsSameSide(p, c, a, b);
531 = IsSameLineSegment(p, a, b)
532 || IsSameLineSegment(p, b, c)
533 || IsSameLineSegment(p, c, a);
535 return inside || onEdge;
550 G4double result = (std::atan2(t1.
y(), t1.
x()) - std::atan2(t2.
y(), t2.
x()));
552 if ( result < 0 ) result += 2*pi;
560G4ExtrudedSolid::MakeDownFacet(
G4int ind1,
G4int ind2,
G4int ind3)
const
565 std::vector<G4ThreeVector> vertices;
573 = (vertices[1]-vertices[0]).cross(vertices[2]-vertices[1]);
575 if ( cross.
z() > 0.0 )
583 vertices[1] = vertices[2];
599 std::vector<G4ThreeVector> vertices;
607 = (vertices[1]-vertices[0]).cross(vertices[2]-vertices[1]);
609 if ( cross.
z() < 0.0 )
617 vertices[1] = vertices[2];
627G4bool G4ExtrudedSolid::AddGeneralPolygonFacets()
631 typedef std::pair < G4TwoVector, G4int > Vertex;
633 static const G4double kAngTolerance =
638 std::vector< Vertex > verticesToBeDone;
641 verticesToBeDone.emplace_back(fPolygon[i], i);
643 std::vector< Vertex > ears;
645 auto c1 = verticesToBeDone.begin();
648 while ( verticesToBeDone.size()>2 )
660 G4double angle = GetAngle(c2->first, c3->first, c1->first);
664 std::size_t counter = 0;
665 while ( angle >= (pi-kAngTolerance) )
674 if ( c3 == verticesToBeDone.end() ) { c3 = verticesToBeDone.begin(); }
680 angle = GetAngle(c2->first, c3->first, c1->first);
687 G4Exception(
"G4ExtrudedSolid::AddGeneralPolygonFacets",
689 "Triangularisation has failed.");
695 for (
auto it=verticesToBeDone.cbegin(); it!=verticesToBeDone.cend(); ++it )
699 if ( it == c1 || it == c2 || it == c3 ) {
continue; }
701 if ( IsPointInside(c1->first, c2->first, c3->first, it->first) )
711 if ( c3 == verticesToBeDone.end() ) { c3 = verticesToBeDone.begin(); }
726 result =
AddFacet( MakeDownFacet(c1->second, c2->second, c3->second) );
727 if ( ! result ) {
return false; }
729 result =
AddFacet( MakeUpFacet(c1->second, c2->second, c3->second) );
730 if ( ! result ) {
return false; }
732 std::vector<G4int> triangle(3);
733 triangle[0] = c1->second;
734 triangle[1] = c2->second;
735 triangle[2] = c3->second;
736 fTriangles.push_back(triangle);
740 verticesToBeDone.erase(c2);
741 c1 = verticesToBeDone.begin();
751G4bool G4ExtrudedSolid::MakeFacets()
763 if ( ! good ) {
return false; }
769 if ( ! good ) {
return false; }
771 std::vector<G4int> triangle(3);
775 fTriangles.push_back(triangle);
783 if ( ! good ) {
return false; }
790 if ( ! good ) {
return false; }
792 std::vector<G4int> triangle1(3);
796 fTriangles.push_back(triangle1);
798 std::vector<G4int> triangle2(3);
802 fTriangles.push_back(triangle2);
806 good = AddGeneralPolygonFacets();
807 if ( ! good ) {
return false; }
816 G4int j = (i+1) % fNv;
820 if ( ! good ) {
return false; }
835 return fGeometryType;
853 G4double dist = std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
856 std::size_t np = fPlanes.size();
857 for (std::size_t i=0; i<np; ++i)
859 G4double dd = fPlanes[i].a*p.
x() + fPlanes[i].b*p.
y() + fPlanes[i].d;
860 if (dd > dist) { dist = dd; }
867 G4double distz = std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
870 G4bool in = PointInPolygon(p);
910 G4int j = (i+1) % fNv;
911 if ( IsSameLineSegment(pscaled, fPolygon[i], fPolygon[j]) )
922 auto it = fTriangles.cbegin();
926 if ( IsPointInside(fPolygon[(*it)[0]], fPolygon[(*it)[1]],
927 fPolygon[(*it)[2]], pscaled) ) { inside =
true; }
929 }
while ( (!inside) && (it != fTriangles.cend()) );
972 for (std::size_t i=0; i<fNv; ++i)
974 G4double dd = fPlanes[i].a*p.
x() + fPlanes[i].b*p.
y() + fPlanes[i].d;
994 for (std::size_t i=0, k=fNv-1; i<fNv; k=i++)
998 G4double u = fPlanes[i].a*iy - fPlanes[i].b*ix;
1001 if (ix*ix + iy*iy > sqrCarToleranceHalf)
continue;
1003 else if (u > fLengths[i])
1007 if (kx*kx + ky*ky > sqrCarToleranceHalf)
continue;
1011 G4double dd = fPlanes[i].a*p.
x() + fPlanes[i].b*p.
y() + fPlanes[i].d;
1012 if (dd*dd > sqrCarToleranceHalf)
continue;
1030 return { nx,ny,nz };
1032 else if (nsurf != 0)
1041 std::ostringstream message;
1042 G4long oldprc = message.precision(16);
1043 message <<
"Point p is not on surface (!?) of solid: "
1045 message <<
"Position:\n";
1046 message <<
" p.x() = " << p.
x()/mm <<
" mm\n";
1047 message <<
" p.y() = " << p.
y()/mm <<
" mm\n";
1048 message <<
" p.z() = " << p.
z()/mm <<
" mm";
1049 G4cout.precision(oldprc) ;
1050 G4Exception(
"G4TesselatedSolid::SurfaceNormal(p)",
"GeomSolids1002",
1054 return ApproxSurfaceNormal(p);
1065 if (fSolidType == 1 || fSolidType == 2)
1069 G4double dz0 = fZSections[0].fZ - p.
z();
1070 G4double dz1 = p.
z() - fZSections[1].fZ;
1076 std::size_t iside = 0;
1078 for (std::size_t i=0, k=fNv-1; i<fNv; k=i++)
1082 G4double u = fPlanes[i].a*iy - fPlanes[i].b*ix;
1086 if (tmp < dd) { dd = tmp; iside = i; }
1088 else if (u > fLengths[i])
1093 if (tmp < dd) { dd = tmp; iside = i; }
1097 G4double tmp = fPlanes[i].a*p.
x() + fPlanes[i].b*p.
y() + fPlanes[i].d;
1099 if (tmp < dd) { dd = tmp; iside = i; }
1112 if (std::max(dz0,dz1) > 0) iregion = 1;
1114 G4bool in = PointInPolygon(p);
1115 if (!in) iregion += 2;
1123 if (ddz0 <= ddz1 && ddz0 <= dd)
return {0, 0,-1};
1124 if (ddz1 <= ddz0 && ddz1 <= dd)
return {0, 0, 1};
1125 return { fPlanes[iside].a, fPlanes[iside].b, 0 };
1129 return { 0, 0, (
G4double)((dz0 > dz1) ? -1 : 1) };
1133 return { fPlanes[iside].a, fPlanes[iside].b, 0 };
1137 G4double dzmax = std::max(dz0,dz1);
1138 if (dzmax*dzmax > dd)
return { 0, 0, (
G4double)((dz0 > dz1) ? -1 : 1) };
1139 return { fPlanes[iside].a, fPlanes[iside].b, 0 };
1152 G4double z1 = fZSections[fNz-1].fZ;
1166 G4double ddz = (invz < 0) ? dz : -dz;
1172 std::size_t np = fPlanes.size();
1173 G4double txmin = tzmin, txmax = tzmax;
1174 for (std::size_t i=0; i<np; ++i)
1176 G4double cosa = fPlanes[i].a*v.
x()+fPlanes[i].b*v.
y();
1177 G4double dist = fPlanes[i].a*p.
x()+fPlanes[i].b*p.
y()+fPlanes[i].d;
1180 if (cosa >= 0) {
return kInfinity; }
1182 if (txmin < tmp) { txmin = tmp; }
1187 if (txmax > tmp) { txmax = tmp; }
1193 G4double tmin = txmin, tmax = txmax;
1215 G4double dist = std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
1216 std::size_t np = fPlanes.size();
1217 for (std::size_t i=0; i<np; ++i)
1219 G4double dd = fPlanes[i].a*p.
x() + fPlanes[i].b*p.
y() + fPlanes[i].d;
1220 if (dd > dist) dist = dd;
1222 return (dist > 0) ? dist : 0.;
1226 G4bool in = PointInPolygon(p);
1229 G4double distz= std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
1230 return (distz > 0) ? distz : 0;
1234 G4double distz= std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
1235 G4double dd = DistanceToPolygonSqr(p);
1236 if (distz > 0) dd += distz*distz;
1237 return std::sqrt(dd);
1254 G4bool getnorm = calcNorm;
1255 if (getnorm) *validNorm =
true;
1258 G4double z1 = fZSections[fNz-1].fZ;
1261 if (getnorm) n->set(0,0,-1);
1266 if (getnorm) n->set(0,0,1);
1281 G4int iside = (vz < 0) ? -4 : -2;
1285 std::size_t np = fPlanes.size();
1286 for (std::size_t i=0; i<np; ++i)
1288 G4double cosa = fPlanes[i].a*v.
x()+fPlanes[i].b*v.
y();
1291 G4double dist = fPlanes[i].a*p.
x()+fPlanes[i].b*p.
y()+fPlanes[i].d;
1294 if (getnorm) n->set(fPlanes[i].a, fPlanes[i].b, fPlanes[i].c);
1298 if (tmax > tmp) { tmax = tmp; iside = (
G4int)i; }
1307 { n->set(0, 0, iside + 3); }
1309 { n->set(fPlanes[iside].a, fPlanes[iside].b, fPlanes[iside].c); }
1323 if (validNorm !=
nullptr) { *validNorm = fIsConvex; }
1336 G4double dist = std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
1337 std::size_t np = fPlanes.size();
1338 for (std::size_t i=0; i<np; ++i)
1340 G4double dd = fPlanes[i].a*p.
x() + fPlanes[i].b*p.
y() + fPlanes[i].d;
1341 if (dd > dist) dist = dd;
1343 return (dist < 0) ? -dist : 0.;
1347 G4double distz = std::max(fZSections[0].fZ-p.
z(),p.
z()-fZSections[1].fZ);
1348 G4bool in = PointInPolygon(p);
1349 if (distz >= 0 || (!in))
return 0;
1350 return std::min(-distz,std::sqrt(DistanceToPolygonSqr(p)));
1364 G4double xmin0 = kInfinity, xmax0 = -kInfinity;
1365 G4double ymin0 = kInfinity, ymax0 = -kInfinity;
1370 if (x < xmin0) xmin0 = x;
1371 if (x > xmax0) xmax0 = x;
1373 if (y < ymin0) ymin0 = y;
1374 if (y > ymax0) ymax0 = y;
1377 G4double xmin = kInfinity, xmax = -kInfinity;
1378 G4double ymin = kInfinity, ymax = -kInfinity;
1381 for (
G4int i=0; i<nsect; ++i)
1387 xmin = std::min(xmin,xmin0*scale+dx);
1388 xmax = std::max(xmax,xmax0*scale+dx);
1389 ymin = std::min(ymin,ymin0*scale+dy);
1390 ymax = std::max(ymax,ymax0*scale+dy);
1396 pMin.
set(xmin,ymin,zmin);
1397 pMax.
set(xmax,ymax,zmax);
1401 if (pMin.
x() >= pMax.
x() || pMin.
y() >= pMax.
y() || pMin.
z() >= pMax.
z())
1403 std::ostringstream message;
1404 message <<
"Bad bounding box (min >= max) for solid: "
1406 <<
"\npMin = " << pMin
1407 <<
"\npMax = " << pMax;
1435 return exist = pMin < pMax;
1449 std::ostringstream message;
1450 message <<
"Triangulation of the base polygon has failed for solid: "
1452 <<
"\nExtent has been calculated using boundary box";
1460 std::vector<const G4ThreeVectorList *> polygons;
1461 polygons.resize(nsect);
1468 for (
G4int i=0; i<ntria; ++i)
1471 for (
G4int k=0; k<nsect; ++k)
1480 auto iter = ptr->begin();
1481 G4double x0 = triangles[i3+0].x()*scale+dx;
1482 G4double y0 = triangles[i3+0].y()*scale+dy;
1485 G4double x1 = triangles[i3+1].x()*scale+dx;
1486 G4double y1 = triangles[i3+1].y()*scale+dy;
1489 G4double x2 = triangles[i3+2].x()*scale+dx;
1490 G4double y2 = triangles[i3+2].y()*scale+dy;
1497 if (!benv.
CalculateExtent(pAxis,pVoxelLimit,pTransform,emin,emax))
continue;
1498 if (emin < pMin) pMin = emin;
1499 if (emax > pMax) pMax = emax;
1500 if (eminlim > pMin && emaxlim < pMax)
break;
1503 for (
G4int k=0; k<nsect; ++k) {
delete polygons[k]; polygons[k]=
nullptr;}
1504 return (pMin < pMax);
1511 G4long oldprc = os.precision(16);
1512 os <<
"-----------------------------------------------------------\n"
1513 <<
" *** Dump for solid - " <<
GetName() <<
" ***\n"
1514 <<
" ===================================================\n"
1515 <<
" Solid geometry type: " << fGeometryType <<
G4endl;
1518 { os <<
" Convex polygon; list of vertices:" <<
G4endl; }
1520 { os <<
" Concave polygon; list of vertices:" <<
G4endl; }
1522 for ( std::size_t i=0; i<fNv; ++i )
1524 os << std::setw(5) <<
"#" << i
1525 <<
" vx = " << fPolygon[i].x()/mm <<
" mm"
1526 <<
" vy = " << fPolygon[i].y()/mm <<
" mm" <<
G4endl;
1529 os <<
" Sections:" <<
G4endl;
1530 for ( std::size_t iz=0; iz<fNz; ++iz )
1532 os <<
" z = " << fZSections[iz].fZ/mm <<
" mm "
1533 <<
" x0= " << fZSections[iz].fOffset.x()/mm <<
" mm "
1534 <<
" y0= " << fZSections[iz].fOffset.y()/mm <<
" mm "
1535 <<
" scale= " << fZSections[iz].fScale <<
G4endl;
1554 os.precision(oldprc);
std::vector< G4ThreeVector > G4ThreeVectorList
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
CLHEP::Hep3Vector G4ThreeVector
CLHEP::Hep2Vector G4TwoVector
G4GLOB_DLL std::ostream G4cout
void set(double x, double y, double z)
G4bool BoundingBoxVsVoxelLimits(const EAxis pAxis, const G4VoxelLimits &pVoxelLimits, const G4Transform3D &pTransform3D, G4double &pMin, G4double &pMax) const
G4bool CalculateExtent(const EAxis pAxis, const G4VoxelLimits &pVoxelLimits, const G4Transform3D &pTransform3D, G4double &pMin, G4double &pMax) const
G4bool CalculateExtent(const EAxis pAxis, const G4VoxelLimits &pVoxelLimit, const G4AffineTransform &pTransform, G4double &pMin, G4double &pMax) const override
G4GeometryType GetEntityType() const override
G4ExtrudedSolid & operator=(const G4ExtrudedSolid &rhs)
void BoundingLimits(G4ThreeVector &pMin, G4ThreeVector &pMax) const override
G4ThreeVector SurfaceNormal(const G4ThreeVector &p) const override
~G4ExtrudedSolid() override
G4double DistanceToIn(const G4ThreeVector &p, const G4ThreeVector &v) const override
EInside Inside(const G4ThreeVector &p) const override
ZSection GetZSection(G4int index) const
G4int GetNofZSections() const
G4int GetNofVertices() const
G4VSolid * Clone() const override
G4TwoVector GetVertex(G4int index) const
G4ExtrudedSolid(const G4String &pName, const std::vector< G4TwoVector > &polygon, const std::vector< ZSection > &zsections)
std::ostream & StreamInfo(std::ostream &os) const override
G4double DistanceToOut(const G4ThreeVector &p, const G4ThreeVector &v, const G4bool calcNorm=false, G4bool *validNorm=nullptr, G4ThreeVector *n=nullptr) const override
static G4GeometryTolerance * GetInstance()
G4double GetAngularTolerance() const
G4double GetMinYExtent() const
G4double GetMinZExtent() const
G4TessellatedSolid & operator=(const G4TessellatedSolid &right)
G4double kCarToleranceHalf
G4bool AddFacet(G4VFacet *aFacet)
G4double DistanceToOut(const G4ThreeVector &p) const override
G4double GetMaxYExtent() const
G4double GetMaxZExtent() const
G4double GetMaxXExtent() const
G4double GetMinXExtent() const
void SetSolidClosed(const G4bool t)
G4ThreeVector SurfaceNormal(const G4ThreeVector &p) const override
G4double DistanceToIn(const G4ThreeVector &p, const G4ThreeVector &v) const override
G4double GetMinExtent(const EAxis pAxis) const
G4double GetMaxExtent(const EAxis pAxis) const