ECCE @ EIC Software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
CLHEP Namespace Reference

Namespaces

namespace  detail
 

Classes

class  DoubConvException
 
class  DoubConv
 
class  DualRand
 
class  EngineFactory
 
class  HepJamesRandom
 
class  MixMaxRng
 
class  MTwistEngine
 
class  NonRandomEngine
 
class  RandBinomial
 
class  RandBit
 
class  RandBreitWigner
 
class  RandChiSquare
 
class  RandExponential
 
class  RandExpZiggurat
 
class  RandFlat
 
class  RandGamma
 
class  RandGauss
 
class  RandGaussQ
 
class  RandGaussZiggurat
 
class  RandGeneral
 
class  RandLandau
 
class  HepRandom
 
class  HepRandomEngine
 
class  RandPoisson
 
class  RandPoissonQ
 
class  RandStudentT
 
class  RanecuEngine
 
class  Ranlux64Engine
 
class  RanluxEngine
 
class  RanshiEngine
 
class  HepStat
 
class  StaticRandomStates
 
struct  do_nothing_deleter
 
class  noncopyable
 
class  HepAxisAngle
 
class  HepBoost
 
class  HepBoostX
 
class  HepBoostY
 
class  HepBoostZ
 
class  HepEulerAngles
 
class  HepLorentzRotation
 
class  HepLorentzVector
 
class  Tcomponent
 
class  HepRotation
 
class  Hep4RotationInterface
 
class  Hep3RotationInterface
 
struct  HepRep3x3
 
struct  HepRep4x4
 
struct  HepRep4x4Symmetric
 
class  HepRotationX
 
class  HepRotationY
 
class  HepRotationZ
 
class  Hep3Vector
 
class  Hep2Vector
 

Typedefs

typedef unsigned long int myID_t
 
typedef unsigned long long int myuint_t
 
template<typename T >
using shared_ptr = std::shared_ptr< T >
 
template<typename T >
using weak_ptr = std::weak_ptr< T >
 
typedef HepLorentzVector HepLorentzVectorD
 
typedef HepLorentzVector HepLorentzVectorF
 
typedef Hep3Vector HepThreeVectorD
 
typedef Hep3Vector HepThreeVectorF
 

Enumerations

enum  ZMpvMetric_t { TimePositive, TimeNegative }
 

Functions

unsigned long crc32ul (const std::string &s)
 
template<class E >
unsigned long engineIDulong ()
 
std::ostream & operator<< (std::ostream &os, const HepRandom &dist)
 
std::istream & operator>> (std::istream &is, HepRandom &dist)
 
std::ostream & operator<< (std::ostream &os, const HepRandomEngine &e)
 
std::istream & operator>> (std::istream &is, HepRandomEngine &e)
 
template<class IS , class T >
bool possibleKeywordInput (IS &is, const std::string &key, T &t)
 
std::ostream & operator<< (std::ostream &os, const HepAxisAngle &aa)
 
std::istream & operator>> (std::istream &is, HepAxisAngle &aa)
 
HepBoost inverseOf (const HepBoost &lt)
 
std::ostream & operator<< (std::ostream &os, const HepBoost &b)
 
HepBoostX inverseOf (const HepBoostX &b)
 
std::ostream & operator<< (std::ostream &os, const HepBoostX &b)
 
HepBoostY inverseOf (const HepBoostY &b)
 
std::ostream & operator<< (std::ostream &os, const HepBoostY &b)
 
HepBoostZ inverseOf (const HepBoostZ &b)
 
std::ostream & operator<< (std::ostream &os, const HepBoostZ &b)
 
std::ostream & operator<< (std::ostream &os, const HepEulerAngles &aa)
 
std::istream & operator>> (std::istream &is, HepEulerAngles &aa)
 
HepLorentzRotation inverseOf (const HepLorentzRotation &lt)
 
HepLorentzRotation operator* (const HepRotation &r, const HepLorentzRotation &lt)
 
HepLorentzRotation operator* (const HepRotationX &r, const HepLorentzRotation &lt)
 
HepLorentzRotation operator* (const HepRotationY &r, const HepLorentzRotation &lt)
 
HepLorentzRotation operator* (const HepRotationZ &r, const HepLorentzRotation &lt)
 
std::ostream & operator<< (std::ostream &os, const HepLorentzRotation &lt)
 
bool operator== (const HepRotation &r, const HepLorentzRotation &lt)
 
bool operator!= (const HepRotation &r, const HepLorentzRotation &lt)
 
bool operator<= (const HepRotation &r, const HepLorentzRotation &lt)
 
bool operator>= (const HepRotation &r, const HepLorentzRotation &lt)
 
bool operator< (const HepRotation &r, const HepLorentzRotation &lt)
 
bool operator> (const HepRotation &r, const HepLorentzRotation &lt)
 
bool operator== (const HepBoost &b, const HepLorentzRotation &lt)
 
bool operator!= (const HepBoost &b, const HepLorentzRotation &lt)
 
bool operator<= (const HepBoost &b, const HepLorentzRotation &lt)
 
bool operator>= (const HepBoost &b, const HepLorentzRotation &lt)
 
bool operator< (const HepBoost &b, const HepLorentzRotation &lt)
 
bool operator> (const HepBoost &b, const HepLorentzRotation &lt)
 
HepLorentzVector rotationXOf (const HepLorentzVector &vec, double delta)
 
HepLorentzVector rotationYOf (const HepLorentzVector &vec, double delta)
 
HepLorentzVector rotationZOf (const HepLorentzVector &vec, double delta)
 
HepLorentzVector rotationOf (const HepLorentzVector &vec, const Hep3Vector &axis, double delta)
 
HepLorentzVector rotationOf (const HepLorentzVector &vec, const HepAxisAngle &ax)
 
HepLorentzVector rotationOf (const HepLorentzVector &vec, const HepEulerAngles &e)
 
HepLorentzVector rotationOf (const HepLorentzVector &vec, double phi, double theta, double psi)
 
HepLorentzVector boostXOf (const HepLorentzVector &vec, double beta)
 
HepLorentzVector boostYOf (const HepLorentzVector &vec, double beta)
 
HepLorentzVector boostZOf (const HepLorentzVector &vec, double beta)
 
HepLorentzVector boostOf (const HepLorentzVector &vec, const Hep3Vector &betaVector)
 
HepLorentzVector boostOf (const HepLorentzVector &vec, const Hep3Vector &axis, double beta)
 
std::ostream & operator<< (std::ostream &, const HepLorentzVector &)
 
std::istream & operator>> (std::istream &, HepLorentzVector &)
 
HepLorentzVector operator* (const HepLorentzVector &, double a)
 
HepLorentzVector operator* (double a, const HepLorentzVector &)
 
HepLorentzVector operator/ (const HepLorentzVector &, double a)
 
HepRotation inverseOf (const HepRotation &r)
 
HepRotation operator* (const HepRotationX &rx, const HepRotation &r)
 
HepRotation operator* (const HepRotationY &ry, const HepRotation &r)
 
HepRotation operator* (const HepRotationZ &rz, const HepRotation &r)
 
std::ostream & operator<< (std::ostream &os, const HepRotation &r)
 
HepRotationX inverseOf (const HepRotationX &r)
 
std::ostream & operator<< (std::ostream &os, const HepRotationX &r)
 
HepRotationY inverseOf (const HepRotationY &r)
 
std::ostream & operator<< (std::ostream &os, const HepRotationY &r)
 
HepRotationZ inverseOf (const HepRotationZ &r)
 
std::ostream & operator<< (std::ostream &os, const HepRotationZ &r)
 
Hep3Vector rotationXOf (const Hep3Vector &vec, double delta)
 
Hep3Vector rotationYOf (const Hep3Vector &vec, double delta)
 
Hep3Vector rotationZOf (const Hep3Vector &vec, double delta)
 
Hep3Vector rotationOf (const Hep3Vector &vec, const Hep3Vector &axis, double delta)
 
Hep3Vector rotationOf (const Hep3Vector &vec, const HepAxisAngle &ax)
 
Hep3Vector rotationOf (const Hep3Vector &vec, double phi, double theta, double psi)
 
Hep3Vector rotationOf (const Hep3Vector &vec, const HepEulerAngles &e)
 
std::ostream & operator<< (std::ostream &, const Hep3Vector &)
 
std::istream & operator>> (std::istream &, Hep3Vector &)
 
Hep3Vector operator/ (const Hep3Vector &, double a)
 
Hep3Vector operator+ (const Hep3Vector &, const Hep3Vector &)
 
Hep3Vector operator- (const Hep3Vector &, const Hep3Vector &)
 
double operator* (const Hep3Vector &, const Hep3Vector &)
 
Hep3Vector operator* (const Hep3Vector &, double a)
 
Hep3Vector operator* (double a, const Hep3Vector &)
 
std::ostream & operator<< (std::ostream &, const Hep2Vector &)
 
std::istream & operator>> (std::istream &, Hep2Vector &)
 
double operator* (const Hep2Vector &a, const Hep2Vector &b)
 
Hep2Vector operator* (const Hep2Vector &p, double a)
 
Hep2Vector operator* (double a, const Hep2Vector &p)
 
Hep2Vector operator/ (const Hep2Vector &p, double a)
 
Hep2Vector operator+ (const Hep2Vector &a, const Hep2Vector &b)
 
Hep2Vector operator- (const Hep2Vector &a, const Hep2Vector &b)
 
static const Hep2Vector X_HAT2 (1.0, 0.0)
 
static const Hep2Vector Y_HAT2 (0.0, 1.0)
 
static void ZMpvAxisAngleRep (const HepAxisAngle &aa, double array[])
 
void ZMinputAxisAngle (std::istream &is, double &x, double &y, double &z, double &delta)
 
template<class E >
static HepRandomEnginemakeAnEngine (const std::string &tag, std::istream &is)
 
template<class E >
static HepRandomEnginemakeAnEngine (const std::vector< unsigned long > &v)
 
static std::vector< unsigned long > gen_crc_table ()
 
static void ZMpvEulerAnglesRep (const HepEulerAngles &ex, double array[])
 
void ZMinput3doubles (std::istream &is, const char *type, double &x, double &y, double &z)
 
double transformSmall (double r)
 
static double StirlingCorrection (long int k)
 
double gammln (double xx)
 
static double normal (HepRandomEngine *eptr)
 
static double safe_acos (double x)
 
static double safe_acos (double x)
 
static void correctByPi (double &psi1, double &phi1)
 
static void correctPsiPhi (double rxz, double rzx, double ryz, double rzy, double &psi1, double &phi1)
 
static double safe_acos (double x)
 
static double safe_acos (double x)
 
static double safe_acos (double x)
 
const Hep3Vector HepXHat (1.0, 0.0, 0.0)
 
const Hep3Vector HepYHat (0.0, 1.0, 0.0)
 
const Hep3Vector HepZHat (0.0, 0.0, 1.0)
 
void ZMinput2doubles (std::istream &is, const char *type, double &x, double &y)
 

Variables

static const int HepRandomGenActive = HepRandom::createInstance()
 
static constexpr double Avogadro = 6.02214179e+23/mole
 
static constexpr double c_light = 2.99792458e+8 * m/s
 
static constexpr double c_squared = c_light * c_light
 
static constexpr double h_Planck = 6.62606896e-34 * joule*s
 
static constexpr double hbar_Planck = h_Planck/twopi
 
static constexpr double hbarc = hbar_Planck * c_light
 
static constexpr double hbarc_squared = hbarc * hbarc
 
static constexpr double electron_charge = - eplus
 
static constexpr double e_squared = eplus * eplus
 
static constexpr double electron_mass_c2 = 0.510998910 * MeV
 
static constexpr double proton_mass_c2 = 938.272013 * MeV
 
static constexpr double neutron_mass_c2 = 939.56536 * MeV
 
static constexpr double amu_c2 = 931.494028 * MeV
 
static constexpr double amu = amu_c2/c_squared
 
static constexpr double mu0 = 4*pi*1.e-7 * henry/m
 
static constexpr double epsilon0 = 1./(c_squared*mu0)
 
static constexpr double elm_coupling = e_squared/(4*pi*epsilon0)
 
static constexpr double fine_structure_const = elm_coupling/hbarc
 
static constexpr double classic_electr_radius = elm_coupling/electron_mass_c2
 
static constexpr double electron_Compton_length = hbarc/electron_mass_c2
 
static constexpr double Bohr_radius = electron_Compton_length/fine_structure_const
 
static constexpr double alpha_rcl2
 
static constexpr double twopi_mc2_rcl2
 
static constexpr double k_Boltzmann = 8.617343e-11 * MeV/kelvin
 
static constexpr double STP_Temperature = 273.15*kelvin
 
static constexpr double STP_Pressure = 1.*atmosphere
 
static constexpr double kGasThreshold = 10.*mg/cm3
 
static constexpr double universe_mean_density = 1.e-25*g/cm3
 
static constexpr double pi = 3.14159265358979323846
 
static constexpr double twopi = 2*pi
 
static constexpr double halfpi = pi/2
 
static constexpr double pi2 = pi*pi
 
static constexpr double millimeter = 1.
 
static constexpr double millimeter2 = millimeter*millimeter
 
static constexpr double millimeter3 = millimeter*millimeter*millimeter
 
static constexpr double centimeter = 10.*millimeter
 
static constexpr double centimeter2 = centimeter*centimeter
 
static constexpr double centimeter3 = centimeter*centimeter*centimeter
 
static constexpr double meter = 1000.*millimeter
 
static constexpr double meter2 = meter*meter
 
static constexpr double meter3 = meter*meter*meter
 
static constexpr double kilometer = 1000.*meter
 
static constexpr double kilometer2 = kilometer*kilometer
 
static constexpr double kilometer3 = kilometer*kilometer*kilometer
 
static constexpr double parsec = 3.0856775807e+16*meter
 
static constexpr double micrometer = 1.e-6 *meter
 
static constexpr double nanometer = 1.e-9 *meter
 
static constexpr double angstrom = 1.e-10*meter
 
static constexpr double fermi = 1.e-15*meter
 
static constexpr double barn = 1.e-28*meter2
 
static constexpr double millibarn = 1.e-3 *barn
 
static constexpr double microbarn = 1.e-6 *barn
 
static constexpr double nanobarn = 1.e-9 *barn
 
static constexpr double picobarn = 1.e-12*barn
 
static constexpr double nm = nanometer
 
static constexpr double um = micrometer
 
static constexpr double mm = millimeter
 
static constexpr double mm2 = millimeter2
 
static constexpr double mm3 = millimeter3
 
static constexpr double cm = centimeter
 
static constexpr double cm2 = centimeter2
 
static constexpr double cm3 = centimeter3
 
static constexpr double liter = 1.e+3*cm3
 
static constexpr double L = liter
 
static constexpr double dL = 1.e-1*liter
 
static constexpr double cL = 1.e-2*liter
 
static constexpr double mL = 1.e-3*liter
 
static constexpr double m = meter
 
static constexpr double m2 = meter2
 
static constexpr double m3 = meter3
 
static constexpr double km = kilometer
 
static constexpr double km2 = kilometer2
 
static constexpr double km3 = kilometer3
 
static constexpr double pc = parsec
 
static constexpr double radian = 1.
 
static constexpr double milliradian = 1.e-3*radian
 
static constexpr double degree = (pi/180.0)*radian
 
static constexpr double steradian = 1.
 
static constexpr double rad = radian
 
static constexpr double mrad = milliradian
 
static constexpr double sr = steradian
 
static constexpr double deg = degree
 
static constexpr double nanosecond = 1.
 
static constexpr double second = 1.e+9 *nanosecond
 
static constexpr double millisecond = 1.e-3 *second
 
static constexpr double microsecond = 1.e-6 *second
 
static constexpr double picosecond = 1.e-12*second
 
static constexpr double hertz = 1./second
 
static constexpr double kilohertz = 1.e+3*hertz
 
static constexpr double megahertz = 1.e+6*hertz
 
static constexpr double ns = nanosecond
 
static constexpr double s = second
 
static constexpr double ms = millisecond
 
static constexpr double us = microsecond
 
static constexpr double ps = picosecond
 
static constexpr double eplus = 1.
 
static constexpr double e_SI = 1.602176487e-19
 
static constexpr double coulomb = eplus/e_SI
 
static constexpr double megaelectronvolt = 1.
 
static constexpr double electronvolt = 1.e-6*megaelectronvolt
 
static constexpr double kiloelectronvolt = 1.e-3*megaelectronvolt
 
static constexpr double gigaelectronvolt = 1.e+3*megaelectronvolt
 
static constexpr double teraelectronvolt = 1.e+6*megaelectronvolt
 
static constexpr double petaelectronvolt = 1.e+9*megaelectronvolt
 
static constexpr double joule = electronvolt/e_SI
 
static constexpr double MeV = megaelectronvolt
 
static constexpr double eV = electronvolt
 
static constexpr double keV = kiloelectronvolt
 
static constexpr double GeV = gigaelectronvolt
 
static constexpr double TeV = teraelectronvolt
 
static constexpr double PeV = petaelectronvolt
 
static constexpr double kilogram = joule*second*second/(meter*meter)
 
static constexpr double gram = 1.e-3*kilogram
 
static constexpr double milligram = 1.e-3*gram
 
static constexpr double kg = kilogram
 
static constexpr double g = gram
 
static constexpr double mg = milligram
 
static constexpr double watt = joule/second
 
static constexpr double newton = joule/meter
 
static constexpr double hep_pascal = newton/m2
 
static constexpr double bar = 100000*pascal
 
static constexpr double atmosphere = 101325*pascal
 
static constexpr double ampere = coulomb/second
 
static constexpr double milliampere = 1.e-3*ampere
 
static constexpr double microampere = 1.e-6*ampere
 
static constexpr double nanoampere = 1.e-9*ampere
 
static constexpr double megavolt = megaelectronvolt/eplus
 
static constexpr double kilovolt = 1.e-3*megavolt
 
static constexpr double volt = 1.e-6*megavolt
 
static constexpr double ohm = volt/ampere
 
static constexpr double farad = coulomb/volt
 
static constexpr double millifarad = 1.e-3*farad
 
static constexpr double microfarad = 1.e-6*farad
 
static constexpr double nanofarad = 1.e-9*farad
 
static constexpr double picofarad = 1.e-12*farad
 
static constexpr double weber = volt*second
 
static constexpr double tesla = volt*second/meter2
 
static constexpr double gauss = 1.e-4*tesla
 
static constexpr double kilogauss = 1.e-1*tesla
 
static constexpr double henry = weber/ampere
 
static constexpr double kelvin = 1.
 
static constexpr double mole = 1.
 
static constexpr double becquerel = 1./second
 
static constexpr double curie = 3.7e+10 * becquerel
 
static constexpr double kilobecquerel = 1.e+3*becquerel
 
static constexpr double megabecquerel = 1.e+6*becquerel
 
static constexpr double gigabecquerel = 1.e+9*becquerel
 
static constexpr double millicurie = 1.e-3*curie
 
static constexpr double microcurie = 1.e-6*curie
 
static constexpr double Bq = becquerel
 
static constexpr double kBq = kilobecquerel
 
static constexpr double MBq = megabecquerel
 
static constexpr double GBq = gigabecquerel
 
static constexpr double Ci = curie
 
static constexpr double mCi = millicurie
 
static constexpr double uCi = microcurie
 
static constexpr double gray = joule/kilogram
 
static constexpr double kilogray = 1.e+3*gray
 
static constexpr double milligray = 1.e-3*gray
 
static constexpr double microgray = 1.e-6*gray
 
static constexpr double candela = 1.
 
static constexpr double lumen = candela*steradian
 
static constexpr double lux = lumen/meter2
 
static constexpr double perCent = 0.01
 
static constexpr double perThousand = 0.001
 
static constexpr double perMillion = 0.000001
 
static const HepLorentzVector X_HAT4 = HepLorentzVector( 1, 0, 0, 0 )
 
static const HepLorentzVector Y_HAT4 = HepLorentzVector( 0, 1, 0, 0 )
 
static const HepLorentzVector Z_HAT4 = HepLorentzVector( 0, 0, 1, 0 )
 
static const HepLorentzVector T_HAT4 = HepLorentzVector( 0, 0, 0, 1 )
 
DLL_API const Hep3Vector HepXHat
 
DLL_API const Hep3Vector HepYHat
 
DLL_API const Hep3Vector HepZHat
 
static const int MarkerLen = 64
 
static const int Tsizes [5]
 
static const double Tsteps [5]
 
static const int Toffsets [5]
 
static const double gaussTables [2 *TableSize]
 
static const int MarkerLen = 64
 
static const int MarkerLen = 64
 
static const int MarkerLen = 64
 
static const float gaussTables [TableSize]
 
static const float TABLE_INTERVAL = .001f
 
static const int TABLE_END = 982
 
static const float TABLE_MULTIPLIER = 1.0f/TABLE_INTERVAL
 
static const float inverseLandau [TABLE_END+1]
 
static const double poissonTables [51 *((95-10)/5+1)]
 
static const int MarkerLen = 64
 
static const double prec = 4.6566128E-10
 
static const int MarkerLen = 64
 
static const int MarkerLen = 64
 
static const int MarkerLen = 64
 

Typedef Documentation

Definition at line 551 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 551 of file LorentzVector.h

Definition at line 552 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 552 of file LorentzVector.h

Definition at line 427 of file ThreeVector.h.

View newest version in sPHENIX GitHub at line 427 of file ThreeVector.h

Definition at line 428 of file ThreeVector.h.

View newest version in sPHENIX GitHub at line 428 of file ThreeVector.h

typedef unsigned long int CLHEP::myID_t
Author
K.Savvidy

Definition at line 46 of file MixMaxRng.h.

View newest version in sPHENIX GitHub at line 46 of file MixMaxRng.h

typedef unsigned long long int CLHEP::myuint_t

Definition at line 47 of file MixMaxRng.h.

View newest version in sPHENIX GitHub at line 47 of file MixMaxRng.h

template<typename T >
using CLHEP::shared_ptr = typedef std::shared_ptr<T>

Definition at line 15 of file memory.h.

View newest version in sPHENIX GitHub at line 15 of file memory.h

template<typename T >
using CLHEP::weak_ptr = typedef std::weak_ptr<T>

Definition at line 17 of file memory.h.

View newest version in sPHENIX GitHub at line 17 of file memory.h

Enumeration Type Documentation

Enumerator:
TimePositive 
TimeNegative 

Definition at line 63 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 63 of file LorentzVector.h

Function Documentation

HepLorentzVector CLHEP::boostOf ( const HepLorentzVector &  vec,
const Hep3Vector &  betaVector 
)
inline

Referenced by G4QMDReaction::ApplyYourself().

+ Here is the caller graph for this function:

HepLorentzVector CLHEP::boostOf ( const HepLorentzVector &  vec,
const Hep3Vector &  axis,
double  beta 
)
inline
HepLorentzVector CLHEP::boostXOf ( const HepLorentzVector &  vec,
double  beta 
)
inline
HepLorentzVector CLHEP::boostYOf ( const HepLorentzVector &  vec,
double  beta 
)
inline
HepLorentzVector CLHEP::boostZOf ( const HepLorentzVector &  vec,
double  beta 
)
inline
static void CLHEP::correctByPi ( double &  psi1,
double &  phi1 
)
static

Definition at line 148 of file RotationE.cc.

View newest version in sPHENIX GitHub at line 148 of file RotationE.cc

References pi.

Referenced by correctPsiPhi().

+ Here is the caller graph for this function:

static void CLHEP::correctPsiPhi ( double  rxz,
double  rzx,
double  ryz,
double  rzy,
double &  psi1,
double &  phi1 
)
static

Definition at line 162 of file RotationE.cc.

View newest version in sPHENIX GitHub at line 162 of file RotationE.cc

References kdfinder::abs(), correctByPi(), halfpi, imax, and w.

Referenced by CLHEP::HepRotation::eulerAngles().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

unsigned long CLHEP::crc32ul ( const std::string &  s)

Definition at line 36 of file engineIDulong.cc.

View newest version in sPHENIX GitHub at line 36 of file engineIDulong.cc

References crc_table, gen_crc_table(), and int().

Referenced by engineIDulong().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

template<class E >
unsigned long CLHEP::engineIDulong ( )

Definition at line 23 of file engineIDulong.h.

View newest version in sPHENIX GitHub at line 23 of file engineIDulong.h

References crc32ul().

+ Here is the call graph for this function:

double CLHEP::gammln ( double  xx)

Definition at line 53 of file RandPoisson.cc.

View newest version in sPHENIX GitHub at line 53 of file RandPoisson.cc

References tmp, and x.

Referenced by CLHEP::RandPoisson::fire(), and CLHEP::RandPoisson::shoot().

+ Here is the caller graph for this function:

static std::vector<unsigned long> CLHEP::gen_crc_table ( )
static

Definition at line 18 of file engineIDulong.cc.

View newest version in sPHENIX GitHub at line 18 of file engineIDulong.cc

References crc_table.

Referenced by crc32ul().

+ Here is the caller graph for this function:

const Hep3Vector CLHEP::HepXHat ( 1.  0,
0.  0,
0.  0 
)
const Hep3Vector CLHEP::HepYHat ( 0.  0,
1.  0,
0.  0 
)
const Hep3Vector CLHEP::HepZHat ( 0.  0,
0.  0,
1.  0 
)
HepBoostZ CLHEP::inverseOf ( const HepBoostZ &  b)
inline
HepBoostX CLHEP::inverseOf ( const HepBoostX &  b)
inline
HepBoostY CLHEP::inverseOf ( const HepBoostY &  b)
inline
HepRotationZ CLHEP::inverseOf ( const HepRotationZ &  r)
inline
HepRotationY CLHEP::inverseOf ( const HepRotationY &  r)
inline
HepBoost CLHEP::inverseOf ( const HepBoost &  lt)
inline

Referenced by CML2AcceleratorConstruction::rotateAccelerator().

+ Here is the caller graph for this function:

HepRotationX CLHEP::inverseOf ( const HepRotationX &  r)
inline
HepRotation CLHEP::inverseOf ( const HepRotation &  r)
inline
HepLorentzRotation CLHEP::inverseOf ( const HepLorentzRotation &  lt)
inline
template<class E >
static HepRandomEngine* CLHEP::makeAnEngine ( const std::string &  tag,
std::istream &  is 
)
static

Definition at line 31 of file EngineFactory.cc.

View newest version in sPHENIX GitHub at line 31 of file EngineFactory.cc

References E, and CLHEP::HepRandomEngine::getState().

+ Here is the call graph for this function:

template<class E >
static HepRandomEngine* CLHEP::makeAnEngine ( const std::vector< unsigned long > &  v)
static

Definition at line 42 of file EngineFactory.cc.

View newest version in sPHENIX GitHub at line 42 of file EngineFactory.cc

References E, and CLHEP::HepRandomEngine::getState().

+ Here is the call graph for this function:

static double CLHEP::normal ( HepRandomEngine *  eptr)
static

Definition at line 76 of file RandPoisson.cc.

View newest version in sPHENIX GitHub at line 76 of file RandPoisson.cc

References fac, CLHEP::HepRandomEngine::flat(), r, v1, and v2.

Referenced by Acts::BoundarySurfaceT< T >::attachedVolume(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4PolyconeSide::CalculateExtent(), Acts::GenericCuboidVolumeBounds::construct(), Acts::ConvexPolygonBoundsBase::convex_impl(), Acts::GenericCuboidVolumeBounds::decomposeToSurfaces(), G4ErrorMatrix::dfact_matrix(), G4PolyhedraSide::Distance(), G4VTwistedFaceted::DistanceToIn(), G4VTwistSurface::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4TessellatedSolid::DistanceToInCandidates(), G4TessellatedSolid::DistanceToInNoVoxels(), G4VCSGfaceted::DistanceToOut(), G4ScaledSolid::DistanceToOut(), G4VTwistSurface::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4TessellatedSolid::DistanceToOutCandidates(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4TwistTubsSide::DistanceToSurface(), HepPolyhedron::FindNodeNormal(), CLHEP::RandPoisson::fire(), G4QuadrangularFacet::G4QuadrangularFacet(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), G4SPSEneDistribution::GenerateBiasPowEnergies(), G4PrimaryTransformer::GenerateSingleTrack(), G4PolarizationHelper::GetFrame(), G4ErrorPropagationNavigator::GetGlobalExitNormal(), HepPolyhedron::GetNextNormal(), HepPolyhedron::GetNextUnitNormal(), HepPolyhedron::GetNextVertex(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4Polyhedra::GetPointOnPlane(), G4PolarizationHelper::GetRandomFrame(), G4RTRun::GetSurfaceColour(), G4TheRayTracer::GetSurfaceColour(), G4ErrorCylSurfaceTarget::GetTangentPlane(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::intersect(), Acts::detail::VerticesHelper::isInsidePolygon(), G4Navigator::LocateGlobalPointAndSetup(), G4ITNavigator1::LocateGlobalPointAndSetup(), G4ITNavigator2::LocateGlobalPointAndSetup(), G4Trap::MakePlane(), G4Trap::MakePlanes(), ActsFatras::Interactor< generator_t, physics_list_t, hit_surface_selector_t >::operator()(), G4INCL::ParticleEntryChannel::particleEnters(), G4INCL::TransmissionChannel::particleLeaves(), Acts::PlaneSurface::pathCorrection(), Acts::CylinderSurface::pathCorrection(), G4GeomTools::PolygonAreaNormal(), MicromegasClusterizer::process_event(), PHTpcClusterMover::process_event(), Acts::CylinderSurface::referenceFrame(), G4VisCommandsViewerSet::SetNewValue(), OpNovicePrimaryGeneratorAction::SetOptPhotonPolar(), PrimaryGeneratorAction::SetOptPhotonPolar(), WLSPrimaryGeneratorAction::SetOptPhotonPolar(), G4TriangularFacet::SetSurfaceNormal(), CLHEP::RandPoisson::shoot(), G4VCSGfaceted::SurfaceNormal(), G4ScaledSolid::SurfaceNormal(), G4ReflectedSolid::SurfaceNormal(), G4DisplacedSolid::SurfaceNormal(), G4IntersectionSolid::SurfaceNormal(), G4SubtractionSolid::SurfaceNormal(), and G4MultiUnion::SurfaceNormal().

+ Here is the call graph for this function:

bool CLHEP::operator!= ( const HepRotation &  r,
const HepLorentzRotation &  lt 
)
inline

Definition at line 354 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 354 of file LorentzRotation.h

References r.

bool CLHEP::operator!= ( const HepBoost &  b,
const HepLorentzRotation &  lt 
)
inline

Definition at line 367 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 367 of file LorentzRotation.h

References b.

double CLHEP::operator* ( const Hep2Vector &  a,
const Hep2Vector &  b 
)
inline
Hep2Vector CLHEP::operator* ( const Hep2Vector &  p,
double  a 
)
inline
HepRotation CLHEP::operator* ( const HepRotationX &  rx,
const HepRotation &  r 
)
inline
Hep2Vector CLHEP::operator* ( double  a,
const Hep2Vector &  p 
)
inline
HepRotation CLHEP::operator* ( const HepRotationY &  ry,
const HepRotation &  r 
)
inline
HepRotation CLHEP::operator* ( const HepRotationZ &  rz,
const HepRotation &  r 
)
inline
HepLorentzRotation CLHEP::operator* ( const HepRotationX &  r,
const HepLorentzRotation &  lt 
)
HepLorentzRotation CLHEP::operator* ( const HepRotationY &  r,
const HepLorentzRotation &  lt 
)
HepLorentzRotation CLHEP::operator* ( const HepRotationZ &  r,
const HepLorentzRotation &  lt 
)
double CLHEP::operator* ( const Hep3Vector &  ,
const Hep3Vector &   
)
inline
Hep3Vector CLHEP::operator* ( const Hep3Vector &  ,
double  a 
)
inline
Hep3Vector CLHEP::operator* ( double  a,
const Hep3Vector &   
)
inline
HepLorentzVector CLHEP::operator* ( const HepLorentzVector &  ,
double  a 
)
inline
HepLorentzVector CLHEP::operator* ( double  a,
const HepLorentzVector &   
)
inline
Hep2Vector CLHEP::operator+ ( const Hep2Vector &  a,
const Hep2Vector &  b 
)
inline
Hep3Vector CLHEP::operator+ ( const Hep3Vector &  ,
const Hep3Vector &   
)
inline
Hep2Vector CLHEP::operator- ( const Hep2Vector &  a,
const Hep2Vector &  b 
)
inline
Hep3Vector CLHEP::operator- ( const Hep3Vector &  ,
const Hep3Vector &   
)
inline
Hep2Vector CLHEP::operator/ ( const Hep2Vector &  p,
double  a 
)

Definition at line 61 of file TwoVector.cc.

View newest version in sPHENIX GitHub at line 61 of file TwoVector.cc

References a, CLHEP::Hep2Vector::x(), and CLHEP::Hep2Vector::y().

+ Here is the call graph for this function:

Hep3Vector CLHEP::operator/ ( const Hep3Vector &  v1,
double  a 
)

Definition at line 300 of file ThreeVector.cc.

View newest version in sPHENIX GitHub at line 300 of file ThreeVector.cc

References c, CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::operator/ ( const HepLorentzVector &  w,
double  a 
)

Definition at line 164 of file LorentzVector.cc.

View newest version in sPHENIX GitHub at line 164 of file LorentzVector.cc

References c, CLHEP::HepLorentzVector::getT(), and CLHEP::HepLorentzVector::getV().

+ Here is the call graph for this function:

bool CLHEP::operator< ( const HepRotation &  r,
const HepLorentzRotation &  lt 
)
inline

Definition at line 360 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 360 of file LorentzRotation.h

References r.

bool CLHEP::operator< ( const HepBoost &  b,
const HepLorentzRotation &  lt 
)
inline

Definition at line 373 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 373 of file LorentzRotation.h

References b.

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const HepAxisAngle &  aa 
)

Definition at line 85 of file AxisAngle.cc.

View newest version in sPHENIX GitHub at line 85 of file AxisAngle.cc

References CLHEP::HepAxisAngle::axis(), and CLHEP::HepAxisAngle::delta().

+ Here is the call graph for this function:

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const HepEulerAngles &  aa 
)

Definition at line 100 of file EulerAngles.cc.

View newest version in sPHENIX GitHub at line 100 of file EulerAngles.cc

References CLHEP::HepEulerAngles::phi(), CLHEP::HepEulerAngles::psi(), and CLHEP::HepEulerAngles::theta().

+ Here is the call graph for this function:

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const Hep2Vector &  q 
)

Definition at line 69 of file TwoVector.cc.

View newest version in sPHENIX GitHub at line 69 of file TwoVector.cc

References CLHEP::Hep2Vector::x(), and CLHEP::Hep2Vector::y().

+ Here is the call graph for this function:

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const HepRandom &  dist 
)

Definition at line 215 of file Random.cc.

View newest version in sPHENIX GitHub at line 215 of file Random.cc

References CLHEP::HepRandom::put().

+ Here is the call graph for this function:

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const HepRandomEngine &  e 
)

Definition at line 97 of file RandomEngine.cc.

View newest version in sPHENIX GitHub at line 97 of file RandomEngine.cc

References CLHEP::HepRandomEngine::put().

+ Here is the call graph for this function:

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepBoostZ &  b 
)
inline

Definition at line 217 of file BoostZ.h.

View newest version in sPHENIX GitHub at line 217 of file BoostZ.h

References b.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepBoostX &  b 
)
inline

Definition at line 217 of file BoostX.h.

View newest version in sPHENIX GitHub at line 217 of file BoostX.h

References b.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepBoostY &  b 
)
inline

Definition at line 218 of file BoostY.h.

View newest version in sPHENIX GitHub at line 218 of file BoostY.h

References b.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepBoost &  b 
)
inline

Definition at line 243 of file Boost.h.

View newest version in sPHENIX GitHub at line 243 of file Boost.h

References b.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepRotationZ &  r 
)
inline

Definition at line 280 of file RotationZ.h.

View newest version in sPHENIX GitHub at line 280 of file RotationZ.h

References r.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepRotationX &  r 
)
inline

Definition at line 280 of file RotationX.h.

View newest version in sPHENIX GitHub at line 280 of file RotationX.h

References r.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepRotationY &  r 
)
inline

Definition at line 280 of file RotationY.h.

View newest version in sPHENIX GitHub at line 280 of file RotationY.h

References r.

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepLorentzRotation &  lt 
)
inline

Definition at line 349 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 349 of file LorentzRotation.h

std::ostream& CLHEP::operator<< ( std::ostream &  os,
const HepRotation &  r 
)
inline

Definition at line 411 of file Rotation.h.

View newest version in sPHENIX GitHub at line 411 of file Rotation.h

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const Hep3Vector &  v 
)

Definition at line 65 of file ThreeVector.cc.

View newest version in sPHENIX GitHub at line 65 of file ThreeVector.cc

References CLHEP::Hep3Vector::x(), CLHEP::Hep3Vector::y(), and CLHEP::Hep3Vector::z().

+ Here is the call graph for this function:

std::ostream & CLHEP::operator<< ( std::ostream &  os,
const HepLorentzVector &  v1 
)

Definition at line 89 of file LorentzVector.cc.

View newest version in sPHENIX GitHub at line 89 of file LorentzVector.cc

References CLHEP::HepLorentzVector::t(), CLHEP::HepLorentzVector::x(), CLHEP::HepLorentzVector::y(), and CLHEP::HepLorentzVector::z().

+ Here is the call graph for this function:

bool CLHEP::operator<= ( const HepRotation &  r,
const HepLorentzRotation &  lt 
)
inline

Definition at line 356 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 356 of file LorentzRotation.h

References r.

bool CLHEP::operator<= ( const HepBoost &  b,
const HepLorentzRotation &  lt 
)
inline

Definition at line 369 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 369 of file LorentzRotation.h

References b.

bool CLHEP::operator== ( const HepRotation &  r,
const HepLorentzRotation &  lt 
)
inline

Definition at line 352 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 352 of file LorentzRotation.h

References r.

bool CLHEP::operator== ( const HepBoost &  b,
const HepLorentzRotation &  lt 
)
inline

Definition at line 365 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 365 of file LorentzRotation.h

References b.

bool CLHEP::operator> ( const HepRotation &  r,
const HepLorentzRotation &  lt 
)
inline

Definition at line 362 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 362 of file LorentzRotation.h

References r.

bool CLHEP::operator> ( const HepBoost &  b,
const HepLorentzRotation &  lt 
)
inline

Definition at line 375 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 375 of file LorentzRotation.h

References b.

bool CLHEP::operator>= ( const HepRotation &  r,
const HepLorentzRotation &  lt 
)
inline

Definition at line 358 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 358 of file LorentzRotation.h

References r.

bool CLHEP::operator>= ( const HepBoost &  b,
const HepLorentzRotation &  lt 
)
inline

Definition at line 371 of file LorentzRotation.h.

View newest version in sPHENIX GitHub at line 371 of file LorentzRotation.h

References b.

std::istream & CLHEP::operator>> ( std::istream &  is,
HepAxisAngle &  aa 
)

Definition at line 95 of file AxisAngle.cc.

View newest version in sPHENIX GitHub at line 95 of file AxisAngle.cc

References Acts::Test::delta, CLHEP::HepAxisAngle::set(), CLHEP::Hep3Vector::set(), x, y, z, and ZMinputAxisAngle().

+ Here is the call graph for this function:

std::istream & CLHEP::operator>> ( std::istream &  is,
HepEulerAngles &  aa 
)

Definition at line 109 of file EulerAngles.cc.

View newest version in sPHENIX GitHub at line 109 of file EulerAngles.cc

References CLHEP::HepEulerAngles::set(), and ZMinput3doubles().

+ Here is the call graph for this function:

std::istream & CLHEP::operator>> ( std::istream &  is,
Hep2Vector &  p 
)

Definition at line 77 of file TwoVector.cc.

View newest version in sPHENIX GitHub at line 77 of file TwoVector.cc

References CLHEP::Hep2Vector::set(), x, y, and ZMinput2doubles().

+ Here is the call graph for this function:

std::istream & CLHEP::operator>> ( std::istream &  is,
HepRandom &  dist 
)

Definition at line 219 of file Random.cc.

View newest version in sPHENIX GitHub at line 219 of file Random.cc

References CLHEP::HepRandom::get().

+ Here is the call graph for this function:

std::istream & CLHEP::operator>> ( std::istream &  is,
HepRandomEngine &  e 
)

Definition at line 101 of file RandomEngine.cc.

View newest version in sPHENIX GitHub at line 101 of file RandomEngine.cc

References CLHEP::HepRandomEngine::get().

+ Here is the call graph for this function:

std::istream & CLHEP::operator>> ( std::istream &  is,
Hep3Vector &  v 
)

Definition at line 72 of file ThreeVector.cc.

View newest version in sPHENIX GitHub at line 72 of file ThreeVector.cc

References CLHEP::Hep3Vector::set(), x, y, z, and ZMinput3doubles().

+ Here is the call graph for this function:

std::istream & CLHEP::operator>> ( std::istream &  is,
HepLorentzVector &  v1 
)

Definition at line 95 of file LorentzVector.cc.

View newest version in sPHENIX GitHub at line 95 of file LorentzVector.cc

References c, CLHEP::HepLorentzVector::setT(), CLHEP::HepLorentzVector::setX(), CLHEP::HepLorentzVector::setY(), CLHEP::HepLorentzVector::setZ(), t, x, y, and z.

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationOf ( const HepLorentzVector &  vec,
const Hep3Vector &  axis,
double  delta 
)

Definition at line 47 of file LorentzVectorR.cc.

View newest version in sPHENIX GitHub at line 47 of file LorentzVectorR.cc

References CLHEP::HepLorentzVector::rotate().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationOf ( const HepLorentzVector &  vec,
const HepAxisAngle &  ax 
)

Definition at line 55 of file LorentzVectorR.cc.

View newest version in sPHENIX GitHub at line 55 of file LorentzVectorR.cc

References CLHEP::HepLorentzVector::rotate().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationOf ( const HepLorentzVector &  vec,
const HepEulerAngles &  e 
)

Definition at line 61 of file LorentzVectorR.cc.

View newest version in sPHENIX GitHub at line 61 of file LorentzVectorR.cc

References CLHEP::HepLorentzVector::rotate().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationOf ( const HepLorentzVector &  vec,
double  phi,
double  theta,
double  psi 
)

Definition at line 66 of file LorentzVectorR.cc.

View newest version in sPHENIX GitHub at line 66 of file LorentzVectorR.cc

References CLHEP::HepLorentzVector::rotate().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationOf ( const Hep3Vector &  vec,
const Hep3Vector &  axis,
double  delta 
)

Definition at line 132 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 132 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotate().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationOf ( const Hep3Vector &  vec,
const HepAxisAngle &  ax 
)

Definition at line 127 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 127 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotate().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationOf ( const Hep3Vector &  vec,
double  phi,
double  theta,
double  psi 
)

Definition at line 143 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 143 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotate().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationOf ( const Hep3Vector &  vec,
const HepEulerAngles &  e 
)

Definition at line 138 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 138 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotate().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationXOf ( const HepLorentzVector &  vec,
double  delta 
)

Definition at line 27 of file LorentzVectorB.cc.

View newest version in sPHENIX GitHub at line 27 of file LorentzVectorB.cc

References CLHEP::HepLorentzVector::rotateX().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationXOf ( const Hep3Vector &  vec,
double  delta 
)

Definition at line 149 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 149 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotateX().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationYOf ( const HepLorentzVector &  vec,
double  delta 
)

Definition at line 33 of file LorentzVectorB.cc.

View newest version in sPHENIX GitHub at line 33 of file LorentzVectorB.cc

References CLHEP::HepLorentzVector::rotateY().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationYOf ( const Hep3Vector &  vec,
double  delta 
)

Definition at line 154 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 154 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotateY().

+ Here is the call graph for this function:

HepLorentzVector CLHEP::rotationZOf ( const HepLorentzVector &  vec,
double  delta 
)

Definition at line 39 of file LorentzVectorB.cc.

View newest version in sPHENIX GitHub at line 39 of file LorentzVectorB.cc

References CLHEP::HepLorentzVector::rotateZ().

+ Here is the call graph for this function:

Hep3Vector CLHEP::rotationZOf ( const Hep3Vector &  vec,
double  delta 
)

Definition at line 159 of file SpaceVectorR.cc.

View newest version in sPHENIX GitHub at line 159 of file SpaceVectorR.cc

References CLHEP::Hep3Vector::rotateZ().

+ Here is the call graph for this function:

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 22 of file Rotation.cc.

View newest version in sPHENIX GitHub at line 22 of file Rotation.cc

References kdfinder::abs(), and pi.

Referenced by CLHEP::HepRotation::eulerAngles(), CLHEP::HepRotation::theta(), CLHEP::HepRotationY::thetaX(), CLHEP::HepRotationZ::thetaX(), CLHEP::HepRotationX::thetaX(), CLHEP::HepRotation::thetaX(), CLHEP::HepRotationY::thetaY(), CLHEP::HepRotationZ::thetaY(), CLHEP::HepRotationX::thetaY(), CLHEP::HepRotation::thetaY(), CLHEP::HepRotationZ::thetaZ(), CLHEP::HepRotationY::thetaZ(), CLHEP::HepRotationX::thetaZ(), and CLHEP::HepRotation::thetaZ().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 26 of file RotationY.cc.

View newest version in sPHENIX GitHub at line 26 of file RotationY.cc

References kdfinder::abs(), and pi.

+ Here is the call graph for this function:

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 26 of file RotationX.cc.

View newest version in sPHENIX GitHub at line 26 of file RotationX.cc

References kdfinder::abs(), and pi.

+ Here is the call graph for this function:

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 26 of file RotationE.cc.

View newest version in sPHENIX GitHub at line 26 of file RotationE.cc

References kdfinder::abs(), and pi.

+ Here is the call graph for this function:

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 26 of file RotationZ.cc.

View newest version in sPHENIX GitHub at line 26 of file RotationZ.cc

References kdfinder::abs(), and pi.

+ Here is the call graph for this function:

static double CLHEP::StirlingCorrection ( long int  k)
static

Definition at line 92 of file RandBinomial.cc.

View newest version in sPHENIX GitHub at line 92 of file RandBinomial.cc

References c, C1, C3, C5, C7, L, and r.

Referenced by CLHEP::RandBinomial::genBinomial().

+ Here is the caller graph for this function:

double CLHEP::transformSmall ( double  r)

Definition at line 218 of file flatToGaussian.cc.

View newest version in sPHENIX GitHub at line 218 of file flatToGaussian.cc

References kdfinder::abs(), eps, s1, twopi, and v.

Referenced by CLHEP::HepStat::flatToGaussian().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

static const Hep2Vector CLHEP::X_HAT2 ( 1.  0,
0.  0 
)
static
static const Hep2Vector CLHEP::Y_HAT2 ( 0.  0,
1.  0 
)
static
void CLHEP::ZMinput2doubles ( std::istream &  is,
const char *  type,
double &  x,
double &  y 
)

Definition at line 243 of file ZMinput.cc.

View newest version in sPHENIX GitHub at line 243 of file ZMinput.cc

References c, and m.

Referenced by operator>>().

+ Here is the caller graph for this function:

void CLHEP::ZMinput3doubles ( std::istream &  is,
const char *  type,
double &  x,
double &  y,
double &  z 
)

Definition at line 42 of file ZMinput.cc.

View newest version in sPHENIX GitHub at line 42 of file ZMinput.cc

References c, and m.

Referenced by operator>>(), and ZMinputAxisAngle().

+ Here is the caller graph for this function:

void CLHEP::ZMinputAxisAngle ( std::istream &  is,
double &  x,
double &  y,
double &  z,
double &  delta 
)

Definition at line 156 of file ZMinput.cc.

View newest version in sPHENIX GitHub at line 156 of file ZMinput.cc

References c, m, and ZMinput3doubles().

Referenced by operator>>().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

static void CLHEP::ZMpvAxisAngleRep ( const HepAxisAngle &  aa,
double  array[] 
)
static

Definition at line 20 of file AxisAngle.cc.

View newest version in sPHENIX GitHub at line 20 of file AxisAngle.cc

References CLHEP::HepAxisAngle::delta(), CLHEP::HepAxisAngle::getAxis(), CLHEP::Hep3Vector::getX(), CLHEP::Hep3Vector::getY(), and CLHEP::Hep3Vector::getZ().

Referenced by CLHEP::HepAxisAngle::distance().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

static void CLHEP::ZMpvEulerAnglesRep ( const HepEulerAngles &  ex,
double  array[] 
)
static

Definition at line 43 of file EulerAngles.cc.

View newest version in sPHENIX GitHub at line 43 of file EulerAngles.cc

References CLHEP::HepEulerAngles::phi(), CLHEP::HepEulerAngles::psi(), and CLHEP::HepEulerAngles::theta().

Referenced by CLHEP::HepEulerAngles::distance().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

Variable Documentation

constexpr double CLHEP::alpha_rcl2
static
Initial value:

Definition at line 100 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 100 of file PhysicalConstants.h

constexpr double CLHEP::ampere = coulomb/second
static

Definition at line 213 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 213 of file SystemOfUnits.h

constexpr double CLHEP::amu = amu_c2/c_squared
static

Definition at line 82 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 82 of file PhysicalConstants.h

Referenced by G4SandiaTable::GetSandiaPerAtom().

constexpr double CLHEP::amu_c2 = 931.494028 * MeV
static
constexpr double CLHEP::angstrom = 1.e-10*meter
static

Definition at line 81 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 81 of file SystemOfUnits.h

Referenced by G4ChannelingTrackData::Print().

constexpr double CLHEP::atmosphere = 101325*pascal
static

Definition at line 208 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 208 of file SystemOfUnits.h

Referenced by operator<<().

constexpr double CLHEP::bar = 100000*pascal
static

Definition at line 207 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 207 of file SystemOfUnits.h

constexpr double CLHEP::becquerel = 1./second
static

Definition at line 270 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 270 of file SystemOfUnits.h

constexpr double CLHEP::Bq = becquerel
static

Definition at line 277 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 277 of file SystemOfUnits.h

constexpr double CLHEP::c_squared = c_light * c_light
static

Definition at line 55 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 55 of file PhysicalConstants.h

Referenced by G4ParticleDefinition::CalculateAnomaly(), and F06PrimaryGeneratorAction::F06PrimaryGeneratorAction().

constexpr double CLHEP::candela = 1.
static

Definition at line 296 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 296 of file SystemOfUnits.h

constexpr double CLHEP::centimeter = 10.*millimeter
static

Definition at line 65 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 65 of file SystemOfUnits.h

Referenced by G4Navigator::CheckOverlapsIterative().

constexpr double CLHEP::centimeter2 = centimeter*centimeter
static

Definition at line 66 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 66 of file SystemOfUnits.h

constexpr double CLHEP::centimeter3 = centimeter*centimeter*centimeter
static

Definition at line 67 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 67 of file SystemOfUnits.h

constexpr double CLHEP::Ci = curie
static

Definition at line 281 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 281 of file SystemOfUnits.h

constexpr double CLHEP::cL = 1.e-2*liter
static

Definition at line 105 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 105 of file SystemOfUnits.h

constexpr double CLHEP::classic_electr_radius = elm_coupling/electron_mass_c2
static
constexpr double CLHEP::cm2 = centimeter2
static

Definition at line 99 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 99 of file SystemOfUnits.h

Referenced by G4ICRU90StoppingData::AddData(), G4VLEPTSModel::BuildMeanFreePathTable(), G4Material::ComputeNuclearInterLength(), and G4VMscModel::G4VMscModel().

constexpr double CLHEP::coulomb = eplus/e_SI
static

Definition at line 158 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 158 of file SystemOfUnits.h

constexpr double CLHEP::curie = 3.7e+10 * becquerel
static

Definition at line 271 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 271 of file SystemOfUnits.h

constexpr double CLHEP::degree = (pi/180.0)*radian
static

Definition at line 123 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 123 of file SystemOfUnits.h

constexpr double CLHEP::dL = 1.e-1*liter
static

Definition at line 104 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 104 of file SystemOfUnits.h

constexpr double CLHEP::e_SI = 1.602176487e-19
static

Definition at line 157 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 157 of file SystemOfUnits.h

constexpr double CLHEP::e_squared = eplus * eplus
static

Definition at line 71 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 71 of file PhysicalConstants.h

constexpr double CLHEP::electron_charge = - eplus
static

Definition at line 70 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 70 of file PhysicalConstants.h

constexpr double CLHEP::electron_Compton_length = hbarc/electron_mass_c2
static

Definition at line 97 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 97 of file PhysicalConstants.h

constexpr double CLHEP::electron_mass_c2 = 0.510998910 * MeV
static

Definition at line 78 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 78 of file PhysicalConstants.h

Referenced by G4HadronicProcess::CheckEnergyMomentumConservation(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4hPairProductionModel::ComputeDMicroscopicCrossSection(), G4MuPairProductionModel::ComputeDMicroscopicCrossSection(), G4PairProductionRelModel::ComputeDXSectionPerAtom(), G4PairProductionRelModel::ComputeParametrizedXSectionPerAtom(), G4PairProductionRelModel::ComputeRelDXSectionPerAtom(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4ICRU73QOModel::DEDXPerElement(), G4GSMottCorrection::G4GSMottCorrection(), G4GSPWACorrections::G4GSPWACorrections(), G4NistElementBuilder::GetAtomicMass(), G4DynamicParticle::GetElectronMass(), G4GSPWACorrections::InitDataMaterial(), G4LEPTSElasticModel::Initialise(), G4BetheHeitler5DModel::Initialise(), G4GSMottCorrection::InitMCDataMaterial(), G4GoudsmitSaundersonTable::InitSCPCorrection(), G4eeToHadronsMultiModel::LabToCM(), G4ionIonisation::MinPrimaryEnergy(), G4DipBustGenerator::SampleCosTheta(), G4ModifiedTsai::SampleCosTheta(), G4SBBremTable::SampleEnergyTransfer(), G4GoudsmitSaundersonMscModel::SampleMSC(), G4LEPTSIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4MuBetheBlochModel::SetParticle(), G4MuBremsstrahlungModel::SetParticle(), G4ICRU73QOModel::SetParticle(), G4BraggModel::SetParticle(), G4BraggIonModel::SetParticle(), G4BetaPlusDecay::SetUpBetaSpectrumSampler(), G4BetaMinusDecay::SetUpBetaSpectrumSampler(), G4SeltzerBergerModel::SetupForMaterial(), and G4EmCorrections::SetupKinematics().

constexpr double CLHEP::electronvolt = 1.e-6*megaelectronvolt
static

Definition at line 164 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 164 of file SystemOfUnits.h

constexpr double CLHEP::elm_coupling = e_squared/(4*pi*epsilon0)
static

Definition at line 94 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 94 of file PhysicalConstants.h

Referenced by G4AnnihiToMuPair::ComputeCrossSectionPerAtom(), G4CoulombBarrier::G4CoulombBarrier(), and G4GEMCoulombBarrier::GetCoulombBarrier().

constexpr double CLHEP::epsilon0 = 1./(c_squared*mu0)
static

Definition at line 89 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 89 of file PhysicalConstants.h

constexpr double CLHEP::eV = electronvolt
static

Definition at line 174 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 174 of file SystemOfUnits.h

Referenced by G4DensityEffectData::AddMaterial(), G4NistMaterialBuilder::AddMaterial(), G4UnstableFragmentBreakUp::BreakUpChain(), G4VLEPTSModel::BuildMeanFreePathTable(), G4LossTableBuilder::BuildTableForModel(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4Material::ComputeDerivedQuantities(), G4SandiaTable::ComputeMatSandiaMatrix(), G4ThermalNeutrons::ConstructProcess(), G4GoudsmitSaundersonMscModel::CrossSectionPerVolume(), G4FermiPhaseSpaceDecay::Decay(), G4ParticleHPInelasticData::DumpPhysicsTable(), TSRunAction::EndOfRunAction(), G4ParticleHPSimpleEvapSpectrum::Evapo(), G4DNASancheExcitationModel::ExtendLowEnergyLimit(), G4HadronicProcess::FillResult(), G4EmCalculator::FindEmModel(), G4NuclearPolarizationStore::FindOrBuild(), G4DensityEffectCalculator::G4DensityEffectCalculator(), G4LENDManager::G4LENDManager(), G4NeutronRadCapture::G4NeutronRadCapture(), G4PAIModel::G4PAIModel(), G4PAIPhotModel::G4PAIPhotModel(), G4PhotonEvaporation::G4PhotonEvaporation(), G4VMultipleScattering::G4VMultipleScattering(), G4AtomicShells::GetBindingEnergy(), G4ParticleHPFissionERelease::GetPromptNeutronKinetic(), G4ICRU73QOModel::GetShellEnergy(), G4AtomicShells::GetTotalBindingEnergy(), G4ParticleHPFissionERelease::GetTotalEnergy(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePath(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePathOnly(), G4ParticleHPPolynomExpansion::GetValue(), G4ParticleHPWattSpectrum::Init(), G4ParticleHPFissionSpectrum::Init(), G4ParticleHPSimpleEvapSpectrum::Init(), G4ParticleHPAngularP::Init(), G4ParticleHPFissionERelease::Init(), G4ParticleHPDiscreteTwoBody::Init(), G4ParticleHPArbitaryTab::Init(), G4ParticleHPMadlandNixSpectrum::Init(), G4ParticleHPIsoData::Init(), G4ParticleHPLegendreTable::Init(), G4ParticleHPInelasticBaseFS::Init(), G4ParticleHPPartial::Init(), G4VLEPTSModel::Init(), G4ParticleHPInelasticCompFS::Init(), G4ParticleHPProduct::Init(), G4ParticleHPParticleYield::InitDelayed(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4DNARotExcitation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4ParticleHPParticleYield::InitMean(), G4ParticleHPParticleYield::InitPrompt(), G4SBBremTable::LoadSTGrid(), G4ParticleHPFissionSpectrum::Maxwell(), G4DensityEffectData::PrintData(), UltraPMTSD::ProcessHits(), CCaloSD::ProcessHits(), G4LEPTSExcitationModel::ReadIXS(), G4VLEPTSModel::ReadParam(), G4ParticleHPEvapSpectrum::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPFissionSpectrum::Sample(), G4ParticleHPSimpleEvapSpectrum::Sample(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4VLEPTSModel::SampleEnergyLoss(), G4LEPTSIonisationModel::SampleSecondaries(), G4LEPTSElasticModel::SampleSecondaries(), G4LEPTSRotExcitationModel::SampleSecondaries(), G4LEPTSVibExcitationModel::SampleSecondaries(), G4LEPTSPositroniumModel::SampleSecondaries(), G4LEPTSDissociationModel::SampleSecondaries(), G4LEPTSExcitationModel::SampleSecondaries(), G4PEEffectFluoModel::SampleSecondaries(), LBE::SetCuts(), G4DeexPrecoParameters::SetDefaults(), G4ChannelingMaterialData::SetFilename(), G4ChannelingMaterialData::SetFilenameElement(), G4MicroElecElasticModel::SetKillBelowThreshold(), G4MuElecElasticModel::SetKillBelowThreshold(), G4VHadDecayAlgorithm::TwoBodyMomentum(), CCalSteppingAction::UserSteppingAction(), and G4ParticleHPWattSpectrum::Watt().

constexpr double CLHEP::farad = coulomb/volt
static

Definition at line 233 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 233 of file SystemOfUnits.h

constexpr double CLHEP::gauss = 1.e-4*tesla
static

Definition at line 249 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 249 of file SystemOfUnits.h

const double CLHEP::gaussTables[2 *TableSize]
static
Initial value:
= {
}

Definition at line 84 of file flatToGaussian.cc.

View newest version in sPHENIX GitHub at line 84 of file flatToGaussian.cc

Referenced by CLHEP::HepStat::flatToGaussian(), and CLHEP::RandGaussQ::transformQuick().

const float CLHEP::gaussTables[TableSize]
static
Initial value:
= {
}

Definition at line 87 of file RandGaussQ.cc.

View newest version in sPHENIX GitHub at line 87 of file RandGaussQ.cc

constexpr double CLHEP::GBq = gigabecquerel
static

Definition at line 280 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 280 of file SystemOfUnits.h

constexpr double CLHEP::GeV = gigaelectronvolt
static

Definition at line 176 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 176 of file SystemOfUnits.h

Referenced by G4LMsdGenerator::ApplyYourself(), BiasingOperation::BiasingOperation(), LBE::ConstructHad(), G4EmLEPTSPhysics::ConstructProcess(), G4MuonicAtomDecay::DumpState(), G4HadronicProcess::DumpState(), G4HadronicProcess::FillResult(), G4FissionBarrier::FissionBarrier(), G4BGGPionInelasticXS::G4BGGPionInelasticXS(), G4FTFParamCollBaryonProj::G4FTFParamCollBaryonProj(), G4FTFParamCollMesonProj::G4FTFParamCollMesonProj(), G4HadronicParameters::G4HadronicParameters(), G4InuclParticle::G4InuclParticle(), G4LightTargetCollider::G4LightTargetCollider(), G4LowEGammaNuclearModel::G4LowEGammaNuclearModel(), G4MuonVDNuclearModel::G4MuonVDNuclearModel(), G4NeutronRadCapture::G4NeutronRadCapture(), G4PairProductionRelModel::G4PairProductionRelModel(), G4RPGAntiKZeroInelastic::G4RPGAntiKZeroInelastic(), G4RPGAntiLambdaInelastic::G4RPGAntiLambdaInelastic(), G4RPGAntiNeutronInelastic::G4RPGAntiNeutronInelastic(), G4RPGAntiOmegaMinusInelastic::G4RPGAntiOmegaMinusInelastic(), G4RPGAntiProtonInelastic::G4RPGAntiProtonInelastic(), G4RPGAntiSigmaMinusInelastic::G4RPGAntiSigmaMinusInelastic(), G4RPGAntiSigmaPlusInelastic::G4RPGAntiSigmaPlusInelastic(), G4RPGAntiXiMinusInelastic::G4RPGAntiXiMinusInelastic(), G4RPGAntiXiZeroInelastic::G4RPGAntiXiZeroInelastic(), G4RPGKLongInelastic::G4RPGKLongInelastic(), G4RPGKMinusInelastic::G4RPGKMinusInelastic(), G4RPGKPlusInelastic::G4RPGKPlusInelastic(), G4RPGKShortInelastic::G4RPGKShortInelastic(), G4RPGKZeroInelastic::G4RPGKZeroInelastic(), G4RPGLambdaInelastic::G4RPGLambdaInelastic(), G4RPGOmegaMinusInelastic::G4RPGOmegaMinusInelastic(), G4RPGSigmaMinusInelastic::G4RPGSigmaMinusInelastic(), G4RPGSigmaPlusInelastic::G4RPGSigmaPlusInelastic(), G4RPGXiMinusInelastic::G4RPGXiMinusInelastic(), G4RPGXiZeroInelastic::G4RPGXiZeroInelastic(), G4RTPrimaryGeneratorAction::G4RTPrimaryGeneratorAction(), G4BGGNucleonElasticXS::GetElementCrossSection(), G4BGGNucleonInelasticXS::GetElementCrossSection(), G4InuclParticle::getEnergy(), G4InuclNuclei::getExitationEnergy(), G4InuclNuclei::getExitationEnergyInGeV(), G4NuclNuclDiffuseElastic::GetHadronNucleonXscNS(), G4BGGNucleonElasticXS::GetIsoCrossSection(), G4BGGNucleonInelasticXS::GetIsoCrossSection(), G4InuclParticle::getKineticEnergy(), G4QMDParticipant::GetMass(), G4InuclParticle::getMass(), G4InuclParticle::getMomentum(), G4InuclParticle::getMomModule(), G4InuclNuclei::getNucleiMass(), G4XNNTotalLowE::HighLimit(), G4FTFParameters::InitForInteraction(), G4EmParameters::Initialise(), G4SBBremTable::LoadSTGrid(), operator<<(), G4ChannelingTrackData::Print(), G4LMsdGenerator::SampleMx(), G4LMsdGenerator::SampleT(), G4FTFParameters::SetAveragePt2(), LBE::SetCuts(), G4DeexPrecoParameters::SetDefaults(), G4InuclParticle::setKineticEnergy(), G4InuclParticle::setMass(), G4hhElastic::SetParameters(), G4hhElastic::SetParametersCMS(), G4FTFParameters::SetProjMinDiffMass(), G4FTFParameters::SetProjMinNonDiffMass(), G4FTFParameters::SetTarMinDiffMass(), G4FTFParameters::SetTarMinNonDiffMass(), Shielding::Shielding(), G4EmParameters::StreamInfo(), and CCalSteppingAction::UserSteppingAction().

constexpr double CLHEP::gigabecquerel = 1.e+9*becquerel
static

Definition at line 274 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 274 of file SystemOfUnits.h

constexpr double CLHEP::gigaelectronvolt = 1.e+3*megaelectronvolt
static

Definition at line 166 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 166 of file SystemOfUnits.h

constexpr double CLHEP::gram = 1.e-3*kilogram
static

Definition at line 184 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 184 of file SystemOfUnits.h

Referenced by FW::Geant4::MMSteppingAction::UserSteppingAction().

constexpr double CLHEP::gray = joule/kilogram
static

Definition at line 288 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 288 of file SystemOfUnits.h

Referenced by DicomRunAction::EndOfRunAction(), and Dicom2RunAction::EndOfRunAction().

constexpr double CLHEP::h_Planck = 6.62606896e-34 * joule*s
static

Definition at line 62 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 62 of file PhysicalConstants.h

Referenced by G4GNASHTransitions::CalculateProbability().

constexpr double CLHEP::hbarc = hbar_Planck * c_light
static

Definition at line 64 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 64 of file PhysicalConstants.h

Referenced by G4NeutronElectronElModel::CalculateAm(), G4NeutronElectronElXsc::CalculateAm(), G4DiffuseElasticV2::CalculateAm(), G4NuclNuclDiffuseElastic::CalculateAm(), G4DiffuseElastic::CalculateAm(), G4hhElastic::CalculateBqQ12(), G4hhElastic::CalculateBqQ123(), G4hhElastic::CalculateBqQ13(), G4PreCompoundTransitions::CalculateProbability(), G4ComponentGGNuclNuclXsc::ComputeCoulombBarier(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4EvaporationProbability::G4EvaporationProbability(), G4GEMProbabilityVI::G4GEMProbabilityVI(), G4HETCFragment::G4HETCFragment(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4NuclNuclDiffuseElastic::GetCoulombElasticXsc(), G4DiffuseElastic::GetCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), G4hhElastic::GetdsdtF13qQG(), G4PhotonEvaporation::GetEmissionProbability(), G4hhElastic::GetF1(), G4hhElastic::GetF1qQgG(), G4hhElastic::GetF2(), G4hhElastic::GetF2qQgG(), G4hhElastic::GetF3(), G4hhElastic::GetF3qQgG(), G4NuclNuclDiffuseElastic::InitDynParameters(), G4WentzelOKandVIxSection::Initialise(), G4CoulombScattering::InitialiseProcess(), G4NuclNuclDiffuseElastic::InitParameters(), G4NuclNuclDiffuseElastic::InitParametersGla(), and G4PreCompoundNucleon::ProbabilityDistributionFunction().

constexpr double CLHEP::hbarc_squared = hbarc * hbarc
static

Definition at line 65 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 65 of file PhysicalConstants.h

constexpr double CLHEP::henry = weber/ampere
static

Definition at line 255 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 255 of file SystemOfUnits.h

constexpr double CLHEP::hep_pascal = newton/m2
static

Definition at line 206 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 206 of file SystemOfUnits.h

const int CLHEP::HepRandomGenActive = HepRandom::createInstance()
static

Definition at line 64 of file Randomize.h.

View newest version in sPHENIX GitHub at line 64 of file Randomize.h

constexpr double CLHEP::hertz = 1./second
static

Definition at line 142 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 142 of file SystemOfUnits.h

const float CLHEP::inverseLandau[TABLE_END+1]
static

Definition at line 73 of file RandLandau.cc.

View newest version in sPHENIX GitHub at line 73 of file RandLandau.cc

Referenced by CLHEP::RandLandau::transform().

constexpr double CLHEP::joule = electronvolt/e_SI
static

Definition at line 170 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 170 of file SystemOfUnits.h

constexpr double CLHEP::k_Boltzmann = 8.617343e-11 * MeV/kelvin
static

Definition at line 110 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 110 of file PhysicalConstants.h

Referenced by G4NistMaterialBuilder::ConstructNewIdealGasMaterial(), and G4ParticleHPInelasticData::GetCrossSection().

constexpr double CLHEP::kBq = kilobecquerel
static

Definition at line 278 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 278 of file SystemOfUnits.h

constexpr double CLHEP::kelvin = 1.
static

Definition at line 260 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 260 of file SystemOfUnits.h

Referenced by G4ParticleHPInelasticData::GetCrossSection(), and operator<<().

constexpr double CLHEP::keV = kiloelectronvolt
static

Definition at line 175 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 175 of file SystemOfUnits.h

Referenced by G4ParticleHPInelasticBaseFS::BaseApply(), G4ParticleHPInelasticCompFS::CompositeApply(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4SandiaTable::ComputeMatSandiaMatrix(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), G4MonopolePhysics::ConstructProcess(), BrachyUserScoreWriter::DumpQuantityToFile(), TSRunAction::EndOfRunAction(), G4HadronicProcess::FillResult(), G4VEmissionProbability::FindRecoilExcitation(), G4EmCorrections::G4EmCorrections(), G4GDecay3::G4GDecay3(), G4GoudsmitSaundersonTable::G4GoudsmitSaundersonTable(), G4NeutronRadCapture::G4NeutronRadCapture(), BrachyPrimaryGeneratorAction::GeneratePrimaries(), G4AtomicShells_XDB_EADL::GetBindingEnergy(), G4NuMuNucleusNcModel::GetMinNuMuEnergy(), G4SandiaTable::GetSandiaCofPerAtom(), G4SandiaTable::GetSandiaCofWater(), G4SandiaTable::GetSandiaPerAtom(), G4AtomicShells_XDB_EADL::GetTotalBindingEnergy(), G4SandiaTable::GetWaterEnergyLimit(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4EmParameters::Initialise(), G4LevelReader::LevelManager(), main(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4UniversalFluctuation::SampleFluctuations(), G4DNAUeharaScreenedRutherfordElasticModel::SelectHighEnergyLimit(), IORTPrimaryGeneratorAction::SetDefaultPrimaryParticle(), G4CoupledTransportation::SetLowLooperThresholds(), G4Transportation::SetLowLooperThresholds(), and G4DeexPrecoParameters::StreamInfo().

constexpr double CLHEP::kg = kilogram
static

Definition at line 188 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 188 of file SystemOfUnits.h

constexpr double CLHEP::kGasThreshold = 10.*mg/cm3
static

Definition at line 117 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 117 of file PhysicalConstants.h

constexpr double CLHEP::kilobecquerel = 1.e+3*becquerel
static

Definition at line 272 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 272 of file SystemOfUnits.h

constexpr double CLHEP::kiloelectronvolt = 1.e-3*megaelectronvolt
static

Definition at line 165 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 165 of file SystemOfUnits.h

Referenced by F01RunAction::F01RunAction().

constexpr double CLHEP::kilogauss = 1.e-1*tesla
static

Definition at line 250 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 250 of file SystemOfUnits.h

Referenced by genfit::Field::get().

constexpr double CLHEP::kilogram = joule*second*second/(meter*meter)
static

Definition at line 183 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 183 of file SystemOfUnits.h

constexpr double CLHEP::kilogray = 1.e+3*gray
static

Definition at line 289 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 289 of file SystemOfUnits.h

constexpr double CLHEP::kilohertz = 1.e+3*hertz
static

Definition at line 143 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 143 of file SystemOfUnits.h

constexpr double CLHEP::kilometer = 1000.*meter
static

Definition at line 73 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 73 of file SystemOfUnits.h

constexpr double CLHEP::kilometer2 = kilometer*kilometer
static

Definition at line 74 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 74 of file SystemOfUnits.h

constexpr double CLHEP::kilometer3 = kilometer*kilometer*kilometer
static

Definition at line 75 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 75 of file SystemOfUnits.h

constexpr double CLHEP::kilovolt = 1.e-3*megavolt
static

Definition at line 222 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 222 of file SystemOfUnits.h

constexpr double CLHEP::km = kilometer
static

Definition at line 112 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 112 of file SystemOfUnits.h

Referenced by XrayFluoMercuryDetectorConstruction::ComputeApparateParameters().

constexpr double CLHEP::km2 = kilometer2
static

Definition at line 113 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 113 of file SystemOfUnits.h

constexpr double CLHEP::km3 = kilometer3
static

Definition at line 114 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 114 of file SystemOfUnits.h

constexpr double CLHEP::L = liter
static

Definition at line 103 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 103 of file SystemOfUnits.h

Referenced by CLHEP::RandBinomial::genBinomial(), CLHEP::RanshiEngine::RanshiEngine(), CLHEP::HepJamesRandom::setSeeds(), and StirlingCorrection().

constexpr double CLHEP::liter = 1.e+3*cm3
static

Definition at line 102 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 102 of file SystemOfUnits.h

constexpr double CLHEP::lumen = candela*steradian
static

Definition at line 301 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 301 of file SystemOfUnits.h

constexpr double CLHEP::lux = lumen/meter2
static
constexpr double CLHEP::m2 = meter2
static

Definition at line 109 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 109 of file SystemOfUnits.h

constexpr double CLHEP::m3 = meter3
static

Definition at line 110 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 110 of file SystemOfUnits.h

Referenced by G4DNAMolecularReactionData::ArrehniusParam(), and G4DNAMolecularReactionData::PolynomialParam().

const int CLHEP::MarkerLen = 64
static

Definition at line 50 of file MixMaxRng.cc.

View newest version in sPHENIX GitHub at line 50 of file MixMaxRng.cc

const int CLHEP::MarkerLen = 64
static

Definition at line 55 of file RanecuEngine.cc.

View newest version in sPHENIX GitHub at line 55 of file RanecuEngine.cc

const int CLHEP::MarkerLen = 64
static

Definition at line 57 of file RanluxEngine.cc.

View newest version in sPHENIX GitHub at line 57 of file RanluxEngine.cc

const int CLHEP::MarkerLen = 64
static

Definition at line 58 of file JamesRandom.cc.

View newest version in sPHENIX GitHub at line 58 of file JamesRandom.cc

const int CLHEP::MarkerLen = 64
static

Definition at line 58 of file RanshiEngine.cc.

View newest version in sPHENIX GitHub at line 58 of file RanshiEngine.cc

const int CLHEP::MarkerLen = 64
static

Definition at line 59 of file MTwistEngine.cc.

View newest version in sPHENIX GitHub at line 59 of file MTwistEngine.cc

const int CLHEP::MarkerLen = 64
static

Definition at line 75 of file Ranlux64Engine.cc.

View newest version in sPHENIX GitHub at line 75 of file Ranlux64Engine.cc

constexpr double CLHEP::MBq = megabecquerel
static

Definition at line 279 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 279 of file SystemOfUnits.h

constexpr double CLHEP::mCi = millicurie
static

Definition at line 282 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 282 of file SystemOfUnits.h

constexpr double CLHEP::megabecquerel = 1.e+6*becquerel
static

Definition at line 273 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 273 of file SystemOfUnits.h

constexpr double CLHEP::megaelectronvolt = 1.
static

Definition at line 163 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 163 of file SystemOfUnits.h

constexpr double CLHEP::megahertz = 1.e+6*hertz
static

Definition at line 144 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 144 of file SystemOfUnits.h

constexpr double CLHEP::megavolt = megaelectronvolt/eplus
static

Definition at line 221 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 221 of file SystemOfUnits.h

constexpr double CLHEP::meter = 1000.*millimeter
static

Definition at line 69 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 69 of file SystemOfUnits.h

Referenced by G4ChannelingECHARM::ReadFromECHARM(), and G4ChannelingMaterialData::SetBR().

constexpr double CLHEP::meter2 = meter*meter
static

Definition at line 70 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 70 of file SystemOfUnits.h

constexpr double CLHEP::meter3 = meter*meter*meter
static

Definition at line 71 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 71 of file SystemOfUnits.h

constexpr double CLHEP::MeV = megaelectronvolt
static

Definition at line 173 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 173 of file SystemOfUnits.h

Referenced by G4ICRU90StoppingData::AddData(), G4LMsdGenerator::ApplyYourself(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), G4FissionBarrier::BarashenkovFissionBarrier(), G4ParticleHPInelasticBaseFS::BaseApply(), BiasingOperation::BiasingOperation(), G4UnstableFragmentBreakUp::BreakUpChain(), G4NeutronEvaporationProbability::CalcBetaParam(), G4GEMProbability::CalcBetaParam(), G4GNASHTransitions::CalculateProbability(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4NIELCalculator::ComputeNIEL(), G4PairProductionRelModel::ComputeParametrizedXSectionPerAtom(), G4UrbanMscModel::ComputeTheta0(), G4UrbanAdjointMscModel::ComputeTheta0(), G4GEMProbabilityVI::ComputeTotalProbability(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), LBE::ConstructEM(), LBE::ConstructHad(), G4FissionParameters::DefineParameters(), G4FermiFragmentsPoolVI::Dump(), G4ParticleHPInelasticData::DumpPhysicsTable(), G4FPYSamplingOps::EvaluateWattConstants(), G4CompetitiveFission::FissionKineticEnergy(), G4BGGPionInelasticXS::G4BGGPionInelasticXS(), G4CameronGilbertPairingCorrections::G4CameronGilbertPairingCorrections(), G4CameronGilbertShellCorrections::G4CameronGilbertShellCorrections(), G4CameronShellPlusPairingCorrections::G4CameronShellPlusPairingCorrections(), G4CameronTruranHilfPairingCorrections::G4CameronTruranHilfPairingCorrections(), G4CameronTruranHilfShellCorrections::G4CameronTruranHilfShellCorrections(), G4CookPairingCorrections::G4CookPairingCorrections(), G4CookShellCorrections::G4CookShellCorrections(), G4DiffElasticRatio::G4DiffElasticRatio(), G4ElasticHadrNucleusHE::G4ElasticHadrNucleusHE(), G4EmCorrections::G4EmCorrections(), G4EvaporationProbability::G4EvaporationProbability(), G4FermiBreakUpVI::G4FermiBreakUpVI(), G4FTFSettingDefaultHDP::G4FTFSettingDefaultHDP(), G4GEMProbabilityVI::G4GEMProbabilityVI(), G4GoudsmitSaundersonTable::G4GoudsmitSaundersonTable(), G4InuclParticle::G4InuclParticle(), G4LowEHadronElastic::G4LowEHadronElastic(), G4PairProductionRelModel::G4PairProductionRelModel(), G4ParticleHPInelasticData::G4ParticleHPInelasticData(), G4UPiNuclearCrossSection::G4UPiNuclearCrossSection(), G4VMscModel::G4VMscModel(), G4NeutronInelasticXS::GetElementCrossSection(), G4NeutronElasticXS::GetElementCrossSection(), G4ParticleInelasticXS::GetElementCrossSection(), G4NeutronCaptureXS::GetElementCrossSection(), G4EvaporationChannel::GetEmissionProbability(), G4PhotonEvaporation::GetEmissionProbability(), G4InuclParticle::getEnergy(), G4InuclNuclei::getExitationEnergy(), G4InuclParticle::getKineticEnergy(), G4InuclParticle::getMass(), G4NuMuNucleusCcModel::GetMinNuMuEnergy(), G4NeutrinoNucleusModel::GetMinNuMuEnergy(), G4InuclParticle::getMomentum(), G4InuclParticle::getMomModule(), G4InuclNuclei::getNucleiMass(), G4NuclearLevelData::GetPairingCorrection(), G4VLEPTSModel::Init(), G4GSPWACorrections::InitDataMaterial(), G4LEPTSElasticModel::Initialise(), G4EmParameters::Initialise(), G4PhotonEvaporation::InitialiseGRData(), G4DNADissociation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4GSMottCorrection::InitMCDataMaterial(), G4GoudsmitSaundersonTable::InitMoliereMSCParams(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4VEmissionProbability::IntegrateProbability(), G4LMsdGenerator::IsApplicable(), G4ParticleInelasticXS::IsoCrossSection(), G4NeutronElasticXS::IsoCrossSection(), G4NeutronInelasticXS::IsoCrossSection(), G4LevelReader::LevelManager(), G4SBBremTable::LoadSTGrid(), main(), operator<<(), G4VEnergyLossProcess::PreparePhysicsTable(), G4Transportation::PrintStatistics(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), G4Transportation::ProcessDescription(), G4ComponentSAIDTotalXS::ReadData(), G4TransportationLogger::ReportLooperThresholds(), G4ParticleHPFissionSpectrum::Sample(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4HadronElastic::SampleInvariantT(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), IORTPrimaryGeneratorAction::SetDefaultPrimaryParticle(), G4DeexPrecoParameters::SetDefaults(), G4CoupledTransportation::SetHighLooperThresholds(), G4Transportation::SetHighLooperThresholds(), G4InuclParticle::setKineticEnergy(), G4DeexPrecoParameters::SetLevelDensity(), G4CoupledTransportation::SetLowLooperThresholds(), G4Transportation::SetLowLooperThresholds(), G4InuclParticle::setMass(), G4hhElastic::SetParametersCMS(), G4DeexPrecoParameters::StreamInfo(), G4EmParameters::StreamInfo(), TSPrimaryGeneratorAction::TSPrimaryGeneratorAction(), and G4EmConfigurator::UpdateModelEnergyRange().

constexpr double CLHEP::mg = milligram
static

Definition at line 190 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 190 of file SystemOfUnits.h

constexpr double CLHEP::microampere = 1.e-6*ampere
static

Definition at line 215 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 215 of file SystemOfUnits.h

constexpr double CLHEP::microbarn = 1.e-6 *barn
static

Definition at line 86 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 86 of file SystemOfUnits.h

Referenced by G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), and G4PairProductionRelModel::ComputeParametrizedXSectionPerAtom().

constexpr double CLHEP::microcurie = 1.e-6*curie
static

Definition at line 276 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 276 of file SystemOfUnits.h

constexpr double CLHEP::microfarad = 1.e-6*farad
static

Definition at line 235 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 235 of file SystemOfUnits.h

constexpr double CLHEP::microgray = 1.e-6*gray
static

Definition at line 291 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 291 of file SystemOfUnits.h

constexpr double CLHEP::micrometer = 1.e-6 *meter
static

Definition at line 79 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 79 of file SystemOfUnits.h

Referenced by LBE::LBE().

constexpr double CLHEP::microsecond = 1.e-6 *second
static

Definition at line 139 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 139 of file SystemOfUnits.h

Referenced by G4DeexPrecoParameters::SetDefaults().

constexpr double CLHEP::milliampere = 1.e-3*ampere
static

Definition at line 214 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 214 of file SystemOfUnits.h

constexpr double CLHEP::millicurie = 1.e-3*curie
static

Definition at line 275 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 275 of file SystemOfUnits.h

constexpr double CLHEP::millifarad = 1.e-3*farad
static

Definition at line 234 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 234 of file SystemOfUnits.h

constexpr double CLHEP::milligram = 1.e-3*gram
static

Definition at line 185 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 185 of file SystemOfUnits.h

constexpr double CLHEP::milligray = 1.e-3*gray
static

Definition at line 290 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 290 of file SystemOfUnits.h

constexpr double CLHEP::millimeter = 1.
static

Definition at line 61 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 61 of file SystemOfUnits.h

Referenced by G4ChannelingMaterialData::SetBR().

constexpr double CLHEP::millimeter2 = millimeter*millimeter
static

Definition at line 62 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 62 of file SystemOfUnits.h

constexpr double CLHEP::millimeter3 = millimeter*millimeter*millimeter
static

Definition at line 63 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 63 of file SystemOfUnits.h

constexpr double CLHEP::milliradian = 1.e-3*radian
static

Definition at line 122 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 122 of file SystemOfUnits.h

constexpr double CLHEP::millisecond = 1.e-3 *second
static

Definition at line 138 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 138 of file SystemOfUnits.h

constexpr double CLHEP::mL = 1.e-3*liter
static

Definition at line 106 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 106 of file SystemOfUnits.h

constexpr double CLHEP::mm2 = millimeter2
static

Definition at line 95 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 95 of file SystemOfUnits.h

constexpr double CLHEP::mm3 = millimeter3
static

Definition at line 96 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 96 of file SystemOfUnits.h

Referenced by FW::Geant4::MMSteppingAction::UserSteppingAction().

constexpr double CLHEP::mrad = milliradian
static

Definition at line 129 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 129 of file SystemOfUnits.h

constexpr double CLHEP::ms = millisecond
static

Definition at line 149 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 149 of file SystemOfUnits.h

constexpr double CLHEP::mu0 = 4*pi*1.e-7 * henry/m
static

Definition at line 88 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 88 of file PhysicalConstants.h

constexpr double CLHEP::nanoampere = 1.e-9*ampere
static

Definition at line 216 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 216 of file SystemOfUnits.h

constexpr double CLHEP::nanobarn = 1.e-9 *barn
static

Definition at line 87 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 87 of file SystemOfUnits.h

constexpr double CLHEP::nanofarad = 1.e-9*farad
static

Definition at line 236 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 236 of file SystemOfUnits.h

constexpr double CLHEP::nanosecond = 1.
static

Definition at line 136 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 136 of file SystemOfUnits.h

constexpr double CLHEP::neutron_mass_c2 = 939.56536 * MeV
static
constexpr double CLHEP::newton = joule/meter
static

Definition at line 200 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 200 of file SystemOfUnits.h

constexpr double CLHEP::nm = nanometer
static
constexpr double CLHEP::ohm = volt/ampere
static

Definition at line 228 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 228 of file SystemOfUnits.h

constexpr double CLHEP::parsec = 3.0856775807e+16*meter
static

Definition at line 77 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 77 of file SystemOfUnits.h

constexpr double CLHEP::pc = parsec
static

Definition at line 116 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 116 of file SystemOfUnits.h

constexpr double CLHEP::perCent = 0.01
static

Definition at line 311 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 311 of file SystemOfUnits.h

Referenced by G4ParticleHPElementData::Init(), and G4Cerenkov::SetMaxBetaChangePerStep().

constexpr double CLHEP::perThousand = 0.001
static

Definition at line 312 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 312 of file SystemOfUnits.h

Referenced by G4MultiLevelLocator::EstimateIntersectionPoint(), and G4VIntersectionLocator::GetLocalSurfaceNormal().

constexpr double CLHEP::petaelectronvolt = 1.e+9*megaelectronvolt
static

Definition at line 168 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 168 of file SystemOfUnits.h

constexpr double CLHEP::PeV = petaelectronvolt
static

Definition at line 178 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 178 of file SystemOfUnits.h

Referenced by G4MuonVDNuclearModel::G4MuonVDNuclearModel().

constexpr double CLHEP::pi = 3.14159265358979323846
static

Definition at line 53 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 53 of file SystemOfUnits.h

Referenced by G4NuclNuclDiffuseElastic::AmplitudeFar(), G4NuclNuclDiffuseElastic::AmplitudeGG(), G4NuclNuclDiffuseElastic::AmplitudeGla(), G4NuclNuclDiffuseElastic::AmplitudeNear(), G4MuonRadiativeDecayChannelWithSpin::atan4(), G4DiffuseElasticV2::BuildAngleTable(), G4DiffuseElastic::BuildAngleTable(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4ParticleHPNBodyPhaseSpace::C(), G4hhElastic::CalculateBqQ12(), G4hhElastic::CalculateBqQ123(), G4hhElastic::CalculateBqQ13(), G4PreCompoundTransitions::CalculateProbability(), G4ScreeningMottCrossSection::ComputeAngle(), G4AnnihiToMuPair::ComputeCrossSectionPerAtom(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4DNAMolecularReactionData::ComputeEffectiveRadius(), G4eBremsstrahlungRelModel::ComputeLPMGsPhis(), G4PairProductionRelModel::ComputeLPMGsPhis(), G4CrystalExtension::ComputeStructureFactor(), G4CrystalExtension::ComputeStructureFactorGeometrical(), G4TablesForExtrapolator::ComputeTrasportXS(), DetectorConstruction::ConstructLine(), correctByPi(), DNAParser::CreateCutSolid(), G4GHEKinematicsVector::Defs1(), CLHEP::HepRotation::delta(), CLHEP::Hep3Vector::deltaPhi(), G4ScreeningMottCrossSection::DifferentialXSection(), CLHEP::HepStat::erf(), CLHEP::RandPoisson::fire(), G4EvaporationProbability::G4EvaporationProbability(), G4GEMProbabilityVI::G4GEMProbabilityVI(), G4HETCFragment::G4HETCFragment(), G4Poisson(), G4PreCompoundIon::G4PreCompoundIon(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4ParticleHPMadlandNixSpectrum::Gamma05(), G4NuclNuclDiffuseElastic::GammaLess(), G4NuclNuclDiffuseElastic::GammaMore(), G4hhElastic::GetAqq(), G4hhElastic::GetAQQ(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), G4EllipticalCone::GetCubicVolume(), G4Ellipsoid::GetCubicVolume(), G4hhElastic::GetdsdtF1(), G4hhElastic::GetdsdtF12(), G4hhElastic::GetdsdtF123(), G4hhElastic::GetdsdtF123qQgG(), G4hhElastic::GetdsdtF12qQgG(), G4hhElastic::GetdsdtF13qQG(), G4hhElastic::GetdsdtF1qQgG(), G4NuclNuclDiffuseElastic::GetErfComp(), G4NuclNuclDiffuseElastic::GetErfInt(), G4NuclNuclDiffuseElastic::GetErfSer(), G4hhElastic::GetExpRatioF123(), G4hhElastic::GetF1(), G4hhElastic::GetF1qQgG(), G4hhElastic::GetF2(), G4hhElastic::GetF2qQgG(), G4hhElastic::GetF3(), G4hhElastic::GetF3qQgG(), G4DiffuseElasticV2::GetIntegrandFunction(), G4NuclNuclDiffuseElastic::GetLegendrePol(), G4ElasticHadrNucleusHE::GetLightFq2(), G4PreCompoundFragment::GetOpt0(), G4Channeling::GetOscillationPeriod(), G4Ellipsoid::GetPointOnSurface(), G4ProtonInelasticCrossSection::GetProtonCrossSection(), G4NuclNuclDiffuseElastic::GetRatioGen(), G4NuclNuclDiffuseElastic::GetRatioSim(), G4EllipticalCone::GetSurfaceArea(), G4Ellipsoid::GetSurfaceArea(), G4ElasticHadrNucleusHE::HadrNucDifferCrSec(), G4WentzelVIModel::Initialise(), G4hCoulombScatteringModel::Initialise(), G4EmParameters::Initialise(), G4CoulombScattering::InitialiseProcess(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4EmCorrections::MottCorrection(), G4NuclNuclDiffuseElastic::PhaseFar(), G4NuclNuclDiffuseElastic::PhaseNear(), G4VAngularDistribution::Phi(), CLHEP::HepRotationY::phi(), CLHEP::HepRotationX::phi(), CLHEP::HepRotation::phi(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGeneratePhiAndTheta(), G4DipBustGenerator::PolarAngle(), G4hhElastic::Pomeron(), G4NuclNuclDiffuseElastic::Profile(), G4NuclNuclDiffuseElastic::ProfileFar(), G4NuclNuclDiffuseElastic::ProfileNear(), CLHEP::HepRotationY::psi(), CLHEP::HepRotationX::psi(), CLHEP::HepRotation::psi(), Run::Run(), safe_acos(), G4UrbanMscModel::SampleCosineTheta(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4Generator2BN::SampleDirection(), G4UrbanMscModel::SampleDisplacement(), G4UrbanMscModel::SampleDisplacementNew(), G4BoldyshevTripletModel::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylTheta(), CLHEP::RandPoisson::shoot(), G4GeomTools::SphereExtent(), and Run::SurveyConvergence().

constexpr double CLHEP::picobarn = 1.e-12*barn
static

Definition at line 88 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 88 of file SystemOfUnits.h

constexpr double CLHEP::picofarad = 1.e-12*farad
static

Definition at line 237 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 237 of file SystemOfUnits.h

constexpr double CLHEP::picosecond = 1.e-12*second
static

Definition at line 140 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 140 of file SystemOfUnits.h

Referenced by ScoreSpecies::ScoreSpecies().

const double CLHEP::poissonTables[51 *((95-10)/5+1)]
static
Initial value:
= {
}

Definition at line 71 of file RandPoissonQ.cc.

View newest version in sPHENIX GitHub at line 71 of file RandPoissonQ.cc

Referenced by CLHEP::RandPoissonQ::poissonDeviateSmall().

const double CLHEP::prec = 4.6566128E-10
static

Definition at line 57 of file RanecuEngine.cc.

View newest version in sPHENIX GitHub at line 57 of file RanecuEngine.cc

Referenced by G4MagInt_Driver::AccurateAdvance(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), RunAction::BeginOfRunAction(), G4SandiaTable::ComputeMatSandiaMatrix(), oncsSub_iduppetdata_v104::dump(), oncsSub_idbspetdata::dump(), oncsSub_idrcpetdata::dump(), oncsSub_iduppetdata::dump(), G4FermiFragmentsPoolVI::Dump(), G4FermiFragmentsPoolVI::DumpFragment(), Run::EndOfRun(), HistoManager::EndOfRun(), LXeRun::EndOfRun(), CLHEP::RanecuEngine::flat(), CLHEP::RanecuEngine::flatArray(), G4PhotonEvaporation::GenerateGamma(), G4ElasticHadrNucleusHE::GetLightFq2(), G4SynchrotronRadiation::GetRandomEnergySR(), G4LevelReader::LevelManager(), G4LevelReader::NormalizedICCProbability(), operator<<(), DetectorConstruction::PrintGeometry(), CexmcRunAction::PrintResults(), CLHEP::RandGauss::put(), G4PropagatorInField::ReportLoopingParticle(), Run::Run(), CLHEP::RandGauss::saveDistState(), CLHEP::RandFlat::saveDistState(), F04SteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), SteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), ExN02SteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F02SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4Physics2DVector::Store(), G4DeexPrecoParameters::StreamInfo(), G4EmParameters::StreamInfo(), G4NucLevel::StreamInfo(), G4LevelManager::StreamInfo(), G4RadioactiveDecayBase::StreamInfo(), G4RadioactiveDecay::StreamInfo(), F04SteppingVerbose::TrackingStarted(), SteppingVerbose::TrackingStarted(), ExN04SteppingVerbose::TrackingStarted(), eRositaSteppingVerbose::TrackingStarted(), FCALSteppingVerbose::TrackingStarted(), XrayFluoSteppingVerbose::TrackingStarted(), PurgMagSteppingVerbose::TrackingStarted(), ExN02SteppingVerbose::TrackingStarted(), RE05SteppingVerbose::TrackingStarted(), ExP01SteppingVerbose::TrackingStarted(), F05SteppingVerbose::TrackingStarted(), G4SteppingVerbose::TrackingStarted(), G4ITSteppingVerbose::TrackingStarted(), F01SteppingVerbose::TrackingStarted(), F03SteppingVerbose::TrackingStarted(), F02SteppingVerbose::TrackingStarted(), G4SteppingVerbose::VerboseTrack(), G4ITSteppingVerbose::VerboseTrack(), and EventAction::WriteFibers().

constexpr double CLHEP::ps = picosecond
static

Definition at line 151 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 151 of file SystemOfUnits.h

Referenced by G4RadioactiveDecayBase::StreamInfo(), and G4RadioactiveDecay::StreamInfo().

constexpr double CLHEP::rad = radian
static

Definition at line 128 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 128 of file SystemOfUnits.h

Referenced by G4EmParameters::StreamInfo().

constexpr double CLHEP::radian = 1.
static

Definition at line 121 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 121 of file SystemOfUnits.h

constexpr double CLHEP::second = 1.e+9 *nanosecond
static

Definition at line 137 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 137 of file SystemOfUnits.h

Referenced by G4LevelReader::G4LevelReader().

constexpr double CLHEP::sr = steradian
static

Definition at line 130 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 130 of file SystemOfUnits.h

constexpr double CLHEP::steradian = 1.
static

Definition at line 125 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 125 of file SystemOfUnits.h

constexpr double CLHEP::STP_Pressure = 1.*atmosphere
static

Definition at line 116 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 116 of file PhysicalConstants.h

Referenced by G4NistMaterialBuilder::ConstructNewIdealGasMaterial(), and G4NistMaterialBuilder::ConstructNewMaterial().

constexpr double CLHEP::STP_Temperature = 273.15*kelvin
static

Definition at line 115 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 115 of file PhysicalConstants.h

const HepLorentzVector CLHEP::T_HAT4 = HepLorentzVector( 0, 0, 0, 1 )
static

Definition at line 541 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 541 of file LorentzVector.h

Referenced by CLHEP::HepLorentzRotation::set().

const int CLHEP::TABLE_END = 982
static

Definition at line 60 of file RandLandau.cc.

View newest version in sPHENIX GitHub at line 60 of file RandLandau.cc

const float CLHEP::TABLE_INTERVAL = .001f
static

Definition at line 59 of file RandLandau.cc.

View newest version in sPHENIX GitHub at line 59 of file RandLandau.cc

const float CLHEP::TABLE_MULTIPLIER = 1.0f/TABLE_INTERVAL
static

Definition at line 61 of file RandLandau.cc.

View newest version in sPHENIX GitHub at line 61 of file RandLandau.cc

Referenced by CLHEP::RandLandau::transform().

constexpr double CLHEP::teraelectronvolt = 1.e+6*megaelectronvolt
static

Definition at line 167 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 167 of file SystemOfUnits.h

constexpr double CLHEP::tesla = volt*second/meter2
static

Definition at line 247 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 247 of file SystemOfUnits.h

Referenced by PHTpcTracker::getMagField().

constexpr double CLHEP::TeV = teraelectronvolt
static

Definition at line 177 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 177 of file SystemOfUnits.h

Referenced by G4HadronicParameters::G4HadronicParameters(), and G4EmParameters::Initialise().

const int CLHEP::Toffsets[5]
static
Initial value:

Definition at line 76 of file flatToGaussian.cc.

View newest version in sPHENIX GitHub at line 76 of file flatToGaussian.cc

Referenced by CLHEP::HepStat::flatToGaussian().

const int CLHEP::Tsizes[5]
static
Initial value:

Definition at line 52 of file flatToGaussian.cc.

View newest version in sPHENIX GitHub at line 52 of file flatToGaussian.cc

Referenced by CLHEP::HepStat::flatToGaussian().

const double CLHEP::Tsteps[5]
static
Initial value:

Definition at line 64 of file flatToGaussian.cc.

View newest version in sPHENIX GitHub at line 64 of file flatToGaussian.cc

Referenced by CLHEP::HepStat::flatToGaussian().

constexpr double CLHEP::twopi = 2*pi
static

Definition at line 54 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 54 of file SystemOfUnits.h

Referenced by PHG4TpcEndCapDetector::AddLayer(), G4NuclNuclDiffuseElastic::AmplitudeGG(), G4PreCompoundEmission::AngularDistribution(), G4HadronElastic::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4NuMuNucleusCcModel::ApplyYourself(), G4NuMuNucleusNcModel::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4KineticTrack::BrWig(), G4ParticleHPInelasticCompFS::CompositeApply(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), PHG4TpcEndCapDetector::ConstructElectronics(), PHG4ZDCDetector::ConstructMe(), PHG4TpcEndCapDetector::ConstructWagonWheel(), CLHEP::Hep3Vector::deltaPhi(), G4ScreeningMottCrossSection::DifferentialXSection(), G4GeomTools::DiskExtent(), G4MuonDecayChannelWithSpin::F_c(), G4MuonDecayChannelWithSpin::F_theta(), G4MuonicAtomDecay::FillResult(), G4PlaneVectorRand(), G4RandomDirection(), G4RandomPointOnEllipse(), G4NuclNuclDiffuseElastic::GammaLogB2n(), G4PolarizationTransition::GenerateGammaPhi(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4ParticleHPDeExGammas::GetDecayGammas(), G4Ellipsoid::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), CML2Acc2::MLC(), G4NeutrinoElectronProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4LEPTSDiffXS::readDXS(), G4ParticleHPDiscreteTwoBody::Sample(), G4LEPTSDiffXS::SampleAngle(), G4DipBustGenerator::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4GammaTransition::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4SBBremTable::SampleEnergyTransfer(), G4PolarizationTransition::SampleGammaTransition(), G4NuMuNucleusCcModel::SampleLVkr(), G4NuMuNucleusNcModel::SampleLVkr(), G4GoudsmitSaundersonMscModel::SampleMSC(), G4VLEPTSModel::SampleNewDirection(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4BetheHeitler5DModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4GoudsmitSaundersonTable::Sampling(), G4GHEKinematicsVector::SetEnergyAndUpdate(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), G4GHEKinematicsVector::SetMassAndUpdate(), G4GeomTools::SphereExtent(), G4EvaporationProbability::TotalProbability(), transformSmall(), CLHEP::RandGaussQ::transformSmall(), and G4ParticleHPInelasticCompFS::two_body_reaction().

constexpr double CLHEP::twopi_mc2_rcl2
static
constexpr double CLHEP::uCi = microcurie
static

Definition at line 283 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 283 of file SystemOfUnits.h

constexpr double CLHEP::um = micrometer
static

Definition at line 92 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 92 of file SystemOfUnits.h

Referenced by LBE::ConstructEM().

constexpr double CLHEP::universe_mean_density = 1.e-25*g/cm3
static

Definition at line 122 of file PhysicalConstants.h.

View newest version in sPHENIX GitHub at line 122 of file PhysicalConstants.h

constexpr double CLHEP::us = microsecond
static

Definition at line 150 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 150 of file SystemOfUnits.h

constexpr double CLHEP::volt = 1.e-6*megavolt
static

Definition at line 223 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 223 of file SystemOfUnits.h

constexpr double CLHEP::watt = joule/second
static

Definition at line 195 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 195 of file SystemOfUnits.h

constexpr double CLHEP::weber = volt*second
static

Definition at line 242 of file SystemOfUnits.h.

View newest version in sPHENIX GitHub at line 242 of file SystemOfUnits.h

const HepLorentzVector CLHEP::X_HAT4 = HepLorentzVector( 1, 0, 0, 0 )
static

Definition at line 538 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 538 of file LorentzVector.h

Referenced by CLHEP::HepLorentzRotation::set().

const HepLorentzVector CLHEP::Y_HAT4 = HepLorentzVector( 0, 1, 0, 0 )
static

Definition at line 539 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 539 of file LorentzVector.h

Referenced by CLHEP::HepLorentzRotation::set().

const HepLorentzVector CLHEP::Z_HAT4 = HepLorentzVector( 0, 0, 1, 0 )
static

Definition at line 540 of file LorentzVector.h.

View newest version in sPHENIX GitHub at line 540 of file LorentzVector.h

Referenced by CLHEP::HepLorentzRotation::set().