|
Geant4
10.03.p02
|
Namespaces | |
| detail | |
Typedefs | |
| typedef uint64_t | myuint |
| typedef struct rng_state_st | rng_state_t |
| typedef uint32_t | myID_t |
| template<typename T > | |
| using | shared_ptr = std::shared_ptr< T > |
| template<typename T > | |
| using | weak_ptr = std::weak_ptr< T > |
| typedef HepLorentzVector | HepLorentzVectorD |
| typedef HepLorentzVector | HepLorentzVectorF |
| typedef Hep3Vector | HepThreeVectorD |
| typedef Hep3Vector | HepThreeVectorF |
Enumerations | |
| enum | ZMpvMetric_t { TimePositive, TimeNegative } |
Functions | |
| unsigned long | crc32ul (const std::string &s) |
| template<class E > | |
| unsigned long | engineIDulong () |
| int | rng_get_N (void) |
| rng_state_t * | rng_alloc () |
| int | rng_free (rng_state_t *X) |
| rng_state_t * | rng_copy (myuint *Y) |
| void | read_state (rng_state_t *X, const char filename[]) |
| void | print_state (rng_state_t *X) |
| int | iterate (rng_state_t *X) |
| myuint | iterate_raw_vec (myuint *Y, myuint sumtotOld) |
| void | seed_uniquestream (rng_state_t *X, myID_t clusterID, myID_t machineID, myID_t runID, myID_t streamID) |
| void | seed_spbox (rng_state_t *X, myuint seed) |
| void | seed_vielbein (rng_state_t *X, unsigned int i) |
| void | fill_array (rng_state_t *X, unsigned int n, double *array) |
| void | iterate_and_fill_array (rng_state_t *X, double *array) |
| myuint | precalc (rng_state_t *X) |
| myuint | apply_bigskip (myuint *Vout, myuint *Vin, myID_t clusterID, myID_t machineID, myID_t runID, myID_t streamID) |
| void | branch_inplace (rng_state_t *Xin, myID_t *ID) |
| myuint | modadd (myuint foo, myuint bar) |
| myuint | modmulM61 (myuint s, myuint a) |
| myuint | fmodmulM61 (myuint cum, myuint s, myuint a) |
| myuint | GET_BY_MACRO (rng_state_t *X) |
| double | get_next_float_BY_MACRO (rng_state_t *X) |
| std::ostream & | operator<< (std::ostream &os, const HepRandom &dist) |
| std::istream & | operator>> (std::istream &is, HepRandom &dist) |
| std::ostream & | operator<< (std::ostream &os, const HepRandomEngine &e) |
| std::istream & | operator>> (std::istream &is, HepRandomEngine &e) |
| template<class IS , class T > | |
| bool | possibleKeywordInput (IS &is, const std::string &key, T &t) |
| std::ostream & | operator<< (std::ostream &os, const HepAxisAngle &aa) |
| std::istream & | operator>> (std::istream &is, HepAxisAngle &aa) |
| HepBoost | inverseOf (const HepBoost <) |
| std::ostream & | operator<< (std::ostream &os, const HepBoost &b) |
| HepBoostX | inverseOf (const HepBoostX &b) |
| std::ostream & | operator<< (std::ostream &os, const HepBoostX &b) |
| HepBoostY | inverseOf (const HepBoostY &b) |
| std::ostream & | operator<< (std::ostream &os, const HepBoostY &b) |
| HepBoostZ | inverseOf (const HepBoostZ &b) |
| std::ostream & | operator<< (std::ostream &os, const HepBoostZ &b) |
| std::ostream & | operator<< (std::ostream &os, const HepEulerAngles &aa) |
| std::istream & | operator>> (std::istream &is, HepEulerAngles &aa) |
| HepLorentzRotation | inverseOf (const HepLorentzRotation <) |
| HepLorentzRotation | operator* (const HepRotation &r, const HepLorentzRotation <) |
| HepLorentzRotation | operator* (const HepRotationX &r, const HepLorentzRotation <) |
| HepLorentzRotation | operator* (const HepRotationY &r, const HepLorentzRotation <) |
| HepLorentzRotation | operator* (const HepRotationZ &r, const HepLorentzRotation <) |
| std::ostream & | operator<< (std::ostream &os, const HepLorentzRotation <) |
| bool | operator== (const HepRotation &r, const HepLorentzRotation <) |
| bool | operator!= (const HepRotation &r, const HepLorentzRotation <) |
| bool | operator<= (const HepRotation &r, const HepLorentzRotation <) |
| bool | operator>= (const HepRotation &r, const HepLorentzRotation <) |
| bool | operator< (const HepRotation &r, const HepLorentzRotation <) |
| bool | operator> (const HepRotation &r, const HepLorentzRotation <) |
| bool | operator== (const HepBoost &b, const HepLorentzRotation <) |
| bool | operator!= (const HepBoost &b, const HepLorentzRotation <) |
| bool | operator<= (const HepBoost &b, const HepLorentzRotation <) |
| bool | operator>= (const HepBoost &b, const HepLorentzRotation <) |
| bool | operator< (const HepBoost &b, const HepLorentzRotation <) |
| bool | operator> (const HepBoost &b, const HepLorentzRotation <) |
| HepLorentzVector | rotationXOf (const HepLorentzVector &vec, double delta) |
| HepLorentzVector | rotationYOf (const HepLorentzVector &vec, double delta) |
| HepLorentzVector | rotationZOf (const HepLorentzVector &vec, double delta) |
| HepLorentzVector | rotationOf (const HepLorentzVector &vec, const Hep3Vector &axis, double delta) |
| HepLorentzVector | rotationOf (const HepLorentzVector &vec, const HepAxisAngle &ax) |
| HepLorentzVector | rotationOf (const HepLorentzVector &vec, const HepEulerAngles &e) |
| HepLorentzVector | rotationOf (const HepLorentzVector &vec, double phi, double theta, double psi) |
| HepLorentzVector | boostXOf (const HepLorentzVector &vec, double beta) |
| HepLorentzVector | boostYOf (const HepLorentzVector &vec, double beta) |
| HepLorentzVector | boostZOf (const HepLorentzVector &vec, double beta) |
| HepLorentzVector | boostOf (const HepLorentzVector &vec, const Hep3Vector &betaVector) |
| HepLorentzVector | boostOf (const HepLorentzVector &vec, const Hep3Vector &axis, double beta) |
| std::ostream & | operator<< (std::ostream &, const HepLorentzVector &) |
| std::istream & | operator>> (std::istream &, HepLorentzVector &) |
| HepLorentzVector | operator* (const HepLorentzVector &, double a) |
| HepLorentzVector | operator* (double a, const HepLorentzVector &) |
| HepLorentzVector | operator/ (const HepLorentzVector &, double a) |
| HepRotation | inverseOf (const HepRotation &r) |
| HepRotation | operator* (const HepRotationX &rx, const HepRotation &r) |
| HepRotation | operator* (const HepRotationY &ry, const HepRotation &r) |
| HepRotation | operator* (const HepRotationZ &rz, const HepRotation &r) |
| std::ostream & | operator<< (std::ostream &os, const HepRotation &r) |
| HepRotationX | inverseOf (const HepRotationX &r) |
| std::ostream & | operator<< (std::ostream &os, const HepRotationX &r) |
| HepRotationY | inverseOf (const HepRotationY &r) |
| std::ostream & | operator<< (std::ostream &os, const HepRotationY &r) |
| HepRotationZ | inverseOf (const HepRotationZ &r) |
| std::ostream & | operator<< (std::ostream &os, const HepRotationZ &r) |
| Hep3Vector | rotationXOf (const Hep3Vector &vec, double delta) |
| Hep3Vector | rotationYOf (const Hep3Vector &vec, double delta) |
| Hep3Vector | rotationZOf (const Hep3Vector &vec, double delta) |
| Hep3Vector | rotationOf (const Hep3Vector &vec, const Hep3Vector &axis, double delta) |
| Hep3Vector | rotationOf (const Hep3Vector &vec, const HepAxisAngle &ax) |
| Hep3Vector | rotationOf (const Hep3Vector &vec, double phi, double theta, double psi) |
| Hep3Vector | rotationOf (const Hep3Vector &vec, const HepEulerAngles &e) |
| std::ostream & | operator<< (std::ostream &, const Hep3Vector &) |
| std::istream & | operator>> (std::istream &, Hep3Vector &) |
| Hep3Vector | operator/ (const Hep3Vector &, double a) |
| Hep3Vector | operator+ (const Hep3Vector &, const Hep3Vector &) |
| Hep3Vector | operator- (const Hep3Vector &, const Hep3Vector &) |
| double | operator* (const Hep3Vector &, const Hep3Vector &) |
| Hep3Vector | operator* (const Hep3Vector &, double a) |
| Hep3Vector | operator* (double a, const Hep3Vector &) |
| std::ostream & | operator<< (std::ostream &, const Hep2Vector &) |
| std::istream & | operator>> (std::istream &, Hep2Vector &) |
| double | operator* (const Hep2Vector &a, const Hep2Vector &b) |
| Hep2Vector | operator* (const Hep2Vector &p, double a) |
| Hep2Vector | operator* (double a, const Hep2Vector &p) |
| Hep2Vector | operator/ (const Hep2Vector &p, double a) |
| Hep2Vector | operator+ (const Hep2Vector &a, const Hep2Vector &b) |
| Hep2Vector | operator- (const Hep2Vector &a, const Hep2Vector &b) |
| static const Hep2Vector | X_HAT2 (1.0, 0.0) |
| static const Hep2Vector | Y_HAT2 (0.0, 1.0) |
| static void | ZMpvAxisAngleRep (const HepAxisAngle &aa, double array[]) |
| void | ZMinputAxisAngle (std::istream &is, double &x, double &y, double &z, double &delta) |
| template<class E > | |
| static HepRandomEngine * | makeAnEngine (const std::string &tag, std::istream &is) |
| template<class E > | |
| static HepRandomEngine * | makeAnEngine (const std::vector< unsigned long > &v) |
| static std::vector< unsigned long > | gen_crc_table () |
| static void | ZMpvEulerAnglesRep (const HepEulerAngles &ex, double array[]) |
| void | ZMinput3doubles (std::istream &is, const char *type, double &x, double &y, double &z) |
| double | transformSmall (double r) |
| uint64_t | MULWU (uint64_t) |
| myuint | get_next (rng_state_t *X) |
| double | get_next_float (rng_state_t *X) |
| static double | StirlingCorrection (long int k) |
| double | gammln (double xx) |
| static double | normal (HepRandomEngine *eptr) |
| static double | safe_acos (double x) |
| static double | safe_acos (double x) |
| static void | correctByPi (double &psi1, double &phi1) |
| static void | correctPsiPhi (double rxz, double rzx, double ryz, double rzy, double &psi1, double &phi1) |
| static double | safe_acos (double x) |
| static double | safe_acos (double x) |
| static double | safe_acos (double x) |
| const Hep3Vector | HepXHat (1.0, 0.0, 0.0) |
| const Hep3Vector | HepYHat (0.0, 1.0, 0.0) |
| const Hep3Vector | HepZHat (0.0, 0.0, 1.0) |
| void | ZMinput2doubles (std::istream &is, const char *type, double &x, double &y) |
Variables | |
| const int | N = 17 |
| static const int | HepRandomGenActive = HepRandom::createInstance() |
| static constexpr double | Avogadro = 6.02214179e+23/mole |
| static constexpr double | c_light = 2.99792458e+8 * m/s |
| static constexpr double | c_squared = c_light * c_light |
| static constexpr double | h_Planck = 6.62606896e-34 * joule*s |
| static constexpr double | hbar_Planck = h_Planck/twopi |
| static constexpr double | hbarc = hbar_Planck * c_light |
| static constexpr double | hbarc_squared = hbarc * hbarc |
| static constexpr double | electron_charge = - eplus |
| static constexpr double | e_squared = eplus * eplus |
| static constexpr double | electron_mass_c2 = 0.510998910 * MeV |
| static constexpr double | proton_mass_c2 = 938.272013 * MeV |
| static constexpr double | neutron_mass_c2 = 939.56536 * MeV |
| static constexpr double | amu_c2 = 931.494028 * MeV |
| static constexpr double | amu = amu_c2/c_squared |
| static constexpr double | mu0 = 4*pi*1.e-7 * henry/m |
| static constexpr double | epsilon0 = 1./(c_squared*mu0) |
| static constexpr double | elm_coupling = e_squared/(4*pi*epsilon0) |
| static constexpr double | fine_structure_const = elm_coupling/hbarc |
| static constexpr double | classic_electr_radius = elm_coupling/electron_mass_c2 |
| static constexpr double | electron_Compton_length = hbarc/electron_mass_c2 |
| static constexpr double | Bohr_radius = electron_Compton_length/fine_structure_const |
| static constexpr double | alpha_rcl2 |
| static constexpr double | twopi_mc2_rcl2 |
| static constexpr double | k_Boltzmann = 8.617343e-11 * MeV/kelvin |
| static constexpr double | STP_Temperature = 273.15*kelvin |
| static constexpr double | STP_Pressure = 1.*atmosphere |
| static constexpr double | kGasThreshold = 10.*mg/cm3 |
| static constexpr double | universe_mean_density = 1.e-25*g/cm3 |
| static constexpr double | pi = 3.14159265358979323846 |
| static constexpr double | twopi = 2*pi |
| static constexpr double | halfpi = pi/2 |
| static constexpr double | pi2 = pi*pi |
| static constexpr double | millimeter = 1. |
| static constexpr double | millimeter2 = millimeter*millimeter |
| static constexpr double | millimeter3 = millimeter*millimeter*millimeter |
| static constexpr double | centimeter = 10.*millimeter |
| static constexpr double | centimeter2 = centimeter*centimeter |
| static constexpr double | centimeter3 = centimeter*centimeter*centimeter |
| static constexpr double | meter = 1000.*millimeter |
| static constexpr double | meter2 = meter*meter |
| static constexpr double | meter3 = meter*meter*meter |
| static constexpr double | kilometer = 1000.*meter |
| static constexpr double | kilometer2 = kilometer*kilometer |
| static constexpr double | kilometer3 = kilometer*kilometer*kilometer |
| static constexpr double | parsec = 3.0856775807e+16*meter |
| static constexpr double | micrometer = 1.e-6 *meter |
| static constexpr double | nanometer = 1.e-9 *meter |
| static constexpr double | angstrom = 1.e-10*meter |
| static constexpr double | fermi = 1.e-15*meter |
| static constexpr double | barn = 1.e-28*meter2 |
| static constexpr double | millibarn = 1.e-3 *barn |
| static constexpr double | microbarn = 1.e-6 *barn |
| static constexpr double | nanobarn = 1.e-9 *barn |
| static constexpr double | picobarn = 1.e-12*barn |
| static constexpr double | nm = nanometer |
| static constexpr double | um = micrometer |
| static constexpr double | mm = millimeter |
| static constexpr double | mm2 = millimeter2 |
| static constexpr double | mm3 = millimeter3 |
| static constexpr double | cm = centimeter |
| static constexpr double | cm2 = centimeter2 |
| static constexpr double | cm3 = centimeter3 |
| static constexpr double | liter = 1.e+3*cm3 |
| static constexpr double | L = liter |
| static constexpr double | dL = 1.e-1*liter |
| static constexpr double | cL = 1.e-2*liter |
| static constexpr double | mL = 1.e-3*liter |
| static constexpr double | m = meter |
| static constexpr double | m2 = meter2 |
| static constexpr double | m3 = meter3 |
| static constexpr double | km = kilometer |
| static constexpr double | km2 = kilometer2 |
| static constexpr double | km3 = kilometer3 |
| static constexpr double | pc = parsec |
| static constexpr double | radian = 1. |
| static constexpr double | milliradian = 1.e-3*radian |
| static constexpr double | degree = (pi/180.0)*radian |
| static constexpr double | steradian = 1. |
| static constexpr double | rad = radian |
| static constexpr double | mrad = milliradian |
| static constexpr double | sr = steradian |
| static constexpr double | deg = degree |
| static constexpr double | nanosecond = 1. |
| static constexpr double | second = 1.e+9 *nanosecond |
| static constexpr double | millisecond = 1.e-3 *second |
| static constexpr double | microsecond = 1.e-6 *second |
| static constexpr double | picosecond = 1.e-12*second |
| static constexpr double | hertz = 1./second |
| static constexpr double | kilohertz = 1.e+3*hertz |
| static constexpr double | megahertz = 1.e+6*hertz |
| static constexpr double | ns = nanosecond |
| static constexpr double | s = second |
| static constexpr double | ms = millisecond |
| static constexpr double | us = microsecond |
| static constexpr double | ps = picosecond |
| static constexpr double | eplus = 1. |
| static constexpr double | e_SI = 1.602176487e-19 |
| static constexpr double | coulomb = eplus/e_SI |
| static constexpr double | megaelectronvolt = 1. |
| static constexpr double | electronvolt = 1.e-6*megaelectronvolt |
| static constexpr double | kiloelectronvolt = 1.e-3*megaelectronvolt |
| static constexpr double | gigaelectronvolt = 1.e+3*megaelectronvolt |
| static constexpr double | teraelectronvolt = 1.e+6*megaelectronvolt |
| static constexpr double | petaelectronvolt = 1.e+9*megaelectronvolt |
| static constexpr double | joule = electronvolt/e_SI |
| static constexpr double | MeV = megaelectronvolt |
| static constexpr double | eV = electronvolt |
| static constexpr double | keV = kiloelectronvolt |
| static constexpr double | GeV = gigaelectronvolt |
| static constexpr double | TeV = teraelectronvolt |
| static constexpr double | PeV = petaelectronvolt |
| static constexpr double | kilogram = joule*second*second/(meter*meter) |
| static constexpr double | gram = 1.e-3*kilogram |
| static constexpr double | milligram = 1.e-3*gram |
| static constexpr double | kg = kilogram |
| static constexpr double | g = gram |
| static constexpr double | mg = milligram |
| static constexpr double | watt = joule/second |
| static constexpr double | newton = joule/meter |
| static constexpr double | hep_pascal = newton/m2 |
| static constexpr double | bar = 100000*pascal |
| static constexpr double | atmosphere = 101325*pascal |
| static constexpr double | ampere = coulomb/second |
| static constexpr double | milliampere = 1.e-3*ampere |
| static constexpr double | microampere = 1.e-6*ampere |
| static constexpr double | nanoampere = 1.e-9*ampere |
| static constexpr double | megavolt = megaelectronvolt/eplus |
| static constexpr double | kilovolt = 1.e-3*megavolt |
| static constexpr double | volt = 1.e-6*megavolt |
| static constexpr double | ohm = volt/ampere |
| static constexpr double | farad = coulomb/volt |
| static constexpr double | millifarad = 1.e-3*farad |
| static constexpr double | microfarad = 1.e-6*farad |
| static constexpr double | nanofarad = 1.e-9*farad |
| static constexpr double | picofarad = 1.e-12*farad |
| static constexpr double | weber = volt*second |
| static constexpr double | tesla = volt*second/meter2 |
| static constexpr double | gauss = 1.e-4*tesla |
| static constexpr double | kilogauss = 1.e-1*tesla |
| static constexpr double | henry = weber/ampere |
| static constexpr double | kelvin = 1. |
| static constexpr double | mole = 1. |
| static constexpr double | becquerel = 1./second |
| static constexpr double | curie = 3.7e+10 * becquerel |
| static constexpr double | kilobecquerel = 1.e+3*becquerel |
| static constexpr double | megabecquerel = 1.e+6*becquerel |
| static constexpr double | gigabecquerel = 1.e+9*becquerel |
| static constexpr double | millicurie = 1.e-3*curie |
| static constexpr double | microcurie = 1.e-6*curie |
| static constexpr double | Bq = becquerel |
| static constexpr double | kBq = kilobecquerel |
| static constexpr double | MBq = megabecquerel |
| static constexpr double | GBq = gigabecquerel |
| static constexpr double | Ci = curie |
| static constexpr double | mCi = millicurie |
| static constexpr double | uCi = microcurie |
| static constexpr double | gray = joule/kilogram |
| static constexpr double | kilogray = 1.e+3*gray |
| static constexpr double | milligray = 1.e-3*gray |
| static constexpr double | microgray = 1.e-6*gray |
| static constexpr double | candela = 1. |
| static constexpr double | lumen = candela*steradian |
| static constexpr double | lux = lumen/meter2 |
| static constexpr double | perCent = 0.01 |
| static constexpr double | perThousand = 0.001 |
| static constexpr double | perMillion = 0.000001 |
| static const HepLorentzVector | X_HAT4 = HepLorentzVector( 1, 0, 0, 0 ) |
| static const HepLorentzVector | Y_HAT4 = HepLorentzVector( 0, 1, 0, 0 ) |
| static const HepLorentzVector | Z_HAT4 = HepLorentzVector( 0, 0, 1, 0 ) |
| static const HepLorentzVector | T_HAT4 = HepLorentzVector( 0, 0, 0, 1 ) |
| DLL_API const Hep3Vector | HepXHat |
| DLL_API const Hep3Vector | HepYHat |
| DLL_API const Hep3Vector | HepZHat |
| static const int | MarkerLen = 64 |
| static const int | Tsizes [5] |
| static const double | Tsteps [5] |
| static const int | Toffsets [5] |
| static const double | gaussTables [2 *TableSize] |
| static const int | MarkerLen = 64 |
| static const int | MarkerLen = 64 |
| static const int | MarkerLen = 64 |
| static const float | gaussTables [TableSize] |
| static const float | TABLE_INTERVAL = .001f |
| static const int | TABLE_END = 982 |
| static const float | TABLE_MULTIPLIER = 1.0f/TABLE_INTERVAL |
| static const float | inverseLandau [TABLE_END+1] |
| static const double | poissonTables [51 *((95-10)/5+1)] |
| static const int | MarkerLen = 64 |
| static const double | prec = 4.6566128E-10 |
| static const int | MarkerLen = 64 |
| static const int | MarkerLen = 64 |
| static const int | MarkerLen = 64 |
Definition at line 550 of file LorentzVector.h.
Definition at line 551 of file LorentzVector.h.
| typedef Hep3Vector CLHEP::HepThreeVectorD |
Definition at line 426 of file ThreeVector.h.
| typedef Hep3Vector CLHEP::HepThreeVectorF |
Definition at line 427 of file ThreeVector.h.
| typedef uint32_t CLHEP::myID_t |
| typedef uint64_t CLHEP::myuint |
| typedef struct rng_state_st CLHEP::rng_state_t |
| using CLHEP::shared_ptr = typedef std::shared_ptr<T> |
| using CLHEP::weak_ptr = typedef std::weak_ptr<T> |
| enum CLHEP::ZMpvMetric_t |
| Enumerator | |
|---|---|
| TimePositive | |
| TimeNegative | |
Definition at line 64 of file LorentzVector.h.
| myuint CLHEP::apply_bigskip | ( | myuint * | Vout, |
| myuint * | Vin, | ||
| myID_t | clusterID, | ||
| myID_t | machineID, | ||
| myID_t | runID, | ||
| myID_t | streamID | ||
| ) |
|
inline |

|
inline |
|
inline |
|
inline |
|
inline |
| void CLHEP::branch_inplace | ( | rng_state_t * | Xin, |
| myID_t * | ID | ||
| ) |
|
static |
|
static |
Definition at line 162 of file RotationE.cc.


| unsigned long CLHEP::crc32ul | ( | const std::string & | s | ) |
Definition at line 37 of file engineIDulong.cc.


| unsigned long CLHEP::engineIDulong | ( | ) |
Definition at line 90 of file mixmax.cc.

|
inline |
| double CLHEP::gammln | ( | double | xx | ) |
|
static |
|
inline |
| myuint CLHEP::get_next | ( | rng_state_t * | X | ) |
| double CLHEP::get_next_float | ( | rng_state_t * | X | ) |
Definition at line 86 of file mixmax.cc.


|
inline |
| const Hep3Vector CLHEP::HepXHat | ( | 1. | 0, |
| 0. | 0, | ||
| 0. | 0 | ||
| ) |
| const Hep3Vector CLHEP::HepYHat | ( | 0. | 0, |
| 1. | 0, | ||
| 0. | 0 | ||
| ) |
| const Hep3Vector CLHEP::HepZHat | ( | 0. | 0, |
| 0. | 0, | ||
| 1. | 0 | ||
| ) |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |

|
inline |
|
inline |
| int CLHEP::iterate | ( | rng_state_t * | X | ) |
| void CLHEP::iterate_and_fill_array | ( | rng_state_t * | X, |
| double * | array | ||
| ) |
| myuint CLHEP::iterate_raw_vec | ( | myuint * | Y, |
| myuint | sumtotOld | ||
| ) |
|
static |
Definition at line 32 of file EngineFactory.cc.

|
static |
| myuint CLHEP::modadd | ( | myuint | foo, |
| myuint | bar | ||
| ) |
| myuint CLHEP::modmulM61 | ( | myuint | s, |
| myuint | a | ||
| ) |
|
inline |
|
static |
Definition at line 77 of file RandPoisson.cc.


|
inline |
Definition at line 353 of file LorentzRotation.h.
|
inline |
Definition at line 366 of file LorentzRotation.h.
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
| HepLorentzRotation CLHEP::operator* | ( | const HepRotation & | r, |
| const HepLorentzRotation & | lt | ||
| ) |
|
inline |
| HepLorentzRotation CLHEP::operator* | ( | const HepRotationX & | r, |
| const HepLorentzRotation & | lt | ||
| ) |
| HepLorentzRotation CLHEP::operator* | ( | const HepRotationY & | r, |
| const HepLorentzRotation & | lt | ||
| ) |
| HepLorentzRotation CLHEP::operator* | ( | const HepRotationZ & | r, |
| const HepLorentzRotation & | lt | ||
| ) |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
| Hep2Vector CLHEP::operator/ | ( | const Hep2Vector & | p, |
| double | a | ||
| ) |
| Hep3Vector CLHEP::operator/ | ( | const Hep3Vector & | v1, |
| double | a | ||
| ) |
| HepLorentzVector CLHEP::operator/ | ( | const HepLorentzVector & | w, |
| double | a | ||
| ) |
|
inline |
Definition at line 359 of file LorentzRotation.h.
|
inline |
Definition at line 372 of file LorentzRotation.h.
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const HepAxisAngle & | aa | ||
| ) |
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const HepEulerAngles & | aa | ||
| ) |
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const Hep2Vector & | q | ||
| ) |
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const HepRandom & | dist | ||
| ) |
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const HepRandomEngine & | e | ||
| ) |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
Definition at line 278 of file RotationX.h.
|
inline |
Definition at line 278 of file RotationY.h.
|
inline |
Definition at line 278 of file RotationZ.h.
|
inline |
Definition at line 348 of file LorentzRotation.h.
|
inline |
Definition at line 410 of file Rotation.h.
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const Hep3Vector & | v | ||
| ) |
| std::ostream & CLHEP::operator<< | ( | std::ostream & | os, |
| const HepLorentzVector & | v1 | ||
| ) |
|
inline |
Definition at line 355 of file LorentzRotation.h.
|
inline |
Definition at line 368 of file LorentzRotation.h.
|
inline |
Definition at line 351 of file LorentzRotation.h.
|
inline |
Definition at line 364 of file LorentzRotation.h.
|
inline |
Definition at line 361 of file LorentzRotation.h.
|
inline |
Definition at line 374 of file LorentzRotation.h.
|
inline |
Definition at line 357 of file LorentzRotation.h.
|
inline |
Definition at line 370 of file LorentzRotation.h.
| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| HepAxisAngle & | aa | ||
| ) |
Definition at line 95 of file AxisAngle.cc.

| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| HepEulerAngles & | aa | ||
| ) |
Definition at line 109 of file EulerAngles.cc.

| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| Hep2Vector & | p | ||
| ) |
Definition at line 77 of file TwoVector.cc.

| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| HepRandom & | dist | ||
| ) |
| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| HepRandomEngine & | e | ||
| ) |
| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| Hep3Vector & | v | ||
| ) |
Definition at line 73 of file ThreeVector.cc.

| std::istream & CLHEP::operator>> | ( | std::istream & | is, |
| HepLorentzVector & | v1 | ||
| ) |
| bool CLHEP::possibleKeywordInput | ( | IS & | is, |
| const std::string & | key, | ||
| T & | t | ||
| ) |
| myuint CLHEP::precalc | ( | rng_state_t * | X | ) |
| void CLHEP::print_state | ( | rng_state_t * | X | ) |
| void CLHEP::read_state | ( | rng_state_t * | X, |
| const char | filename[] | ||
| ) |
Definition at line 283 of file mixmax.cc.


| rng_state_t * CLHEP::rng_alloc | ( | ) |
| rng_state_t * CLHEP::rng_copy | ( | myuint * | Y | ) |
Definition at line 165 of file mixmax.cc.


| int CLHEP::rng_free | ( | rng_state_t * | X | ) |
| HepLorentzVector CLHEP::rotationOf | ( | const HepLorentzVector & | vec, |
| const Hep3Vector & | axis, | ||
| double | delta | ||
| ) |
| HepLorentzVector CLHEP::rotationOf | ( | const HepLorentzVector & | vec, |
| const HepAxisAngle & | ax | ||
| ) |
| HepLorentzVector CLHEP::rotationOf | ( | const HepLorentzVector & | vec, |
| const HepEulerAngles & | e | ||
| ) |
| HepLorentzVector CLHEP::rotationOf | ( | const HepLorentzVector & | vec, |
| double | phi, | ||
| double | theta, | ||
| double | psi | ||
| ) |
| Hep3Vector CLHEP::rotationOf | ( | const Hep3Vector & | vec, |
| const Hep3Vector & | axis, | ||
| double | delta | ||
| ) |
| Hep3Vector CLHEP::rotationOf | ( | const Hep3Vector & | vec, |
| const HepAxisAngle & | ax | ||
| ) |
| Hep3Vector CLHEP::rotationOf | ( | const Hep3Vector & | vec, |
| double | phi, | ||
| double | theta, | ||
| double | psi | ||
| ) |
| Hep3Vector CLHEP::rotationOf | ( | const Hep3Vector & | vec, |
| const HepEulerAngles & | e | ||
| ) |
| HepLorentzVector CLHEP::rotationXOf | ( | const HepLorentzVector & | vec, |
| double | delta | ||
| ) |
| Hep3Vector CLHEP::rotationXOf | ( | const Hep3Vector & | vec, |
| double | delta | ||
| ) |
| HepLorentzVector CLHEP::rotationYOf | ( | const HepLorentzVector & | vec, |
| double | delta | ||
| ) |
| Hep3Vector CLHEP::rotationYOf | ( | const Hep3Vector & | vec, |
| double | delta | ||
| ) |
| HepLorentzVector CLHEP::rotationZOf | ( | const HepLorentzVector & | vec, |
| double | delta | ||
| ) |
| Hep3Vector CLHEP::rotationZOf | ( | const Hep3Vector & | vec, |
| double | delta | ||
| ) |
|
inlinestatic |
|
inlinestatic |
Definition at line 26 of file RotationE.cc.
|
inlinestatic |
Definition at line 26 of file RotationZ.cc.
|
inlinestatic |
Definition at line 26 of file RotationX.cc.
|
inlinestatic |
Definition at line 26 of file RotationY.cc.
| void CLHEP::seed_spbox | ( | rng_state_t * | X, |
| myuint | seed | ||
| ) |
| void CLHEP::seed_uniquestream | ( | rng_state_t * | X, |
| myID_t | clusterID, | ||
| myID_t | machineID, | ||
| myID_t | runID, | ||
| myID_t | streamID | ||
| ) |
Definition at line 185 of file mixmax.cc.
|
static |
Definition at line 93 of file RandBinomial.cc.
| double CLHEP::transformSmall | ( | double | r | ) |
|
static |
|
static |
| void CLHEP::ZMinput2doubles | ( | std::istream & | is, |
| const char * | type, | ||
| double & | x, | ||
| double & | y | ||
| ) |
| void CLHEP::ZMinput3doubles | ( | std::istream & | is, |
| const char * | type, | ||
| double & | x, | ||
| double & | y, | ||
| double & | z | ||
| ) |
| void CLHEP::ZMinputAxisAngle | ( | std::istream & | is, |
| double & | x, | ||
| double & | y, | ||
| double & | z, | ||
| double & | delta | ||
| ) |
Definition at line 156 of file ZMinput.cc.


|
static |
Definition at line 20 of file AxisAngle.cc.


|
static |
Definition at line 43 of file EulerAngles.cc.


|
static |
Definition at line 101 of file PhysicalConstants.h.
Definition at line 214 of file SystemOfUnits.h.
Definition at line 83 of file PhysicalConstants.h.
|
static |
Definition at line 82 of file PhysicalConstants.h.
|
static |
Definition at line 82 of file SystemOfUnits.h.
|
static |
Definition at line 209 of file SystemOfUnits.h.
|
static |
Definition at line 49 of file PhysicalConstants.h.
|
static |
Definition at line 208 of file SystemOfUnits.h.
|
static |
Definition at line 85 of file SystemOfUnits.h.
|
static |
Definition at line 271 of file SystemOfUnits.h.
|
static |
Definition at line 99 of file PhysicalConstants.h.
|
static |
Definition at line 278 of file SystemOfUnits.h.
|
static |
Definition at line 55 of file PhysicalConstants.h.
Definition at line 56 of file PhysicalConstants.h.
|
static |
Definition at line 297 of file SystemOfUnits.h.
|
static |
Definition at line 66 of file SystemOfUnits.h.
|
static |
Definition at line 67 of file SystemOfUnits.h.
|
static |
Definition at line 68 of file SystemOfUnits.h.
|
static |
Definition at line 282 of file SystemOfUnits.h.
|
static |
Definition at line 106 of file SystemOfUnits.h.
|
static |
Definition at line 97 of file PhysicalConstants.h.
|
static |
Definition at line 99 of file SystemOfUnits.h.
|
static |
Definition at line 100 of file SystemOfUnits.h.
|
static |
Definition at line 101 of file SystemOfUnits.h.
Definition at line 159 of file SystemOfUnits.h.
|
static |
Definition at line 272 of file SystemOfUnits.h.
|
static |
Definition at line 132 of file SystemOfUnits.h.
Definition at line 124 of file SystemOfUnits.h.
|
static |
Definition at line 105 of file SystemOfUnits.h.
|
static |
Definition at line 158 of file SystemOfUnits.h.
Definition at line 72 of file PhysicalConstants.h.
|
static |
Definition at line 71 of file PhysicalConstants.h.
|
static |
Definition at line 98 of file PhysicalConstants.h.
|
static |
Definition at line 79 of file PhysicalConstants.h.
|
static |
Definition at line 165 of file SystemOfUnits.h.
Definition at line 95 of file PhysicalConstants.h.
|
static |
Definition at line 157 of file SystemOfUnits.h.
Definition at line 90 of file PhysicalConstants.h.
|
static |
Definition at line 175 of file SystemOfUnits.h.
Definition at line 234 of file SystemOfUnits.h.
|
static |
Definition at line 83 of file SystemOfUnits.h.
|
static |
Definition at line 96 of file PhysicalConstants.h.
|
static |
Definition at line 190 of file SystemOfUnits.h.
|
static |
Definition at line 250 of file SystemOfUnits.h.
|
static |
Definition at line 85 of file flatToGaussian.cc.
|
static |
Definition at line 88 of file RandGaussQ.cc.
|
static |
Definition at line 281 of file SystemOfUnits.h.
|
static |
Definition at line 177 of file SystemOfUnits.h.
|
static |
Definition at line 275 of file SystemOfUnits.h.
|
static |
Definition at line 167 of file SystemOfUnits.h.
|
static |
Definition at line 185 of file SystemOfUnits.h.
Definition at line 289 of file SystemOfUnits.h.
|
static |
Definition at line 63 of file PhysicalConstants.h.
|
static |
Definition at line 56 of file SystemOfUnits.h.
Definition at line 64 of file PhysicalConstants.h.
|
static |
Definition at line 65 of file PhysicalConstants.h.
Definition at line 66 of file PhysicalConstants.h.
Definition at line 256 of file SystemOfUnits.h.
Definition at line 207 of file SystemOfUnits.h.
|
static |
Definition at line 65 of file Randomize.h.
| const Hep3Vector CLHEP::HepXHat(1.0, 0.0, 0.0) |
| const Hep3Vector CLHEP::HepYHat(0.0, 1.0, 0.0) |
| const Hep3Vector CLHEP::HepZHat(0.0, 0.0, 1.0) |
|
static |
Definition at line 143 of file SystemOfUnits.h.
|
static |
Definition at line 74 of file RandLandau.cc.
|
static |
Definition at line 171 of file SystemOfUnits.h.
|
static |
Definition at line 111 of file PhysicalConstants.h.
|
static |
Definition at line 279 of file SystemOfUnits.h.
|
static |
Definition at line 261 of file SystemOfUnits.h.
|
static |
Definition at line 176 of file SystemOfUnits.h.
|
static |
Definition at line 189 of file SystemOfUnits.h.
Definition at line 118 of file PhysicalConstants.h.
|
static |
Definition at line 273 of file SystemOfUnits.h.
|
static |
Definition at line 166 of file SystemOfUnits.h.
|
static |
Definition at line 251 of file SystemOfUnits.h.
Definition at line 184 of file SystemOfUnits.h.
|
static |
Definition at line 290 of file SystemOfUnits.h.
|
static |
Definition at line 144 of file SystemOfUnits.h.
|
static |
Definition at line 74 of file SystemOfUnits.h.
Definition at line 75 of file SystemOfUnits.h.
Definition at line 76 of file SystemOfUnits.h.
|
static |
Definition at line 223 of file SystemOfUnits.h.
|
static |
Definition at line 113 of file SystemOfUnits.h.
|
static |
Definition at line 114 of file SystemOfUnits.h.
|
static |
Definition at line 115 of file SystemOfUnits.h.
|
static |
Definition at line 104 of file SystemOfUnits.h.
|
static |
Definition at line 103 of file SystemOfUnits.h.
Definition at line 302 of file SystemOfUnits.h.
Definition at line 307 of file SystemOfUnits.h.
|
static |
Definition at line 109 of file SystemOfUnits.h.
|
static |
Definition at line 110 of file SystemOfUnits.h.
|
static |
Definition at line 111 of file SystemOfUnits.h.
|
static |
Definition at line 49 of file MixMaxRng.cc.
|
static |
Definition at line 56 of file RanecuEngine.cc.
|
static |
Definition at line 58 of file RanluxEngine.cc.
|
static |
Definition at line 59 of file JamesRandom.cc.
|
static |
Definition at line 59 of file RanshiEngine.cc.
|
static |
Definition at line 60 of file MTwistEngine.cc.
|
static |
Definition at line 67 of file DualRand.cc.
|
static |
Definition at line 76 of file Ranlux64Engine.cc.
|
static |
Definition at line 280 of file SystemOfUnits.h.
|
static |
Definition at line 283 of file SystemOfUnits.h.
|
static |
Definition at line 274 of file SystemOfUnits.h.
|
static |
Definition at line 164 of file SystemOfUnits.h.
|
static |
Definition at line 145 of file SystemOfUnits.h.
|
static |
Definition at line 222 of file SystemOfUnits.h.
|
static |
Definition at line 70 of file SystemOfUnits.h.
Definition at line 71 of file SystemOfUnits.h.
Definition at line 72 of file SystemOfUnits.h.
|
static |
Definition at line 174 of file SystemOfUnits.h.
|
static |
Definition at line 191 of file SystemOfUnits.h.
|
static |
Definition at line 216 of file SystemOfUnits.h.
|
static |
Definition at line 87 of file SystemOfUnits.h.
|
static |
Definition at line 277 of file SystemOfUnits.h.
|
static |
Definition at line 236 of file SystemOfUnits.h.
|
static |
Definition at line 292 of file SystemOfUnits.h.
|
static |
Definition at line 80 of file SystemOfUnits.h.
|
static |
Definition at line 140 of file SystemOfUnits.h.
|
static |
Definition at line 215 of file SystemOfUnits.h.
|
static |
Definition at line 86 of file SystemOfUnits.h.
|
static |
Definition at line 276 of file SystemOfUnits.h.
|
static |
Definition at line 235 of file SystemOfUnits.h.
|
static |
Definition at line 186 of file SystemOfUnits.h.
|
static |
Definition at line 291 of file SystemOfUnits.h.
|
static |
Definition at line 62 of file SystemOfUnits.h.
|
static |
Definition at line 63 of file SystemOfUnits.h.
|
static |
Definition at line 64 of file SystemOfUnits.h.
|
static |
Definition at line 123 of file SystemOfUnits.h.
|
static |
Definition at line 139 of file SystemOfUnits.h.
|
static |
Definition at line 107 of file SystemOfUnits.h.
|
static |
Definition at line 95 of file SystemOfUnits.h.
|
static |
Definition at line 96 of file SystemOfUnits.h.
|
static |
Definition at line 97 of file SystemOfUnits.h.
|
static |
Definition at line 266 of file SystemOfUnits.h.
|
static |
Definition at line 130 of file SystemOfUnits.h.
|
static |
Definition at line 150 of file SystemOfUnits.h.
Definition at line 89 of file PhysicalConstants.h.
|
static |
Definition at line 217 of file SystemOfUnits.h.
|
static |
Definition at line 88 of file SystemOfUnits.h.
|
static |
Definition at line 237 of file SystemOfUnits.h.
|
static |
Definition at line 81 of file SystemOfUnits.h.
|
static |
Definition at line 137 of file SystemOfUnits.h.
|
static |
Definition at line 81 of file PhysicalConstants.h.
Definition at line 201 of file SystemOfUnits.h.
|
static |
Definition at line 92 of file SystemOfUnits.h.
|
static |
Definition at line 148 of file SystemOfUnits.h.
Definition at line 229 of file SystemOfUnits.h.
|
static |
Definition at line 78 of file SystemOfUnits.h.
|
static |
Definition at line 117 of file SystemOfUnits.h.
|
static |
Definition at line 312 of file SystemOfUnits.h.
|
static |
Definition at line 314 of file SystemOfUnits.h.
|
static |
Definition at line 313 of file SystemOfUnits.h.
|
static |
Definition at line 169 of file SystemOfUnits.h.
|
static |
Definition at line 179 of file SystemOfUnits.h.
|
static |
Definition at line 54 of file SystemOfUnits.h.
Definition at line 57 of file SystemOfUnits.h.
|
static |
Definition at line 89 of file SystemOfUnits.h.
|
static |
Definition at line 238 of file SystemOfUnits.h.
|
static |
Definition at line 141 of file SystemOfUnits.h.
|
static |
Definition at line 72 of file RandPoissonQ.cc.
|
static |
Definition at line 58 of file RanecuEngine.cc.
|
static |
Definition at line 80 of file PhysicalConstants.h.
|
static |
Definition at line 152 of file SystemOfUnits.h.
|
static |
Definition at line 129 of file SystemOfUnits.h.
|
static |
Definition at line 122 of file SystemOfUnits.h.
|
static |
Definition at line 149 of file SystemOfUnits.h.
|
static |
Definition at line 138 of file SystemOfUnits.h.
|
static |
Definition at line 131 of file SystemOfUnits.h.
|
static |
Definition at line 126 of file SystemOfUnits.h.
|
static |
Definition at line 117 of file PhysicalConstants.h.
|
static |
Definition at line 116 of file PhysicalConstants.h.
|
static |
Definition at line 540 of file LorentzVector.h.
|
static |
Definition at line 61 of file RandLandau.cc.
|
static |
Definition at line 60 of file RandLandau.cc.
|
static |
Definition at line 62 of file RandLandau.cc.
|
static |
Definition at line 168 of file SystemOfUnits.h.
Definition at line 248 of file SystemOfUnits.h.
|
static |
Definition at line 178 of file SystemOfUnits.h.
|
static |
Definition at line 77 of file flatToGaussian.cc.
|
static |
Definition at line 53 of file flatToGaussian.cc.
|
static |
Definition at line 65 of file flatToGaussian.cc.
|
static |
Definition at line 55 of file SystemOfUnits.h.
|
static |
Definition at line 105 of file PhysicalConstants.h.
|
static |
Definition at line 284 of file SystemOfUnits.h.
|
static |
Definition at line 93 of file SystemOfUnits.h.
Definition at line 123 of file PhysicalConstants.h.
|
static |
Definition at line 151 of file SystemOfUnits.h.
|
static |
Definition at line 224 of file SystemOfUnits.h.
Definition at line 196 of file SystemOfUnits.h.
Definition at line 243 of file SystemOfUnits.h.
|
static |
Definition at line 537 of file LorentzVector.h.
|
static |
Definition at line 538 of file LorentzVector.h.
|
static |
Definition at line 539 of file LorentzVector.h.