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::ViewField Class Reference

Visualize the potential or electric field of a component or sensor. More...

#include <ViewField.hh>

+ Inheritance diagram for Garfield::ViewField:

Public Member Functions

 ViewField ()
 Constructor.
 
 ~ViewField ()=default
 Destructor.
 
void SetSensor (Sensor *s)
 Set the sensor for which to plot the field.
 
void SetComponent (Component *c)
 Set the component for which to plot the field.
 
void SetVoltageRange (const double vmin, const double vmax)
 Set the plot limits for the potential.
 
void SetElectricFieldRange (const double emin, const double emax)
 Set the plot limits for the electric field.
 
void SetWeightingFieldRange (const double wmin, const double wmax)
 Set the plot limits for the weighting field.
 
void SetMagneticFieldRange (const double bmin, const double bmax)
 Set the plot limits for the magnetic field.
 
void SetNumberOfContours (const unsigned int n)
 Set the number of contour levels.
 
void SetNumberOfSamples1d (const unsigned int n)
 Set the number of points used for drawing 1D functions.
 
void SetNumberOfSamples2d (const unsigned int nx, const unsigned int ny)
 Set the number of points used for drawing 2D functions.
 
void PlotContour (const std::string &option="v")
 
void Plot (const std::string &option="v", const std::string &drawopt="arr")
 
void PlotProfile (const double x0, const double y0, const double z0, const double x1, const double y1, const double z1, const std::string &option="v", const bool normalised=true)
 
void PlotContourWeightingField (const std::string &label, const std::string &option)
 
void PlotWeightingField (const std::string &label, const std::string &option, const std::string &drawopt, const double t=0.)
 
void PlotProfileWeightingField (const std::string &label, const double x0, const double y0, const double z0, const double x1, const double y1, const double z1, const std::string &option="v", const bool normalised=true)
 
void EnableAutoRange (const bool on=true, const bool samplePotential=true)
 
void AcknowledgeStatus (const bool on, const double v0=0.)
 
void PlotFieldLines (const std::vector< double > &x0, const std::vector< double > &y0, const std::vector< double > &z0, const bool electron=true, const bool axis=true, const short col=kOrange - 3)
 Draw electric field lines from a set of starting points.
 
bool EqualFluxIntervals (const double x0, const double y0, const double z0, const double x1, const double y1, const double z1, std::vector< double > &xf, std::vector< double > &yf, std::vector< double > &zf, const unsigned int nPoints=20) const
 Generates point along a line, spaced by equal flux intervals.
 
bool FixedFluxIntervals (const double x0, const double y0, const double z0, const double x1, const double y1, const double z1, std::vector< double > &xf, std::vector< double > &yf, std::vector< double > &zf, const double interval=10.) const
 Generate points along a line, spaced by a given flux interval.
 
- Public Member Functions inherited from Garfield::ViewBase
 ViewBase ()=delete
 Default constructor.
 
 ViewBase (const std::string &name)
 Constructor.
 
virtual ~ViewBase ()=default
 Destructor.
 
void SetCanvas (TPad *pad)
 Set the canvas to be painted on.
 
void SetCanvas ()
 Unset an external canvas.
 
TPad * GetCanvas ()
 Retrieve the canvas.
 
void SetArea (const double xmin, const double ymin, const double xmax, const double ymax)
 
virtual void SetArea (const double xmin, const double ymin, const double zmin, const double xmax, const double ymax, const double zmax)
 Set a bounding box (if applicable).
 
void SetArea ()
 
virtual void SetPlane (const double fx, const double fy, const double fz, const double x0, const double y0, const double z0)
 
virtual void SetPlane (const double fx, const double fy, const double fz, const double x0, const double y0, const double z0, const double hx, const double hy, const double hz)
 Set the projection plane specifying a hint for the in-plane x axis.
 
void Rotate (const double angle)
 Rotate the viewing plane (angle in radian).
 
void SetPlaneXY ()
 Set the viewing plane to x-y.
 
void SetPlaneXZ ()
 Set the viewing plane to x-z.
 
void SetPlaneYZ ()
 Set the viewing plane to y-z.
 
void SetPlaneZX ()
 Set the viewing plane to z-x.
 
void SetPlaneZY ()
 Set the viewing plane to z-y.
 
void EnableDebugging (const bool on=true)
 Switch on/off debugging output.
 

Additional Inherited Members

- Static Public Member Functions inherited from Garfield::ViewBase
static std::string FindUnusedFunctionName (const std::string &s)
 Find an unused function name.
 
static std::string FindUnusedHistogramName (const std::string &s)
 Find an unused histogram name.
 
static std::string FindUnusedCanvasName (const std::string &s)
 Find an unused canvas name.
 
- Protected Member Functions inherited from Garfield::ViewBase
void UpdateProjectionMatrix ()
 
template<typename T>
void ToPlane (const T x, const T y, const T z, T &xp, T &yp) const
 
template<typename T>
bool InBox (const std::array< T, 3 > &x) const
 
void Clip (const std::array< float, 3 > &x0, const std::array< float, 3 > &x1, std::array< float, 3 > &xc) const
 
void DrawLine (const std::vector< std::array< float, 3 > > &xl, const short col, const short lw)
 
std::string LabelX ()
 
std::string LabelY ()
 
std::string PlaneDescription ()
 
bool PlotLimits (Sensor *sensor, double &xmin, double &ymin, double &xmax, double &ymax) const
 
bool PlotLimits (Component *cmp, double &xmin, double &ymin, double &xmax, double &ymax) const
 
bool PlotLimitsFromUserBox (double &xmin, double &ymin, double &xmax, double &ymax) const
 
bool PlotLimits (std::array< double, 3 > &bbmin, std::array< double, 3 > &bbmax, double &xmin, double &ymin, double &xmax, double &ymax) const
 
- Static Protected Member Functions inherited from Garfield::ViewBase
static bool RangeSet (TVirtualPad *)
 
static void SetRange (TVirtualPad *pad, const double x0, const double y0, const double x1, const double y1)
 
- Protected Attributes inherited from Garfield::ViewBase
std::string m_className = "ViewBase"
 
bool m_debug = false
 
bool m_userPlotLimits = false
 
double m_xMinPlot = -1.
 
double m_xMaxPlot = 1.
 
double m_yMinPlot = -1.
 
double m_yMaxPlot = 1.
 
bool m_userBox = false
 
double m_xMinBox = -1.
 
double m_xMaxBox = 1.
 
double m_yMinBox = -1.
 
double m_yMaxBox = 1.
 
double m_zMinBox = -1.
 
double m_zMaxBox = 1.
 
std::array< std::array< double, 3 >, 3 > m_proj
 
std::array< double, 4 > m_plane {{0, 0, 1, 0}}
 
std::array< std::array< double, 3 >, 3 > m_prmat
 

Detailed Description

Visualize the potential or electric field of a component or sensor.

Definition at line 15 of file ViewField.hh.

Constructor & Destructor Documentation

◆ ViewField()

Garfield::ViewField::ViewField ( )

Constructor.

Definition at line 71 of file ViewField.cc.

71: ViewBase("ViewField") { }
ViewBase()=delete
Default constructor.

◆ ~ViewField()

Garfield::ViewField::~ViewField ( )
default

Destructor.

Member Function Documentation

◆ AcknowledgeStatus()

void Garfield::ViewField::AcknowledgeStatus ( const bool on,
const double v0 = 0. )
inline

Make use (or not) of the status flag returned by the sensor/component.

Parameters
onTake status flag into account (true) or ignore it (false).
v0Value to be used for regions with status != 0.

Definition at line 115 of file ViewField.hh.

115 {
116 m_useStatus = on;
117 m_vBkg = v0;
118 }

◆ EnableAutoRange()

void Garfield::ViewField::EnableAutoRange ( const bool on = true,
const bool samplePotential = true )
inline

Determine the range of the potential/field automatically (true) or set it explicitly (false).

Definition at line 105 of file ViewField.hh.

106 {
107 m_useAutoRange = on;
108 m_samplePotential = samplePotential;
109 }

◆ EqualFluxIntervals()

bool Garfield::ViewField::EqualFluxIntervals ( const double x0,
const double y0,
const double z0,
const double x1,
const double y1,
const double z1,
std::vector< double > & xf,
std::vector< double > & yf,
std::vector< double > & zf,
const unsigned int nPoints = 20 ) const

Generates point along a line, spaced by equal flux intervals.

Definition at line 736 of file ViewField.cc.

741 {
742
743 if (nPoints < 2) {
744 std::cerr << m_className << "::EqualFluxIntervals:\n"
745 << " Number of flux lines must be > 1.\n";
746 return false;
747 }
748
749 // Set integration intervals.
750 constexpr unsigned int nV = 5;
751 // Compute the inplane vector normal to the track.
752 const double xp = (y1 - y0) * m_plane[2] - (z1 - z0) * m_plane[1];
753 const double yp = (z1 - z0) * m_plane[0] - (x1 - x0) * m_plane[2];
754 const double zp = (x1 - x0) * m_plane[1] - (y1 - y0) * m_plane[0];
755 // Compute the total flux, accepting positive and negative parts.
756 double q = 0.;
757 if (m_component) {
758 q = m_component->IntegrateFluxLine(x0, y0, z0, x1, y1, z1,
759 xp, yp, zp, 20 * nV, 0);
760 } else {
761 q = m_sensor->IntegrateFluxLine(x0, y0, z0, x1, y1, z1,
762 xp, yp, zp, 20 * nV, 0);
763 }
764 const int isign = q > 0 ? +1 : -1;
765 if (m_debug) {
766 std::cout << m_className << "::EqualFluxIntervals:\n";
767 std::printf(" Total flux: %15.e8\n", q);
768 }
769 // Compute the 1-sided flux in a number of steps.
770 double fsum = 0.;
771 unsigned int nOtherSign = 0;
772 double s0 = -1.;
773 double s1 = -1.;
774 constexpr size_t nSteps = 1000;
775 std::array<double, nSteps> sTab;
776 std::array<double, nSteps> fTab;
777 constexpr double ds = 1. / nSteps;
778 const double dx = (x1 - x0) * ds;
779 const double dy = (y1 - y0) * ds;
780 const double dz = (z1 - z0) * ds;
781 for (size_t i = 0; i < nSteps; ++i) {
782 const double x = x0 + i * dx;
783 const double y = y0 + i * dy;
784 const double z = z0 + i * dz;
785 if (m_component) {
786 q = m_component->IntegrateFluxLine(x, y, z, x + dx, y + dy, z + dz,
787 xp, yp, zp, nV, isign);
788 } else {
789 q = m_sensor->IntegrateFluxLine(x, y, z, x + dx, y + dy, z + dz,
790 xp, yp, zp, nV, isign);
791 }
792 sTab[i] = (i + 1) * ds;
793 if (q > 0) {
794 fsum += q;
795 if (s0 < -0.5) s0 = i * ds;
796 s1 = (i + 1) * ds;
797 }
798 if (q < 0) ++nOtherSign;
799 fTab[i] = fsum;
800 }
801 if (m_debug) {
802 std::printf(" Used flux: %15.8e V. Start: %10.3f End: %10.3f\n",
803 fsum, s0, s1);
804 }
805 // Make sure that the sum is positive.
806 if (fsum <= 0) {
807 std::cerr << m_className << "::EqualFluxIntervals:\n"
808 << " 1-Sided flux integral is not > 0.\n";
809 return false;
810 } else if (s0 < -0.5 || s1 < -0.5 || s1 <= s0) {
811 std::cerr << m_className << "::EqualFluxIntervals:\n"
812 << " No flux interval without sign change found.\n";
813 return false;
814 } else if (nOtherSign > 0) {
815 std::cerr << m_className << "::EqualFluxIntervals:\n"
816 << " The flux changes sign over the line.\n";
817 }
818 // Normalise the flux.
819 const double scale = (nPoints - 1) / fsum;
820 for (size_t i = 0; i < nSteps; ++i) fTab[i] *= scale;
821
822 // Compute new cluster position.
823 for (size_t i = 0; i < nPoints; ++i) {
824 double s = std::min(s1, std::max(s0, Interpolate(sTab, fTab, i)));
825 xf.push_back(x0 + s * (x1 - x0));
826 yf.push_back(y0 + s * (y1 - y0));
827 zf.push_back(z0 + s * (z1 - z0));
828 }
829 return true;
830}
std::array< double, 4 > m_plane
Definition ViewBase.hh:103
std::string m_className
Definition ViewBase.hh:82

◆ FixedFluxIntervals()

bool Garfield::ViewField::FixedFluxIntervals ( const double x0,
const double y0,
const double z0,
const double x1,
const double y1,
const double z1,
std::vector< double > & xf,
std::vector< double > & yf,
std::vector< double > & zf,
const double interval = 10. ) const

Generate points along a line, spaced by a given flux interval.

Definition at line 832 of file ViewField.cc.

836 {
837
838 if (interval <= 0.) {
839 std::cerr << m_className << "::FixedFluxIntervals:\n"
840 << " Flux interval must be > 0.\n";
841 return false;
842 }
843
844 // Set integration intervals.
845 constexpr unsigned int nV = 5;
846 // Compute the inplane vector normal to the track.
847 const double xp = (y1 - y0) * m_plane[2] - (z1 - z0) * m_plane[1];
848 const double yp = (z1 - z0) * m_plane[0] - (x1 - x0) * m_plane[2];
849 const double zp = (x1 - x0) * m_plane[1] - (y1 - y0) * m_plane[0];
850 // Compute the total flux, accepting positive and negative parts.
851 double q = 0.;
852 if (m_component) {
853 q = m_component->IntegrateFluxLine(x0, y0, z0, x1, y1, z1,
854 xp, yp, zp, 20 * nV, 0);
855 } else {
856 q = m_sensor->IntegrateFluxLine(x0, y0, z0, x1, y1, z1,
857 xp, yp, zp, 20 * nV, 0);
858 }
859 const int isign = q > 0 ? +1 : -1;
860 if (m_debug) {
861 std::cout << m_className << "::FixedFluxIntervals:\n";
862 std::printf(" Total flux: %15.8e V\n", q);
863 }
864 // Compute the 1-sided flux in a number of steps.
865 double fsum = 0.;
866 unsigned int nOtherSign = 0;
867 double s0 = -1.;
868 constexpr size_t nSteps = 1000;
869 std::array<double, nSteps> sTab;
870 std::array<double, nSteps> fTab;
871 constexpr double ds = 1. / nSteps;
872 const double dx = (x1 - x0) * ds;
873 const double dy = (y1 - y0) * ds;
874 const double dz = (z1 - z0) * ds;
875 for (size_t i = 0; i < nSteps; ++i) {
876 const double x = x0 + i * dx;
877 const double y = y0 + i * dy;
878 const double z = z0 + i * dz;
879 if (m_component) {
880 q = m_component->IntegrateFluxLine(x, y, z, x + dx, y + dy, z + dz,
881 xp, yp, zp, nV, isign);
882 } else {
883 q = m_sensor->IntegrateFluxLine(x, y, z, x + dx, y + dy, z + dz,
884 xp, yp, zp, nV, isign);
885 }
886 sTab[i] = (i + 1) * ds;
887 if (q > 0) {
888 fsum += q;
889 if (s0 < -0.5) s0 = i * ds;
890 }
891 if (q < 0) ++nOtherSign;
892 fTab[i] = fsum;
893 }
894 // Make sure that the sum is positive.
895 if (m_debug) {
896 std::printf(" Used flux: %15.8e V. Start offset: %10.3f\n", fsum, s0);
897 }
898 if (fsum <= 0) {
899 std::cerr << m_className << "::FixedFluxIntervals:\n"
900 << " 1-Sided flux integral is not > 0.\n";
901 return false;
902 } else if (s0 < -0.5) {
903 std::cerr << m_className << "::FixedFluxIntervals:\n"
904 << " No flux interval without sign change found.\n";
905 return false;
906 } else if (nOtherSign > 0) {
907 std::cerr << m_className << "::FixedFluxIntervals:\n"
908 << " Warning: The flux changes sign over the line.\n";
909 }
910
911 double f = 0.;
912 while (f < fsum) {
913 const double s = Interpolate(sTab, fTab, f);
914 f += interval;
915 xf.push_back(x0 + s * (x1 - x0));
916 yf.push_back(y0 + s * (y1 - y0));
917 zf.push_back(z0 + s * (z1 - z0));
918 }
919 return true;
920}

◆ Plot()

void Garfield::ViewField::Plot ( const std::string & option = "v",
const std::string & drawopt = "arr" )

Make a 2D plot of the electric potential, electric field or magnetic field.

Parameters
optionquantity to be plotted (see PlotContour)
drawoptoption string passed to TF2::Draw

Definition at line 133 of file ViewField.cc.

133 {
134 std::string opt1;
135 std::transform(drawopt.begin(), drawopt.end(),
136 std::back_inserter(opt1), toupper);
137 if (opt1.find("CONT") != std::string::npos) {
138 Draw2d(option, true, false, "", drawopt);
139 } else {
140 Draw2d(option, false, false, "", drawopt);
141 }
142}

Referenced by main().

◆ PlotContour()

void Garfield::ViewField::PlotContour ( const std::string & option = "v")

Make a contour plot of the electric potential, electric field, or magnetic field.

Parameters
optionquantity to be plotted
  • potential: "v", "voltage", "p", "potential"
  • magnitude of the electric field: "emag", "field"
  • x-component of the electric field: "ex"
  • y-component of the electric field: "ey"
  • z-component of the electric field: "ez"
  • magnitude of the magnetic field: "bmag"
  • x-component of the magnetic field: "bx"
  • y-component of the magnetic field: "by"
  • z-component of the magnetic field: "bz"

Definition at line 129 of file ViewField.cc.

129 {
130 Draw2d(option, true, false, "", "CONT1Z");
131}

Referenced by main().

◆ PlotContourWeightingField()

void Garfield::ViewField::PlotContourWeightingField ( const std::string & label,
const std::string & option )

Make a contour plot of the weighting potential or field.

Parameters
labelidentifier of the electrode
optionquantity to be plotted (see PlotContour)

Definition at line 156 of file ViewField.cc.

157 {
158 Draw2d(option, true, true, label, "CONT1Z");
159}

◆ PlotFieldLines()

void Garfield::ViewField::PlotFieldLines ( const std::vector< double > & x0,
const std::vector< double > & y0,
const std::vector< double > & z0,
const bool electron = true,
const bool axis = true,
const short col = kOrange - 3 )

Draw electric field lines from a set of starting points.

Definition at line 666 of file ViewField.cc.

670 {
671
672 if (x0.empty() || y0.empty() || z0.empty()) return;
673 const size_t nLines = x0.size();
674 if (y0.size() != nLines || z0.size() != nLines) {
675 std::cerr << m_className << "::PlotLines:\n"
676 << " Mismatch in number of x/y/z coordinates.\n";
677 return;
678 }
679
680 if (!m_sensor && !m_component) {
681 std::cerr << m_className << "::PlotFieldLines:\n"
682 << " Neither sensor nor component are defined.\n";
683 return;
684 }
685
686 auto pad = GetCanvas();
687 pad->cd();
688 pad->SetTitle("Field lines");
689 // Determine the x-y range.
690 const bool rangeSet = RangeSet(pad);
691 if (axis || !rangeSet) {
692 // Determine the plot limits.
693 if (!SetPlotLimits()) {
694 std::cerr << m_className << "::PlotFieldLines:\n"
695 << " Could not determine the plot limits.\n";
696 return;
697 }
698 }
699 if (axis) {
700 auto frame = pad->DrawFrame(m_xMinPlot, m_yMinPlot,
702 frame->GetXaxis()->SetTitle(LabelX().c_str());
703 frame->GetYaxis()->SetTitle(LabelY().c_str());
704 pad->Update();
705 } else if (!rangeSet) {
707 }
708
709 DriftLineRKF drift;
710 Sensor sensor;
711 if (m_sensor) {
712 drift.SetSensor(m_sensor);
713 } else {
714 double xmin = 0., ymin = 0., zmin = 0.;
715 double xmax = 0., ymax = 0., zmax = 0.;
716 if (!m_component->GetBoundingBox(xmin, ymin, zmin, xmax, ymax, zmax)) {
717 if (m_userBox) {
718 sensor.SetArea(m_xMinBox, m_yMinBox, m_zMinBox,
720 }
721 }
722 sensor.AddComponent(m_component);
723 drift.SetSensor(&sensor);
724 }
725 const double lx = 0.01 * fabs(m_xMaxPlot - m_xMinPlot);
726 const double ly = 0.01 * fabs(m_yMaxPlot - m_yMinPlot);
727 drift.SetMaximumStepSize(std::min(lx, ly));
728 for (size_t i = 0; i < nLines; ++i) {
729 std::vector<std::array<float, 3> > xl;
730 if (!drift.FieldLine(x0[i], y0[i], z0[i], xl, electron)) continue;
731 DrawLine(xl, col, 1);
732 }
733 pad->Update();
734}
std::string LabelY()
Definition ViewBase.cc:510
static void SetRange(TVirtualPad *pad, const double x0, const double y0, const double x1, const double y1)
Definition ViewBase.cc:93
std::string LabelX()
Definition ViewBase.cc:447
void DrawLine(const std::vector< std::array< float, 3 > > &xl, const short col, const short lw)
Definition ViewBase.cc:398
TPad * GetCanvas()
Retrieve the canvas.
Definition ViewBase.cc:74
static bool RangeSet(TVirtualPad *)
Definition ViewBase.cc:83
DoubleAc fabs(const DoubleAc &f)
Definition DoubleAc.h:615

◆ PlotProfile()

void Garfield::ViewField::PlotProfile ( const double x0,
const double y0,
const double z0,
const double x1,
const double y1,
const double z1,
const std::string & option = "v",
const bool normalised = true )

Make a 1D plot of the potential or field along a line.

Parameters
x0,y0,z0starting point
x1,y1,z1end point
optionquantity to be plotted (see PlotContour)
normalisedflag whether to use normalised x-axis coordinates

Definition at line 144 of file ViewField.cc.

146 {
147 DrawProfile(x0, y0, z0, x1, y1, z1, option, false, "", normalised);
148}

◆ PlotProfileWeightingField()

void Garfield::ViewField::PlotProfileWeightingField ( const std::string & label,
const double x0,
const double y0,
const double z0,
const double x1,
const double y1,
const double z1,
const std::string & option = "v",
const bool normalised = true )

Make a 1D plot of the weighting potential or field along a line.

Parameters
labelidentifier of the electrode
x0,y0,z0starting point
x1,y1,z1end point
optionquantity to be plotted (see PlotContour)
normalisedflag whether to use normalised x-axis coordinates

Definition at line 161 of file ViewField.cc.

166 {
167 DrawProfile(x0, y0, z0, x1, y1, z1, option, true, label, normalised);
168}

◆ PlotWeightingField()

void Garfield::ViewField::PlotWeightingField ( const std::string & label,
const std::string & option,
const std::string & drawopt,
const double t = 0. )

Make a 2D plot of the weighting potential or field.

Parameters
labelidentifier of the electrode
optionquantity to be plotted (see PlotContour)
drawoptoption string passed to TF2::Draw
ttime slice of dynamic weighting potential [ns].

Definition at line 150 of file ViewField.cc.

152 {
153 Draw2d(option, false, true, label, drawopt, t);
154}

◆ SetComponent()

void Garfield::ViewField::SetComponent ( Component * c)

Set the component for which to plot the field.

Definition at line 82 of file ViewField.cc.

82 {
83 if (!c) {
84 std::cerr << m_className << "::SetComponent: Null pointer.\n";
85 return;
86 }
87 m_component = c;
88 m_sensor = nullptr;
89}

◆ SetElectricFieldRange()

void Garfield::ViewField::SetElectricFieldRange ( const double emin,
const double emax )

Set the plot limits for the electric field.

Definition at line 97 of file ViewField.cc.

97 {
98 m_emin = std::min(emin, emax);
99 m_emax = std::max(emin, emax);
100 m_useAutoRange = false;
101}

◆ SetMagneticFieldRange()

void Garfield::ViewField::SetMagneticFieldRange ( const double bmin,
const double bmax )

Set the plot limits for the magnetic field.

Definition at line 109 of file ViewField.cc.

109 {
110 m_bmin = std::min(bmin, bmax);
111 m_bmax = std::max(bmin, bmax);
112 m_useAutoRange = false;
113}

◆ SetNumberOfContours()

void Garfield::ViewField::SetNumberOfContours ( const unsigned int n)

Set the number of contour levels.

Definition at line 115 of file ViewField.cc.

115 {
116 if (n > 0) m_nContours = n;
117}

Referenced by main().

◆ SetNumberOfSamples1d()

void Garfield::ViewField::SetNumberOfSamples1d ( const unsigned int n)

Set the number of points used for drawing 1D functions.

Definition at line 119 of file ViewField.cc.

119 {
120 m_nSamples1d = std::max(4u, n);
121}

◆ SetNumberOfSamples2d()

void Garfield::ViewField::SetNumberOfSamples2d ( const unsigned int nx,
const unsigned int ny )

Set the number of points used for drawing 2D functions.

Definition at line 123 of file ViewField.cc.

124 {
125 m_nSamples2dX = std::max(4u, nx);
126 m_nSamples2dY = std::max(4u, ny);
127}

Referenced by main().

◆ SetSensor()

void Garfield::ViewField::SetSensor ( Sensor * s)

Set the sensor for which to plot the field.

Definition at line 73 of file ViewField.cc.

73 {
74 if (!s) {
75 std::cerr << m_className << "::SetSensor: Null pointer.\n";
76 return;
77 }
78 m_sensor = s;
79 m_component = nullptr;
80}

Referenced by main().

◆ SetVoltageRange()

void Garfield::ViewField::SetVoltageRange ( const double vmin,
const double vmax )

Set the plot limits for the potential.

Definition at line 91 of file ViewField.cc.

91 {
92 m_vmin = std::min(vmin, vmax);
93 m_vmax = std::max(vmin, vmax);
94 m_useAutoRange = false;
95}

◆ SetWeightingFieldRange()

void Garfield::ViewField::SetWeightingFieldRange ( const double wmin,
const double wmax )

Set the plot limits for the weighting field.

Definition at line 103 of file ViewField.cc.

103 {
104 m_wmin = std::min(wmin, wmax);
105 m_wmax = std::max(wmin, wmax);
106 m_useAutoRange = false;
107}

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