Garfield++ 5.0
A toolkit for the detailed simulation of particle detectors based on ionisation measurement in gases and semiconductors
Loading...
Searching...
No Matches
Garfield::SolidTube Class Reference

Cylindrical tube. More...

#include <SolidTube.hh>

+ Inheritance diagram for Garfield::SolidTube:

Public Member Functions

 SolidTube (const double cx, const double cy, const double cz, const double r, const double lz)
 Constructor from centre, outer radius, and half-length.
 
 SolidTube (const double cx, const double cy, const double cz, const double r, const double lz, const double dx, const double dy, const double dz)
 Constructor from centre, outer radius, half-length and orientation.
 
 SolidTube (const double cx, const double cy, const double cz, const double ri, const double ro, const double lz)
 Constructor from centre, inner radius, outer radius, and half-length.
 
 SolidTube (const double cx, const double cy, const double cz, const double ri, const double ro, const double lz, const double dx, const double dy, const double dz)
 
 ~SolidTube ()
 Destructor.
 
bool IsInside (const double x, const double y, const double z, const bool tesselated) const override
 
bool GetBoundingBox (double &xmin, double &ymin, double &zmin, double &xmax, double &ymax, double &zmax) const override
 Return the bounding box of the solid.
 
bool IsTube () const override
 Return true if the solid is a tube.
 
void SetHalfLength (const double lz)
 Set the half-length of the tube.
 
void SetRadius (const double r)
 Set the outer radius.
 
double GetHalfLengthZ () const override
 Retrieve the half-length of the tube.
 
double GetRadius () const override
 Retrieve the outer radius.
 
double GetOuterRadius () const override
 Retrieve the outer radius.
 
double GetInnerRadius () const override
 Retrieve the inner radius.
 
void SetSectors (const unsigned int n)
 
void SetRotation (const double angle)
 
void SetAverageRadius (const bool average)
 
void SetTopLid (const bool closed)
 Request the cylinder to be closed with a (polygonal) lid at +z.
 
void SetBottomLid (const bool closed)
 Request the cylinder to be closed with a (polygonal) lid at -z.
 
unsigned int GetSectors () const
 Return the number of sectors.
 
double GetRotation () const
 Return the current rotation angle.
 
bool GetAverage () const
 Return the status of the "average-radius" flag.
 
bool SolidPanels (std::vector< Panel > &panels) override
 Retrieve the surface panels of the solid.
 
void SetDiscretisationLevel (const double dis) override
 Set the discretisation level (for all panels).
 
double GetDiscretisationLevel (const Panel &panel) override
 Retrieve the discretisation level of a panel.
 
void Cut (const double x0, const double y0, const double z0, const double xn, const double yn, const double zn, std::vector< Panel > &panels) override
 
- Public Member Functions inherited from Garfield::Solid
 Solid ()=delete
 Default constructor.
 
 Solid (const double cx, const double cy, const double cz, const std::string &name)
 Constructor.
 
virtual ~Solid ()
 Destructor.
 
virtual bool IsBox () const
 Return true if the solid is a box.
 
virtual bool IsSphere () const
 Return true if the solid is a sphere.
 
virtual bool IsHole () const
 Return true if the solid is a hole.
 
virtual bool IsRidge () const
 Return true if the solid is a ridge.
 
virtual bool IsExtrusion () const
 Return true if the solid is an extrusion.
 
virtual bool IsWire () const
 Return true if the solid is a wire.
 
void SetLabel (const std::string &label)
 Set a label.
 
std::string GetLabel () const
 Return the label.
 
bool GetCentre (double &x, double &y, double &z) const
 Retrieve the centre point of the solid.
 
bool GetDirection (double &dx, double &dy, double &dz) const
 Retrieve the direction vector.
 
bool GetOrientation (double &ctheta, double &stheta, double &cphi, double &sphi) const
 Retrieve the orientation (azimuthal and polar angles) of the solid.
 
virtual double GetHalfLengthX () const
 Return the half-length along x.
 
virtual double GetHalfLengthY () const
 Return the half-length along y.
 
virtual double GetLowerRadius () const
 Return the lower radius (of a hole).
 
virtual double GetUpperRadius () const
 Return the upper radius (of a hole).
 
virtual double GetRidgeOffset () const
 Return the x-offset of a ridge.
 
virtual double GetRidgeHeight () const
 Return the height of a ridge.
 
virtual bool GetProfile (std::vector< double > &xv, std::vector< double > &yv) const
 Get the vertices defining an extrusion.
 
unsigned int GetId () const
 Get the ID of the solid.
 
void SetBoundaryPotential (const double v)
 Apply Dirichlet boundary conditions (fixed voltage).
 
void SetBoundaryChargeDensity (const double q)
 Apply fixed-charge boundary conditions.
 
void SetBoundaryFloat ()
 Make the potential at the surface of the solid floating.
 
void SetBoundaryDielectric ()
 Make the surfaces of the solid dielectric-dielectric interfaces.
 
void SetBoundaryParallelField ()
 
void SetBoundaryPerpendicularField ()
 
BoundaryCondition GetBoundaryConditionType () const
 Retrieve the type of boundary condition.
 
double GetBoundaryPotential () const
 Retrieve the potential.
 
double GetBoundaryChargeDensity () const
 Retrieve the surface charge density.
 
void EnableDebugging (const bool on=true)
 Switch debugging messages on/off.
 
void SetColour (const int col)
 Set the colour of the solid.
 
int GetColour () const
 Get the colour of the solid.
 

Additional Inherited Members

- Public Types inherited from Garfield::Solid
enum  BoundaryCondition {
  Unknown = 0 , Voltage , Charge , Float ,
  Dielectric , DielectricCharge , ParallelField , PerpendicularField
}
 
- Static Public Member Functions inherited from Garfield::Solid
static bool Intersect (const double x1, const double y1, const double z1, const double x2, const double y2, const double z2, const double x0, const double y0, const double z0, const double a, const double b, const double c, double &xc, double &yc, double &zc)
 
- Protected Member Functions inherited from Garfield::Solid
void ToLocal (const double x, const double y, const double z, double &u, double &v, double &w) const
 
void ToGlobal (const double u, const double v, const double w, double &x, double &y, double &z) const
 
void VectorToLocal (const double x, const double y, const double z, double &u, double &v, double &w)
 Transform a vector from global to local coordinates.
 
void SetDirection (const double dx, const double dy, const double dz)
 
- Protected Attributes inherited from Garfield::Solid
double m_cX = 0.
 Centre of the solid.
 
double m_cY = 0.
 
double m_cZ = 0.
 
double m_dX = 0.
 Direction vector.
 
double m_dY = 0.
 
double m_dZ = 1.
 
double m_cPhi = 1.
 Azimuthal angle.
 
double m_sPhi = 0.
 
double m_cTheta = 1.
 Polar angle.
 
double m_sTheta = 0.
 
std::string m_className = "Solid"
 Class name.
 
std::string m_label = ""
 Label.
 
bool m_debug = false
 Debug flag.
 
BoundaryCondition m_bctype = Unknown
 Type of boundary condition.
 
double m_volt = 0.
 Potential at the surface.
 
double m_charge = 0.
 Surface charge density.
 
double m_eps = 0.
 Dielectric constant.
 
int m_colour = -1
 Colour.
 

Detailed Description

Cylindrical tube.

Definition at line 12 of file SolidTube.hh.

Constructor & Destructor Documentation

◆ SolidTube() [1/4]

Garfield::SolidTube::SolidTube ( const double cx,
const double cy,
const double cz,
const double r,
const double lz )

Constructor from centre, outer radius, and half-length.

Definition at line 10 of file SolidTube.cc.

12 : SolidTube(cx, cy, cz, 0., rt, lz) {}
SolidTube(const double cx, const double cy, const double cz, const double r, const double lz)
Constructor from centre, outer radius, and half-length.
Definition SolidTube.cc:10

Referenced by SolidTube(), SolidTube(), and SolidTube().

◆ SolidTube() [2/4]

Garfield::SolidTube::SolidTube ( const double cx,
const double cy,
const double cz,
const double r,
const double lz,
const double dx,
const double dy,
const double dz )

Constructor from centre, outer radius, half-length and orientation.

Definition at line 14 of file SolidTube.cc.

17 : SolidTube(cx, cy, cz, rt, lz) {
18 SetDirection(dx, dy, dz);
19}
void SetDirection(const double dx, const double dy, const double dz)
Definition Solid.cc:12

◆ SolidTube() [3/4]

Garfield::SolidTube::SolidTube ( const double cx,
const double cy,
const double cz,
const double ri,
const double ro,
const double lz )

Constructor from centre, inner radius, outer radius, and half-length.

Definition at line 21 of file SolidTube.cc.

23 : Solid(cx, cy, cz, "SolidTube"),
24 m_rO(ro),
25 m_rI(ri),
26 m_lZ(lz) {
27 UpdatePolygon();
28}
Solid()=delete
Default constructor.

◆ SolidTube() [4/4]

Garfield::SolidTube::SolidTube ( const double cx,
const double cy,
const double cz,
const double ri,
const double ro,
const double lz,
const double dx,
const double dy,
const double dz )

Constructor from centre, inner radius, outer radius, half-length and orientation.

Definition at line 30 of file SolidTube.cc.

33 : SolidTube(cx, cy, cz, ri, ro, lz) {
34 SetDirection(dx, dy, dz);
35}

◆ ~SolidTube()

Garfield::SolidTube::~SolidTube ( )
inline

Destructor.

Definition at line 29 of file SolidTube.hh.

29{}

Member Function Documentation

◆ Cut()

void Garfield::SolidTube::Cut ( const double x0,
const double y0,
const double z0,
const double xn,
const double yn,
const double zn,
std::vector< Panel > & panels )
overridevirtual

Implements Garfield::Solid.

Definition at line 363 of file SolidTube.cc.

365 {
366
367 // -----------------------------------------------------------------------
368 // PLACYC - Cuts cylinder with a plane.
369 // -----------------------------------------------------------------------
370 std::vector<double> xv;
371 std::vector<double> yv;
372 std::vector<double> zv;
373 double r = m_rpO;
374 const unsigned int nPoints = 4 * (m_n - 1);
375 const double dphi = HalfPi / (m_n - 1.);
376 // Go through the lines of the top and bottom lids.
377 for (const auto zLid : {-m_lZ, +m_lZ}) {
378 double x1, y1, z1;
379 ToGlobal(r * cos(m_rot), r * sin(m_rot), zLid, x1, y1, z1);
380 // Loop over the points.
381 for (unsigned int i = 2; i <= nPoints + 1; ++i) {
382 const double phi = m_rot + (i - 1.) * dphi;
383 double x2, y2, z2;
384 ToGlobal(r * cos(phi), r * sin(phi), zLid, x2, y2, z2);
385 // Cut with the plane.
386 double xc, yc, zc;
387 if (Intersect(x1, y1, z1, x2, y2, z2, x0, y0, z0,
388 xn, yn, zn, xc, yc, zc)) {
389 xv.push_back(xc);
390 yv.push_back(yc);
391 zv.push_back(zc);
392 }
393 // Shift the coordinates.
394 x1 = x2;
395 y1 = y2;
396 z1 = z2;
397 }
398 }
399 // Go through the ribs.
400 for (unsigned int i = 2; i <= nPoints + 1; ++i) {
401 // Bottom and top of the line along the axis of the cylinder.
402 const double phi = m_rot + (i - 1.) * dphi;
403 const double u = r * cos(phi);
404 const double v = r * sin(phi);
405 double x1, y1, z1;
406 ToGlobal(u, v, +m_lZ, x1, y1, z1);
407 double x2, y2, z2;
408 ToGlobal(u, v, -m_lZ, x2, y2, z2);
409 // Cut with the plane.
410 double xc, yc, zc;
411 if (Intersect(x1, y1, z1, x2, y2, z2, x0, y0, z0, xn, yn, zn, xc, yc, zc)) {
412 xv.push_back(xc);
413 yv.push_back(yc);
414 zv.push_back(zc);
415 }
416 }
417 // Get rid of butterflies.
419
420 if (xv.size() >= 3) {
421 Panel panel;
422 panel.a = xn;
423 panel.b = yn;
424 panel.c = zn;
425 panel.xv = xv;
426 panel.yv = yv;
427 panel.zv = zv;
428 panel.colour = m_colour;
429 panel.volume = GetId();
430 panels.push_back(std::move(panel));
431 }
432}
static bool Intersect(const double x1, const double y1, const double z1, const double x2, const double y2, const double z2, const double x0, const double y0, const double z0, const double a, const double b, const double c, double &xc, double &yc, double &zc)
Definition Solid.cc:52
unsigned int GetId() const
Get the ID of the solid.
Definition Solid.hh:137
int m_colour
Colour.
Definition Solid.hh:230
void ToGlobal(const double u, const double v, const double w, double &x, double &y, double &z) const
Definition Solid.hh:246
void EliminateButterflies(std::vector< double > &xp, std::vector< double > &yp, std::vector< double > &zp)
Definition Polygon.cc:355
DoubleAc cos(const DoubleAc &f)
Definition DoubleAc.cpp:432
DoubleAc sin(const DoubleAc &f)
Definition DoubleAc.cpp:384

◆ GetAverage()

bool Garfield::SolidTube::GetAverage ( ) const
inline

Return the status of the "average-radius" flag.

Definition at line 75 of file SolidTube.hh.

75{ return m_average; }

◆ GetBoundingBox()

bool Garfield::SolidTube::GetBoundingBox ( double & xmin,
double & ymin,
double & zmin,
double & xmax,
double & ymax,
double & zmax ) const
overridevirtual

Return the bounding box of the solid.

Implements Garfield::Solid.

Definition at line 94 of file SolidTube.cc.

95 {
96 if (m_cTheta == 1. && m_cPhi == 1.) {
97 xmin = m_cX - m_rO;
98 xmax = m_cX + m_rO;
99 ymin = m_cY - m_rO;
100 ymax = m_cY + m_rO;
101 zmin = m_cZ - m_lZ;
102 zmax = m_cZ + m_lZ;
103 return true;
104 }
105
106 const double dd = sqrt(m_rO * m_rO + m_lZ * m_lZ);
107 xmin = m_cX - dd;
108 xmax = m_cX + dd;
109 ymin = m_cY - dd;
110 ymax = m_cY + dd;
111 zmin = m_cZ - dd;
112 zmax = m_cZ + dd;
113 return true;
114}
double m_cZ
Definition Solid.hh:202
double m_cTheta
Polar angle.
Definition Solid.hh:209
double m_cY
Definition Solid.hh:202
double m_cX
Centre of the solid.
Definition Solid.hh:202
double m_cPhi
Azimuthal angle.
Definition Solid.hh:207
DoubleAc sqrt(const DoubleAc &f)
Definition DoubleAc.cpp:314

◆ GetDiscretisationLevel()

double Garfield::SolidTube::GetDiscretisationLevel ( const Panel & panel)
overridevirtual

Retrieve the discretisation level of a panel.

Implements Garfield::Solid.

Definition at line 349 of file SolidTube.cc.

349 {
350
351 // Transform the normal vector to local coordinates.
352 double u = 0., v = 0., w = 0.;
353 VectorToLocal(panel.a, panel.b, panel.c, u, v, w);
354 // Identify the vector.
355 if (w > std::max(std::abs(u), std::abs(v))) {
356 return m_dis[0];
357 } else if (w < -std::max(std::abs(u), std::abs(v))) {
358 return m_dis[1];
359 }
360 return m_dis[2];
361}
void VectorToLocal(const double x, const double y, const double z, double &u, double &v, double &w)
Transform a vector from global to local coordinates.
Definition Solid.hh:253

◆ GetHalfLengthZ()

double Garfield::SolidTube::GetHalfLengthZ ( ) const
inlineoverridevirtual

Retrieve the half-length of the tube.

Reimplemented from Garfield::Solid.

Definition at line 42 of file SolidTube.hh.

42{ return m_lZ; }

◆ GetInnerRadius()

double Garfield::SolidTube::GetInnerRadius ( ) const
inlineoverridevirtual

Retrieve the inner radius.

Reimplemented from Garfield::Solid.

Definition at line 48 of file SolidTube.hh.

48{ return m_rI; }

◆ GetOuterRadius()

double Garfield::SolidTube::GetOuterRadius ( ) const
inlineoverridevirtual

Retrieve the outer radius.

Reimplemented from Garfield::Solid.

Definition at line 46 of file SolidTube.hh.

46{ return m_rO; }

◆ GetRadius()

double Garfield::SolidTube::GetRadius ( ) const
inlineoverridevirtual

Retrieve the outer radius.

Reimplemented from Garfield::Solid.

Definition at line 44 of file SolidTube.hh.

44{ return m_rO; }

◆ GetRotation()

double Garfield::SolidTube::GetRotation ( ) const
inline

Return the current rotation angle.

Definition at line 73 of file SolidTube.hh.

73{ return m_rot; }

◆ GetSectors()

unsigned int Garfield::SolidTube::GetSectors ( ) const
inline

Return the number of sectors.

Definition at line 71 of file SolidTube.hh.

71{ return m_n; }

◆ IsInside()

bool Garfield::SolidTube::IsInside ( const double x,
const double y,
const double z,
const bool tesselated ) const
overridevirtual

Check whether a given point is inside the solid. If requested, use the tesselated approximation of the solid (if applicable).

Implements Garfield::Solid.

Definition at line 71 of file SolidTube.cc.

72 {
73 // Transform the point to local coordinates.
74 double u = x, v = y, w = z;
75 ToLocal(x, y, z, u, v, w);
76
77 if (fabs(w) > m_lZ) return false;
78
79 const double rho = sqrt(u * u + v * v);
80 if (!tesselated) return (rho <= m_rO && rho >= m_rI);
81
82 if (rho > m_rpO || rho < m_riI) return false;
83 if (rho < m_riO && rho > m_rpI) return true;
84 bool inside = false;
85 bool edge = false;
86 Polygon::Inside(m_xpO, m_ypO, u, v, inside, edge);
87 if (inside && !m_xpI.empty()) {
88 Polygon::Inside(m_xpI, m_ypI, u, v, inside, edge);
89 return !inside;
90 }
91 return inside;
92}
void ToLocal(const double x, const double y, const double z, double &u, double &v, double &w) const
Definition Solid.hh:234
void Inside(const std::vector< double > &xpl, const std::vector< double > &ypl, const double x, const double y, bool &inside, bool &edge)
Definition Polygon.cc:187
DoubleAc fabs(const DoubleAc &f)
Definition DoubleAc.h:615

◆ IsTube()

bool Garfield::SolidTube::IsTube ( ) const
inlineoverridevirtual

Return true if the solid is a tube.

Reimplemented from Garfield::Solid.

Definition at line 35 of file SolidTube.hh.

35{ return true; }

◆ SetAverageRadius()

void Garfield::SolidTube::SetAverageRadius ( const bool average)
inline

By default, the polygon used for approximating the cylinder when calculating surface panels is inscribed in a circle of the specified radius. If the "average-radius" flag is activated, then the radius will be interpreted as the mean radius of the polygon that approximates the cylinder.

Definition at line 64 of file SolidTube.hh.

64{ m_average = average; }

◆ SetBottomLid()

void Garfield::SolidTube::SetBottomLid ( const bool closed)
inline

Request the cylinder to be closed with a (polygonal) lid at -z.

Definition at line 68 of file SolidTube.hh.

68{ m_botlid = closed; }

◆ SetDiscretisationLevel()

void Garfield::SolidTube::SetDiscretisationLevel ( const double dis)
inlineoverridevirtual

Set the discretisation level (for all panels).

Implements Garfield::Solid.

Definition at line 78 of file SolidTube.hh.

78{ m_dis.fill(dis); }

◆ SetHalfLength()

void Garfield::SolidTube::SetHalfLength ( const double lz)

Set the half-length of the tube.

Definition at line 125 of file SolidTube.cc.

125 {
126 if (lz <= 0.) {
127 std::cerr << "SolidTube::SetHalfLength: Half-length must be > 0.\n";
128 return;
129 }
130 m_lZ = lz;
131 UpdatePolygon();
132}

◆ SetRadius()

void Garfield::SolidTube::SetRadius ( const double r)

Set the outer radius.

Definition at line 116 of file SolidTube.cc.

116 {
117 if (r <= 0.) {
118 std::cerr << "SolidTube::SetRadius: Radius must be > 0.\n";
119 return;
120 }
121 m_rO = r;
122 UpdatePolygon();
123}

◆ SetRotation()

void Garfield::SolidTube::SetRotation ( const double angle)
inline

Specify a rotation angle (radian) of the cylinder. Such a rotation is meaningful only if the number of sectors (when approximating the circle with a polygon) has been chosen small.

Definition at line 58 of file SolidTube.hh.

58{ m_rot = angle; }

◆ SetSectors()

void Garfield::SolidTube::SetSectors ( const unsigned int n)

When calculating the surface panels, the cylinder is approximated as a polygon with a finite number of panels. The number of corners of the polygon equals $4(n - 1)$. Thus, $n = 2$ will produce a square, $n = 3$ an octagon etc.

Definition at line 134 of file SolidTube.cc.

134 {
135 if (n < 1) {
136 std::cerr << "SolidTube::SetSectors: Number must be > 0.\n";
137 return;
138 }
139 m_n = n;
140 UpdatePolygon();
141}

◆ SetTopLid()

void Garfield::SolidTube::SetTopLid ( const bool closed)
inline

Request the cylinder to be closed with a (polygonal) lid at +z.

Definition at line 66 of file SolidTube.hh.

66{ m_toplid = closed; }

◆ SolidPanels()

bool Garfield::SolidTube::SolidPanels ( std::vector< Panel > & panels)
overridevirtual

Retrieve the surface panels of the solid.

Implements Garfield::Solid.

Definition at line 143 of file SolidTube.cc.

143 {
144
145 const auto id = GetId();
146 const auto nPanels = panels.size();
147 // Direction vector.
148 const double fnorm = sqrt(m_dX * m_dX + m_dY * m_dY + m_dZ * m_dZ);
149 if (fnorm <= 0) {
150 std::cerr << "SolidTube::SolidPanels:\n"
151 << " Zero norm direction vector; no panels generated.\n";
152 return false;
153 }
154
155 const unsigned int nPoints = 4 * (m_n - 1);
156 // Create the top lid(s).
157 if (m_toplid) {
158 const double a = m_cPhi * m_sTheta;
159 const double b = m_sPhi * m_sTheta;
160 const double c = m_cTheta;
161 if (m_rI > 0.) {
162 double alpha = m_rot;
163 double calpha = cos(alpha);
164 double salpha = sin(alpha);
165 double xv0, yv0, zv0;
166 ToGlobal(m_rpI * calpha, m_rpI * salpha, +m_lZ, xv0, yv0, zv0);
167 double xv1, yv1, zv1;
168 ToGlobal(m_rpO * calpha, m_rpO * salpha, +m_lZ, xv1, yv1, zv1);
169 // Go around the cylinder.
170 for (unsigned int i = 0; i < nPoints; ++i) {
171 alpha += HalfPi / (m_n - 1.);
172 calpha = cos(alpha);
173 salpha = sin(alpha);
174 double xv2, yv2, zv2;
175 ToGlobal(m_rpO * calpha, m_rpO * salpha, +m_lZ, xv2, yv2, zv2);
176 double xv3, yv3, zv3;
177 ToGlobal(m_rpI * calpha, m_rpI * salpha, +m_lZ, xv3, yv3, zv3);
178 std::vector<double> xv = {xv0, xv1, xv2, xv3};
179 std::vector<double> yv = {yv0, yv1, yv2, yv3};
180 std::vector<double> zv = {zv0, zv1, zv2, zv3};
181 Panel panel;
182 panel.a = a;
183 panel.b = b;
184 panel.c = c;
185 panel.xv = xv;
186 panel.yv = yv;
187 panel.zv = zv;
188 panel.colour = m_colour;
189 panel.volume = id;
190 panels.push_back(std::move(panel));
191 // Shift.
192 xv0 = xv3;
193 yv0 = yv3;
194 zv0 = zv3;
195 xv1 = xv2;
196 yv1 = yv2;
197 zv1 = zv2;
198 }
199 } else {
200 std::vector<double> xv;
201 std::vector<double> yv;
202 std::vector<double> zv;
203 const double r = m_rpO;
204 for (unsigned int i = 1; i <= nPoints; i++) {
205 const double alpha = m_rot + HalfPi * (i - 1.) / (m_n - 1.);
206 // Rotate into place.
207 double x, y, z;
208 ToGlobal(r * cos(alpha), r * sin(alpha), m_lZ, x, y, z);
209 xv.push_back(x);
210 yv.push_back(y);
211 zv.push_back(z);
212 }
213 Panel panel;
214 panel.a = a;
215 panel.b = b;
216 panel.c = c;
217 panel.xv = xv;
218 panel.yv = yv;
219 panel.zv = zv;
220 panel.colour = m_colour;
221 panel.volume = id;
222 panels.push_back(std::move(panel));
223 }
224 }
225 // Create the bottom lid(s).
226 if (m_botlid) {
227 const double a = -m_cPhi * m_sTheta;
228 const double b = -m_sPhi * m_sTheta;
229 const double c = -m_cTheta;
230 if (m_rI > 0.) {
231 double alpha = m_rot;
232 double calpha = cos(alpha);
233 double salpha = sin(alpha);
234 double xv0, yv0, zv0;
235 ToGlobal(m_rpI * calpha, m_rpI * salpha, -m_lZ, xv0, yv0, zv0);
236 double xv1, yv1, zv1;
237 ToGlobal(m_rpO * calpha, m_rpO * salpha, -m_lZ, xv1, yv1, zv1);
238 // Go around the cylinder.
239 for (unsigned int i = 0; i < nPoints; ++i) {
240 alpha += HalfPi / (m_n - 1.);
241 calpha = cos(alpha);
242 salpha = sin(alpha);
243 double xv2, yv2, zv2;
244 ToGlobal(m_rpO * calpha, m_rpO * salpha, -m_lZ, xv2, yv2, zv2);
245 double xv3, yv3, zv3;
246 ToGlobal(m_rpI * calpha, m_rpI * salpha, -m_lZ, xv3, yv3, zv3);
247 std::vector<double> xv = {xv0, xv1, xv2, xv3};
248 std::vector<double> yv = {yv0, yv1, yv2, yv3};
249 std::vector<double> zv = {zv0, zv1, zv2, zv3};
250 Panel panel;
251 panel.a = a;
252 panel.b = b;
253 panel.c = c;
254 panel.xv = xv;
255 panel.yv = yv;
256 panel.zv = zv;
257 panel.colour = m_colour;
258 panel.volume = id;
259 panels.push_back(std::move(panel));
260 // Shift.
261 xv0 = xv3;
262 yv0 = yv3;
263 zv0 = zv3;
264 xv1 = xv2;
265 yv1 = yv2;
266 zv1 = zv2;
267 }
268 } else {
269 std::vector<double> xv;
270 std::vector<double> yv;
271 std::vector<double> zv;
272 const double r = m_rpO;
273 for (unsigned int i = 1; i <= nPoints; i++) {
274 const double alpha = m_rot + HalfPi * (i - 1.) / (m_n - 1.);
275 // Rotate into place.
276 double x, y, z;
277 ToGlobal(r * cos(alpha), r * sin(alpha), -m_lZ, x, y, z);
278 xv.push_back(x);
279 yv.push_back(y);
280 zv.push_back(z);
281 }
282 Panel panel;
283 panel.a = a;
284 panel.b = b;
285 panel.c = c;
286 panel.xv = xv;
287 panel.yv = yv;
288 panel.zv = zv;
289 panel.colour = m_colour;
290 panel.volume = id;
291 panels.push_back(std::move(panel));
292 }
293 }
294 // Create the side panels.
295 const unsigned int n = m_rpI > 0. ? 2 : 1;
296 for (unsigned int j = 0; j < n; ++j) {
297 const double r = j == 0 ? m_rpO : m_rpI;
298 double u = r * cos(m_rot);
299 double v = r * sin(m_rot);
300 // Rotate into place.
301 double xv0, yv0, zv0;
302 ToGlobal(u, v, -m_lZ, xv0, yv0, zv0);
303 double xv1, yv1, zv1;
304 ToGlobal(u, v, +m_lZ, xv1, yv1, zv1);
305 // Go around the cylinder.
306 for (unsigned int i = 2; i <= nPoints + 1; i++) {
307 // Bottom and top of the line along the axis of the cylinder.
308 double alpha = m_rot + HalfPi * (i - 1.) / (m_n - 1.);
309 u = r * cos(alpha);
310 v = r * sin(alpha);
311 // Rotate into place.
312 double xv2, yv2, zv2;
313 ToGlobal(u, v, +m_lZ, xv2, yv2, zv2);
314 double xv3, yv3, zv3;
315 ToGlobal(u, v, -m_lZ, xv3, yv3, zv3);
316 // Store the plane.
317 Panel panel;
318 alpha = m_rot + HalfPi * (i - 1.5) / (m_n - 1.);
319 const double cAlpha = cos(alpha);
320 const double sAlpha = sin(alpha);
321 panel.a = m_cPhi * m_cTheta * cAlpha - m_sPhi * sAlpha;
322 panel.b = m_sPhi * m_cTheta * cAlpha + m_cPhi * sAlpha;
323 panel.c = -m_sTheta * cAlpha;
324 if (j == 1) {
325 panel.a *= -1.;
326 panel.b *= -1.;
327 panel.c *= -1.;
328 }
329 panel.xv = {xv0, xv1, xv2, xv3};
330 panel.yv = {yv0, yv1, yv2, yv3};
331 panel.zv = {zv0, zv1, zv2, zv3};
332 panel.colour = m_colour;
333 panel.volume = id;
334 panels.push_back(std::move(panel));
335 // Shift the points.
336 xv0 = xv3;
337 yv0 = yv3;
338 zv0 = zv3;
339 xv1 = xv2;
340 yv1 = yv2;
341 zv1 = zv2;
342 }
343 }
344 std::cout << "SolidTube::SolidPanels: " << panels.size() - nPanels
345 << " panels.\n";
346 return true;
347}
double m_dZ
Definition Solid.hh:205
double m_dX
Direction vector.
Definition Solid.hh:205
double m_sPhi
Definition Solid.hh:207
double m_sTheta
Definition Solid.hh:209
double m_dY
Definition Solid.hh:205

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