Jpp
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Public Member Functions | Public Attributes | Protected Attributes | List of all members
JPHYSICS::JLED_C Class Referenceabstract

Probability Density Functions of the time response of a PMT (C-like interface) More...

#include <JLED.hh>

Inheritance diagram for JPHYSICS::JLED_C:
JPHYSICS::JLED JPHYSICS::JDispersion JPHYSICS::JDispersionInterface JPHYSICS::JAbstractPMT JPHYSICS::JAbstractLED JPHYSICS::JAbstractMedium JPHYSICS::JDispersionInterface

Public Member Functions

 JLED_C (const double Area, const JAbstractLED *LED, double(*QE)(const double), double(*Pmt)(const double), const double L_abs, const double L_s, double(*Km3)(const double), const double P_atm, const double wavelength, const double Tmin_ns, const double Tmax_ns, const JQuadrature &engine=JCotangent(20), const int numberOfPoints=20, const double epsilon=1e-12)
 Constructor. More...
 
virtual double getLightFromLED (const double ct, const double phi, const double dt) const
 Light yield from LED (number of p.e. More...
 
virtual double getPhotocathodeArea () const
 Photo-cathode area of PMT. More...
 
virtual double getQE (const double lambda) const
 Quantum efficiency of PMT (incl. More...
 
virtual double getAngularAcceptance (const double ct) const
 Angular acceptence of PMT (normalised to one at cos() = -1). More...
 
virtual double getAbsorptionLength (const double lambda) const
 Absorption length. More...
 
virtual double getScatteringLength (const double lambda) const
 Scattering length. More...
 
virtual double getScatteringProbability (const double ct) const
 Model specific function to describe light scattering in water (integral over full solid angle normalised to one). More...
 
double getDirectLightFromLED (const double D_m, const double cd, const double theta, const double phi, const double t_ns) const
 Probability density function for direct light from LED. More...
 
double getScatteredLightFromLED (const double D_m, const double cd, const double theta, const double phi, const double t_ns) const
 Probability density function for scattered light from LED. More...
 
virtual double getIndexOfRefractionPhase (const double lambda) const =0
 Index of refraction for phase velocity. More...
 
virtual double getDispersionPhase (const double lambda) const =0
 Dispersion of light for phase velocity. More...
 
virtual double getIndexOfRefractionGroup (const double lambda) const
 Index of refraction for group velocity. More...
 
virtual double getDispersionGroup (const double lambda) const =0
 Dispersion of light for group velocity. More...
 
double getKappa (const double lambda) const
 Get effective index of refraction for muon light. More...
 
double getKmin (const double lambda) const
 Get smallest index of refraction for Bremsstrahlung light (i.e. More...
 
virtual double getIndexOfRefractionPhase (const double lambda) const
 Index of refraction (phase velocity). More...
 
virtual double getDispersionPhase (const double lambda) const
 Dispersion of light for phase velocity. More...
 
virtual double getDispersionGroup (const double lambda) const
 Dispersion of light for group velocity. More...
 

Public Attributes

const double P
 Dispersion parameters (x = 1/lambda) More...
 
const double a0
 offset More...
 
const double a1
 dn/dP More...
 
const double a2
 d^1n/(dx)^1 More...
 
const double a3
 d^2n/(dx)^2 More...
 
const double a4
 d^3n/(dx)^3 More...
 

Protected Attributes

const double A
 photo-cathode area [m2] More...
 
const JAbstractLEDled
 Pointer to interface for emission profile from LED. More...
 
double(* qe )(const double lambda)
 Quantum efficiency of PMT (incl. More...
 
double l_abs
 Absorption length. More...
 
double ls
 Scattering length. More...
 
double(* pmt )(const double ct)
 Angular acceptence of PMT (normalised to one at cos() = -1) More...
 
double(* km3 )(const double ct)
 Model specific function to describe light scattering in water. More...
 
double wavelength
 
double tmin
 
double tmax
 
JQuadrature main_engine
 
JQuadrature beta_engine
 
std::vector< JElement3D_tphi_engine
 

Detailed Description

Probability Density Functions of the time response of a PMT (C-like interface)

Definition at line 278 of file JLED.hh.

Constructor & Destructor Documentation

JPHYSICS::JLED_C::JLED_C ( const double  Area,
const JAbstractLED LED,
double(*)(const double)  QE,
double(*)(const double)  Pmt,
const double  L_abs,
const double  L_s,
double(*)(const double)  Km3,
const double  P_atm,
const double  wavelength,
const double  Tmin_ns,
const double  Tmax_ns,
const JQuadrature engine = JCotangent(20),
const int  numberOfPoints = 20,
const double  epsilon = 1e-12 
)
inline

Constructor.

Parameters
Areaphoto-cathode area [m^2]
LEDpointer to interface for emission profile from LED
QEpointer to function for quantum efficiency of PMT
Pmtpointer to function for angular acceptence of PMT
L_absabsorption length [m]
L_sscattering length [m]
Km3pointer to model specific function to describe light scattering in water
P_atmambient pressure [atm]
wavelengthwavelength of light [nm]
Tmin_nsminimal time of emmision [ns]
Tmax_nsminimal time of emmision [ns]
enginescattering angle integrator
numberOfPointsnumber of points for integration
epsilonprecision of points for integration

Definition at line 301 of file JLED.hh.

320  :
321  JLED(wavelength, Tmin_ns, Tmax_ns, engine, numberOfPoints, epsilon),
322  JDispersion(P_atm),
323  A (Area ),
324  led (LED ),
325  qe (QE ),
326  l_abs(L_abs),
327  ls (L_s ),
328  pmt (Pmt ),
329  km3 (Km3 )
330  {}
const JAbstractLED * led
Pointer to interface for emission profile from LED.
Definition: JLED.hh:429
double l_abs
Absorption length.
Definition: JLED.hh:442
double(* km3)(const double ct)
Model specific function to describe light scattering in water.
Definition: JLED.hh:463
JDispersion(const double P_atm)
Constructor.
Definition: JDispersion.hh:35
double ls
Scattering length.
Definition: JLED.hh:447
double(* pmt)(const double ct)
Angular acceptence of PMT (normalised to one at cos() = -1)
Definition: JLED.hh:455
const double A
photo-cathode area [m2]
Definition: JLED.hh:424
int numberOfPoints
Definition: JResultPDF.cc:22
double(* qe)(const double lambda)
Quantum efficiency of PMT (incl.
Definition: JLED.hh:437
JLED(const double lambda, const double Tmin_ns, const double Tmax_ns, const JQuadrature &engine=JCotangent(20), const int numberOfPoints=20, const double epsilon=1e-12)
Constructor.
Definition: JLED.hh:77
double wavelength
Definition: JLED.hh:264

Member Function Documentation

virtual double JPHYSICS::JLED_C::getLightFromLED ( const double  ct,
const double  phi,
const double  dt 
) const
inlinevirtual

Light yield from LED (number of p.e.

per unit solid angle per unit time).

Parameters
ctzenith angle of emission
phiazimuth angle of emission
dttime of emission [ns]
Returns
d^2P / dOmega dt [npe/ns/sr]

Implements JPHYSICS::JAbstractLED.

Definition at line 341 of file JLED.hh.

344  {
345  return led->getLightFromLED(ct, phi, dt);
346  }
const JAbstractLED * led
Pointer to interface for emission profile from LED.
Definition: JLED.hh:429
virtual double getLightFromLED(const double ct, const double phi, const double dt) const =0
Light yield from LED (number of p.e.
virtual double JPHYSICS::JLED_C::getPhotocathodeArea ( ) const
inlinevirtual

Photo-cathode area of PMT.

Returns
photo-cathode area [m^2]

Implements JPHYSICS::JAbstractPMT.

Definition at line 354 of file JLED.hh.

355  {
356  return A;
357  }
const double A
photo-cathode area [m2]
Definition: JLED.hh:424
virtual double JPHYSICS::JLED_C::getQE ( const double  lambda) const
inlinevirtual

Quantum efficiency of PMT (incl.

absorption in glass, gel, etc.).

Parameters
lambdawavelenth [nm]
Returns
QE

Implements JPHYSICS::JAbstractPMT.

Definition at line 366 of file JLED.hh.

367  {
368  return qe(lambda);
369  }
double(* qe)(const double lambda)
Quantum efficiency of PMT (incl.
Definition: JLED.hh:437
virtual double JPHYSICS::JLED_C::getAngularAcceptance ( const double  ct) const
inlinevirtual

Angular acceptence of PMT (normalised to one at cos() = -1).

Parameters
ctcosine angle of incidence
Returns
relative efficiency

Implements JPHYSICS::JAbstractPMT.

Definition at line 378 of file JLED.hh.

379  {
380  return pmt(ct);
381  }
double(* pmt)(const double ct)
Angular acceptence of PMT (normalised to one at cos() = -1)
Definition: JLED.hh:455
virtual double JPHYSICS::JLED_C::getAbsorptionLength ( const double  lambda) const
inlinevirtual

Absorption length.

Parameters
lambdawavelenth [nm]
Returns
absorption length [m]

Implements JPHYSICS::JAbstractMedium.

Definition at line 390 of file JLED.hh.

391  {
392  return l_abs;
393  }
double l_abs
Absorption length.
Definition: JLED.hh:442
virtual double JPHYSICS::JLED_C::getScatteringLength ( const double  lambda) const
inlinevirtual

Scattering length.

Parameters
lambdawavelenth [nm]
Returns
scattering length [m]

Implements JPHYSICS::JAbstractMedium.

Definition at line 402 of file JLED.hh.

403  {
404  return ls;
405  }
double ls
Scattering length.
Definition: JLED.hh:447
virtual double JPHYSICS::JLED_C::getScatteringProbability ( const double  ct) const
inlinevirtual

Model specific function to describe light scattering in water (integral over full solid angle normalised to one).

Parameters
ctcosine scattering angle
Returns
probability

Implements JPHYSICS::JAbstractMedium.

Definition at line 415 of file JLED.hh.

416  {
417  return km3(ct);
418  }
double(* km3)(const double ct)
Model specific function to describe light scattering in water.
Definition: JLED.hh:463
double JPHYSICS::JLED::getDirectLightFromLED ( const double  D_m,
const double  cd,
const double  theta,
const double  phi,
const double  t_ns 
) const
inlineinherited

Probability density function for direct light from LED.

Parameters
D_mdistance between LED and PMT [m]
cdcosine angle LED orientation and LED - PMT position
thetazenith angle orientation PMT
phiazimuth angle orientation PMT
t_nstime difference relative to direct light [ns]
Returns
dP/dt [npe/ns]

Definition at line 109 of file JLED.hh.

114  {
115  const double sd = sqrt((1.0 + cd)*(1.0 - cd));
116  const double d = D_m; // photon path [m]
117 
118  const double A = getPhotocathodeArea();
119 
120  const double px = sin(theta)*cos(phi);
121  //const double py = sin(theta)*sin(phi);
122  const double pz = cos(theta);
123 
124  const double ct = sd*px + cd*pz; // cosine angle of incidence on PMT
125 
126  const double qe = getQE(wavelength);
127  const double l_abs = getAbsorptionLength(wavelength);
128  const double ls = getScatteringLength(wavelength);
129 
130  const double U = getAngularAcceptance(ct);
131  const double V = exp(-d/l_abs) * exp(-d/ls); // absorption & scattering
132  const double W = A/(d*d); // solid angle
133 
134  return qe * getLightFromLED(cd, 0.0, t_ns) * U * V * W;
135  }
virtual double getScatteringLength(const double lambda) const =0
Scattering length.
virtual double getAbsorptionLength(const double lambda) const =0
Absorption length.
virtual double getPhotocathodeArea() const =0
Photo-cathode area of PMT.
virtual double getAngularAcceptance(const double ct) const =0
Angular acceptence of PMT.
virtual double getLightFromLED(const double ct, const double phi, const double dt) const =0
Light yield from LED (number of p.e.
virtual double getQE(const double lambda) const =0
Quantum efficiency of PMT (incl.
double wavelength
Definition: JLED.hh:264
double JPHYSICS::JLED::getScatteredLightFromLED ( const double  D_m,
const double  cd,
const double  theta,
const double  phi,
const double  t_ns 
) const
inlineinherited

Probability density function for scattered light from LED.

Parameters
D_mdistance between LED and PMT [m]
cdcosine angle LED orientation and LED - PMT position
thetazenith angle orientation PMT
phiazimuth angle orientation PMT
t_nstime difference relative to direct light [ns]
Returns
dP/dt [npe/ns]

Definition at line 148 of file JLED.hh.

153  {
154  using namespace std;
155  using JTOOLS::PI;
156  using JTOOLS::C;
157 
158  double value = 0;
159 
160  if (t_ns >= tmin) {
161 
162  const double ng = getIndexOfRefractionGroup(wavelength);
163 
164  const double sd = sqrt((1.0 + cd)*(1.0 - cd));
165  const double l = D_m; // distance [m]
166 
167  const double A = getPhotocathodeArea();
168  //const double sr = sqrt(A/PI) / D_m;
169  //const double cr = sqrt((1.0 + sr)*(1.0 - sr));
170 
171  const double px = sin(theta)*cos(phi);
172  const double py = sin(theta)*sin(phi);
173  const double pz = cos(theta);
174 
175  const double qx = cd*px + 0 - sd*pz;
176  const double qy = 1*py;
177  const double qz = sd*px + 0 + cd*pz;
178 
179  const double qe = getQE(wavelength);
180  const double l_abs = getAbsorptionLength(wavelength);
181  const double ls = getScatteringLength(wavelength);
182 
183  const double Jc = 1.0 / ls; // dN/dx
184 
185  const double xmin = tmin;
186  const double xmax = std::min(tmax, t_ns);
187 
188  JQuadrature buffer;
189 
190  if (xmax > xmin) {
191 
192  for (JQuadrature::const_iterator i = main_engine.begin(); i != main_engine.end(); ++i) {
193 
194  const double t = 0.5 * (xmax + xmin) + i->getX() * 0.5 * (xmax - xmin);
195  const double dt = i->getY() * 0.5 * (xmax - xmin);
196 
197  buffer[t] = dt;
198  }
199 
200  } else {
201 
202  buffer[tmin] = 1.0;
203  }
204 
205  for (JQuadrature::const_iterator i = buffer.begin(); i != buffer.end(); ++i) {
206 
207  const double t = i->getX();
208  const double dt = i->getY();
209 
210  const double d = l + C*(t_ns - t)/ng; // photon path
211  const double V = exp(-d/l_abs); // absorption
212 
213  for (JQuadrature::const_iterator j = beta_engine.begin(); j != beta_engine.end(); ++j) {
214 
215  const double cb = j->getX();
216  const double dc = j->getY();
217 
218  const double sb = sqrt((1.0 + cb)*(1.0 - cb));
219 
220  const double v = 0.5 * (d + l) * (d - l) / (d - l*cb);
221  const double u = d - v;
222 
223  if (u <= 0) continue;
224  if (v <= 0) continue;
225 
226  const double cts = (l*cb - v) / u; // cosine scattering angle
227 
228  const double W = min(A/(v*v), 2.0*PI); // solid angle
229  const double Ja = getScatteringProbability(cts); // P(cos(),phi)
230  const double Jd = ng * (1.0 - cts) / C; // dt/du
231 
232  const double ca = (l - v*cb) / u;
233  const double sa = v*sb / u;
234 
235  for (std::vector<JElement3D_t>::const_iterator k = phi_engine.begin(); k != phi_engine.end(); ++k) {
236 
237  const double cp = k->getX();
238  const double sp = k->getY();
239  const double dp = k->getZ();
240 
241  const double dom = dc * dp * v*v / (u*u);
242 
243  const double ct0 = cd*ca - sd*sa*cp;
244  const double ph0 = atan2(sa*sp, cd*sa*cp + sd*ca);
245 
246  const double vx = -sb*cp * qx;
247  const double vy = -sb*sp * qy;
248  const double vz = cb * qz;
249 
250  const double U =
251  getAngularAcceptance(vx + vy + vz) * getLightFromLED(ct0, +ph0, t) +
252  getAngularAcceptance(vx - vy + vz) * getLightFromLED(ct0, -ph0, t);
253 
254  value += qe * dt * dom * Ja * Jc * U * V * W / Jd;
255  }
256  }
257  }
258  }
259 
260  return value;
261  }
double tmin
Definition: JLED.hh:266
JQuadrature main_engine
Definition: JLED.hh:269
double tmax
Definition: JLED.hh:267
static const double PI
Constants.
Definition: JConstants.hh:20
std::vector< JElement3D_t > phi_engine
Definition: JLED.hh:271
virtual double getScatteringLength(const double lambda) const =0
Scattering length.
JQuadrature beta_engine
Definition: JLED.hh:270
virtual double getAbsorptionLength(const double lambda) const =0
Absorption length.
virtual double getPhotocathodeArea() const =0
Photo-cathode area of PMT.
virtual double getIndexOfRefractionGroup(const double lambda) const
Index of refraction for group velocity.
virtual double getAngularAcceptance(const double ct) const =0
Angular acceptence of PMT.
virtual double getLightFromLED(const double ct, const double phi, const double dt) const =0
Light yield from LED (number of p.e.
container_type::const_iterator const_iterator
Definition: JCollection.hh:89
virtual double getQE(const double lambda) const =0
Quantum efficiency of PMT (incl.
static const double C
Speed of light in vacuum [m/ns].
Definition: JConstants.hh:22
virtual double getScatteringProbability(const double ct) const =0
Model specific function to describe light scattering in water (integral over full solid angle normali...
double wavelength
Definition: JLED.hh:264
virtual double JPHYSICS::JDispersionInterface::getIndexOfRefractionPhase ( const double  lambda) const
pure virtualinherited

Index of refraction for phase velocity.

Parameters
lambdawavelenth [nm]
Returns
index of refraction

Implemented in JPHYSICS::JDispersion.

virtual double JPHYSICS::JDispersionInterface::getDispersionPhase ( const double  lambda) const
pure virtualinherited

Dispersion of light for phase velocity.

Parameters
lambdawavelength of light [nm]
Returns
dn/dlambda

Implemented in JPHYSICS::JDispersion.

virtual double JPHYSICS::JDispersionInterface::getIndexOfRefractionGroup ( const double  lambda) const
inlinevirtualinherited

Index of refraction for group velocity.

Parameters
lambdawavelenth [nm]
Returns
index of refraction

Definition at line 52 of file JDispersionInterface.hh.

53  {
54  const double n = getIndexOfRefractionPhase(lambda);
55  const double y = getDispersionPhase(lambda);
56 
57  return n / (1.0 + y*lambda/n);
58  }
virtual double getIndexOfRefractionPhase(const double lambda) const =0
Index of refraction for phase velocity.
virtual double getDispersionPhase(const double lambda) const =0
Dispersion of light for phase velocity.
virtual double JPHYSICS::JDispersionInterface::getDispersionGroup ( const double  lambda) const
pure virtualinherited

Dispersion of light for group velocity.

Parameters
lambdawavelength of light [nm]
Returns
dn/dlambda

Implemented in JPHYSICS::JDispersion.

double JPHYSICS::JDispersionInterface::getKappa ( const double  lambda) const
inlineinherited

Get effective index of refraction for muon light.

Parameters
lambdawavelength of light [nm]
Returns
index of refraction

Definition at line 76 of file JDispersionInterface.hh.

77  {
78  const double n = getIndexOfRefractionPhase(lambda);
79  const double ng = getIndexOfRefractionGroup(lambda);
80 
81  return (ng * n - 1.0) / sqrt(n*n - 1.0);
82  }
virtual double getIndexOfRefractionPhase(const double lambda) const =0
Index of refraction for phase velocity.
virtual double getIndexOfRefractionGroup(const double lambda) const
Index of refraction for group velocity.
double JPHYSICS::JDispersionInterface::getKmin ( const double  lambda) const
inlineinherited

Get smallest index of refraction for Bremsstrahlung light (i.e.

point at which dt/dz = 0).

Parameters
lambdawavelength of light [nm]
Returns
index of refraction

Definition at line 91 of file JDispersionInterface.hh.

92  {
93  const double ng = getIndexOfRefractionGroup(lambda);
94 
95  return sqrt(ng*ng - 1.0);
96  }
virtual double getIndexOfRefractionGroup(const double lambda) const
Index of refraction for group velocity.
virtual double JPHYSICS::JDispersion::getIndexOfRefractionPhase ( const double  lambda) const
inlinevirtualinherited

Index of refraction (phase velocity).

Parameters
lambdawavelenth [nm]
Returns
index of refraction

Implements JPHYSICS::JDispersionInterface.

Definition at line 51 of file JDispersion.hh.

52  {
53  const double x = 1.0 / lambda;
54 
55  return a0 + a1*P + x*(a2 + x*(a3 + x*a4));
56  }
const double a4
d^3n/(dx)^3
Definition: JDispersion.hh:100
const double a1
dn/dP
Definition: JDispersion.hh:97
const double P
Dispersion parameters (x = 1/lambda)
Definition: JDispersion.hh:95
const double a0
offset
Definition: JDispersion.hh:96
const double a2
d^1n/(dx)^1
Definition: JDispersion.hh:98
const double a3
d^2n/(dx)^2
Definition: JDispersion.hh:99
virtual double JPHYSICS::JDispersion::getDispersionPhase ( const double  lambda) const
inlinevirtualinherited

Dispersion of light for phase velocity.

Parameters
lambdawavelength of light [nm]
Returns
dn/dlambda

Implements JPHYSICS::JDispersionInterface.

Definition at line 65 of file JDispersion.hh.

66  {
67  const double x = 1.0 / lambda;
68 
69  return -x*x*(a2 + x*(2.0*a3 + x*3.0*a4));
70  }
const double a4
d^3n/(dx)^3
Definition: JDispersion.hh:100
const double a2
d^1n/(dx)^1
Definition: JDispersion.hh:98
const double a3
d^2n/(dx)^2
Definition: JDispersion.hh:99
virtual double JPHYSICS::JDispersion::getDispersionGroup ( const double  lambda) const
inlinevirtualinherited

Dispersion of light for group velocity.

Parameters
lambdawavelength of light [nm]
Returns
dn/dlambda

Implements JPHYSICS::JDispersionInterface.

Definition at line 79 of file JDispersion.hh.

80  {
81  const double x = 1.0 / lambda;
82 
83  const double n = getIndexOfRefractionPhase(lambda);
84  const double np = getDispersionPhase(lambda);
85  const double npp = x*x*x*(2.0*a2 + x*(6.0*a3 + x*12.0*a4));
86  const double ng = n / (1.0 + np*lambda/n);
87 
88  return ng*ng * (2*np*np - n*npp) * lambda / (n*n*n);
89  }
const double a4
d^3n/(dx)^3
Definition: JDispersion.hh:100
virtual double getIndexOfRefractionPhase(const double lambda) const
Index of refraction (phase velocity).
Definition: JDispersion.hh:51
virtual double getDispersionPhase(const double lambda) const
Dispersion of light for phase velocity.
Definition: JDispersion.hh:65
const double a2
d^1n/(dx)^1
Definition: JDispersion.hh:98
const double a3
d^2n/(dx)^2
Definition: JDispersion.hh:99

Member Data Documentation

const double JPHYSICS::JLED_C::A
protected

photo-cathode area [m2]

Definition at line 424 of file JLED.hh.

const JAbstractLED* JPHYSICS::JLED_C::led
protected

Pointer to interface for emission profile from LED.

Definition at line 429 of file JLED.hh.

double(* JPHYSICS::JLED_C::qe)(const double lambda)
protected

Quantum efficiency of PMT (incl.

absorption in glass, gel, etc.)

Parameters
lambdawavelenth [nm]
Returns
QE

Definition at line 437 of file JLED.hh.

double JPHYSICS::JLED_C::l_abs
protected

Absorption length.

Definition at line 442 of file JLED.hh.

double JPHYSICS::JLED_C::ls
protected

Scattering length.

Definition at line 447 of file JLED.hh.

double(* JPHYSICS::JLED_C::pmt)(const double ct)
protected

Angular acceptence of PMT (normalised to one at cos() = -1)

Parameters
ctcosine angle of incidence
Returns
relative efficiency

Definition at line 455 of file JLED.hh.

double(* JPHYSICS::JLED_C::km3)(const double ct)
protected

Model specific function to describe light scattering in water.

Parameters
ctcosine scattering angle
Returns
probability

Definition at line 463 of file JLED.hh.

double JPHYSICS::JLED::wavelength
protectedinherited

Definition at line 264 of file JLED.hh.

double JPHYSICS::JLED::tmin
protectedinherited

Definition at line 266 of file JLED.hh.

double JPHYSICS::JLED::tmax
protectedinherited

Definition at line 267 of file JLED.hh.

JQuadrature JPHYSICS::JLED::main_engine
protectedinherited

Definition at line 269 of file JLED.hh.

JQuadrature JPHYSICS::JLED::beta_engine
protectedinherited

Definition at line 270 of file JLED.hh.

std::vector<JElement3D_t> JPHYSICS::JLED::phi_engine
protectedinherited

Definition at line 271 of file JLED.hh.

const double JPHYSICS::JDispersion::P
inherited

Dispersion parameters (x = 1/lambda)

ambient pressure [atm]

Definition at line 95 of file JDispersion.hh.

const double JPHYSICS::JDispersion::a0
inherited

offset

Definition at line 96 of file JDispersion.hh.

const double JPHYSICS::JDispersion::a1
inherited

dn/dP

Definition at line 97 of file JDispersion.hh.

const double JPHYSICS::JDispersion::a2
inherited

d^1n/(dx)^1

Definition at line 98 of file JDispersion.hh.

const double JPHYSICS::JDispersion::a3
inherited

d^2n/(dx)^2

Definition at line 99 of file JDispersion.hh.

const double JPHYSICS::JDispersion::a4
inherited

d^3n/(dx)^3

Definition at line 100 of file JDispersion.hh.


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