Geant4-11
Namespaces | Data Structures | Typedefs | Enumerations | Functions | Variables
CLHEP Namespace Reference

Namespaces

namespace  anonymous_namespace{DualRand.cc}
 
namespace  anonymous_namespace{JamesRandom.cc}
 
namespace  anonymous_namespace{MixMaxRng.cc}
 
namespace  anonymous_namespace{MTwistEngine.cc}
 
namespace  anonymous_namespace{Random.cc}
 
namespace  anonymous_namespace{RanecuEngine.cc}
 
namespace  anonymous_namespace{Ranlux64Engine.cc}
 
namespace  anonymous_namespace{RanluxEngine.cc}
 
namespace  anonymous_namespace{RanluxppEngine.cc}
 
namespace  anonymous_namespace{RanshiEngine.cc}
 
namespace  detail
 

Data Structures

struct  do_nothing_deleter
 
class  DoubConv
 
class  DoubConvException
 
class  DualRand
 
class  EngineFactory
 
class  Hep2Vector
 
class  Hep3RotationInterface
 
class  Hep3Vector
 
class  Hep4RotationInterface
 
class  HepAxisAngle
 
class  HepBoost
 
class  HepBoostX
 
class  HepBoostY
 
class  HepBoostZ
 
class  HepEulerAngles
 
class  HepJamesRandom
 
class  HepLorentzRotation
 
class  HepLorentzVector
 
class  HepRandom
 
class  HepRandomEngine
 
struct  HepRep3x3
 
struct  HepRep4x4
 
struct  HepRep4x4Symmetric
 
class  HepRotation
 
class  HepRotationX
 
class  HepRotationY
 
class  HepRotationZ
 
class  HepStat
 
class  MixMaxRng
 
class  MTwistEngine
 
class  noncopyable
 
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  RandPoisson
 
class  RandPoissonQ
 
class  RandStudentT
 
class  RanecuEngine
 
class  Ranlux64Engine
 
class  RanluxEngine
 
class  RanluxppEngine
 
class  RanshiEngine
 
class  StaticRandomStates
 
class  Tcomponent
 

Typedefs

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

Enumerations

enum  ZMpvMetric_t { TimePositive , TimeNegative }
 

Functions

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

Variables

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

Typedef Documentation

◆ HepLorentzVectorD

Definition at line 547 of file LorentzVector.h.

◆ HepLorentzVectorF

Definition at line 548 of file LorentzVector.h.

◆ HepThreeVectorD

Definition at line 421 of file ThreeVector.h.

◆ HepThreeVectorF

Definition at line 422 of file ThreeVector.h.

◆ myID_t

using CLHEP::myID_t = typedef std::uint32_t
Author
K.Savvidy

Definition at line 46 of file MixMaxRng.h.

◆ myuint_t

using CLHEP::myuint_t = typedef unsigned long long int

Definition at line 47 of file MixMaxRng.h.

◆ shared_ptr

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

Definition at line 15 of file memory.h.

◆ weak_ptr

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

Definition at line 17 of file memory.h.

Enumeration Type Documentation

◆ ZMpvMetric_t

Enumerator
TimePositive 
TimeNegative 

Definition at line 59 of file LorentzVector.h.

Function Documentation

◆ boostOf() [1/2]

HepLorentzVector CLHEP::boostOf ( const HepLorentzVector vec,
const Hep3Vector axis,
double  beta 
)
inline

◆ boostOf() [2/2]

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

◆ boostXOf()

HepLorentzVector CLHEP::boostXOf ( const HepLorentzVector vec,
double  beta 
)
inline

◆ boostYOf()

HepLorentzVector CLHEP::boostYOf ( const HepLorentzVector vec,
double  beta 
)
inline

◆ boostZOf()

HepLorentzVector CLHEP::boostZOf ( const HepLorentzVector vec,
double  beta 
)
inline

◆ correctByPi()

static void CLHEP::correctByPi ( double &  psi1,
double &  phi1 
)
static

Definition at line 145 of file RotationE.cc.

145 {
146 if (psi1 > 0) {
147 psi1 -= CLHEP::pi;
148 } else {
149 psi1 += CLHEP::pi;
150 }
151 if (phi1 > 0) {
152 phi1 -= CLHEP::pi;
153 } else {
154 phi1 += CLHEP::pi;
155 }
156}
static constexpr double pi
Definition: SystemOfUnits.h:55

References pi.

Referenced by correctPsiPhi().

◆ correctPsiPhi()

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

Definition at line 159 of file RotationE.cc.

160 {
161
162 // set up quatities which would be positive if sin and cosine of
163 // psi1 and phi1 were positive:
164 double w[4];
165 w[0] = rxz; w[1] = rzx; w[2] = ryz; w[3] = -rzy;
166
167 // find biggest relevant term, which is the best one to use in correcting.
168 double maxw = std::abs(w[0]);
169 int imax = 0;
170 for (int i = 1; i < 4; ++i) {
171 if (std::abs(w[i]) > maxw) {
172 maxw = std::abs(w[i]);
173 imax = i;
174 }
175 }
176 // Determine if the correction needs to be applied: The criteria are
177 // different depending on whether a sine or cosine was the determinor:
178 switch (imax) {
179 case 0:
180 if (w[0] > 0 && psi1 < 0) correctByPi ( psi1, phi1 );
181 if (w[0] < 0 && psi1 > 0) correctByPi ( psi1, phi1 );
182 break;
183 case 1:
184 if (w[1] > 0 && phi1 < 0) correctByPi ( psi1, phi1 );
185 if (w[1] < 0 && phi1 > 0) correctByPi ( psi1, phi1 );
186 break;
187 case 2:
188 if (w[2] > 0 && std::abs(psi1) > CLHEP::halfpi) correctByPi ( psi1, phi1 );
189 if (w[2] < 0 && std::abs(psi1) < CLHEP::halfpi) correctByPi ( psi1, phi1 );
190 break;
191 case 3:
192 if (w[3] > 0 && std::abs(phi1) > CLHEP::halfpi) correctByPi ( psi1, phi1 );
193 if (w[3] < 0 && std::abs(phi1) < CLHEP::halfpi) correctByPi ( psi1, phi1 );
194 break;
195 }
196}
static const G4int imax
static constexpr double halfpi
Definition: SystemOfUnits.h:57
static void correctByPi(double &psi1, double &phi1)
Definition: RotationE.cc:145

References correctByPi(), halfpi, and imax.

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

◆ crc32ul()

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

Definition at line 36 of file engineIDulong.cc.

36 {
37 static const std::vector<unsigned long> crc_table = gen_crc_table();
38 unsigned long crc = 0;
39 int end = s.length();
40 for (int j = 0; j != end; ++j) {
41 int i = ( (int) ( crc >> 24) ^ s[j] ) & 0xff;
42 crc = ( ( crc << 8 ) ^ crc_table[i] ) & 0xffffffffUL;
43 }
44 return crc;
45}
static constexpr double s
Definition: G4SIunits.hh:154
const z_crc_t FAR crc_table[TBLS][256]
Definition: crc32.h:5
static std::vector< unsigned long > gen_crc_table()

References crc_table, gen_crc_table(), and s.

Referenced by engineIDulong().

◆ engineIDulong()

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

Definition at line 25 of file engineIDulong.h.

25 {
26 static const unsigned long id = crc32ul(E::engineName());
27 return id;
28}
unsigned long crc32ul(const std::string &s)

References crc32ul().

◆ gammln()

double CLHEP::gammln ( double  xx)

Definition at line 56 of file RandPoisson.cc.

56 {
57
58// Returns the value ln(Gamma(xx) for xx > 0. Full accuracy is obtained for
59// xx > 1. For 0 < xx < 1. the reflection formula (6.1.4) can be used first.
60// (Adapted from Numerical Recipes in C)
61
62 static const double cof[6] = {76.18009172947146,-86.50532032941677,
63 24.01409824083091, -1.231739572450155,
64 0.1208650973866179e-2, -0.5395239384953e-5};
65 int j;
66 double x = xx - 1.0;
67 double tmp = x + 5.5;
68 tmp -= (x + 0.5) * std::log(tmp);
69 double ser = 1.000000000190015;
70
71 for ( j = 0; j <= 5; j++ ) {
72 x += 1.0;
73 ser += cof[j]/x;
74 }
75 return -tmp + std::log(2.5066282746310005*ser);
76}

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

◆ gen_crc_table()

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

Definition at line 18 of file engineIDulong.cc.

18 {
19 /* generate the table of CRC remainders for all possible bytes */
20 static const unsigned long POLYNOMIAL = 0x04c11db7UL;
21 std::vector<unsigned long> crc_table;
22 for ( unsigned long i = 0; i < 256; ++i ) {
23 unsigned long crc = i << 24;
24 for ( int j = 0; j < 8; j++ ) {
25 if ( crc & 0x80000000UL ) {
26 crc = ( ( crc << 1 ) ^ POLYNOMIAL ) & 0xffffffffUL;
27 } else {
28 crc = ( crc << 1 ) & 0xffffffffUL;
29 }
30 }
31 crc_table.push_back(crc);
32 }
33 return crc_table;
34}

References crc_table.

Referenced by crc32ul().

◆ HepXHat()

const Hep3Vector CLHEP::HepXHat ( 1.  0,
0.  0,
0.  0 
)

◆ HepYHat()

const Hep3Vector CLHEP::HepYHat ( 0.  0,
1.  0,
0.  0 
)

◆ HepZHat()

const Hep3Vector CLHEP::HepZHat ( 0.  0,
0.  0,
1.  0 
)

◆ inverseOf() [1/9]

HepBoost CLHEP::inverseOf ( const HepBoost lt)
inline

◆ inverseOf() [2/9]

HepBoostX CLHEP::inverseOf ( const HepBoostX b)
inline

◆ inverseOf() [3/9]

HepBoostY CLHEP::inverseOf ( const HepBoostY b)
inline

◆ inverseOf() [4/9]

HepBoostZ CLHEP::inverseOf ( const HepBoostZ b)
inline

◆ inverseOf() [5/9]

HepLorentzRotation CLHEP::inverseOf ( const HepLorentzRotation lt)
inline

◆ inverseOf() [6/9]

HepRotation CLHEP::inverseOf ( const HepRotation r)
inline

◆ inverseOf() [7/9]

HepRotationX CLHEP::inverseOf ( const HepRotationX r)
inline

◆ inverseOf() [8/9]

HepRotationY CLHEP::inverseOf ( const HepRotationY r)
inline

◆ inverseOf() [9/9]

HepRotationZ CLHEP::inverseOf ( const HepRotationZ r)
inline

◆ makeAnEngine() [1/2]

template<class E >
static HepRandomEngine * CLHEP::makeAnEngine ( const std::string &  tag,
std::istream &  is 
)
static

Definition at line 33 of file EngineFactory.cc.

34 {
35 if ( tag != E::beginTag() ) return 0;
36 HepRandomEngine* eptr = new E;
37 eptr->getState(is);
38 if (!is) return 0;
39 return eptr;
40}
virtual std::istream & getState(std::istream &is)
Definition: RandomEngine.cc:72
Definition: xmlparse.cc:187

References CLHEP::HepRandomEngine::getState().

◆ makeAnEngine() [2/2]

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

Definition at line 44 of file EngineFactory.cc.

44 {
45 if ( (v[0] & 0xffffffffUL) != engineIDulong<E>() ) return 0;
46 HepRandomEngine* eptr = new E;
47 bool success = eptr->getState(v);
48 if (!success) return 0;
49 // std::cerr << "makeAnEngine made " << E::engineName() << "\n";
50 return eptr;
51}

References CLHEP::HepRandomEngine::getState().

◆ normal()

static double CLHEP::normal ( HepRandomEngine eptr)
static

Definition at line 79 of file RandPoisson.cc.

80{
81 double r;
82 double v1,v2,fac;
83 do {
84 v1 = 2.0 * eptr->flat() - 1.0;
85 v2 = 2.0 * eptr->flat() - 1.0;
86 r = v1*v1 + v2*v2;
87 } while ( r > 1.0 );
88
89 fac = std::sqrt(-2.0*std::log(r)/r);
90 return v2*fac;
91}
static const G4double fac
virtual double flat()=0

References fac, and CLHEP::HepRandomEngine::flat().

Referenced by G4Qt3DSceneHandler::AddPrimitive(), G4ToolsSGSceneHandler::AddPrimitive(), G4PolyconeSide::CalculateExtent(), G4PVPlacement::CheckOverlaps(), G4ErrorMatrix::dfact_matrix(), G4PolyhedraSide::Distance(), G4VTwistSurface::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4TwistedTubs::DistanceToIn(), G4VTwistedFaceted::DistanceToIn(), G4TessellatedSolid::DistanceToInCandidates(), G4TessellatedSolid::DistanceToInNoVoxels(), G4VTwistSurface::DistanceToOut(), G4ScaledSolid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TwistedTubs::DistanceToOut(), G4VCSGfaceted::DistanceToOut(), G4VTwistedFaceted::DistanceToOut(), G4TessellatedSolid::DistanceToOutCandidates(), G4TessellatedSolid::DistanceToOutNoVoxels(), G4TwistTubsSide::DistanceToSurface(), HepPolyhedron::FindNodeNormal(), CLHEP::RandPoisson::fire(), G4LambertianRand(), G4PlaneVectorRand(), G4QuadrangularFacet::G4QuadrangularFacet(), G4TwistTubsFlatSide::G4TwistTubsFlatSide(), Geant4_SoPolyhedron::generateAlternateRep(), G4SPSEneDistribution::GenerateBiasPowEnergies(), Geant4_SoPolyhedron::generatePrimitives(), SoBox::generatePrimitives(), SoCons::generatePrimitives(), SoTrap::generatePrimitives(), SoTrd::generatePrimitives(), SoTubs::generatePrimitives(), G4PrimaryTransformer::GenerateSingleTrack(), G4OpBoundaryProcess::GetFacetNormal(), G4PolarizationHelper::GetFrame(), G4ErrorPropagationNavigator::GetGlobalExitNormal(), HepPolyhedron::GetNextNormal(), HepPolyhedron::GetNextUnitNormal(), HepPolyhedron::GetNextVertex(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TwistTubsHypeSide::GetNormal(), G4TwistTubsSide::GetNormal(), G4PolarizationHelper::GetRandomFrame(), G4RTRun::GetSurfaceColour(), G4TheRayTracer::GetSurfaceColour(), G4ErrorCylSurfaceTarget::GetTangentPlane(), G4QuadrangularFacet::Intersect(), G4TriangularFacet::Intersect(), G4PolyhedraSide::Intersect(), G4PolyconeSide::Intersect(), G4ITNavigator1::LocateGlobalPointAndSetup(), G4ITNavigator2::LocateGlobalPointAndSetup(), G4Navigator::LocateGlobalPointAndSetup(), G4Trap::MakePlane(), G4Trap::MakePlanes(), G4INCL::ParticleEntryChannel::particleEnters(), G4INCL::TransmissionChannel::particleLeaves(), G4PolyconeSide::PointOnCone(), G4GeomTools::PolygonAreaNormal(), G4VisCommandsViewerSet::SetNewValue(), G4TriangularFacet::SetSurfaceNormal(), CLHEP::RandPoisson::shoot(), G4MultiUnion::SurfaceNormal(), G4ReflectedSolid::SurfaceNormal(), G4DisplacedSolid::SurfaceNormal(), G4IntersectionSolid::SurfaceNormal(), G4ScaledSolid::SurfaceNormal(), G4SubtractionSolid::SurfaceNormal(), G4VCSGfaceted::SurfaceNormal(), and SoTrap::updateChildren().

◆ operator!=() [1/2]

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

Definition at line 363 of file LorentzRotation.h.

◆ operator!=() [2/2]

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

Definition at line 350 of file LorentzRotation.h.

351 { return lt!=HepLorentzRotation(r); }

◆ operator*() [1/15]

double CLHEP::operator* ( const Hep2Vector a,
const Hep2Vector b 
)
inline

◆ operator*() [2/15]

Hep2Vector CLHEP::operator* ( const Hep2Vector p,
double  a 
)
inline

◆ operator*() [3/15]

double CLHEP::operator* ( const Hep3Vector ,
const Hep3Vector  
)
inline

◆ operator*() [4/15]

Hep3Vector CLHEP::operator* ( const Hep3Vector ,
double  a 
)
inline

◆ operator*() [5/15]

HepLorentzVector CLHEP::operator* ( const HepLorentzVector ,
double  a 
)
inline

◆ operator*() [6/15]

HepLorentzRotation CLHEP::operator* ( const HepRotation r,
const HepLorentzRotation lt 
)

Definition at line 260 of file LorentzRotation.cc.

261 {
262 r.rep4x4();
263 lt.rep4x4();
265 r.xx()*lt.xx() + r.xy()*lt.yx() + r.xz()*lt.zx() + r.xt()*lt.tx(),
266 r.xx()*lt.xy() + r.xy()*lt.yy() + r.xz()*lt.zy() + r.xt()*lt.ty(),
267 r.xx()*lt.xz() + r.xy()*lt.yz() + r.xz()*lt.zz() + r.xt()*lt.tz(),
268 r.xx()*lt.xt() + r.xy()*lt.yt() + r.xz()*lt.zt() + r.xt()*lt.tt(),
269
270 r.yx()*lt.xx() + r.yy()*lt.yx() + r.yz()*lt.zx() + r.yt()*lt.tx(),
271 r.yx()*lt.xy() + r.yy()*lt.yy() + r.yz()*lt.zy() + r.yt()*lt.ty(),
272 r.yx()*lt.xz() + r.yy()*lt.yz() + r.yz()*lt.zz() + r.yt()*lt.tz(),
273 r.yx()*lt.xt() + r.yy()*lt.yt() + r.yz()*lt.zt() + r.yt()*lt.tt(),
274
275 r.zx()*lt.xx() + r.zy()*lt.yx() + r.zz()*lt.zx() + r.zt()*lt.tx(),
276 r.zx()*lt.xy() + r.zy()*lt.yy() + r.zz()*lt.zy() + r.zt()*lt.ty(),
277 r.zx()*lt.xz() + r.zy()*lt.yz() + r.zz()*lt.zz() + r.zt()*lt.tz(),
278 r.zx()*lt.xt() + r.zy()*lt.yt() + r.zz()*lt.zt() + r.zt()*lt.tt(),
279
280 r.tx()*lt.xx() + r.ty()*lt.yx() + r.tz()*lt.zx() + r.tt()*lt.tx(),
281 r.tx()*lt.xy() + r.ty()*lt.yy() + r.tz()*lt.zy() + r.tt()*lt.ty(),
282 r.tx()*lt.xz() + r.ty()*lt.yz() + r.tz()*lt.zz() + r.tt()*lt.tz(),
283 r.tx()*lt.xt() + r.ty()*lt.yt() + r.tz()*lt.zt() + r.tt()*lt.tt() ) );
284}
HepRep4x4 rep4x4() const
double zz() const
double yz() const
double zx() const
double tz() const
double ty() const
double tx() const
double yx() const
double zy() const
HepRep4x4 rep4x4() const
double zt() const
double xx() const
double tt() const
double yy() const
double xz() const
double yt() const
double xy() const
double xt() const

References CLHEP::HepLorentzRotation::rep4x4(), CLHEP::HepRotation::rep4x4(), CLHEP::HepLorentzRotation::tt(), CLHEP::HepRotation::tt(), CLHEP::HepLorentzRotation::tx(), CLHEP::HepRotation::tx(), CLHEP::HepLorentzRotation::ty(), CLHEP::HepRotation::ty(), CLHEP::HepLorentzRotation::tz(), CLHEP::HepRotation::tz(), CLHEP::HepLorentzRotation::xt(), CLHEP::HepRotation::xt(), CLHEP::HepLorentzRotation::xx(), CLHEP::HepRotation::xx(), CLHEP::HepLorentzRotation::xy(), CLHEP::HepRotation::xy(), CLHEP::HepLorentzRotation::xz(), CLHEP::HepRotation::xz(), CLHEP::HepLorentzRotation::yt(), CLHEP::HepRotation::yt(), CLHEP::HepLorentzRotation::yx(), CLHEP::HepRotation::yx(), CLHEP::HepLorentzRotation::yy(), CLHEP::HepRotation::yy(), CLHEP::HepLorentzRotation::yz(), CLHEP::HepRotation::yz(), CLHEP::HepLorentzRotation::zt(), CLHEP::HepRotation::zt(), CLHEP::HepLorentzRotation::zx(), CLHEP::HepRotation::zx(), CLHEP::HepLorentzRotation::zy(), CLHEP::HepRotation::zy(), CLHEP::HepLorentzRotation::zz(), and CLHEP::HepRotation::zz().

◆ operator*() [7/15]

HepLorentzRotation CLHEP::operator* ( const HepRotationX r,
const HepLorentzRotation lt 
)

◆ operator*() [8/15]

HepRotation CLHEP::operator* ( const HepRotationX rx,
const HepRotation r 
)
inline

◆ operator*() [9/15]

HepLorentzRotation CLHEP::operator* ( const HepRotationY r,
const HepLorentzRotation lt 
)

◆ operator*() [10/15]

HepRotation CLHEP::operator* ( const HepRotationY ry,
const HepRotation r 
)
inline

◆ operator*() [11/15]

HepLorentzRotation CLHEP::operator* ( const HepRotationZ r,
const HepLorentzRotation lt 
)

◆ operator*() [12/15]

HepRotation CLHEP::operator* ( const HepRotationZ rz,
const HepRotation r 
)
inline

◆ operator*() [13/15]

Hep2Vector CLHEP::operator* ( double  a,
const Hep2Vector p 
)
inline

◆ operator*() [14/15]

Hep3Vector CLHEP::operator* ( double  a,
const Hep3Vector  
)
inline

◆ operator*() [15/15]

HepLorentzVector CLHEP::operator* ( double  a,
const HepLorentzVector  
)
inline

◆ operator+() [1/2]

Hep2Vector CLHEP::operator+ ( const Hep2Vector a,
const Hep2Vector b 
)
inline

◆ operator+() [2/2]

Hep3Vector CLHEP::operator+ ( const Hep3Vector ,
const Hep3Vector  
)
inline

◆ operator-() [1/2]

Hep2Vector CLHEP::operator- ( const Hep2Vector a,
const Hep2Vector b 
)
inline

◆ operator-() [2/2]

Hep3Vector CLHEP::operator- ( const Hep3Vector ,
const Hep3Vector  
)
inline

◆ operator/() [1/3]

Hep2Vector CLHEP::operator/ ( const Hep2Vector p,
double  a 
)

Definition at line 61 of file TwoVector.cc.

61 {
62// if (a==0) {
63// std::cerr << "Hep2Vector operator/ () - "
64// << "Division of Hep2Vector by zero" << std::endl;
65// }
66 return Hep2Vector(p.x()/a, p.y()/a);
67}
double x() const
double y() const

◆ operator/() [2/3]

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

Definition at line 298 of file ThreeVector.cc.

298 {
299// if (c == 0) {
300// std::cerr << "Hep3Vector::operator/ () - "
301// << "Attempt to divide vector by 0 -- "
302// << "will produce infinities and/or NANs" << std::endl;
303// }
304 return v1 * (1.0/c);
305} /* v / c */

◆ operator/() [3/3]

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

Definition at line 161 of file LorentzVector.cc.

161 {
162// if (c == 0) {
163// std::cerr << "HepLorentzVector::operator /() - "
164// << "Attempt to do LorentzVector / 0 -- \n"
165// << "division by zero would produce infinite or NAN components"
166// << std::endl;
167// }
168 double oneOverC = 1.0/c;
169 return HepLorentzVector (w.getV() * oneOverC,
170 w.getT() * oneOverC);
171} /* LV = w / c */
Hep3Vector getV() const

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

◆ operator<() [1/2]

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

Definition at line 369 of file LorentzRotation.h.

370 { return lt<b; }

◆ operator<() [2/2]

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

Definition at line 356 of file LorentzRotation.h.

357 { return lt<r; }

◆ operator<<() [1/16]

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

Definition at line 69 of file TwoVector.cc.

69 {
70 os << "(" << q.x() << ", " << q.y() << ")";
71 return os;
72}

◆ operator<<() [2/16]

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

Definition at line 63 of file ThreeVector.cc.

63 {
64 return os << "(" << v.x() << "," << v.y() << "," << v.z() << ")";
65}
double z() const
double x() const
double y() const

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

◆ operator<<() [3/16]

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

Definition at line 86 of file LorentzVector.cc.

87{
88 return os << "(" << v1.x() << "," << v1.y() << "," << v1.z()
89 << ";" << v1.t() << ")";
90}

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

◆ operator<<() [4/16]

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

Definition at line 89 of file AxisAngle.cc.

89 {
90 os << '(' << aa.axis() << ", " << aa.delta() << ')';
91 return os;
92} // operator<<()
double delta() const
Hep3Vector axis() const

◆ operator<<() [5/16]

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

Definition at line 238 of file Boost.h.

239{return b.print(os);}
std::ostream & print(std::ostream &os) const
Definition: Boost.cc:245

◆ operator<<() [6/16]

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

Definition at line 212 of file BoostX.h.

213{return b.print(os);}
std::ostream & print(std::ostream &os) const
Definition: BoostX.cc:156

◆ operator<<() [7/16]

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

Definition at line 213 of file BoostY.h.

214{return b.print(os);}
std::ostream & print(std::ostream &os) const
Definition: BoostY.cc:155

◆ operator<<() [8/16]

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

Definition at line 212 of file BoostZ.h.

213{return b.print(os);}
std::ostream & print(std::ostream &os) const
Definition: BoostZ.cc:155

◆ operator<<() [9/16]

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

Definition at line 101 of file EulerAngles.cc.

102{
103 os << "(" << ea.phi() << ", " << ea.theta() << ", " << ea.psi() << ")";
104 return os;
105} // operator<<()

◆ operator<<() [10/16]

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

Definition at line 344 of file LorentzRotation.h.

346 {return lt.print(os);}
std::ostream & print(std::ostream &os) const

◆ operator<<() [11/16]

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

Definition at line 219 of file Random.cc.

219 {
220 return dist.put(os);
221}
virtual std::ostream & put(std::ostream &os) const
Definition: Random.cc:227

References CLHEP::HepRandom::put().

◆ operator<<() [12/16]

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

Definition at line 100 of file RandomEngine.cc.

100 {
101 return e.put(os);
102}
virtual std::ostream & put(std::ostream &os) const
Definition: RandomEngine.cc:59

References CLHEP::HepRandomEngine::put().

◆ operator<<() [13/16]

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

Definition at line 406 of file Rotation.h.

407{return r.print(os);}
std::ostream & print(std::ostream &os) const
Definition: RotationIO.cc:17

◆ operator<<() [14/16]

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

Definition at line 275 of file RotationX.h.

276{return r.print(os);}
std::ostream & print(std::ostream &os) const
Definition: RotationX.cc:185

◆ operator<<() [15/16]

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

Definition at line 275 of file RotationY.h.

276{return r.print(os);}
std::ostream & print(std::ostream &os) const
Definition: RotationY.cc:188

◆ operator<<() [16/16]

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

Definition at line 275 of file RotationZ.h.

276{return r.print(os);}
std::ostream & print(std::ostream &os) const
Definition: RotationZ.cc:176

◆ operator<=() [1/2]

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

Definition at line 365 of file LorentzRotation.h.

366 { return lt<=b; }

◆ operator<=() [2/2]

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

Definition at line 352 of file LorentzRotation.h.

353 { return lt<=r; }

◆ operator==() [1/2]

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

Definition at line 361 of file LorentzRotation.h.

362 { return lt==HepLorentzRotation(b); }

◆ operator==() [2/2]

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

Definition at line 348 of file LorentzRotation.h.

349 { return lt==HepLorentzRotation(r); }

◆ operator>() [1/2]

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

Definition at line 371 of file LorentzRotation.h.

372 { return lt>b; }

◆ operator>() [2/2]

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

Definition at line 358 of file LorentzRotation.h.

359 { return lt>r; }

◆ operator>=() [1/2]

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

Definition at line 367 of file LorentzRotation.h.

368 { return lt>=b; }

◆ operator>=() [2/2]

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

Definition at line 354 of file LorentzRotation.h.

355 { return lt>=r; }

◆ operator>>() [1/7]

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

Definition at line 77 of file TwoVector.cc.

77 {
78 double x, y;
79 ZMinput2doubles ( is, "Hep2Vector", x, y );
80 p.set(x, y);
81 return is;
82} // operator>>()
void set(double x, double y)
void ZMinput2doubles(std::istream &is, const char *type, double &x, double &y)
Definition: ZMinput.cc:243

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

◆ operator>>() [2/7]

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

Definition at line 70 of file ThreeVector.cc.

70 {
71 double x, y, z;
72 ZMinput3doubles ( is, "Hep3Vector", x, y, z );
73 v.set(x, y, z);
74 return is;
75} // operator>>()
void set(double x, double y, double z)
void ZMinput3doubles(std::istream &is, const char *type, double &x, double &y, double &z)
Definition: ZMinput.cc:42

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

◆ operator>>() [3/7]

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

Definition at line 92 of file LorentzVector.cc.

92 {
93
94// Required format is ( a, b, c; d ) that is, four numbers, preceded by
95// (, followed by ), components of the spatial vector separated by commas,
96// time component separated by semicolon. The four numbers are taken
97// as x, y, z, t.
98
99 double x, y, z, t;
100 char c;
101
102 is >> std::ws >> c;
103 // ws is defined to invoke eatwhite(istream & )
104 // see (Stroustrup gray book) page 333 and 345.
105 if (is.fail() || c != '(' ) {
106 std::cerr << "Could not find required opening parenthesis "
107 << "in input of a HepLorentzVector" << std::endl;
108 return is;
109 }
110
111 is >> x >> std::ws >> c;
112 if (is.fail() || c != ',' ) {
113 std::cerr << "Could not find x value and required trailing comma "
114 << "in input of a HepLorentzVector" << std::endl;
115 return is;
116 }
117
118 is >> y >> std::ws >> c;
119 if (is.fail() || c != ',' ) {
120 std::cerr << "Could not find y value and required trailing comma "
121 << "in input of a HepLorentzVector" << std::endl;
122 return is;
123 }
124
125 is >> z >> std::ws >> c;
126 if (is.fail() || c != ';' ) {
127 std::cerr << "Could not find z value and required trailing semicolon "
128 << "in input of a HepLorentzVector" << std::endl;
129 return is;
130 }
131
132 is >> t >> std::ws >> c;
133 if (is.fail() || c != ')' ) {
134 std::cerr << "Could not find t value and required close parenthesis "
135 << "in input of a HepLorentzVector" << std::endl;
136 return is;
137 }
138
139 v1.setX(x);
140 v1.setY(y);
141 v1.setZ(z);
142 v1.setT(t);
143 return is;
144}

References CLHEP::HepLorentzVector::setT(), CLHEP::HepLorentzVector::setX(), CLHEP::HepLorentzVector::setY(), and CLHEP::HepLorentzVector::setZ().

◆ operator>>() [4/7]

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

Definition at line 99 of file AxisAngle.cc.

99 {
100 Hep3Vector axis;
101 double delta;
102 double x,y,z;
103 ZMinputAxisAngle ( is, x, y, z, delta );
104 axis.set(x,y,z);
105 aa.set ( axis, delta );
106 return is;
107} // operator>>()
AA & set(const Hep3Vector axis, Scalar delta)
void ZMinputAxisAngle(std::istream &is, double &x, double &y, double &z, double &delta)
Definition: ZMinput.cc:156

◆ operator>>() [5/7]

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

Definition at line 110 of file EulerAngles.cc.

110 {
111 double thePhi;
112 double theTheta;
113 double thePsi;
114 ZMinput3doubles ( is, "HepEulerAngle", thePhi , theTheta , thePsi );
115 ea.set ( thePhi , theTheta , thePsi );
116 return is;
117} // operator>>()

◆ operator>>() [6/7]

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

Definition at line 223 of file Random.cc.

223 {
224 return dist.get(is);
225}
virtual std::istream & get(std::istream &is)
Definition: Random.cc:228

References CLHEP::HepRandom::get().

◆ operator>>() [7/7]

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

Definition at line 104 of file RandomEngine.cc.

104 {
105 return e.get(is);
106}
virtual std::istream & get(std::istream &is)
Definition: RandomEngine.cc:63

References CLHEP::HepRandomEngine::get().

◆ possibleKeywordInput()

template<class IS , class T >
bool CLHEP::possibleKeywordInput ( IS &  is,
const std::string &  key,
T &  t 
)

◆ rotationOf() [1/8]

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

Definition at line 126 of file SpaceVectorR.cc.

127 {
128 Hep3Vector vv(vec);
129 return vv.rotate(axis, ddelta);
130}

References CLHEP::Hep3Vector::rotate().

◆ rotationOf() [2/8]

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

Definition at line 121 of file SpaceVectorR.cc.

121 {
122 Hep3Vector vv(vec);
123 return vv.rotate (ax);
124}

References CLHEP::Hep3Vector::rotate().

◆ rotationOf() [3/8]

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

Definition at line 132 of file SpaceVectorR.cc.

132 {
133 Hep3Vector vv(vec);
134 return vv.rotate (ex);
135}

References CLHEP::Hep3Vector::rotate().

◆ rotationOf() [4/8]

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

Definition at line 137 of file SpaceVectorR.cc.

138 {
139 Hep3Vector vv(vec);
140 return vv.rotate(phi, theta, psi);
141}

References CLHEP::Hep3Vector::rotate().

◆ rotationOf() [5/8]

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

Definition at line 43 of file LorentzVectorR.cc.

45 {
46 HepLorentzVector vv (vec);
47 return vv.rotate (aaxis, ddelta);
48}

◆ rotationOf() [6/8]

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

Definition at line 50 of file LorentzVectorR.cc.

51 {
52 HepLorentzVector vv (vec);
53 return vv.rotate (ax);
54}

◆ rotationOf() [7/8]

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

Definition at line 56 of file LorentzVectorR.cc.

57 {
58 HepLorentzVector vv (vec);
59 return vv.rotate (e1);
60}
static const G4double e1[44]

◆ rotationOf() [8/8]

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

Definition at line 62 of file LorentzVectorR.cc.

65 {
66 HepLorentzVector vv (vec);
67 return vv.rotate (phi1, theta1, psi1);
68}

◆ rotationXOf() [1/2]

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

Definition at line 143 of file SpaceVectorR.cc.

143 {
144 Hep3Vector vv(vec);
145 return vv.rotateX (ddelta);
146}

References CLHEP::Hep3Vector::rotateX().

◆ rotationXOf() [2/2]

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

Definition at line 25 of file LorentzVectorB.cc.

26 {
27 HepLorentzVector vv (vec);
28 return vv.rotateX (phi);
29}

◆ rotationYOf() [1/2]

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

Definition at line 148 of file SpaceVectorR.cc.

148 {
149 Hep3Vector vv(vec);
150 return vv.rotateY (ddelta);
151}

References CLHEP::Hep3Vector::rotateY().

◆ rotationYOf() [2/2]

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

Definition at line 31 of file LorentzVectorB.cc.

32 {
33 HepLorentzVector vv (vec);
34 return vv.rotateY (phi);
35}

◆ rotationZOf() [1/2]

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

Definition at line 153 of file SpaceVectorR.cc.

153 {
154 Hep3Vector vv(vec);
155 return vv.rotateZ (ddelta);
156}

References CLHEP::Hep3Vector::rotateZ().

◆ rotationZOf() [2/2]

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

Definition at line 37 of file LorentzVectorB.cc.

38 {
39 HepLorentzVector vv (vec);
40 return vv.rotateZ (phi);
41}

◆ safe_acos() [1/5]

static double CLHEP::safe_acos ( double  x)
inlinestatic

◆ safe_acos() [2/5]

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 23 of file RotationE.cc.

23 {
24 if (std::abs(x) <= 1.0) return std::acos(x);
25 return ( (x>0) ? 0 : CLHEP::pi );
26}

References pi.

◆ safe_acos() [3/5]

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 22 of file RotationX.cc.

22 {
23 if (std::abs(x) <= 1.0) return std::acos(x);
24 return ( (x>0) ? 0 : CLHEP::pi );
25}

References pi.

◆ safe_acos() [4/5]

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 22 of file RotationY.cc.

22 {
23 if (std::abs(x) <= 1.0) return std::acos(x);
24 return ( (x>0) ? 0 : CLHEP::pi );
25}

References pi.

◆ safe_acos() [5/5]

static double CLHEP::safe_acos ( double  x)
inlinestatic

Definition at line 22 of file RotationZ.cc.

22 {
23 if (std::abs(x) <= 1.0) return std::acos(x);
24 return ( (x>0) ? 0 : CLHEP::pi );
25}

References pi.

◆ StirlingCorrection()

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

Definition at line 94 of file RandBinomial.cc.

95{
96 #define C1 8.33333333333333333e-02 // +1/12
97 #define C3 -2.77777777777777778e-03 // -1/360
98 #define C5 7.93650793650793651e-04 // +1/1260
99 #define C7 -5.95238095238095238e-04 // -1/1680
100
101 static const double c[31] = { 0.0,
102 8.106146679532726e-02, 4.134069595540929e-02,
103 2.767792568499834e-02, 2.079067210376509e-02,
104 1.664469118982119e-02, 1.387612882307075e-02,
105 1.189670994589177e-02, 1.041126526197209e-02,
106 9.255462182712733e-03, 8.330563433362871e-03,
107 7.573675487951841e-03, 6.942840107209530e-03,
108 6.408994188004207e-03, 5.951370112758848e-03,
109 5.554733551962801e-03, 5.207655919609640e-03,
110 4.901395948434738e-03, 4.629153749334029e-03,
111 4.385560249232324e-03, 4.166319691996922e-03,
112 3.967954218640860e-03, 3.787618068444430e-03,
113 3.622960224683090e-03, 3.472021382978770e-03,
114 3.333155636728090e-03, 3.204970228055040e-03,
115 3.086278682608780e-03, 2.976063983550410e-03,
116 2.873449362352470e-03, 2.777674929752690e-03,
117 };
118 double r, rr;
119
120 if (k > 30L) {
121 r = 1.0 / (double) k; rr = r * r;
122 return(r*(C1 + rr*(C3 + rr*(C5 + rr*C7))));
123 }
124 else return(c[k]);
125}
#define C5
#define C1
#define C3
#define C7

References C1, C3, C5, and C7.

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

◆ transformSmall()

double CLHEP::transformSmall ( double  r)

Definition at line 218 of file flatToGaussian.cc.

218 {
219
220 // Solve for -v in the asymtotic formula
221 //
222 // errInt (-v) = exp(-v*v/2) 1 1*3 1*3*5
223 // ------------ * (1 - ---- + ---- - ----- + ... )
224 // v*sqrt(2*pi) v**2 v**4 v**6
225
226 // The value of r (=errInt(-v)) supplied is going to less than 2.0E-13,
227 // which is such that v < -7.25. Since the value of r is meaningful only
228 // to an absolute error of 1E-16 (double precision accuracy for a number
229 // which on the high side could be of the form 1-epsilon), computing
230 // v to more than 3-4 digits of accuracy is suspect; however, to ensure
231 // smoothness with the table generator (which uses quite a few terms) we
232 // also use terms up to 1*3*5* ... *13/v**14, and insist on accuracy of
233 // solution at the level of 1.0e-7.
234
235 // This routine is called less than one time in a trillion firings, so
236 // speed is of no concern. As a matter of technique, we terminate the
237 // iterations in case they would be infinite, but this should not happen.
238
239 double eps = 1.0e-7;
240 double guess = 7.5;
241 double v;
242
243 for ( int i = 1; i < 50; i++ ) {
244 double vn2 = 1.0/(guess*guess);
245 double s1 = -13*11*9*7*5*3 * vn2*vn2*vn2*vn2*vn2*vn2*vn2;
246 s1 += 11*9*7*5*3 * vn2*vn2*vn2*vn2*vn2*vn2;
247 s1 += -9*7*5*3 * vn2*vn2*vn2*vn2*vn2;
248 s1 += 7*5*3 * vn2*vn2*vn2*vn2;
249 s1 += -5*3 * vn2*vn2*vn2;
250 s1 += 3 * vn2*vn2 - vn2 + 1.0;
251 v = std::sqrt ( 2.0 * std::log ( s1 / (r*guess*std::sqrt(CLHEP::twopi)) ) );
252 if ( std::abs(v-guess) < eps ) break;
253 guess = v;
254 }
255
256 return -v;
257
258} // transformSmall()
static const G4double eps
static constexpr double twopi
Definition: SystemOfUnits.h:56

References eps, and twopi.

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

◆ X_HAT2()

static const Hep2Vector CLHEP::X_HAT2 ( 1.  0,
0.  0 
)
static

◆ Y_HAT2()

static const Hep2Vector CLHEP::Y_HAT2 ( 0.  0,
1.  0 
)
static

◆ ZMinput2doubles()

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

Definition at line 243 of file ZMinput.cc.

244 {
245
246// Accepted formats are
247// x y
248// x, y (comma is optional, and whitespace ignored if comma present)
249// ( x, y ) (comma optional)
250
251 char c;
252 bool parenthesis = false;
253
254 if ( !eatwhitespace(is) ) {
255 std::cerr << "istream ended before trying to input " << type << "\n";
256 return;
257 }
258
259 if ( !is.get(c) ) { fouledup(); return; }
260 if ( c == '(' ) {
261 parenthesis = true;
262 if ( !eatwhitespace(is) ) {
263 std::cerr << "istream ended after ( trying to input " << type << "\n";
264 return;
265 }
266 } else {
267 is.putback(c);
268 }
269
270 // At this point, parenthesis or not, the next item read is supposed to
271 // be the number x.
272
273 if (!(is >> x)) {
274 std::cerr << "Could not read first value in input of " << type << "\n";
275 return;
276 }
277
278 if ( !eatwhitespace(is) ) {
279 std::cerr << "istream ended before second value of " << type << "\n";
280 return;
281 }
282
283 if ( !is.get(c) ) { fouledup(); return; }
284 if ( c == ',' ) {
285 if ( !eatwhitespace(is) ) {
286 std::cerr << "istream ended ater one value and comma in "
287 << type << "\n";
288 return;
289 }
290 } else {
291 is.putback(c);
292 }
293
294 // At this point, comma or not, the next item read is supposed to
295 // be the number y.
296
297 if (!(is >> y)) {
298 std::cerr << "Could not read second value in input of " << type << "\n";
299 return;
300 }
301
302 // Finally, check for the closing parenthesis if there was an open paren.
303
304 if (parenthesis) {
305 if ( !eatwhitespace(is) ) {
306 std::cerr << "No closing parenthesis in input of " << type << "\n";
307 return;
308 }
309 if ( !is.get(c) ) { fouledup(); return; }
310 if ( c != ')' ) {
311 std::cerr << "Missing closing parenthesis in input of "
312 << type << "\n";
313 // Now a trick to do (as nearly as we can) what
314 // is.putback(c); is.setstate(std::ios_base::failbit);
315 // would do (because using ios_base will confuse old CLHEP compilers):
316 if ( isdigit(c) || (c=='-') || (c=='+') ) {
317 is.putback('@');
318 } else {
319 is.putback('c');
320 }
321 int m;
322 is >> m; // This fails, leaving the state bad, and the istream
323 // otherwise unchanged, except if the next char might
324 // have started a valid int, it turns to @
325 return;
326 }
327 }
328
329 return;
330
331}
static constexpr double m
Definition: G4SIunits.hh:109
bool eatwhitespace(std::istream &is)
Definition: ZMinput.cc:13

References anonymous_namespace{ZMinput.cc}::eatwhitespace(), anonymous_namespace{ZMinput.cc}::fouledup(), and m.

Referenced by operator>>().

◆ ZMinput3doubles()

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

Definition at line 42 of file ZMinput.cc.

43 {
44
45// Accepted formats are
46// x y z
47// x, y, z (each comma is optional, and whitespace ignored if comma present)
48// ( x, y, z ) (commas optional)
49
50 char c;
51 bool parenthesis = false;
52
53 if ( !eatwhitespace(is) ) {
54 std::cerr << "istream ended before trying to input " << type << "\n";
55 return;
56 }
57
58 if ( !is.get(c) ) { fouledup(); return; }
59 if ( c == '(' ) {
60 parenthesis = true;
61 if ( !eatwhitespace(is) ) {
62 std::cerr << "istream ended after ( trying to input " << type << "\n";
63 return;
64 }
65 } else {
66 is.putback(c);
67 }
68
69 // At this point, parenthesis or not, the next item read is supposed to
70 // be the number x.
71
72 if (!(is >> x)) {
73 std::cerr << "Could not read first value in input of " << type << "\n";
74 return;
75 }
76
77 if ( !eatwhitespace(is) ) {
78 std::cerr << "istream ended before second value of " << type << "\n";
79 return;
80 }
81
82 if ( !is.get(c) ) { fouledup(); return; }
83 if ( c == ',' ) {
84 if ( !eatwhitespace(is) ) {
85 std::cerr << "istream ended ater one value and comma in "
86 << type << "\n";
87 return;
88 }
89 } else {
90 is.putback(c);
91 }
92
93 // At this point, comma or not, the next item read is supposed to
94 // be the number y.
95
96 if (!(is >> y)) {
97 std::cerr << "Could not read second value in input of " << type << "\n";
98 return;
99 }
100
101 if ( !eatwhitespace(is) ) {
102 std::cerr << "istream ended before third value of " << type << "\n";
103 return;
104 }
105
106 if ( !is.get(c) ) { fouledup(); return; }
107 if ( c == ',' ) {
108 if ( !eatwhitespace(is) ) {
109 std::cerr << "istream ended ater two values and comma in "
110 << type << "\n";
111 return;
112 }
113 } else {
114 is.putback(c);
115 }
116
117 // At this point, comma or not, the next item read is supposed to
118 // be the number z.
119
120 if (!(is >> z)) {
121 std::cerr << "Could not read third value in input of " << type << "\n";
122 return;
123 }
124
125 // Finally, check for the closing parenthesis if there was an open paren.
126
127 if (parenthesis) {
128 if ( !eatwhitespace(is) ) {
129 std::cerr << "No closing parenthesis in input of " << type << "\n";
130 return;
131 }
132 if ( !is.get(c) ) { fouledup(); return; }
133 if ( c != ')' ) {
134 std::cerr << "Missing closing parenthesis in input of "
135 << type << "\n";
136 // Now a trick to do (as nearly as we can) what
137 // is.putback(c); is.setstate(std::ios_base::failbit);
138 // would do (because using ios_base will confuse old CLHEP compilers):
139 if ( isdigit(c) || (c=='-') || (c=='+') ) {
140 is.putback('@');
141 } else {
142 is.putback('c');
143 }
144 int m;
145 is >> m; // This fails, leaving the state bad, and the istream
146 // otherwise unchanged, except if the next char might
147 // have started a valid int, it turns to @
148 return;
149 }
150 }
151
152 return;
153
154}

References anonymous_namespace{ZMinput.cc}::eatwhitespace(), anonymous_namespace{ZMinput.cc}::fouledup(), and m.

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

◆ ZMinputAxisAngle()

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

Definition at line 156 of file ZMinput.cc.

158 {
159// Accepted formats are
160// parenthesis optional, then
161// any acceptable format for a Hep3Vector, then
162// optional comma, then
163// delta, then
164// close parenthesis if opened at start.
165//
166// But if there is an open parenthesis, it must be for the overall
167// object. That is, if the axis has parentheses, the form must be
168// ( (x,y,z) , delta )
169
170 char c;
171 bool parenthesis = false;
172
173 if ( !eatwhitespace(is) ) {
174 std::cerr << "istream ended before trying to input AxisAngle \n";
175 return;
176 }
177
178 if ( !is.get(c) ) { fouledup(); return; }
179 if ( c == '(' ) {
180 parenthesis = true;
181 if ( !eatwhitespace(is) ) {
182 std::cerr << "istream ended after ( trying to input AxisAngle \n";
183 return;
184 }
185 } else {
186 is.putback(c);
187 }
188
189 // At this point, parenthesis or not, the next item read is supposed to
190 // be a valid Hep3Vector axis.
191
192 ZMinput3doubles ( is, "axis of AxisAngle", x, y, z );
193 if (!is) return;
194
195 if ( !eatwhitespace(is) ) {
196 std::cerr << "istream ended before delta of AxisAngle \n";
197 return;
198 }
199
200 if ( !is.get(c) ) { fouledup(); return; }
201 if ( c == ',' ) {
202 if ( !eatwhitespace(is) ) {
203 std::cerr << "istream ended ater axis and comma in AxisAngle \n";
204 return;
205 }
206 } else {
207 is.putback(c);
208 }
209
210 // At this point, comma or not, the next item read is supposed to
211 // be the number delta.
212
213 if (!(is >> delta)) {
214 std::cerr << "Could not delta value in input of AxisAngle \n";
215 return;
216 }
217
218 // Finally, check for the closing parenthesis if there was an open paren.
219
220 if (parenthesis) {
221 if ( !eatwhitespace(is) ) {
222 std::cerr << "No closing parenthesis in input of AxisAngle \n";
223 return;
224 }
225 if ( !is.get(c) ) { fouledup(); return; }
226 if ( c != ')' ) {
227 std::cerr << "Missing closing parenthesis in input of AxisAngle \n";
228 if ( isdigit(c) || (c=='-') || (c=='+') ) {
229 is.putback('@');
230 } else {
231 is.putback('c');
232 }
233 int m;
234 is >> m; // This fails, leaving the state bad.
235 return;
236 }
237 }
238
239 return;
240
241}

References anonymous_namespace{ZMinput.cc}::eatwhitespace(), anonymous_namespace{ZMinput.cc}::fouledup(), m, and ZMinput3doubles().

◆ ZMpvAxisAngleRep()

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

Definition at line 24 of file AxisAngle.cc.

24 {
25
26 double sinDelta = std::sin( aa.delta() );
27 double cosDelta = std::cos( aa.delta() );
28 double oneMinusCosDelta = 1.0 - cosDelta;
29
30 double uX = aa.getAxis().getX();
31 double uY = aa.getAxis().getY();
32 double uZ = aa.getAxis().getZ();
33
34 array[0] = oneMinusCosDelta * uX * uX + cosDelta;
35 array[1] = oneMinusCosDelta * uX * uY - sinDelta * uZ;
36 array[2] = oneMinusCosDelta * uX * uZ + sinDelta * uY;
37
38 array[3] = oneMinusCosDelta * uY * uX + sinDelta * uZ;
39 array[4] = oneMinusCosDelta * uY * uY + cosDelta;
40 array[5] = oneMinusCosDelta * uY * uZ - sinDelta * uX;
41
42 array[6] = oneMinusCosDelta * uZ * uX - sinDelta * uY;
43 array[7] = oneMinusCosDelta * uZ * uY + sinDelta * uX;
44 array[8] = oneMinusCosDelta * uZ * uZ + cosDelta;
45
46} // ZMpvAxisAngleRep
double getZ() const
double getX() const
double getY() const
Hep3Vector getAxis() const

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

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

◆ ZMpvEulerAnglesRep()

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

Definition at line 44 of file EulerAngles.cc.

44 {
45
46 double sinPhi = std::sin( ex.phi() ) , cosPhi = std::cos( ex.phi() );
47 double sinTheta = std::sin( ex.theta() ), cosTheta = std::cos( ex.theta() );
48 double sinPsi = std::sin( ex.psi() ) , cosPsi = std::cos( ex.psi() );
49
50 array[0] = cosPsi * cosPhi - sinPsi * cosTheta * sinPhi;
51 array[1] = cosPsi * sinPhi + sinPsi * cosTheta * cosPhi;
52 array[2] = sinPsi * sinTheta;
53
54 array[3] = - sinPsi * cosPhi - cosPsi * cosTheta * sinPhi;
55 array[4] = - sinPsi * sinPhi + cosPsi * cosTheta * cosPhi;
56 array[5] = cosPsi * sinTheta;
57
58 array[6] = sinTheta * sinPhi;
59 array[7] = - sinTheta * cosPhi;
60 array[8] = cosTheta;
61
62} // ZMpvEulerAnglesRep
double phi() const
double theta() const
double psi() const

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

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

Variable Documentation

◆ alpha_rcl2

constexpr double CLHEP::alpha_rcl2
staticconstexpr
Initial value:
static constexpr double fine_structure_const
static constexpr double classic_electr_radius

Definition at line 102 of file PhysicalConstants.h.

◆ ampere

constexpr double CLHEP::ampere = coulomb/second
staticconstexpr

Definition at line 221 of file SystemOfUnits.h.

◆ amu

constexpr double CLHEP::amu = amu_c2/c_squared
staticconstexpr

Definition at line 84 of file PhysicalConstants.h.

Referenced by G4SandiaTable::GetSandiaPerAtom().

◆ amu_c2

constexpr double CLHEP::amu_c2 = 931.494028 * MeV
staticconstexpr

◆ angstrom

constexpr double CLHEP::angstrom = 1.e-10*meter
staticconstexpr

Definition at line 83 of file SystemOfUnits.h.

Referenced by G4ChannelingTrackData::Print().

◆ atmosphere

constexpr double CLHEP::atmosphere = 101325*pascal
staticconstexpr

Definition at line 216 of file SystemOfUnits.h.

◆ Avogadro

constexpr double CLHEP::Avogadro = 6.02214076e+23/mole
staticconstexpr

◆ bar

constexpr double CLHEP::bar = 100000*pascal
staticconstexpr

Definition at line 215 of file SystemOfUnits.h.

Referenced by CLHEP::MixMaxRng::modadd().

◆ barn

constexpr double CLHEP::barn = 1.e-28*meter2
staticconstexpr

◆ becquerel

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

Definition at line 278 of file SystemOfUnits.h.

◆ Bohr_magneton

constexpr double CLHEP::Bohr_magneton = (eplus*hbarc*c_light)/(2*electron_mass_c2)
staticconstexpr

Definition at line 110 of file PhysicalConstants.h.

◆ Bohr_radius

constexpr double CLHEP::Bohr_radius = electron_Compton_length/fine_structure_const
staticconstexpr

◆ Bq

constexpr double CLHEP::Bq = becquerel
staticconstexpr

Definition at line 285 of file SystemOfUnits.h.

◆ c_light

constexpr double CLHEP::c_light = 2.99792458e+8 * m/s
staticconstexpr

◆ c_squared

constexpr double CLHEP::c_squared = c_light * c_light
staticconstexpr

◆ candela

constexpr double CLHEP::candela = 1.
staticconstexpr

Definition at line 304 of file SystemOfUnits.h.

◆ centimeter

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

Definition at line 67 of file SystemOfUnits.h.

Referenced by G4Navigator::CheckOverlapsIterative().

◆ centimeter2

constexpr double CLHEP::centimeter2 = centimeter*centimeter
staticconstexpr

Definition at line 68 of file SystemOfUnits.h.

◆ centimeter3

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

Definition at line 69 of file SystemOfUnits.h.

◆ Ci

constexpr double CLHEP::Ci = curie
staticconstexpr

Definition at line 289 of file SystemOfUnits.h.

◆ cL

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

Definition at line 107 of file SystemOfUnits.h.

◆ classic_electr_radius

constexpr double CLHEP::classic_electr_radius = elm_coupling/electron_mass_c2
staticconstexpr

◆ cm

constexpr double CLHEP::cm = centimeter
staticconstexpr

◆ cm2

constexpr double CLHEP::cm2 = centimeter2
staticconstexpr

◆ cm3

constexpr double CLHEP::cm3 = centimeter3
staticconstexpr

◆ coulomb

constexpr double CLHEP::coulomb = eplus/e_SI
staticconstexpr

Definition at line 165 of file SystemOfUnits.h.

Referenced by G4MicroElecLOPhononModel::CrossSectionPerVolume().

◆ curie

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

Definition at line 279 of file SystemOfUnits.h.

◆ day

constexpr double CLHEP::day = 24*hour
staticconstexpr

Definition at line 146 of file SystemOfUnits.h.

◆ deg

constexpr double CLHEP::deg = degree
staticconstexpr

◆ degree

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

◆ dL

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

Definition at line 106 of file SystemOfUnits.h.

◆ e_SI

constexpr double CLHEP::e_SI = 1.602176634e-19
staticconstexpr

Definition at line 164 of file SystemOfUnits.h.

◆ e_squared

constexpr double CLHEP::e_squared = eplus * eplus
staticconstexpr

Definition at line 73 of file PhysicalConstants.h.

◆ electron_charge

constexpr double CLHEP::electron_charge = - eplus
staticconstexpr

Definition at line 72 of file PhysicalConstants.h.

◆ electron_Compton_length

constexpr double CLHEP::electron_Compton_length = hbarc/electron_mass_c2
staticconstexpr

Definition at line 99 of file PhysicalConstants.h.

◆ electron_mass_c2

constexpr double CLHEP::electron_mass_c2 = 0.510998910 * MeV
staticconstexpr

Definition at line 80 of file PhysicalConstants.h.

Referenced by G4HadronicProcess::CheckEnergyMomentumConservation(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4PairProductionRelModel::ComputeDXSectionPerAtom(), G4PairProductionRelModel::ComputeParametrizedXSectionPerAtom(), G4PairProductionRelModel::ComputeRelDXSectionPerAtom(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4RToEConvForElectron::ComputeValue(), G4RToEConvForPositron::ComputeValue(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MicroElecLOPhononModel::CrossSectionPerVolume(), G4ICRU73QOModel::DEDXPerElement(), G4IonFluctuations::Dispersion(), G4AnnihiToMuPair::G4AnnihiToMuPair(), G4GammaConversion::G4GammaConversion(), G4GSMottCorrection::G4GSMottCorrection(), G4GSPWACorrections::G4GSPWACorrections(), G4mplIonisationModel::G4mplIonisationModel(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4NistElementBuilder::GetAtomicMass(), G4DNAQuinnPlasmonExcitationModel::GetCrossSection(), G4DNARelativisticIonisationModel::GetDifferentialCrossSection(), G4DNARelativisticIonisationModel::GetEjectedElectronDirection(), G4DynamicParticle::GetElectronMass(), G4DNARelativisticIonisationModel::GetPartialCrossSection(), G4GSPWACorrections::InitDataMaterial(), G4LEPTSElasticModel::Initialise(), G4BetheHeitler5DModel::Initialise(), G4WentzelOKandVIxSection::InitialiseA(), G4MuIonisation::InitialiseEnergyLossProcess(), G4UniversalFluctuation::InitialiseMe(), G4GammaConversion::InitialiseProcess(), G4PolarizedPhotoElectricXS::Initialize(), G4PolarizedGammaConversionXS::Initialize(), G4GSMottCorrection::InitMCDataMaterial(), G4GoudsmitSaundersonTable::InitSCPCorrection(), G4eDPWAElasticDCS::InitSCPCorrection(), G4eeToHadronsMultiModel::LabToCM(), G4DNARelativisticIonisationModel::LoadAtomicStates(), G4BetheBlochModel::MaxSecondaryEnergy(), G4LindhardSorensenIonModel::MaxSecondaryEnergy(), G4GammaConversion::MinPrimaryEnergy(), G4ionIonisation::MinPrimaryEnergy(), G4MuIonisation::MinPrimaryEnergy(), G4AnnihiToMuPair::PostStepDoIt(), G4IonFluctuations::RelativisticFactor(), G4DipBustGenerator::SampleCosTheta(), G4ModifiedTsai::SampleCosTheta(), G4SBBremTable::SampleEnergyTransfer(), G4UniversalFluctuation::SampleFluctuations(), G4GoudsmitSaundersonMscModel::SampleMSC(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4DNAQuinnPlasmonExcitationModel::SampleSecondaries(), G4DNARelativisticIonisationModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4MuBremsstrahlungModel::SetParticle(), G4MuBetheBlochModel::SetParticle(), G4BraggIonModel::SetParticle(), G4BraggModel::SetParticle(), G4ICRU73QOModel::SetParticle(), G4UniversalFluctuation::SetParticleAndCharge(), G4BetaMinusDecay::SetUpBetaSpectrumSampler(), G4BetaPlusDecay::SetUpBetaSpectrumSampler(), G4SeltzerBergerModel::SetupForMaterial(), G4EnergyLossForExtrapolator::SetupKinematics(), G4EmCorrections::SetupKinematics(), G4LindhardSorensenIonModel::SetupParameters(), and G4BetheBlochModel::SetupParameters().

◆ electronvolt

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

Definition at line 171 of file SystemOfUnits.h.

◆ elm_coupling

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

◆ eplus

constexpr double CLHEP::eplus = 1.
staticconstexpr

◆ epsilon0

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

◆ eV

constexpr double CLHEP::eV = electronvolt
staticconstexpr

Definition at line 182 of file SystemOfUnits.h.

Referenced by G4EmModelActivator::ActivatePAI(), G4NistMaterialBuilder::AddMaterial(), G4DensityEffectData::AddMaterial(), G4UnstableFragmentBreakUp::BreakUpChain(), G4VLEPTSModel::BuildMeanFreePathTable(), G4LossTableBuilder::BuildTableForModel(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4IonisParamMat::ComputeDensityEffectParameters(), G4Material::ComputeDerivedQuantities(), G4IonisParamMat::ComputeFluctModel(), G4SandiaTable::ComputeMatSandiaMatrix(), G4ThermalNeutrons::ConstructProcess(), G4MicroElecMaterialStructure::ConvertUnit(), G4GoudsmitSaundersonMscModel::CrossSectionPerVolume(), G4MicroElecLOPhononModel::CrossSectionPerVolume(), G4FermiPhaseSpaceDecay::Decay(), G4ParticleHPInelasticData::DumpPhysicsTable(), G4ParticleHPSimpleEvapSpectrum::Evapo(), G4DNASancheExcitationModel::ExtendLowEnergyLimit(), G4HadronicProcess::FillResult(), G4EmCalculator::FindEmModel(), G4NuclearPolarizationStore::FindOrBuild(), G4BraggModel::G4BraggModel(), G4DensityEffectCalculator::G4DensityEffectCalculator(), G4eDPWACoulombScatteringModel::G4eDPWACoulombScatteringModel(), G4EmDNAPhysics::G4EmDNAPhysics(), G4EmLivermorePhysics::G4EmLivermorePhysics(), G4EmLowEPPhysics::G4EmLowEPPhysics(), G4EmPenelopePhysics::G4EmPenelopePhysics(), G4EmStandardPhysics_option3::G4EmStandardPhysics_option3(), G4EmStandardPhysics_option4::G4EmStandardPhysics_option4(), G4EmStandardPhysicsSS::G4EmStandardPhysicsSS(), G4EmStandardPhysicsWVI::G4EmStandardPhysicsWVI(), G4LENDManager::G4LENDManager(), G4LivermorePolarizedRayleighModel::G4LivermorePolarizedRayleighModel(), G4LivermoreRayleighModel::G4LivermoreRayleighModel(), G4NeutronRadCapture::G4NeutronRadCapture(), G4PAIModel::G4PAIModel(), G4PAIPhotModel::G4PAIPhotModel(), G4PEEffectFluoModel::G4PEEffectFluoModel(), G4PhotonEvaporation::G4PhotonEvaporation(), G4VMultipleScattering::G4VMultipleScattering(), G4WentzelVIModel::G4WentzelVIModel(), G4AtomicShells::GetBindingEnergy(), G4AtomicShells::GetNumberOfFreeElectrons(), G4ParticleHPFissionERelease::GetPromptNeutronKinetic(), G4ICRU73QOModel::GetShellEnergy(), G4AtomicShells::GetTotalBindingEnergy(), G4ParticleHPFissionERelease::GetTotalEnergy(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePath(), G4GoudsmitSaundersonMscModel::GetTransportMeanFreePathOnly(), G4ParticleHPPolynomExpansion::GetValue(), G4VLEPTSModel::Init(), G4ParticleHPInelasticCompFS::Init(), G4ParticleHPInelasticBaseFS::Init(), G4ParticleHPIsoData::Init(), G4ParticleHPAngularP::Init(), G4ParticleHPDiscreteTwoBody::Init(), G4ParticleHPFissionERelease::Init(), G4ParticleHPFissionSpectrum::Init(), G4ParticleHPLegendreTable::Init(), G4ParticleHPMadlandNixSpectrum::Init(), G4ParticleHPPartial::Init(), G4ParticleHPSimpleEvapSpectrum::Init(), G4ParticleHPWattSpectrum::Init(), G4ParticleHPProduct::Init(), G4ParticleHPArbitaryTab::Init(), G4ParticleHPParticleYield::InitDelayed(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4eeToTwoGammaModel::Initialise(), G4DNADissociation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4ParticleHPParticleYield::InitMean(), G4ParticleHPParticleYield::InitPrompt(), G4SBBremTable::LoadSTGrid(), G4ParticleHPFissionSpectrum::Maxwell(), G4eDPWACoulombScatteringModel::MinPrimaryEnergy(), G4DensityEffectData::PrintData(), G4LEPTSExcitationModel::ReadIXS(), G4VLEPTSModel::ReadParam(), G4ParticleHPEvapSpectrum::Sample(), G4ParticleHPFissionSpectrum::Sample(), G4ParticleHPSimpleEvapSpectrum::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4VLEPTSModel::SampleEnergyLoss(), G4UrbanMscModel::SampleScattering(), G4PEEffectFluoModel::SampleSecondaries(), G4LEPTSDissociationModel::SampleSecondaries(), G4LEPTSElasticModel::SampleSecondaries(), G4LEPTSExcitationModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4LEPTSPositroniumModel::SampleSecondaries(), G4LEPTSRotExcitationModel::SampleSecondaries(), G4LEPTSVibExcitationModel::SampleSecondaries(), LBE::SetCuts(), G4DeexPrecoParameters::SetDefaults(), G4ChannelingMaterialData::SetFilename(), G4ChannelingMaterialData::SetFilenameElement(), G4MicroElecElasticModel::SetKillBelowThreshold(), G4MicroElecElasticModel_new::SetKillBelowThreshold(), G4IonisParamMat::SetMeanExcitationEnergy(), G4EmParameters::SetMinEnergy(), G4VHadDecayAlgorithm::TwoBodyMomentum(), and G4ParticleHPWattSpectrum::Watt().

◆ farad

constexpr double CLHEP::farad = coulomb/volt
staticconstexpr

Definition at line 241 of file SystemOfUnits.h.

Referenced by G4MicroElecLOPhononModel::CrossSectionPerVolume().

◆ fermi

constexpr double CLHEP::fermi = 1.e-15*meter
staticconstexpr

◆ fine_structure_const

constexpr double CLHEP::fine_structure_const = elm_coupling/hbarc
staticconstexpr

◆ g

constexpr double CLHEP::g = gram
staticconstexpr

◆ gauss

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

Definition at line 257 of file SystemOfUnits.h.

◆ gaussTables [1/2]

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

Definition at line 84 of file flatToGaussian.cc.

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

◆ gaussTables [2/2]

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

Definition at line 87 of file RandGaussQ.cc.

◆ GBq

constexpr double CLHEP::GBq = gigabecquerel
staticconstexpr

Definition at line 288 of file SystemOfUnits.h.

◆ GeV

constexpr double CLHEP::GeV = gigaelectronvolt
staticconstexpr

Definition at line 184 of file SystemOfUnits.h.

Referenced by G4LMsdGenerator::ApplyYourself(), G4RToEConvForElectron::ComputeValue(), G4RToEConvForPositron::ComputeValue(), LBE::ConstructHad(), G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4HadronElasticPhysics::ConstructProcess(), G4HadronInelasticQBBC::ConstructProcess(), G4HadronicProcess::DumpState(), G4MuonicAtomDecay::DumpState(), G4QuarkExchange::ExciteParticipants(), G4SingleDiffractiveExcitation::ExciteParticipants(), G4QGSDiffractiveExcitation::ExciteParticipants(), G4HadronicProcess::FillResult(), G4FissionBarrier::FissionBarrier(), G4BGGPionInelasticXS::G4BGGPionInelasticXS(), G4eeToHadronsMultiModel::G4eeToHadronsMultiModel(), G4EmCorrections::G4EmCorrections(), G4FTFParamCollBaryonProj::G4FTFParamCollBaryonProj(), G4FTFParamCollMesonProj::G4FTFParamCollMesonProj(), G4HadronicParameters::G4HadronicParameters(), G4HadronPhysicsFTF_BIC::G4HadronPhysicsFTF_BIC(), G4HadronPhysicsFTFP_BERT_ATL::G4HadronPhysicsFTFP_BERT_ATL(), G4InuclParticle::G4InuclParticle(), G4LightTargetCollider::G4LightTargetCollider(), G4LivermorePolarizedRayleighModel::G4LivermorePolarizedRayleighModel(), G4LowEGammaNuclearModel::G4LowEGammaNuclearModel(), G4mplIonisationModel::G4mplIonisationModel(), G4MuonVDNuclearModel::G4MuonVDNuclearModel(), G4NeutronRadCapture::G4NeutronRadCapture(), G4PairProductionRelModel::G4PairProductionRelModel(), G4RTPrimaryGeneratorAction::G4RTPrimaryGeneratorAction(), G4VEnergyLossProcess::G4VEnergyLossProcess(), G4VRangeToEnergyConverter::G4VRangeToEnergyConverter(), G4EmExtraPhysics::GammaNuclearLEModelLimit(), G4ErrorEnergyLoss::GetContinuousStepLimit(), 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(), G4VMscModel::GetParticleChangeForMSC(), G4XNNTotalLowE::HighLimit(), G4FTFParameters::InitForInteraction(), G4EmParameters::Initialise(), G4BraggModel::Initialise(), G4MuIonisation::InitialiseEnergyLossProcess(), G4CoulombScattering::InitialiseProcess(), G4SBBremTable::LoadSTGrid(), G4VMultipleScattering::PreparePhysicsTable(), G4ChannelingTrackData::Print(), G4AnnihiToMuPair::PrintInfoDefinition(), G4LMsdGenerator::SampleMx(), G4LMsdGenerator::SampleT(), G4FTFParameters::SetAveragePt2(), LBE::SetCuts(), G4DeexPrecoParameters::SetDefaults(), G4HadronicParameters::SetEnergyThresholdForHeavyHadrons(), G4InuclParticle::setKineticEnergy(), G4InuclParticle::setMass(), G4EmParameters::SetMaxEnergy(), G4EmParameters::SetMaxEnergyForCSDARange(), G4hhElastic::SetParameters(), G4hhElastic::SetParametersCMS(), G4FTFParameters::SetProjMinDiffMass(), G4FTFParameters::SetProjMinNonDiffMass(), G4FTFParameters::SetTarMinDiffMass(), G4FTFParameters::SetTarMinNonDiffMass(), G4LindhardSorensenIonModel::SetupParameters(), G4BetheBlochModel::SetupParameters(), Shielding::Shielding(), and G4EmParameters::StreamInfo().

◆ gigabecquerel

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

Definition at line 282 of file SystemOfUnits.h.

◆ gigaelectronvolt

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

Definition at line 173 of file SystemOfUnits.h.

◆ gram

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

Definition at line 192 of file SystemOfUnits.h.

◆ gray

constexpr double CLHEP::gray = joule/kilogram
staticconstexpr

Definition at line 296 of file SystemOfUnits.h.

◆ h_Planck

constexpr double CLHEP::h_Planck = 6.62607015e-34 * joule*s
staticconstexpr

◆ halfpi

constexpr double CLHEP::halfpi = pi/2
staticconstexpr

◆ hbar_Planck

constexpr double CLHEP::hbar_Planck = h_Planck/twopi
staticconstexpr

◆ hbarc

constexpr double CLHEP::hbarc = hbar_Planck * c_light
staticconstexpr

Definition at line 66 of file PhysicalConstants.h.

Referenced by G4NeutronElectronElXsc::CalculateAm(), G4NeutronElectronElModel::CalculateAm(), G4DiffuseElastic::CalculateAm(), G4DiffuseElasticV2::CalculateAm(), G4NuclNuclDiffuseElastic::CalculateAm(), G4hhElastic::CalculateBqQ12(), G4hhElastic::CalculateBqQ123(), G4hhElastic::CalculateBqQ13(), G4PreCompoundTransitions::CalculateProbability(), G4ComponentGGNuclNuclXsc::ComputeCoulombBarier(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4EvaporationProbability::G4EvaporationProbability(), G4GEMProbabilityVI::G4GEMProbabilityVI(), G4HETCFragment::G4HETCFragment(), G4mplIonisationModel::G4mplIonisationModel(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4DiffuseElastic::GetCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetCoulombElasticXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), G4NuclNuclDiffuseElastic::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().

◆ hbarc_squared

constexpr double CLHEP::hbarc_squared = hbarc * hbarc
staticconstexpr

Definition at line 67 of file PhysicalConstants.h.

Referenced by G4IonisParamMat::ComputeDensityEffectParameters().

◆ henry

constexpr double CLHEP::henry = weber/ampere
staticconstexpr

Definition at line 263 of file SystemOfUnits.h.

◆ hep_pascal

constexpr double CLHEP::hep_pascal = newton/m2
staticconstexpr

Definition at line 214 of file SystemOfUnits.h.

◆ HepRandomGenActive

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

Definition at line 65 of file Randomize.h.

◆ HepXHat

const Hep3Vector CLHEP::HepXHat(1.0, 0.0, 0.0)

◆ HepYHat

const Hep3Vector CLHEP::HepYHat(0.0, 1.0, 0.0)

◆ HepZHat

const Hep3Vector CLHEP::HepZHat(0.0, 0.0, 1.0)

◆ hertz

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

Definition at line 149 of file SystemOfUnits.h.

◆ hour

constexpr double CLHEP::hour = 60*minute
staticconstexpr

Definition at line 145 of file SystemOfUnits.h.

◆ inverseLandau

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

Definition at line 73 of file RandLandau.cc.

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

◆ joule

constexpr double CLHEP::joule = electronvolt/e_SI
staticconstexpr

Definition at line 178 of file SystemOfUnits.h.

Referenced by G4MicroElecLOPhononModel::CrossSectionPerVolume().

◆ k_Boltzmann

constexpr double CLHEP::k_Boltzmann = 8.617333e-11 * MeV/kelvin
staticconstexpr

◆ kBits

constexpr int CLHEP::kBits = 48
staticconstexpr

◆ kBq

constexpr double CLHEP::kBq = kilobecquerel
staticconstexpr

Definition at line 286 of file SystemOfUnits.h.

◆ kelvin

constexpr double CLHEP::kelvin = 1.
staticconstexpr

◆ keV

constexpr double CLHEP::keV = kiloelectronvolt
staticconstexpr

Definition at line 183 of file SystemOfUnits.h.

Referenced by G4EmModelActivator::ActivatePAI(), G4ParticleHPInelasticBaseFS::BaseApply(), G4ParticleHPInelasticCompFS::CompositeApply(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4IonisParamMat::ComputeIonParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), G4RToEConvForElectron::ComputeValue(), G4RToEConvForGamma::ComputeValue(), G4RToEConvForPositron::ComputeValue(), G4VRangeToEnergyConverter::Convert(), G4RToEConvForProton::Convert(), G4MicroElecMaterialStructure::ConvertUnit(), G4ionEffectiveCharge::EffectiveCharge(), G4HadronicProcess::FillResult(), G4VEmissionProbability::FindRecoilExcitation(), G4BraggModel::G4BraggModel(), G4EmCorrections::G4EmCorrections(), G4GDecay3::G4GDecay3(), G4GoudsmitSaundersonTable::G4GoudsmitSaundersonTable(), G4ionEffectiveCharge::G4ionEffectiveCharge(), G4NeutronRadCapture::G4NeutronRadCapture(), G4UrbanMscModel::G4UrbanMscModel(), G4VEmProcess::G4VEmProcess(), G4VEnergyLossProcess::G4VEnergyLossProcess(), G4VRangeToEnergyConverter::G4VRangeToEnergyConverter(), G4VXTRenergyLoss::G4VXTRenergyLoss(), G4AtomicShells_XDB_EADL::GetBindingEnergy(), G4ANuElNucleusNcModel::GetMinNuElEnergy(), G4NuElNucleusNcModel::GetMinNuElEnergy(), G4ANuMuNucleusNcModel::GetMinNuMuEnergy(), G4NuMuNucleusNcModel::GetMinNuMuEnergy(), G4AtomicShells_XDB_EADL::GetNumberOfFreeElectrons(), G4SandiaTable::GetSandiaCofPerAtom(), G4SandiaTable::GetSandiaCofWater(), G4SandiaTable::GetSandiaPerAtom(), G4AtomicShells_XDB_EADL::GetTotalBindingEnergy(), G4SandiaTable::GetWaterEnergyLimit(), G4EmParameters::Initialise(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4LevelReader::LevelManager(), G4eDPWAElasticDCS::LoadGrid(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4UniversalFluctuation::SampleFluctuations(), G4DNAUeharaScreenedRutherfordElasticModel::SelectHighEnergyLimit(), G4CoupledTransportation::SetLowLooperThresholds(), G4Transportation::SetLowLooperThresholds(), G4EnergyLossForExtrapolator::SetupKinematics(), and G4DeexPrecoParameters::StreamInfo().

◆ kg

constexpr double CLHEP::kg = kilogram
staticconstexpr

Definition at line 196 of file SystemOfUnits.h.

Referenced by G4MicroElecLOPhononModel::CrossSectionPerVolume().

◆ kGasThreshold

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

Definition at line 123 of file PhysicalConstants.h.

◆ kilobecquerel

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

Definition at line 280 of file SystemOfUnits.h.

◆ kiloelectronvolt

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

Definition at line 172 of file SystemOfUnits.h.

◆ kilogauss

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

Definition at line 258 of file SystemOfUnits.h.

◆ kilogram

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

Definition at line 191 of file SystemOfUnits.h.

◆ kilogray

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

Definition at line 297 of file SystemOfUnits.h.

◆ kilohertz

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

Definition at line 150 of file SystemOfUnits.h.

◆ kilometer

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

Definition at line 75 of file SystemOfUnits.h.

◆ kilometer2

constexpr double CLHEP::kilometer2 = kilometer*kilometer
staticconstexpr

Definition at line 76 of file SystemOfUnits.h.

◆ kilometer3

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

Definition at line 77 of file SystemOfUnits.h.

◆ kilovolt

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

Definition at line 230 of file SystemOfUnits.h.

◆ km

constexpr double CLHEP::km = kilometer
staticconstexpr

Definition at line 114 of file SystemOfUnits.h.

◆ km2

constexpr double CLHEP::km2 = kilometer2
staticconstexpr

Definition at line 115 of file SystemOfUnits.h.

◆ km3

constexpr double CLHEP::km3 = kilometer3
staticconstexpr

Definition at line 116 of file SystemOfUnits.h.

◆ kMaxPos

constexpr int CLHEP::kMaxPos = 9 * 64
staticconstexpr

◆ L

constexpr double CLHEP::L = liter
staticconstexpr

Definition at line 105 of file SystemOfUnits.h.

◆ liter

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

Definition at line 104 of file SystemOfUnits.h.

◆ lumen

constexpr double CLHEP::lumen = candela*steradian
staticconstexpr

Definition at line 309 of file SystemOfUnits.h.

◆ lux

constexpr double CLHEP::lux = lumen/meter2
staticconstexpr

◆ m

constexpr double CLHEP::m = meter
staticconstexpr

◆ m2

constexpr double CLHEP::m2 = meter2
staticconstexpr

Definition at line 111 of file SystemOfUnits.h.

Referenced by G4MicroElecLOPhononModel::CrossSectionPerVolume().

◆ m3

constexpr double CLHEP::m3 = meter3
staticconstexpr

◆ MarkerLen [1/8]

const int CLHEP::MarkerLen = 64
static

◆ MarkerLen [2/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 62 of file JamesRandom.cc.

◆ MarkerLen [3/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 53 of file MixMaxRng.cc.

◆ MarkerLen [4/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 62 of file MTwistEngine.cc.

◆ MarkerLen [5/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 59 of file RanecuEngine.cc.

◆ MarkerLen [6/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 78 of file Ranlux64Engine.cc.

◆ MarkerLen [7/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 61 of file RanluxEngine.cc.

◆ MarkerLen [8/8]

const int CLHEP::MarkerLen = 64
static

Definition at line 61 of file RanshiEngine.cc.

◆ MBq

constexpr double CLHEP::MBq = megabecquerel
staticconstexpr

Definition at line 287 of file SystemOfUnits.h.

◆ mCi

constexpr double CLHEP::mCi = millicurie
staticconstexpr

Definition at line 290 of file SystemOfUnits.h.

◆ megabecquerel

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

Definition at line 281 of file SystemOfUnits.h.

◆ megaelectronvolt

constexpr double CLHEP::megaelectronvolt = 1.
staticconstexpr

Definition at line 170 of file SystemOfUnits.h.

◆ megahertz

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

Definition at line 151 of file SystemOfUnits.h.

◆ megavolt

constexpr double CLHEP::megavolt = megaelectronvolt/eplus
staticconstexpr

Definition at line 229 of file SystemOfUnits.h.

◆ meter

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

◆ meter2

constexpr double CLHEP::meter2 = meter*meter
staticconstexpr

Definition at line 72 of file SystemOfUnits.h.

◆ meter3

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

Definition at line 73 of file SystemOfUnits.h.

◆ MeV

constexpr double CLHEP::MeV = megaelectronvolt
staticconstexpr

Definition at line 181 of file SystemOfUnits.h.

Referenced by G4WaterStopping::AddData(), G4ICRU90StoppingData::AddData(), G4PreCompoundEmission::AngularDistribution(), G4LMsdGenerator::ApplyYourself(), G4TheoFSGenerator::ApplyYourself(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), G4FissionBarrier::BarashenkovFissionBarrier(), G4ParticleHPInelasticBaseFS::BaseApply(), G4UnstableFragmentBreakUp::BreakUpChain(), G4EmCorrections::BuildCorrectionVector(), G4GEMProbability::CalcBetaParam(), G4NeutronEvaporationProbability::CalcBetaParam(), G4GNASHTransitions::CalculateProbability(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4BraggIonModel::ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4BraggIonModel::ComputeDEDXPerVolume(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4eDPWAElasticDCS::ComputeMParams(), G4NIELCalculator::ComputeNIEL(), G4PairProductionRelModel::ComputeParametrizedXSectionPerAtom(), G4UrbanAdjointMscModel::ComputeTheta0(), G4UrbanMscModel::ComputeTheta0(), G4GEMProbabilityVI::ComputeTotalProbability(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4RToEConvForElectron::ComputeValue(), G4RToEConvForGamma::ComputeValue(), G4RToEConvForPositron::ComputeValue(), LBE::ConstructEM(), G4EmExtraPhysics::ConstructGammaElectroNuclear(), LBE::ConstructHad(), G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), G4MicroElecMaterialStructure::ConvertUnit(), G4BraggIonModel::CrossSectionPerVolume(), G4FissionParameters::DefineParameters(), G4FermiFragmentsPoolVI::Dump(), G4ParticleHPInelasticData::DumpPhysicsTable(), G4BraggIonModel::ElectronicStoppingPower(), G4FPYSamplingOps::EvaluateWattConstants(), G4IonFluctuations::Factor(), G4CompetitiveFission::FissionKineticEnergy(), G4BetheBlochModel::G4BetheBlochModel(), G4BGGPionInelasticXS::G4BGGPionInelasticXS(), G4BraggIonModel::G4BraggIonModel(), G4BraggModel::G4BraggModel(), G4CameronGilbertPairingCorrections::G4CameronGilbertPairingCorrections(), G4CameronGilbertShellCorrections::G4CameronGilbertShellCorrections(), G4CameronShellPlusPairingCorrections::G4CameronShellPlusPairingCorrections(), G4CameronTruranHilfPairingCorrections::G4CameronTruranHilfPairingCorrections(), G4CameronTruranHilfShellCorrections::G4CameronTruranHilfShellCorrections(), G4ComptonScattering::G4ComptonScattering(), G4CookPairingCorrections::G4CookPairingCorrections(), G4CookShellCorrections::G4CookShellCorrections(), G4DiffElasticRatio::G4DiffElasticRatio(), G4eDPWACoulombScatteringModel::G4eDPWACoulombScatteringModel(), G4eeToHadronsMultiModel::G4eeToHadronsMultiModel(), G4eeToTwoPiModel::G4eeToTwoPiModel(), G4ElasticHadrNucleusHE::G4ElasticHadrNucleusHE(), G4EmCorrections::G4EmCorrections(), G4EmLivermorePhysics::G4EmLivermorePhysics(), G4EmPenelopePhysics::G4EmPenelopePhysics(), G4EmStandardPhysics_option3::G4EmStandardPhysics_option3(), G4EmStandardPhysics_option4::G4EmStandardPhysics_option4(), G4EmStandardPhysicsWVI::G4EmStandardPhysicsWVI(), G4EnergyLossForExtrapolator::G4EnergyLossForExtrapolator(), G4EvaporationProbability::G4EvaporationProbability(), G4FermiBreakUpVI::G4FermiBreakUpVI(), G4FTFSettingDefaultHDP::G4FTFSettingDefaultHDP(), G4GEMProbabilityVI::G4GEMProbabilityVI(), G4GoudsmitSaundersonTable::G4GoudsmitSaundersonTable(), G4HadronPhysicsFTFP_BERT_HP::G4HadronPhysicsFTFP_BERT_HP(), G4HadronPhysicsQGSP_BIC_AllHP::G4HadronPhysicsQGSP_BIC_AllHP(), G4HadronPhysicsShielding::G4HadronPhysicsShielding(), G4hIonisation::G4hIonisation(), G4InuclParticle::G4InuclParticle(), G4ionEffectiveCharge::G4ionEffectiveCharge(), G4IonICRU73Data::G4IonICRU73Data(), G4ionIonisation::G4ionIonisation(), G4LindhardSorensenIonModel::G4LindhardSorensenIonModel(), G4LowEHadronElastic::G4LowEHadronElastic(), G4PairProductionRelModel::G4PairProductionRelModel(), G4ParticleHPInelasticData::G4ParticleHPInelasticData(), G4UPiNuclearCrossSection::G4UPiNuclearCrossSection(), G4UrbanMscModel::G4UrbanMscModel(), G4VMscModel::G4VMscModel(), G4EmExtraPhysics::GammaNuclearLEModelLimit(), G4LivermorePolarizedRayleighModel::GenerateCosTheta(), G4EMDissociationCrossSection::GetElementCrossSection(), G4NeutronCaptureXS::GetElementCrossSection(), G4NeutronElasticXS::GetElementCrossSection(), G4NeutronInelasticXS::GetElementCrossSection(), G4GammaNuclearXS::GetElementCrossSection(), G4ParticleInelasticXS::GetElementCrossSection(), G4EvaporationChannel::GetEmissionProbability(), G4PhotonEvaporation::GetEmissionProbability(), G4InuclParticle::getEnergy(), G4InuclNuclei::getExitationEnergy(), G4GammaNuclearXS::GetIsoCrossSection(), G4InuclParticle::getKineticEnergy(), G4InuclParticle::getMass(), G4ANuElNucleusCcModel::GetMinNuElEnergy(), G4NuElNucleusCcModel::GetMinNuElEnergy(), G4ANuMuNucleusCcModel::GetMinNuMuEnergy(), G4NeutrinoNucleusModel::GetMinNuMuEnergy(), G4NuMuNucleusCcModel::GetMinNuMuEnergy(), G4InuclParticle::getMomentum(), G4InuclParticle::getMomModule(), G4InuclNuclei::getNucleiMass(), G4NuclearLevelData::GetPairingCorrection(), G4VLEPTSModel::Init(), G4GSPWACorrections::InitDataMaterial(), G4EmParameters::Initialise(), G4LEPTSElasticModel::Initialise(), G4WaterStopping::Initialise(), G4WentzelOKandVIxSection::InitialiseA(), G4hhIonisation::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4PhotonEvaporation::InitialiseGRData(), G4DNADissociation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4GSMottCorrection::InitMCDataMaterial(), G4GoudsmitSaundersonTable::InitMoliereMSCParams(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4VEmissionProbability::IntegrateProbability(), G4LMsdGenerator::IsApplicable(), G4ParticleInelasticXS::IsoCrossSection(), G4NeutronInelasticXS::IsoCrossSection(), G4LevelReader::LevelManager(), G4eDPWAElasticDCS::LoadGrid(), G4SBBremTable::LoadSTGrid(), G4MuPairProductionModel::MakeSamplingTables(), G4VEnergyLossProcess::PreparePhysicsTable(), G4VMultipleScattering::PreparePhysicsTable(), G4Transportation::PrintStatistics(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), G4Transportation::ProcessDescription(), G4ComponentSAIDTotalXS::ReadData(), G4TransportationLogger::ReportLooperThresholds(), G4IonICRU73Data::RetrieveVector(), G4ParticleHPFissionSpectrum::Sample(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4HadronElastic::SampleInvariantT(), G4MuBremsstrahlungModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4eeToHadronsModel::SampleSecondaries(), G4DeexPrecoParameters::SetDefaults(), G4CoupledTransportation::SetHighLooperThresholds(), G4Transportation::SetHighLooperThresholds(), G4InuclParticle::setKineticEnergy(), G4DeexPrecoParameters::SetLevelDensity(), G4CoupledTransportation::SetLowLooperThresholds(), G4Transportation::SetLowLooperThresholds(), G4InuclParticle::setMass(), G4EmParameters::SetMaxEnergy(), G4EmParameters::SetMinEnergy(), G4hhElastic::SetParametersCMS(), G4BraggIonModel::StoppingPower(), G4EmParameters::StreamInfo(), G4DeexPrecoParameters::StreamInfo(), G4ElNucleusSFcs::ThresholdEnergy(), and G4EmConfigurator::UpdateModelEnergyRange().

◆ mg

constexpr double CLHEP::mg = milligram
staticconstexpr

Definition at line 198 of file SystemOfUnits.h.

◆ microampere

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

Definition at line 223 of file SystemOfUnits.h.

◆ microbarn

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

◆ microcurie

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

Definition at line 284 of file SystemOfUnits.h.

◆ microfarad

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

Definition at line 243 of file SystemOfUnits.h.

◆ microgray

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

Definition at line 299 of file SystemOfUnits.h.

◆ micrometer

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

Definition at line 81 of file SystemOfUnits.h.

Referenced by LBE::LBE().

◆ microsecond

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

Definition at line 141 of file SystemOfUnits.h.

◆ milliampere

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

Definition at line 222 of file SystemOfUnits.h.

◆ millibarn

constexpr double CLHEP::millibarn = 1.e-3 *barn
staticconstexpr

◆ millicurie

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

Definition at line 283 of file SystemOfUnits.h.

◆ millielectronvolt

constexpr double CLHEP::millielectronvolt = 1.e-9*megaelectronvolt
staticconstexpr

Definition at line 176 of file SystemOfUnits.h.

◆ millifarad

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

Definition at line 242 of file SystemOfUnits.h.

◆ milligram

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

Definition at line 193 of file SystemOfUnits.h.

◆ milligray

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

Definition at line 298 of file SystemOfUnits.h.

◆ millimeter

constexpr double CLHEP::millimeter = 1.
staticconstexpr

◆ millimeter2

constexpr double CLHEP::millimeter2 = millimeter*millimeter
staticconstexpr

Definition at line 64 of file SystemOfUnits.h.

◆ millimeter3

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

Definition at line 65 of file SystemOfUnits.h.

◆ milliradian

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

Definition at line 124 of file SystemOfUnits.h.

◆ millisecond

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

Definition at line 140 of file SystemOfUnits.h.

◆ minute

constexpr double CLHEP::minute = 60*second
staticconstexpr

Definition at line 144 of file SystemOfUnits.h.

◆ mL

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

Definition at line 108 of file SystemOfUnits.h.

◆ mm

constexpr double CLHEP::mm = millimeter
staticconstexpr

◆ mm2

constexpr double CLHEP::mm2 = millimeter2
staticconstexpr

Definition at line 97 of file SystemOfUnits.h.

◆ mm3

constexpr double CLHEP::mm3 = millimeter3
staticconstexpr

Definition at line 98 of file SystemOfUnits.h.

◆ mole

constexpr double CLHEP::mole = 1.
staticconstexpr

◆ mrad

constexpr double CLHEP::mrad = milliradian
staticconstexpr

Definition at line 131 of file SystemOfUnits.h.

◆ ms

constexpr double CLHEP::ms = millisecond
staticconstexpr

Definition at line 156 of file SystemOfUnits.h.

◆ mu0

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

Definition at line 90 of file PhysicalConstants.h.

◆ nanoampere

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

Definition at line 224 of file SystemOfUnits.h.

◆ nanobarn

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

Definition at line 89 of file SystemOfUnits.h.

◆ nanofarad

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

Definition at line 244 of file SystemOfUnits.h.

◆ nanometer

constexpr double CLHEP::nanometer = 1.e-9 *meter
staticconstexpr

◆ nanosecond

constexpr double CLHEP::nanosecond = 1.
staticconstexpr

Definition at line 138 of file SystemOfUnits.h.

Referenced by G4DeexPrecoParameters::SetDefaults().

◆ neutron_mass_c2

constexpr double CLHEP::neutron_mass_c2 = 939.56536 * MeV
staticconstexpr

◆ newton

constexpr double CLHEP::newton = joule/meter
staticconstexpr

Definition at line 208 of file SystemOfUnits.h.

◆ nm

constexpr double CLHEP::nm = nanometer
staticconstexpr

◆ ns

constexpr double CLHEP::ns = nanosecond
staticconstexpr

◆ nuclear_magneton

constexpr double CLHEP::nuclear_magneton = (eplus*hbarc*c_light)/(2*proton_mass_c2)
staticconstexpr

Definition at line 111 of file PhysicalConstants.h.

◆ ohm

constexpr double CLHEP::ohm = volt/ampere
staticconstexpr

Definition at line 236 of file SystemOfUnits.h.

◆ parsec

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

Definition at line 79 of file SystemOfUnits.h.

◆ pc

constexpr double CLHEP::pc = parsec
staticconstexpr

Definition at line 118 of file SystemOfUnits.h.

◆ perCent

constexpr double CLHEP::perCent = 0.01
staticconstexpr

◆ perMillion

constexpr double CLHEP::perMillion = 0.000001
staticconstexpr

◆ perThousand

constexpr double CLHEP::perThousand = 0.001
staticconstexpr

◆ petaelectronvolt

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

Definition at line 175 of file SystemOfUnits.h.

◆ PeV

constexpr double CLHEP::PeV = petaelectronvolt
staticconstexpr

Definition at line 186 of file SystemOfUnits.h.

Referenced by G4MuonVDNuclearModel::G4MuonVDNuclearModel().

◆ pi

constexpr double CLHEP::pi = 3.14159265358979323846
staticconstexpr

Definition at line 55 of file SystemOfUnits.h.

Referenced by G4NuclNuclDiffuseElastic::AmplitudeFar(), G4NuclNuclDiffuseElastic::AmplitudeGG(), G4NuclNuclDiffuseElastic::AmplitudeGla(), G4NuclNuclDiffuseElastic::AmplitudeNear(), G4MuonRadiativeDecayChannelWithSpin::atan4(), G4MicroElecInelasticModel_new::BKZ(), G4DiffuseElastic::BuildAngleTable(), G4DiffuseElasticV2::BuildAngleTable(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4ParticleHPNBodyPhaseSpace::C(), G4hhElastic::CalculateBqQ12(), G4hhElastic::CalculateBqQ123(), G4hhElastic::CalculateBqQ13(), G4PreCompoundTransitions::CalculateProbability(), G4DNAEventScheduler::CheckingReactionRadius(), G4ScreeningMottCrossSection::ComputeAngle(), G4AnnihiToMuPair::ComputeCrossSectionPerElectron(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4IonisParamMat::ComputeDensityEffectParameters(), G4DNAMolecularReactionData::ComputeEffectiveRadius(), G4eBremsstrahlungRelModel::ComputeLPMGsPhis(), G4PairProductionRelModel::ComputeLPMGsPhis(), G4CrystalExtension::ComputeStructureFactor(), G4CrystalExtension::ComputeStructureFactorGeometrical(), G4TablesForExtrapolator::ComputeTrasportXS(), correctByPi(), CLHEP::HepRotation::delta(), CLHEP::Hep3Vector::deltaPhi(), G4StokesVector::DiceUniform(), G4ScreeningMottCrossSection::DifferentialXSection(), CLHEP::HepStat::erf(), G4ErrorFunction::erfcx(), CLHEP::RandPoisson::fire(), G4EvaporationProbability::G4EvaporationProbability(), G4GEMProbabilityVI::G4GEMProbabilityVI(), G4HETCFragment::G4HETCFragment(), G4mplIonisationModel::G4mplIonisationModel(), G4Poisson(), G4PreCompoundIon::G4PreCompoundIon(), G4ParticleHPMadlandNixSpectrum::Gamma05(), G4NuclNuclDiffuseElastic::GammaLess(), G4NuclNuclDiffuseElastic::GammaMore(), G4DNAPartiallyDiffusionControlled::GeminateRecombinationProbability(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnASphereBoundary(), G4hhElastic::GetAqq(), G4hhElastic::GetAQQ(), G4Nucleus::GetBiasedThermalNucleus(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4DiffuseElastic::GetCoulombTotalXsc(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DNAQuinnPlasmonExcitationModel::GetCrossSection(), G4Ellipsoid::GetCubicVolume(), G4EllipticalCone::GetCubicVolume(), G4DNARelativisticIonisationModel::GetDifferentialCrossSection(), G4hhElastic::GetdsdtF1(), G4hhElastic::GetdsdtF12(), G4hhElastic::GetdsdtF123(), G4hhElastic::GetdsdtF123qQgG(), G4hhElastic::GetdsdtF12qQgG(), G4hhElastic::GetdsdtF13qQG(), G4hhElastic::GetdsdtF1qQgG(), G4DNARelativisticIonisationModel::GetEjectedElectronDirection(), G4NuclNuclDiffuseElastic::GetErfComp(), G4NuclNuclDiffuseElastic::GetErfInt(), G4NuclNuclDiffuseElastic::GetErfSer(), G4hhElastic::GetExpRatioF123(), G4hhElastic::GetF1(), G4hhElastic::GetF1qQgG(), G4hhElastic::GetF2(), G4hhElastic::GetF2qQgG(), G4hhElastic::GetF3(), G4hhElastic::GetF3qQgG(), G4DNAIRT::GetIndependentReactionTime(), G4DNAIRT_geometries::GetIndependentReactionTime(), G4DiffuseElasticV2::GetIntegrandFunction(), G4NuclNuclDiffuseElastic::GetLegendrePol(), G4ElasticHadrNucleusHE::GetLightFq2(), G4PreCompoundFragment::GetOpt0(), G4Channeling::GetOscillationPeriod(), G4DNARelativisticIonisationModel::GetPartialCrossSection(), G4Ellipsoid::GetPointOnSurface(), G4NuclNuclDiffuseElastic::GetRatioGen(), G4NuclNuclDiffuseElastic::GetRatioSim(), G4DiffusionControlledReactionModel::GetReactionRadius(), G4Sphere::GetSurfaceArea(), G4Ellipsoid::GetSurfaceArea(), G4EllipticalCone::GetSurfaceArea(), G4DNAPartiallyDiffusionControlled::GetTimeToEncounter(), G4DNATotallyDiffusionControlled::GetTimeToEncounter(), G4ElasticHadrNucleusHE::HadrNucDifferCrSec(), G4EmParameters::Initialise(), G4hCoulombScatteringModel::Initialise(), G4WentzelVIModel::Initialise(), G4CoulombScattering::InitialiseProcess(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4ErrorFunction::Lambda(), G4DNARelativisticIonisationModel::LoadAtomicStates(), G4DNAIRT::MakeReaction(), G4DNAIRT_geometries::MakeReaction(), G4EmCorrections::MottCorrection(), G4NuclNuclDiffuseElastic::PhaseFar(), G4NuclNuclDiffuseElastic::PhaseNear(), CLHEP::HepRotation::phi(), CLHEP::HepRotationX::phi(), CLHEP::HepRotationY::phi(), G4VAngularDistribution::Phi(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGeneratePhiAndTheta(), G4DipBustGenerator::PolarAngle(), G4hhElastic::Pomeron(), G4AnnihiToMuPair::PostStepDoIt(), G4NuclNuclDiffuseElastic::Profile(), G4NuclNuclDiffuseElastic::ProfileFar(), G4NuclNuclDiffuseElastic::ProfileNear(), CLHEP::HepRotation::psi(), CLHEP::HepRotationX::psi(), CLHEP::HepRotationY::psi(), G4DNAELSEPAElasticModel::RandomizeCosTheta(), safe_acos(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4UrbanMscModel::SampleCosineTheta(), G4Generator2BN::SampleDirection(), G4UrbanMscModel::SampleDisplacement(), G4UrbanMscModel::SampleDisplacementNew(), G4DNAIRT::SamplePDC(), G4DNAIRT_geometries::SamplePDC(), G4DNAELSEPAElasticModel::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), CLHEP::Hep3Vector::setCylEta(), CLHEP::Hep3Vector::setCylTheta(), CLHEP::RandPoisson::shoot(), G4GeomTools::SphereExtent(), G4PolarizedComptonXS::TotalXSection(), and G4DNAMakeReaction::UpdatePositionForReaction().

◆ pi2

constexpr double CLHEP::pi2 = pi*pi
staticconstexpr

◆ picobarn

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

Definition at line 90 of file SystemOfUnits.h.

◆ picofarad

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

Definition at line 245 of file SystemOfUnits.h.

◆ picosecond

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

Definition at line 142 of file SystemOfUnits.h.

◆ poissonTables

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

Definition at line 74 of file RandPoissonQ.cc.

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

◆ prec

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

◆ proton_mass_c2

constexpr double CLHEP::proton_mass_c2 = 938.272013 * MeV
staticconstexpr

Definition at line 81 of file PhysicalConstants.h.

Referenced by G4EmDNAPhysicsActivator::AddHeliumModels0(), G4TheoFSGenerator::ApplyYourself(), G4PreCompoundTransitions::CalculateProbability(), G4WentzelVIRelModel::ComputeCrossSectionPerAtom(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4EnergyLossForExtrapolator::ComputeDEDX(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4EnergyLossForExtrapolator::ComputeEnergy(), G4EnergyLossForExtrapolator::ComputeRange(), G4ionEffectiveCharge::EffectiveCharge(), G4EmCorrections::EffectiveChargeCorrection(), G4BraggIonModel::G4BraggIonModel(), G4eCoulombScatteringModel::G4eCoulombScatteringModel(), G4hCoulombScatteringModel::G4hCoulombScatteringModel(), G4ionEffectiveCharge::G4ionEffectiveCharge(), G4UrbanMscModel::G4UrbanMscModel(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4Fragment::GetBindingEnergy(), G4hhElastic::GetdsdtF1(), G4hhElastic::GetdsdtF12(), G4hhElastic::GetdsdtF123(), G4hhElastic::GetExpRatioF123(), G4hhElastic::GetF1(), G4hhElastic::GetF2(), G4hhElastic::GetF3(), G4HadronNucleonXsc::HadronNucleonXscEL(), G4ionIonisation::InitialiseEnergyLossProcess(), G4hImpactIonisation::IsApplicable(), G4LowECapture::PostStepGetPhysicalInteractionLength(), G4BraggIonModel::SetParticle(), G4BraggModel::SetParticle(), G4ICRU73QOModel::SetParticle(), G4PAIModel::SetParticle(), G4PAIPhotModel::SetParticle(), G4LindhardSorensenIonModel::SetupParameters(), G4WentzelOKandVIxSection::SetupTarget(), and G4VEnergyLossProcess::StartTracking().

◆ ps

constexpr double CLHEP::ps = picosecond
staticconstexpr

Definition at line 158 of file SystemOfUnits.h.

Referenced by G4RadioactiveDecay::StreamInfo().

◆ rad

constexpr double CLHEP::rad = radian
staticconstexpr

Definition at line 130 of file SystemOfUnits.h.

Referenced by G4EmParameters::StreamInfo().

◆ radian

constexpr double CLHEP::radian = 1.
staticconstexpr

Definition at line 123 of file SystemOfUnits.h.

◆ s

constexpr double CLHEP::s = second
staticconstexpr

◆ second

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

Definition at line 139 of file SystemOfUnits.h.

Referenced by G4LevelReader::G4LevelReader().

◆ sr

constexpr double CLHEP::sr = steradian
staticconstexpr

Definition at line 132 of file SystemOfUnits.h.

Referenced by G4eDPWAElasticDCS::LoadDCSForZ().

◆ steradian

constexpr double CLHEP::steradian = 1.
staticconstexpr

Definition at line 127 of file SystemOfUnits.h.

◆ STP_Pressure

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

◆ STP_Temperature

constexpr double CLHEP::STP_Temperature = 273.15*kelvin
staticconstexpr

Definition at line 121 of file PhysicalConstants.h.

◆ T_HAT4

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

Definition at line 537 of file LorentzVector.h.

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

◆ TABLE_END

const int CLHEP::TABLE_END = 982
static

Definition at line 60 of file RandLandau.cc.

◆ TABLE_INTERVAL

const float CLHEP::TABLE_INTERVAL = .001f
static

Definition at line 59 of file RandLandau.cc.

◆ TABLE_MULTIPLIER

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

Definition at line 61 of file RandLandau.cc.

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

◆ teraelectronvolt

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

Definition at line 174 of file SystemOfUnits.h.

◆ tesla

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

Definition at line 255 of file SystemOfUnits.h.

◆ TeV

constexpr double CLHEP::TeV = teraelectronvolt
staticconstexpr

◆ Toffsets

const int CLHEP::Toffsets[5]
static
Initial value:
#define Table3offset
#define Table1offset
#define Table4offset
#define Table2offset
#define Table0offset

Definition at line 76 of file flatToGaussian.cc.

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

◆ Tsizes

const int CLHEP::Tsizes[5]
static
Initial value:
#define Table3size
#define Table0size
#define Table1size
#define Table2size
#define Table4size

Definition at line 52 of file flatToGaussian.cc.

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

◆ Tsteps

const double CLHEP::Tsteps[5]
static
Initial value:
#define Table4step
#define Table0step
#define Table3step
#define Table2step
#define Table1step

Definition at line 64 of file flatToGaussian.cc.

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

◆ twopi

constexpr double CLHEP::twopi = 2*pi
staticconstexpr

Definition at line 56 of file SystemOfUnits.h.

Referenced by G4NuclNuclDiffuseElastic::AmplitudeGG(), G4PreCompoundEmission::AngularDistribution(), G4ParticleHPThermalScattering::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4ANuElNucleusCcModel::ApplyYourself(), G4ANuElNucleusNcModel::ApplyYourself(), G4ANuMuNucleusCcModel::ApplyYourself(), G4ANuMuNucleusNcModel::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NuElNucleusCcModel::ApplyYourself(), G4NuElNucleusNcModel::ApplyYourself(), G4NuMuNucleusCcModel::ApplyYourself(), G4NuMuNucleusNcModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4TwistedTubs::BoundingLimits(), G4KineticTrack::BrWig(), G4ParticleHPInelasticCompFS::CompositeApply(), G4UrbanAdjointMscModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4eDPWAElasticDCS::ComputeCSPerAtom(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4PSCellFluxForCylinder3D::ComputeVolume(), G4PSDoseDepositForCylinder3D::ComputeVolume(), G4PSPassageCellFluxForCylinder3D::ComputeVolume(), CLHEP::Hep3Vector::deltaPhi(), G4ScreeningMottCrossSection::DifferentialXSection(), G4GeomTools::DiskExtent(), G4MuonDecayChannelWithSpin::F_c(), G4MuonDecayChannelWithSpin::F_theta(), G4MuonicAtomDecay::FillResult(), G4PlaneVectorRand(), G4RandomDirection(), G4RandomPointOnEllipse(), G4VScoringMesh::G4VScoringMesh(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4NuclNuclDiffuseElastic::GammaLogB2n(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnABoxBoundary(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnASphereBoundary(), G4PolarizationTransition::GenerateGammaPhi(), G4LivermorePolarizedRayleighModel::GeneratePhi(), G4JAEAPolarizedElasticScatteringModel::GeneratePolarizedPhi(), G4Nucleus::GetBiasedThermalNucleus(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4ParticleHPDeExGammas::GetDecayGammas(), G4LivermorePolarizedRayleighModel::GetPhotonPolarization(), G4Ellipsoid::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), HepPolyhedronHyperbolicMirror::HepPolyhedronHyperbolicMirror(), G4NeutrinoElectronProcess::PostStepDoIt(), G4ElNeutrinoNucleusProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4LEPTSDiffXS::readDXS(), G4ParticleHPDiscreteTwoBody::Sample(), G4LEPTSDiffXS::SampleAngle(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4ModifiedMephi::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4GammaTransition::SampleDirection(), G4SBBremTable::SampleEnergyTransfer(), G4PolarizationTransition::SampleGammaTransition(), G4ANuElNucleusCcModel::SampleLVkr(), G4ANuElNucleusNcModel::SampleLVkr(), G4ANuMuNucleusCcModel::SampleLVkr(), G4ANuMuNucleusNcModel::SampleLVkr(), G4NuElNucleusCcModel::SampleLVkr(), G4NuElNucleusNcModel::SampleLVkr(), G4NuMuNucleusCcModel::SampleLVkr(), G4NuMuNucleusNcModel::SampleLVkr(), G4GoudsmitSaundersonMscModel::SampleMSC(), G4VLEPTSModel::SampleNewDirection(), G4ModifiedMephi::SamplePairDirections(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4UrbanMscModel::SampleScattering(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4eDPWACoulombScatteringModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4GoudsmitSaundersonTable::Sampling(), G4GeomTools::SphereExtent(), G4EvaporationProbability::TotalProbability(), CLHEP::RandGaussQ::transformSmall(), transformSmall(), and G4ParticleHPInelasticCompFS::two_body_reaction().

◆ twopi_mc2_rcl2

constexpr double CLHEP::twopi_mc2_rcl2
staticconstexpr

◆ uCi

constexpr double CLHEP::uCi = microcurie
staticconstexpr

Definition at line 291 of file SystemOfUnits.h.

◆ um

constexpr double CLHEP::um = micrometer
staticconstexpr

◆ universe_mean_density

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

Definition at line 128 of file PhysicalConstants.h.

◆ us

constexpr double CLHEP::us = microsecond
staticconstexpr

Definition at line 157 of file SystemOfUnits.h.

◆ volt

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

Definition at line 231 of file SystemOfUnits.h.

◆ watt

constexpr double CLHEP::watt = joule/second
staticconstexpr

Definition at line 203 of file SystemOfUnits.h.

◆ weber

constexpr double CLHEP::weber = volt*second
staticconstexpr

Definition at line 250 of file SystemOfUnits.h.

◆ X_HAT4

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

Definition at line 534 of file LorentzVector.h.

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

◆ Y_HAT4

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

Definition at line 535 of file LorentzVector.h.

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

◆ year

constexpr double CLHEP::year = 365*day
staticconstexpr

Definition at line 147 of file SystemOfUnits.h.

◆ Z_HAT4

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

Definition at line 536 of file LorentzVector.h.

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