|
template<typename T , std::size_t N> |
constexpr T | array_add_n (const std::array< T, N > a, const std::array< T, N > b, int n) |
|
template<typename T , std::size_t N, int... S> |
constexpr std::array< T, N > | array_add_impl (const std::array< T, N > a, const std::array< T, N > b, seq< S... >) |
|
template<typename T , std::size_t N> |
constexpr std::array< T, N > | array_add (const std::array< T, N > a, const std::array< T, N > b) |
|
template<typename T , std::size_t N> |
constexpr T | array_minus_n (const std::array< T, N > a, const std::array< T, N > b, int n) |
|
template<typename T , std::size_t N, int... S> |
constexpr std::array< T, N > | array_minus_impl (const std::array< T, N > a, const std::array< T, N > b, seq< S... >) |
|
template<typename T , std::size_t N> |
constexpr std::array< T, N > | array_minus (const std::array< T, N > a, const std::array< T, N > b) |
|
template<typename T , std::size_t N> |
constexpr T | array_scale_n (const std::array< T, N > a, T b_val, int n) |
|
template<typename T , std::size_t N, int... S> |
constexpr std::array< T, N > | array_scale_impl (const std::array< T, N > a, const T b, seq< S... >) |
|
template<typename T , std::size_t N> |
constexpr std::array< T, N > | array_scale (const std::array< T, N > a, T b) |
|
constexpr real_precision | reduce_l_nonzero (const dimension7 dim) |
|
constexpr real_precision | reduce_l_energy (const dimension7 dim) |
|
constexpr uval | operator* (const uval &lhs, const uval &rhs) |
|
constexpr uval | operator* (const real_precision &lhs, const uval &rhs) |
|
constexpr uval | operator* (const uval &lhs, const real_precision &rhs) |
|
constexpr uval | operator/ (const uval &lhs, const uval &rhs) |
|
constexpr uval | operator/ (const real_precision &lhs, const uval &rhs) |
|
constexpr uval | operator/ (const uval &lhs, const real_precision &rhs) |
|
const uval | operator+ (const uval &lhs, const uval &rhs) |
|
const uval | operator- (const uval &lhs, const uval &rhs) |
|
uval | power (const uval &lhs, const real_precision &index) |
|
bool | is_same_dimension7 (const uval &lhs, const uval &rhs) |
|
std::string | to_string (const uval &u) |
|
|
constexpr uval | G_gravitional_constant (dimension7{{3, -2, -1}}, 6.6740831E-11L) |
|
constexpr uval | c_lightspeed (speed_d, 2.997924580E+8L) |
|
constexpr uval | ep0_permittivity (permittivity_d, 8.854187817E-12L) |
| 1/(4*pi*ke)
|
|
constexpr uval | mu0_permeability (magnetic_permeability_d, 1.256637061E-6L) |
| 4*pi*ke/c^2
|
|
constexpr uval | ke_Comloub (dimensionless_d/permittivity_d, 8.9875517873681764E+9L) |
|
constexpr uval | R_gas_constant (molar_entropy_d, 8.314459848L) |
| k * N
|
|
constexpr uval | Rydberg_constant (wave_number_d, 10973731.56850865L) |
| me* e ^ 4 / (8 * ep0 ^ 2 * h ^ 3 * c)
|
|
constexpr uval | Faraday_constant (electric_charge_d/amount_of_substance_d, 96485.3328959L) |
| e*N
|
|
constexpr uval | Stefan_constant (dimension7{{0, -3, 1, -4}}, 5.67036713E-8L) |
| pi^2 kB^4/(60*hb^3*c^2)
|
|
constexpr uval | muB_magnetic_moment (magnetic_moment_d, 9.27400999457E-24L) |
| e*hb / (2*me)
|
|
constexpr uval | muN_magnetic_moment (magnetic_moment_d, 5.05078369931E-27L) |
| e*hb / (2*mn)
|
|
constexpr uval | Bohr_length (length_d, 5.291772106712E-11L) |
| hb^2/(ke*me*e^2)
|
|
constexpr uval | h_Planck (action_d, 6.62607004081E-34L) |
|
constexpr uval | hb_Planck (action_d, 1.05457180013E-34L) |
| h/(2*pi)
|
|
constexpr uval | me_mass (mass_d, 9.1093835611E-31L) |
|
constexpr uval | mp_mass (mass_d, 1.67262189821E-27L) |
|
constexpr uval | mn_mass (mass_d, 1.67492749804e-27L) |
|
constexpr uval | amu_mass (mass_d, 1.66053886E-27L) |
|
constexpr uval | e_charge (electric_charge_d, 1.602176620898E-19L) |
|
constexpr uval | k_Boltzman (entropy_d, 1.3806490351E-23L) |
|
constexpr uval | N_Avagadro (dimensionless_d/amount_of_substance_d, 6.02214085774E+23L) |
|
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (si, _base_1m, _base_1s, _base_1kg, _base_1A, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (planck, c_lightspeed, hb_Planck, G_gravitional_constant, k_Boltzman, _base_1A, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (god_given, c_lightspeed, hb_Planck, G_gravitional_constant, _base_1A, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (stoney, c_lightspeed, G_gravitional_constant, ke_Comloub, e_charge, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (natural, c_lightspeed, hb_Planck, me_mass, ep0_permittivity, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (gauss, 0.01L *_base_1m, _base_1s, 0.001L *_base_1kg, ke_Comloub, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (rydberg, hb_Planck, 2 *me_mass, e_charge *e_charge/2, ke_Comloub, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (hartree, hb_Planck, me_mass, e_charge, ke_Comloub, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (ghartree, hb_Planck, me_mass, e_charge, ke_Comloub, k_Boltzman, N_Avagadro, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (quantum_chromo_dynamics, c_lightspeed, hb_Planck, mp_mass, e_charge, _base_1K, _base_1mol, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (au_test, hb_Planck, me_mass, e_charge, ke_Comloub, k_Boltzman, N_Avagadro, _base_1cd) |
|
| PHYS_DEFINE_UNITSYS_NAMESPACE (amu, hb_Planck, me_mass, e_charge, ke_Comloub, _base_1K, _base_1mol, _base_1cd) |
|
|
const int | dimension7_size = 7 |
| dimension7 is provided as compile-time dimensional tools
|
|
const std::map< const dimension7, const std::string > | description |
|
static const std::map< std::string, real_precision > | uval_prefix |
|
static const std::map< std::string, uval > | uval_names |
|
static CONSTTYPE real_precision | au_2_amu = unitsys::conv(au::unit, amu_mass) |
| 1mea means we measure a quantity at 1*N level.
|
|
static CONSTTYPE real_precision | au_2_ang = unitsys::conv(au::unit, 1e-10L * _base_1m) |
|
static CONSTTYPE real_precision | au_2_ev = unitsys::conv(au::unit, e_charge* _base_1V) |
|
static CONSTTYPE real_precision | au_2_J_1mea = unitsys::conv(au::unit, _base_1J / _base_1mol) * au::N |
|
static CONSTTYPE real_precision | au_2_kcal_1mea = unitsys::conv(au::unit, 1e+3L * _nostd_1cal / _base_1mol) * au::N |
|
static CONSTTYPE real_precision | au_2_g_1mea = unitsys::conv(au::unit, 1e-3L * _base_1kg / _base_1mol) * au::N |
|
static CONSTTYPE real_precision | au_2_wn = unitsys::conv(au::unit, h_Planck* c_lightspeed / (0.01L * _base_1m)) |
|
static CONSTTYPE real_precision | au_2_fs = unitsys::conv(au::unit, 1e-15L * _base_1s) |
|
static CONSTTYPE real_precision | au_2_ps = unitsys::conv(au::unit, 1e-12L * _base_1s) |
|
static CONSTTYPE real_precision | au_2_K = unitsys::conv(au::unit, _base_1K) |
|
static CONSTTYPE real_precision | au_2_angoverps = au_2_ang / au_2_ps |
|
|
constexpr dimension7 | dimensionless_d {{}} |
| [1]
|
|
constexpr dimension7 | length_d {{1, 0, 0, 0, 0, 0, 0}} |
| [L]
|
|
constexpr dimension7 | time_d {{0, 1, 0, 0, 0, 0, 0}} |
| [T]
|
|
constexpr dimension7 | mass_d {{0, 0, 1, 0, 0, 0, 0}} |
| [M]
|
|
constexpr dimension7 | electric_current_d {{0, 0, 0, 1, 0, 0, 0}} |
| [I]
|
|
constexpr dimension7 | thermodynamic_temperature_d {{0, 0, 0, 0, 1, 0, 0}} |
| [Q]
|
|
constexpr dimension7 | amount_of_substance_d {{0, 0, 0, 0, 0, 1, 0}} |
| [N]
|
|
constexpr dimension7 | luminous_intensity_d {{0, 0, 0, 0, 0, 0, 1}} |
| [J]
|
|
constexpr dimension7 | current_d = electric_current_d |
|
constexpr dimension7 | temperature_d = thermodynamic_temperature_d |
|
constexpr dimension7 | amount_d = amount_of_substance_d |
|
constexpr dimension7 | none_d = dimensionless_d |
|
|
constexpr dimension7 | distance_d = length_d |
|
constexpr dimension7 | wavelength_d = length_d |
|
constexpr dimension7 | wave_number_d {{-1, 0, 0}} |
| [L^-1]
|
|
constexpr dimension7 | area_d {{2, 0, 0}} |
| [L^2]
|
|
constexpr dimension7 | volume_d {{3, 0, 0}} |
| [L^3]
|
|
|
constexpr dimension7 | frequency_d {{0, -1, 0}} |
| [T^-1]
|
|
constexpr dimension7 | angular_velocity_d {{0, -1, 0}} |
| [T^-1]
|
|
constexpr dimension7 | angular_acceleration_d {{0, -2, 0}} |
| [T^-2]
|
|
constexpr dimension7 | activity_of_a_nuclide_d = frequency_d |
|
|
constexpr dimension7 | speed_d {{1, -1, 0}} |
| [L*T^-1]
|
|
constexpr dimension7 | acceleration_d {{1, -2, 0}} |
| [L*T^-2]
|
|
constexpr dimension7 | jerk_d {{1, -3, 0}} |
| [L*T^-3]
|
|
constexpr dimension7 | jounce_d {{1, -4, 0}} |
| [L*T^-4]
|
|
constexpr dimension7 | crackle_d {{1, -5, 0}} |
| [L*T^-5]
|
|
constexpr dimension7 | pop_d {{1, -6, 0}} |
| [L*T^-6]
|
|
constexpr dimension7 | absement_d {{1, 1, 0}} |
| [L*T]
|
|
constexpr dimension7 | area_flow_rate_d {{2, -1, 0}} |
| [L^2*T^-1]
|
|
constexpr dimension7 | volume_flow_rate_d {{3, -1, 0}} |
| [L^3*T^-1]
|
|
constexpr dimension7 | kinematic_viscosity_d = area_flow_rate_d |
| [L^2*T^-1] = viscosity / density
|
|
constexpr dimension7 | thermal_diffusivity_d |
| [L^2*T^-1] = thermal_conductivity / (specific_heat_capacity * density)
|
|
constexpr dimension7 | specific_energy_d {{2, -2, 0}} |
| [L^2/T^2] (count) energy per mass
|
|
constexpr dimension7 | dose_equivalent_d = specific_energy_d |
| [L^2/T^2] (radiation) energy per mass
|
|
constexpr dimension7 | absorbed_dose_d = specific_energy_d |
| [L^2/T^2] (radiation) energy per mass
|
|
constexpr dimension7 | absorbed_dose_rate_d {{2, -3, 0}} |
| [L^2/T^3] (radiation) power per mass
|
|
constexpr dimension7 | substance_permeability_d {{-1, 1, 0}} |
| [L^-1*T]
|
|
|
constexpr dimension7 | inertia_d {{2, 0, 1}} |
| [M*L^2]
|
|
constexpr dimension7 | mass_line_density_d {{-1, 0, 1}} |
| [M/L] mass per line
|
|
constexpr dimension7 | mass_area_density_d {{-2, 0, 1}} |
| [M/L^2] mass per area
|
|
constexpr dimension7 | mass_density_d {{-3, 0, 1}} |
| [M/L^3] mass per volume
|
|
constexpr dimension7 | specific_volume_d {{3, 0, -1}} |
| [L^3/M] volume per mass
|
|
constexpr dimension7 | mass_flow_rate_d {{0, -1, 1}} |
| [M/T] mass per time
|
|
constexpr dimension7 | mass_flow_acceleration_d {{0, -2, 1}} |
| [M/T^2] mass per per time
|
|
constexpr dimension7 | mass_flow_jerk_d {{0, -3, 1}} |
| [M/T^3] mass per per per time
|
|
constexpr dimension7 | force_d {{1, -2, 1}} |
| [M*L/T^2] mass times acceleration
|
|
constexpr dimension7 | momentum_d {{1, -1, 1}} |
| [M*L/T] force integrate time
|
|
constexpr dimension7 | energy_d {{2, -2, 1}} |
| [M*L^2/T^2] force integrate length
|
|
constexpr dimension7 | moment_of_force_d = energy_d |
| [M*L^2/T^2] force cross length
|
|
constexpr dimension7 | torque_d = moment_of_force_d |
|
constexpr dimension7 | angular_momentum_d {{2, -1, 1}} |
| [M*L^2/T] torque integrate time
|
|
constexpr dimension7 | action_d = angular_momentum_d |
| [M*L^2/T] energy integrate time
|
|
constexpr dimension7 | inv_ener_d {{-2, 2, -1}} |
| [M^-1*L^-2*T^2], inversed energy, such as 1/(kB * T)
|
|
constexpr dimension7 | power_d {{2, -3, 1}} |
| [M*L^2/T^3] energy per time
|
|
constexpr dimension7 | energy_density_d {{-1, -2, 1}} |
| [M/L/T^2] energy per volume
|
|
constexpr dimension7 | pressure_d = energy_density_d |
| [M/L/T^2] energy per volume = force per area
|
|
constexpr dimension7 | surface_tension_d = mass_flow_acceleration_d |
| [M/T^2] energy per area
|
|
constexpr dimension7 | energy_line_density_d {{1, -2, 1}} |
| [M/L/T^2] energy per line
|
|
constexpr dimension7 | power_density_d {{-1, -3, 1}} |
| [M/L/T^3] power per volume
|
|
constexpr dimension7 | power_area_density_d = mass_flow_jerk_d |
| [M/T^3] power per area
|
|
constexpr dimension7 | dynamic_viscosity_d {{-1, -1, 1}} |
| [M/L/T] force / (area * gradient(velocity))
|
|
constexpr dimension7 | heat_flow_rate_d = power_d |
| [M/L/T^3] (heat) energy per time
|
|
constexpr dimension7 | heat_density_d = mass_flow_acceleration_d |
| [M/T^2] (heat flow) energy per area
|
|
constexpr dimension7 | heat_density_flow_rate_d = power_area_density_d |
| [M/T^3] (heat flow) energy per area per time
|
|
constexpr dimension7 | heat_flux_density_d = power_area_density_d |
| [M/T^3] (heat) energy per time per area
|
|
constexpr dimension7 | radiant_intensity_d = power_d |
| [M/L/T^3] (radiation) energy per time
|
|
constexpr dimension7 | radiance_d = power_area_density_d |
| [M/T^3] (radiation) power per area
|
|
constexpr dimension7 | irradiance_d = power_area_density_d |
| [M/T^3] (radiation) power per area
|
|
|
constexpr dimension7 | current_density_d {{-2, 0, 0, 1}} |
| [I/L^2] current per area
|
|
constexpr dimension7 | electric_charge_d {{0, 1, 0, 1}} |
| [I*T] current integrate time
|
|
constexpr dimension7 | electric_charge_density_d {{-3, 1, 0, 1}} |
| [I/L^3*T] charge per volume
|
|
constexpr dimension7 | electric_area_charge_density_d {{-2, 1, 0, 1}} |
| [I/L^2*T] charge per area
|
|
constexpr dimension7 | electric_line_charge_density_d {{-1, 1, 0, 1}} |
| [I/L*T] charge per line
|
|
constexpr dimension7 | electric_dipole_moment_d {{1, 1, 0, 1}} |
| [I*L*T] charge times length
|
|
constexpr dimension7 | electric_flux_density_d = electric_area_charge_density_d |
| [I/L^2*T]
|
|
constexpr dimension7 | electric_displacement_field_d = electric_area_charge_density_d |
| [I/L^2*T], D
|
|
constexpr dimension7 | electric_polarization_field_d |
| [I/L^2*T], P = dipole moment pe volume
|
|
constexpr dimension7 | magnetic_moment_d {{2, 0, 0, 1}} |
| [I*L^2] current integrate area
|
|
constexpr dimension7 | magnetic_field_strength_d {{-1, 0, 0, 1}} |
| [I/L] magnetic moment per volume
|
|
constexpr dimension7 | magnetization_d = magnetic_field_strength_d |
| [I/L] magnetic moment per volume
|
|
constexpr dimension7 | electric_potential_d {{2, -3, 1, -1}} |
| [M*L^2/T^3/I] energy per charge
|
|
constexpr dimension7 | electric_field_strenth_d {{1, -3, 1, -1}} |
| [M*L/T^3/I] electric potential per length
|
|
constexpr dimension7 | electric_resistance_d {{2, -3, 1, -2}} |
| [M*L^2/T^3/I^2] electric potential versus current
|
|
constexpr dimension7 | electric_conductance_d {{-2, 3, -1, 2}} |
| [M^-1*L^-2*T^3*I^2] = 1 / electric_resistance
|
|
constexpr dimension7 | electric_resistivity_d {{3, -3, 1, -2}} |
| [M*L^3/T^3/I^2] electric_resistance time length
|
|
constexpr dimension7 | electric_conductivity_d {{-3, 3, -1, 2}} |
| [M^-1*L^-3*T^3*I^2] 1 / electric_resistivity
|
|
constexpr dimension7 | electric_capacitance_d {{-2, 4, -1, 2}} |
| [M^-1*L^-2*T^4*I^2] charge versus electric potential
|
|
constexpr dimension7 | magnetic_flux_d {{2, -2, 1, -1}} |
| [M*L^2/T^2/I] energy per current = E/I = B*S
|
|
constexpr dimension7 | magnetic_flux_density_d |
| [M*T^-2/I] B = electric_field_strenth_d versus velocity
|
|
constexpr dimension7 | inductance_d {{2, -2, 1, -2}} |
| [M*L^2/T^2/I^2] magnetic flux versus current, L
|
|
constexpr dimension7 | electric_chargme_mass_ratio_d {{0, 1, -1, 1}} |
| [M^-1*T*I]
|
|
constexpr dimension7 | magnetic_permeability_d {{1, -2, 1, -2}} |
| [M*L/T^2/I^2], mu
|
|
constexpr dimension7 | permittivity_d {{-3, 4, -1, 2}} |
| [M^-1*L^-2*T^4*I^2], epsilon
|
|
|
constexpr dimension7 | inv_temp_d {{0, 0, 0, 0, -1}} |
|
constexpr dimension7 | heat_capacity_d {{2, -2, 1, 0, -1}} |
| [M*L^2/T^2/Q] energy per temperature
|
|
constexpr dimension7 | entropy_d = heat_capacity_d |
| [M*L^2/T^2/Q] energy per temperature
|
|
constexpr dimension7 | heat_transfer_coefficient_d |
| [M/T^3/Q] heat_flux_density versus temperature
|
|
constexpr dimension7 | specific_heat_capacity_d {{2, -2, 0, 0, -1}} |
| [L^2/T^2/Q] capacity per mass
|
|
constexpr dimension7 | thermal_conductivity_d {{1, -3, 1, 0, -1}} |
| [M*L/T^3/Q]
|
|
constexpr dimension7 | thermal_insulance_d {{0, 3, -1, 0, 1}} |
| [M^-1*T^3*Q] = 1 / heat_transfer_coefficient
|
|
constexpr dimension7 | thermal_resistance_d {{-2, 3, -1, 0, 1}} |
| [M^-1*L^-2*T^3*Q]
|
|
constexpr dimension7 | thermal_resistivity_d {{-1, 3, -1, 0, 1}} |
| [M^-1*L^-1*T^3*Q]
|
|
|
constexpr dimension7 | concentration_d {{-3, 0, 0, 0, 0, 1}} |
| [N/L^3] amount per volume
|
|
constexpr dimension7 | molar_energy_d {{2, -2, 1, 0, 0, -1}} |
| [M*L^2/T^2/N] energy per amount
|
|
constexpr dimension7 | molar_entropy_d {{2, -2, 1, 0, -1, -1}} |
| [M*L^2/T^2/Q/N] entropy per amount
|
|
|
constexpr dimension7 | luminous_flux_d = luminous_intensity_d |
| [J]
|
|
constexpr dimension7 | illuminance_d {{-2, 0, 0, 0, 0, 0, 1}} |
| [J/L^2] luminous_intensity per area
|
|
constexpr dimension7 | luminance_d = illuminance_d |
| [J/L^2] luminous_intensity per area
|
|