Mantid
|
A namespace containing physical constants that are required by algorithms and unit routines. More...
Classes | |
class | Atom |
Struture to hold the common information for an atom. More... | |
struct | MagneticIon |
Struture to hold information about magnetic form factor for 3d, 4d, rare earth, and actinide atoms and ions. More... | |
struct | NeutronAtom |
Structure to store neutronic scattering information for the various elements. More... | |
Typedefs | |
using | IonIndex = std::unordered_map< std::string, MagneticIon > |
Typedef the map type. More... | |
Functions | |
bool | AtomEqualsWithNaN (const double left, const double right) |
Check if two atoms are not valid. More... | |
MANTID_KERNEL_DLL void | calculateScatteringLengths (NeutronAtom &atom) |
Utility function to calculate scattering lengths from cross-sections. More... | |
bool | compareAtoms (const Atom &left, uint16_t a_number) |
Compare two atoms. More... | |
bool | compareAtoms (const NeutronAtom &left, const NeutronAtom &right) |
Comparison between neutron atoms (for sorting) More... | |
void | createIonLookup (IonIndex &ion_map) |
Forward decalre intializer. More... | |
MANTID_KERNEL_DLL const Atom & | getAtom (const std::string &symbol, const uint16_t a_number=0) |
MANTID_KERNEL_DLL const Atom & | getAtom (const uint16_t z_number, const uint16_t a_number=0) |
MANTID_KERNEL_DLL std::vector< double > | getJL (const std::string &symbol, const uint16_t charge, const uint16_t l=0) |
Returns the Lth-coefficients for the given ion. More... | |
MANTID_KERNEL_DLL const MagneticIon & | getMagneticIon (const std::string &symbol) |
Returns the magnetic ion from a combined symbol and charge given as string. More... | |
MANTID_KERNEL_DLL const MagneticIon & | getMagneticIon (const std::string &symbol, const uint16_t charge) |
Returns the magnetic ion for the given symbol and charge. More... | |
MANTID_KERNEL_DLL std::vector< std::string > | getMagneticIonList () |
Returns a list of all ions. More... | |
MANTID_KERNEL_DLL NeutronAtom | getNeutronAtom (const uint16_t z_number, const uint16_t a_number) |
Retrieve a copy of NeutronAtom. More... | |
MANTID_KERNEL_DLL NeutronAtom | getNeutronNoExceptions (const NeutronAtom &other) |
MANTID_KERNEL_DLL NeutronAtom | getNeutronNoExceptions (const uint16_t z_number, const uint16_t a_number) |
const IonIndex & | ionMap () |
Returns a reference to the static lookup map. More... | |
bool | NeutronAtomEqualsWithNaN (const double left, const double right) |
MANTID_KERNEL_DLL bool | operator!= (const Atom &left, const Atom &right) |
Inequality operator overload. More... | |
MANTID_KERNEL_DLL bool | operator!= (const NeutronAtom &left, const NeutronAtom &right) |
Inequality between two neutron atoms. More... | |
MANTID_KERNEL_DLL NeutronAtom | operator* (const double left, const NeutronAtom &right) |
This calls operator*(const NeutronAtom&, const double) with the parameters reversed. More... | |
MANTID_KERNEL_DLL NeutronAtom | operator* (const NeutronAtom &left, const double right) |
Multiplying a NeutronAtom by a number sets a_number=z_number=0 and multiplies all of the scattering information. More... | |
MANTID_KERNEL_DLL NeutronAtom | operator+ (const NeutronAtom &left, const NeutronAtom &right) |
Adding two NeutronAtoms together sets a_number=z_number=0 and adds all of the scattering information. More... | |
MANTID_KERNEL_DLL std::ostream & | operator<< (std::ostream &out, const Atom &atom) |
Stream operator overload. More... | |
MANTID_KERNEL_DLL std::ostream & | operator<< (std::ostream &out, const NeutronAtom &atom) |
Output neutron atom to a stream. More... | |
MANTID_KERNEL_DLL bool | operator== (const Atom &left, const Atom &right) |
Equality operator overload. More... | |
MANTID_KERNEL_DLL bool | operator== (const NeutronAtom &left, const NeutronAtom &right) |
Equality between two neutron atoms. More... | |
Variables | |
static constexpr double | AtomicMassUnit = 1.660538921e-27 |
AMU in kg. More... | |
static std::array< tcb::span< Atom >, 96 > | ATOMS |
static NeutronAtom | ATOMS [] |
All of the atoms in a single array so it can be searched. More... | |
static std::array< Atom, 2845 > | ATOMS_ARRAY |
static constexpr double | BoltzmannConstant = 8.6173324e-02 |
Boltzmann Constant in meV/K Taken from http://physics.nist.gov/cuu/Constants on 10/07/2012. More... | |
static constexpr double | E_mev_toNeutronWavenumberSq |
Transformation coefficient to transform neutron energy into neutron wavevector: K-neutron[m^-10] = sqrt(E_neutron[meV]/E_transtormation[mEv]);. More... | |
static constexpr double | g = 9.80665 |
Standard acceleration due to gravity. More... | |
static constexpr double | h = 6.62606896e-34 |
Planck constant in J*s. More... | |
static constexpr double | h_bar = h / (2 * M_PI) |
Planck constant in J*s, divided by 2 PI. More... | |
static constexpr double | meV = 1.602176487e-22 |
1 meV in Joules. More... | |
static constexpr double | meVtoFrequency = 0.2417989262 |
1 meV in frequency (GHz). More... | |
static constexpr double | meVtoKelvin = 11.604519 |
1 meV in Kelvin. More... | |
static constexpr double | meVtoWavenumber = 8.06554465 |
1 meV in wavenumber (cm-1). More... | |
static constexpr double | MuonGyromagneticRatio = 0.01355342 |
Muon gyromagnetic ratio in MHz/G Taken from CalMuonDetectorPhases and DynamicKuboToyabe on 02/02/2016. More... | |
static constexpr double | MuonLifetime = 2.1969811e-6 |
Muon lifetime. More... | |
static constexpr double | N_A = 6.02214179e23 |
Avagodro constant in mol-1. More... | |
static constexpr double | NeutronMass = 1.674927211e-27 |
Mass of the neutron in kg. More... | |
static constexpr double | NeutronMassAMU = 1.008664916 |
Mass of the neutron in AMU. More... | |
static const size_t | NUM_ATOMS = 371 |
The total number of atoms in the array. More... | |
static constexpr double | StandardAtmosphere = 101.325 |
Standard atmospheric pressure in kPa. More... | |
A namespace containing physical constants that are required by algorithms and unit routines.
using Mantid::PhysicalConstants::IonIndex = typedef std::unordered_map<std::string, MagneticIon> |
Typedef the map type.
Definition at line 672 of file MagneticIon.cpp.
bool Mantid::PhysicalConstants::AtomEqualsWithNaN | ( | const double | left, |
const double | right | ||
) |
Check if two atoms are not valid.
Definition at line 3120 of file Atom.cpp.
Referenced by operator==().
void Mantid::PhysicalConstants::calculateScatteringLengths | ( | NeutronAtom & | atom | ) |
Utility function to calculate scattering lengths from cross-sections.
Definition at line 27 of file NeutronAtom.cpp.
References Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::tot_scatt_length, and Mantid::PhysicalConstants::NeutronAtom::tot_scatt_xs.
Referenced by Mantid::PhysicalConstants::NeutronAtom::NeutronAtom(), and Mantid::PhysicalConstants::NeutronAtom::operator=().
bool Mantid::PhysicalConstants::compareAtoms | ( | const Atom & | left, |
uint16_t | a_number | ||
) |
Compare two atoms.
Definition at line 3160 of file Atom.cpp.
References left.
Referenced by getAtom(), getNeutronAtom(), and getNeutronNoExceptions().
bool Mantid::PhysicalConstants::compareAtoms | ( | const NeutronAtom & | left, |
const NeutronAtom & | right | ||
) |
Comparison between neutron atoms (for sorting)
left | :: NeutronAtom to compare |
right | :: NeutronAtom to compare |
Definition at line 634 of file NeutronAtom.cpp.
void Mantid::PhysicalConstants::createIonLookup | ( | IonIndex & | ion_map | ) |
Forward decalre intializer.
Creates the lookup table.
ion_map | A reference to the static lookup |
Definition at line 690 of file MagneticIon.cpp.
Referenced by ionMap().
const Atom & Mantid::PhysicalConstants::getAtom | ( | const std::string & | symbol, |
const uint16_t | a_number | ||
) |
symbol | :: Chemical symbol of the atom to get |
a_number | :: Mass number of the atom to get |
Definition at line 3192 of file Atom.cpp.
References ATOMS, compareAtoms(), and getAtom().
const Atom & Mantid::PhysicalConstants::getAtom | ( | const uint16_t | z_number, |
const uint16_t | a_number | ||
) |
z_number | :: Atomic number of the atom to get |
a_number | :: Mass number of the atom to get |
Definition at line 3167 of file Atom.cpp.
References ATOMS, compareAtoms(), getAtom(), and index.
Referenced by Mantid::WorkflowAlgorithms::DgsAbsoluteUnitsReduction::exec(), getAtom(), and Mantid::Geometry::IsotropicAtomBraggScatterer::setElement().
std::vector< double > Mantid::PhysicalConstants::getJL | ( | const std::string & | symbol, |
const uint16_t | charge, | ||
const uint16_t | l | ||
) |
Returns the Lth-coefficients for the given ion.
Returns the coffieients for a given angular momentum.
symbol | :: The string symbol defining the element |
charge | :: The charge |
l | :: The angular momentum |
Definition at line 1018 of file MagneticIon.cpp.
References getMagneticIon(), Mantid::PhysicalConstants::MagneticIon::j0, Mantid::PhysicalConstants::MagneticIon::j2, Mantid::PhysicalConstants::MagneticIon::j4, and Mantid::PhysicalConstants::MagneticIon::j6.
const MagneticIon & Mantid::PhysicalConstants::getMagneticIon | ( | const std::string & | symbol | ) |
Returns the magnetic ion from a combined symbol and charge given as string.
Returns a MagneticIon corresponding to the given symbol containing the atom & charge Throws std::runtime_error if one cannot be found.
symbol | :: The string symbol |
Definition at line 983 of file MagneticIon.cpp.
References ionMap().
const MagneticIon & Mantid::PhysicalConstants::getMagneticIon | ( | const std::string & | symbol, |
const uint16_t | charge | ||
) |
Returns the magnetic ion for the given symbol and charge.
Returns a MagneticIon corresponding to the given symbol & charge.
Throws std::runtime_error if one cannot be found
symbol | :: The string symbol |
charge | :: The charge |
Definition at line 1004 of file MagneticIon.cpp.
References getMagneticIon().
Referenced by Mantid::Algorithms::MagFormFactorCorrection::exec(), getJL(), and getMagneticIon().
std::vector< std::string > Mantid::PhysicalConstants::getMagneticIonList | ( | ) |
Returns a list of all ions.
Returns a std::vector<std::string> of the keys of ion_map (a list of all ions programmed into this class)
Definition at line 1048 of file MagneticIon.cpp.
References ionMap().
Referenced by Mantid::Algorithms::MagFormFactorCorrection::init().
NeutronAtom Mantid::PhysicalConstants::getNeutronAtom | ( | const uint16_t | z_number, |
const uint16_t | a_number | ||
) |
Retrieve a copy of NeutronAtom.
z_number | :: Atomic number of the atom to get |
a_number | :: Mass number of the atom to get |
Definition at line 710 of file NeutronAtom.cpp.
References Mantid::PhysicalConstants::NeutronAtom::a_number, ATOMS, compareAtoms(), NUM_ATOMS, and Mantid::PhysicalConstants::NeutronAtom::z_number.
Referenced by Mantid::WorkflowAlgorithms::DgsAbsoluteUnitsReduction::exec(), and Mantid::Kernel::Material::loadNexus().
NeutronAtom Mantid::PhysicalConstants::getNeutronNoExceptions | ( | const NeutronAtom & | other | ) |
Definition at line 735 of file NeutronAtom.cpp.
References getNeutronNoExceptions().
NeutronAtom Mantid::PhysicalConstants::getNeutronNoExceptions | ( | const uint16_t | z_number, |
const uint16_t | a_number | ||
) |
Definition at line 723 of file NeutronAtom.cpp.
References Mantid::PhysicalConstants::NeutronAtom::a_number, ATOMS, compareAtoms(), NUM_ATOMS, and Mantid::PhysicalConstants::NeutronAtom::z_number.
Referenced by getNeutronNoExceptions().
const IonIndex & Mantid::PhysicalConstants::ionMap | ( | ) |
Returns a reference to the static lookup map.
Definition at line 678 of file MagneticIon.cpp.
References createIonLookup(), and ionMap().
Referenced by getMagneticIon(), getMagneticIonList(), and ionMap().
bool Mantid::PhysicalConstants::NeutronAtomEqualsWithNaN | ( | const double | left, |
const double | right | ||
) |
Definition at line 568 of file NeutronAtom.cpp.
Referenced by operator==().
bool Mantid::PhysicalConstants::operator!= | ( | const NeutronAtom & | left, |
const NeutronAtom & | right | ||
) |
Inequality between two neutron atoms.
left | :: NeutronAtom to compare |
right | :: NeutronAtom to compare |
Definition at line 615 of file NeutronAtom.cpp.
NeutronAtom Mantid::PhysicalConstants::operator* | ( | const double | left, |
const NeutronAtom & | right | ||
) |
This calls operator*(const NeutronAtom&, const double) with the parameters reversed.
Definition at line 700 of file NeutronAtom.cpp.
NeutronAtom Mantid::PhysicalConstants::operator* | ( | const NeutronAtom & | left, |
const double | right | ||
) |
Multiplying a NeutronAtom by a number sets a_number=z_number=0 and multiplies all of the scattering information.
Definition at line 673 of file NeutronAtom.cpp.
References Mantid::PhysicalConstants::NeutronAtom::a_number, Mantid::PhysicalConstants::NeutronAtom::abs_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_xs, left, right, Mantid::PhysicalConstants::NeutronAtom::tot_scatt_length, Mantid::PhysicalConstants::NeutronAtom::tot_scatt_xs, and Mantid::PhysicalConstants::NeutronAtom::z_number.
NeutronAtom Mantid::PhysicalConstants::operator+ | ( | const NeutronAtom & | left, |
const NeutronAtom & | right | ||
) |
Adding two NeutronAtoms together sets a_number=z_number=0 and adds all of the scattering information.
Definition at line 646 of file NeutronAtom.cpp.
References Mantid::PhysicalConstants::NeutronAtom::a_number, Mantid::PhysicalConstants::NeutronAtom::abs_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_xs, left, right, Mantid::PhysicalConstants::NeutronAtom::tot_scatt_length, Mantid::PhysicalConstants::NeutronAtom::tot_scatt_xs, and Mantid::PhysicalConstants::NeutronAtom::z_number.
std::ostream & Mantid::PhysicalConstants::operator<< | ( | std::ostream & | out, |
const Atom & | atom | ||
) |
Stream operator overload.
Definition at line 3152 of file Atom.cpp.
References Mantid::PhysicalConstants::Atom::a_number, and Mantid::PhysicalConstants::Atom::symbol.
std::ostream & Mantid::PhysicalConstants::operator<< | ( | std::ostream & | out, |
const NeutronAtom & | atom | ||
) |
Output neutron atom to a stream.
out | :: stream |
atom | :: NeutronAtom |
Definition at line 622 of file NeutronAtom.cpp.
References Mantid::PhysicalConstants::NeutronAtom::abs_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::coh_scatt_xs, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_img, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_length_real, Mantid::PhysicalConstants::NeutronAtom::inc_scatt_xs, and Mantid::PhysicalConstants::NeutronAtom::tot_scatt_xs.
Equality operator overload.
Definition at line 3128 of file Atom.cpp.
References AtomEqualsWithNaN(), left, and right.
bool Mantid::PhysicalConstants::operator== | ( | const NeutronAtom & | left, |
const NeutronAtom & | right | ||
) |
Equality between two neutron atoms.
left | :: NeutronAtom to compare |
right | :: NeutronAtom to compare |
Definition at line 581 of file NeutronAtom.cpp.
References left, NeutronAtomEqualsWithNaN(), and right.
|
staticconstexpr |
AMU in kg.
Taken from http://physics.nist.gov/cuu/Constants on 10/09/2014.
Definition at line 47 of file PhysicalConstants.h.
Referenced by Mantid::CurveFitting::Algorithms::VesuvioCalculateMS::cacheInputs(), and export_PhysicalConstants().
|
static |
Definition at line 3068 of file Atom.cpp.
Referenced by getAtom(), getNeutronAtom(), and getNeutronNoExceptions().
|
static |
All of the atoms in a single array so it can be searched.
Definition at line 539 of file NeutronAtom.cpp.
|
static |
|
staticconstexpr |
Boltzmann Constant in meV/K Taken from http://physics.nist.gov/cuu/Constants on 10/07/2012.
Definition at line 83 of file PhysicalConstants.h.
Referenced by export_PhysicalConstants().
|
staticconstexpr |
Transformation coefficient to transform neutron energy into neutron wavevector: K-neutron[m^-10] = sqrt(E_neutron[meV]/E_transtormation[mEv]);.
Definition at line 67 of file PhysicalConstants.h.
Referenced by Mantid::CurveFitting::Functions::VesuvioResolution::cacheResolutionComponents(), Mantid::CurveFitting::Functions::ComptonProfile::cacheYSpaceValues(), Mantid::MDAlgorithms::MDTransfQ3D::calcMatrixCoord3DInelastic(), Mantid::MDAlgorithms::MDTransfModQ::calcMatrixCoordInelastic(), Mantid::CurveFitting::Algorithms::VesuvioCalculateMS::calculateE1Range(), Mantid::CurveFitting::Algorithms::ConvertToYSpace::calculateY(), Mantid::MDAlgorithms::MDTransfModQ::calcYDepCoordinates(), Mantid::MDAlgorithms::MDTransfQ3D::calcYDepCoordinates(), Mantid::CurveFitting::Algorithms::ConvertToYSpace::convert(), Mantid::Algorithms::SofQCommon::directQ(), Mantid::Algorithms::SofQWCentre::exec(), export_PhysicalConstants(), Mantid::Algorithms::SofQCommon::indirectQ(), Mantid::MDAlgorithms::MDTransfModQ::initialize(), Mantid::MDAlgorithms::MDTransfQ3D::initialize(), Mantid::CurveFitting::Algorithms::VesuvioCalculateMS::partialDiffXSec(), and Mantid::CurveFitting::Functions::ComptonPeakProfile::setWorkspace().
|
staticconstexpr |
Standard acceleration due to gravity.
Precise value in ms-2.
Definition at line 35 of file PhysicalConstants.h.
Referenced by Mantid::Algorithms::ConvertAxisByFormula::exec(), export_PhysicalConstants(), and Mantid::Algorithms::GravitySANSHelper::gravitationalDrop().
|
staticconstexpr |
Planck constant in J*s.
Taken from http://physics.nist.gov/cuu/Constants on 2007-10-31 and confirmed again on 2010-12-28.
Definition at line 29 of file PhysicalConstants.h.
Referenced by Mantid::Algorithms::SparseWorkspace::bilinearInterpolateFromDetectorGrid(), Mantid::MDAlgorithms::CalculateCoverageDGS::cacheDimensionXValues(), Mantid::MDAlgorithms::MDNormDirectSC::cacheDimensionXValues(), Mantid::MDAlgorithms::MDNormDirectSC::cacheInputs(), Mantid::DataHandling::LoadHelper::calculateEnergy(), Mantid::MDAlgorithms::MDNormDirectSC::calculateNormalization(), Mantid::Algorithms::ConvertToConstantL2::calculateTOF(), Mantid::Algorithms::ConvertEmptyToTof::calculateTOF(), Mantid::DataHandling::LoadHelper::calculateTOF(), Mantid::Kernel::Units::Energy::Energy(), Mantid::Kernel::Units::Energy_inWavenumber::Energy_inWavenumber(), Mantid::Algorithms::ConvertAxisByFormula::exec(), Mantid::Algorithms::GroupToXResolution::exec(), Mantid::Algorithms::ModeratorTzeroLinear::exec(), Mantid::Crystal::IndexSXPeaks::exec(), Mantid::Crystal::LoadHKL::exec(), Mantid::MDAlgorithms::CalculateCoverageDGS::exec(), Mantid::MDAlgorithms::ConvertToMDMinMaxGlobal::exec(), Mantid::MDAlgorithms::RecalculateTrajectoriesExtents::exec(), Mantid::DataHandling::LoadPLN::exec(), export_PhysicalConstants(), Mantid::Algorithms::SparseWorkspace::extremeWavelengths(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspace(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspaceRaw(), Mantid::MDAlgorithms::MDNorm::getBinParameters(), Mantid::DataObjects::Peak::getDSpacing(), Mantid::DataObjects::LeanElasticPeak::getFinalEnergy(), Mantid::DataHandling::LoadILLSANS::getVariableTimeBinning(), Mantid::DataObjects::Peak::getWavelength(), Mantid::Algorithms::GravitySANSHelper::gravitationalDrop(), Mantid::Algorithms::UnwrapMonitor::init(), Mantid::Algorithms::UnwrapSNS::init(), Mantid::Kernel::Units::Wavelength::init(), Mantid::Kernel::Units::dSpacingPerpendicular::init(), Mantid::Kernel::Units::Momentum::init(), Mantid::Algorithms::DiscusMultipleScatteringCorrection::integrateCumulative(), Mantid::Algorithms::SparseWorkspace::interpolateFromDetectorGrid(), Mantid::Algorithms::SparseWorkspace::modelHistogram(), Mantid::Kernel::Units::Momentum::Momentum(), Mantid::Crystal::LoadIsawPeaks::readPeak(), Mantid::DataObjects::Peak::setWavelength(), Mantid::Algorithms::SparseWorkspace::SparseWorkspace(), and Mantid::Kernel::Units::Wavelength::Wavelength().
|
staticconstexpr |
Planck constant in J*s, divided by 2 PI.
Definition at line 32 of file PhysicalConstants.h.
Referenced by Mantid::MDAlgorithms::ConvertToDiffractionMDWorkspace::convertEventList(), Mantid::Algorithms::AddPeak::exec(), Mantid::Algorithms::ConvertAxisByFormula::exec(), export_PhysicalConstants(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspace(), Mantid::Crystal::FindSXPeaksHelper::SXPeak::getQ(), and Mantid::DataObjects::Peak::getQLabFrame().
|
staticconstexpr |
1 meV in Joules.
Taken from http://physics.nist.gov/cuu/Constants on 28/03/2008.
Definition at line 51 of file PhysicalConstants.h.
Referenced by Mantid::MDAlgorithms::CalculateCoverageDGS::cacheDimensionXValues(), Mantid::MDAlgorithms::MDNormDirectSC::cacheDimensionXValues(), Mantid::MDAlgorithms::MDNormDirectSC::cacheInputs(), Mantid::CurveFitting::Functions::ComptonProfile::cacheYSpaceValues(), Mantid::Algorithms::TimeAtSampleStrategyIndirect::calculate(), Mantid::DataHandling::LoadHelper::calculateEnergy(), Mantid::MDAlgorithms::MDNormDirectSC::calculateNormalization(), Mantid::Algorithms::ModeratorTzeroLinear::calculateTfLi(), Mantid::Algorithms::CorrectTOFAxis::correctManually(), Mantid::Kernel::Units::Energy::Energy(), Mantid::Kernel::Units::Energy_inWavenumber::Energy_inWavenumber(), Mantid::Algorithms::CorelliCrossCorrelate::exec(), Mantid::Algorithms::GetEi::exec(), Mantid::Algorithms::GetEiMonDet3::exec(), Mantid::Algorithms::ModeratorTzero::exec(), Mantid::MDAlgorithms::CalculateCoverageDGS::exec(), Mantid::MDAlgorithms::ConvertToMDMinMaxGlobal::exec(), Mantid::MDAlgorithms::RecalculateTrajectoriesExtents::exec(), Mantid::Algorithms::ModeratorTzero::execEvent(), export_PhysicalConstants(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspace(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspaceRaw(), Mantid::MDAlgorithms::MDNorm::getBinParameters(), Mantid::DataObjects::Peak::getDSpacing(), Mantid::Algorithms::GetEi2::GetEi2(), Mantid::DataObjects::LeanElasticPeak::getFinalEnergy(), Mantid::DataObjects::Peak::getQLabFrame(), Mantid::DataObjects::Peak::getTOF(), Mantid::DataObjects::Peak::getWavelength(), Mantid::Kernel::Units::Wavelength::init(), Mantid::Kernel::Units::Energy::init(), Mantid::Kernel::Units::Energy_inWavenumber::init(), Mantid::Kernel::Units::DeltaE::init(), Mantid::Kernel::Units::Momentum::init(), Mantid::Kernel::Units::Momentum::Momentum(), Mantid::DataObjects::Peak::setWavelength(), Mantid::Algorithms::TimeAtSampleStrategyDirect::TimeAtSampleStrategyDirect(), Mantid::Algorithms::GetEi::timeToFly(), and Mantid::Kernel::Units::Wavelength::Wavelength().
|
staticconstexpr |
1 meV in frequency (GHz).
Division of energy by Plank's constant. Taken from http://physics.nist.gov/cuu/Constants on 03/11/2017.
Definition at line 59 of file PhysicalConstants.h.
Referenced by Mantid::Kernel::Units::DeltaE::DeltaE(), Mantid::Kernel::Units::DeltaE_inFrequency::DeltaE_inFrequency(), export_PhysicalConstants(), and Mantid::Kernel::Units::DeltaE_inFrequency::init().
|
staticconstexpr |
1 meV in Kelvin.
Taken from http://physics.nist.gov/cuu/Constants on 09/09/2011.
Definition at line 63 of file PhysicalConstants.h.
Referenced by Mantid::MDAlgorithms::ApplyDetailedBalanceMD::applyDetailedBalance(), Mantid::Algorithms::ApplyDetailedBalance::exec(), export_PhysicalConstants(), Mantid::CurveFitting::Functions::ActivationmeV::function1D(), and Mantid::CurveFitting::Functions::ActivationmeV::functionDeriv1D().
|
staticconstexpr |
1 meV in wavenumber (cm-1).
Taken from http://physics.nist.gov/cuu/Constants on 02/04/2008.
Definition at line 55 of file PhysicalConstants.h.
Referenced by Mantid::Kernel::Units::DeltaE::DeltaE(), Mantid::Kernel::Units::DeltaE_inWavenumber::DeltaE_inWavenumber(), Mantid::Kernel::Units::Energy::Energy(), Mantid::Kernel::Units::Energy_inWavenumber::Energy_inWavenumber(), export_PhysicalConstants(), Mantid::Kernel::Units::Energy_inWavenumber::init(), Mantid::Kernel::Units::DeltaE_inWavenumber::init(), Mantid::Kernel::Units::Momentum::Momentum(), and Mantid::Kernel::Units::Wavelength::Wavelength().
|
staticconstexpr |
Muon gyromagnetic ratio in MHz/G Taken from CalMuonDetectorPhases and DynamicKuboToyabe on 02/02/2016.
Definition at line 88 of file PhysicalConstants.h.
Referenced by Mantid::CurveFitting::Functions::Keren::activeParameter(), export_PhysicalConstants(), Mantid::CurveFitting::Functions::Keren::function1D(), Mantid::CurveFitting::Functions::HKT(), and Mantid::CurveFitting::Functions::Keren::setActiveParameter().
|
staticconstexpr |
Muon lifetime.
Taken from Particle Data Group on 15/1/2016 http://pdg.lbl.gov/2015/tables/rpp2015-sum-leptons.pdf.
Definition at line 72 of file PhysicalConstants.h.
Referenced by export_PhysicalConstants().
|
staticconstexpr |
Avagodro constant in mol-1.
Taken from http://physics.nist.gov/cuu/Constants on 2010-12-28.
Definition at line 25 of file PhysicalConstants.h.
Referenced by export_PhysicalConstants(), and Mantid::Kernel::MaterialBuilder::getOrCalculateRhoAndPacking().
|
staticconstexpr |
Mass of the neutron in kg.
Taken from http://physics.nist.gov/cuu/Constants on 30/10/2007.
Definition at line 39 of file PhysicalConstants.h.
Referenced by Mantid::MDAlgorithms::CalculateCoverageDGS::cacheDimensionXValues(), Mantid::MDAlgorithms::MDNormDirectSC::cacheDimensionXValues(), Mantid::MDAlgorithms::MDNormDirectSC::cacheInputs(), Mantid::CurveFitting::Functions::ComptonProfile::cacheYSpaceValues(), Mantid::Algorithms::TimeAtSampleStrategyIndirect::calculate(), Mantid::DataHandling::LoadHelper::calculateEnergy(), Mantid::MDAlgorithms::MDNormDirectSC::calculateNormalization(), Mantid::Algorithms::ModeratorTzeroLinear::calculateTfLi(), Mantid::Algorithms::ConvertToConstantL2::calculateTOF(), Mantid::Algorithms::ConvertEmptyToTof::calculateTOF(), Mantid::DataHandling::LoadHelper::calculateTOF(), Mantid::MDAlgorithms::ConvertToDiffractionMDWorkspace::convertEventList(), Mantid::Algorithms::CorrectTOFAxis::correctManually(), Mantid::Kernel::Units::Energy::Energy(), Mantid::Kernel::Units::Energy_inWavenumber::Energy_inWavenumber(), Mantid::Algorithms::AddPeak::exec(), Mantid::Algorithms::ConvertAxisByFormula::exec(), Mantid::Algorithms::CorelliCrossCorrelate::exec(), Mantid::Algorithms::GetEiMonDet3::exec(), Mantid::Algorithms::ModeratorTzero::exec(), Mantid::Algorithms::ModeratorTzeroLinear::exec(), Mantid::MDAlgorithms::CalculateCoverageDGS::exec(), Mantid::MDAlgorithms::ConvertToMDMinMaxGlobal::exec(), Mantid::MDAlgorithms::RecalculateTrajectoriesExtents::exec(), Mantid::DataHandling::LoadPLN::exec(), Mantid::Algorithms::ModeratorTzero::execEvent(), export_PhysicalConstants(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspace(), Mantid::MDAlgorithms::LoadDNSSCD::fillOutputWorkspaceRaw(), Mantid::MDAlgorithms::MDNorm::getBinParameters(), Mantid::DataObjects::Peak::getDSpacing(), Mantid::Algorithms::GetEi2::GetEi2(), Mantid::DataObjects::LeanElasticPeak::getFinalEnergy(), Mantid::Crystal::FindSXPeaksHelper::SXPeak::getQ(), Mantid::DataObjects::Peak::getQLabFrame(), Mantid::DataObjects::Peak::getTOF(), Mantid::DataHandling::LoadILLSANS::getVariableTimeBinning(), Mantid::DataObjects::Peak::getWavelength(), Mantid::Algorithms::GravitySANSHelper::gravitationalDrop(), Mantid::Algorithms::UnwrapMonitor::init(), Mantid::Algorithms::UnwrapSNS::init(), Mantid::Kernel::Units::Wavelength::init(), Mantid::Kernel::Units::Energy::init(), Mantid::Kernel::Units::Energy_inWavenumber::init(), Mantid::Kernel::Units::dSpacingPerpendicular::init(), Mantid::Kernel::Units::DeltaE::init(), Mantid::Kernel::Units::Momentum::init(), Mantid::Kernel::Units::Momentum::Momentum(), Mantid::Algorithms::GetEi::neutron_E_At(), Mantid::DataObjects::Peak::setWavelength(), Mantid::Algorithms::TimeAtSampleStrategyDirect::TimeAtSampleStrategyDirect(), Mantid::Algorithms::GetEi::timeToFly(), and Mantid::Kernel::Units::Wavelength::Wavelength().
|
staticconstexpr |
Mass of the neutron in AMU.
Taken from http://physics.nist.gov/cuu/Constants on 02/01/2013.
Definition at line 43 of file PhysicalConstants.h.
Referenced by Mantid::CurveFitting::Algorithms::VesuvioCalculateMS::cacheInputs(), Mantid::CurveFitting::Functions::VesuvioResolution::cacheResolutionComponents(), Mantid::Algorithms::ConvertAxisByFormula::exec(), and export_PhysicalConstants().
|
static |
The total number of atoms in the array.
Definition at line 566 of file NeutronAtom.cpp.
Referenced by getNeutronAtom(), and getNeutronNoExceptions().
|
staticconstexpr |
Standard atmospheric pressure in kPa.
Taken from <http://physics.nist.gov/cgi-bin/cuu/Value?stdatm|search_for=adopted_in!> on 01/12/2010
Definition at line 78 of file PhysicalConstants.h.
Referenced by export_PhysicalConstants().