|
const double | squared_barrier_factor (unsigned l, double z) |
|
bool | operator== (const CachedValue::Status &S, const CalculationStatus &s) |
| equality operator for checking the CalculationStatus
|
|
bool | operator!= (const CachedValue::Status &S, const CalculationStatus &s) |
| inequality operator for checking the CalculationStatus
|
|
bool | operator== (const CachedValue::Status &S, const VariableStatus &s) |
| equality operator for checking the VariableStatus
|
|
bool | operator!= (const CachedValue::Status &S, const VariableStatus &s) |
| inequality operator for checking the VariableStatus
|
|
std::string | to_string (const CachedValue::Status &S) |
| streaming operator for CachedValue::Status
|
|
std::string | to_string (const CalculationStatus &c) |
|
template<typename T , size_t N> |
std::string | to_string (const CoordinateSystem< T, N > &C) |
|
template<typename T , size_t N> |
const CoordinateSystem< T, N > | unit (const CoordinateSystem< T, N > &C) |
|
template<typename T , size_t N> |
const CoordinateSystem< T, N > | operator* (const SquareMatrix< T, N > &M, const CoordinateSystem< T, N > &C) |
|
void | remove_expired (DataAccessorSet &S) |
| remove expired elements of set
|
|
const DataIterator | operator+ (DataIterator lhs, DataIterator::difference_type n) |
| addition operator
|
|
const DataIterator | operator+ (DataIterator::difference_type n, const DataIterator &rhs) |
| addition operator
|
|
const DataIterator | operator- (const DataIterator &lhs, DataIterator::difference_type n) |
| subraction operator
|
|
const bool | operator<= (const DataIterator &lhs, const DataIterator &rhs) |
| less-than-or-equal operator
|
|
const bool | operator>= (const DataIterator &lhs, const DataIterator &rhs) |
| greater-than-or-equal operator
|
|
const bool | operator!= (const DataIterator &lhs, const DataIterator &rhs) |
| inequality operator
|
|
const int | charge (const DecayChannel &dc) |
|
std::string | to_string (const DecayChannel &dc) |
| convert to string
|
|
std::ostream & | operator<< (std::ostream &os, const DecayChannel &dc) |
| << operator
|
|
std::string | to_string (const DecayTreeVectorMap &m_dtv_map) |
| convert to (multiline) string
|
|
DecayTreeSet | decay_trees (const DecayingParticle &dp) |
|
template<typename Last , typename... Predicates> |
DecayTreeSet | decay_trees (const DecayingParticle &dp, Last p, Predicates...P) |
|
template<typename Last , typename... Predicates> |
DecayTreeSet::value_type | decay_tree (const DecayingParticle &dp, Last p, Predicates...P) |
|
FreeAmplitudeSet | free_amplitudes (const DecayingParticle &dp) |
|
template<typename Last , typename... UnaryPredicates> |
FreeAmplitudeSet | free_amplitudes (const DecayingParticle &dp, Last p, UnaryPredicates...P) |
|
template<typename Last , typename... UnaryPredicates> |
FreeAmplitudeSet::value_type | free_amplitude (const DecayingParticle &dp, Last p, UnaryPredicates...P) |
|
ParticleSet | particles (DecayingParticle &dp) |
|
template<typename Last , typename... UnaryPredicates> |
DecayChannelSet | decay_channels (const DecayingParticle &dp, Last p, UnaryPredicates...P) |
|
template<typename Last , typename... UnaryPredicates> |
DecayChannelSet::value_type | decay_channel (const DecayingParticle &dp, Last p, UnaryPredicates...P) |
|
std::string | to_string (const DecayTree &dt, std::string offset="") |
| convert to (multiline) string
|
|
std::string | to_string (const DecayTreeVector &dtv) |
| convert to (mutliline string)
|
|
bool | operator== (const DecayTree &lhs, const DecayTree &rhs) |
| equality operator
|
|
unsigned | depth (const DecayTree &DT) |
|
const std::complex< double > | amplitude (const DecayTree &dt, const DataPoint &d) |
|
const std::complex< double > | amplitude (const DecayTree &dt, const DataPoint &d, const std::shared_ptr< ParticleCombination > &pc) |
|
const std::complex< double > | amplitude (const DecayTreeVector &dtv, const DataPoint &d) |
|
const double | intensity (const DecayTreeVector &dtv, const DataPoint &d) |
|
FreeAmplitudeSet | free_amplitudes (const DecayTree &DT) |
|
FreeAmplitudeSet | free_amplitudes (const DecayTreeVector &DTV) |
|
const bool | has_changed (const std::shared_ptr< DecayTree > &dt) |
|
const DecayTreeVector | select_changed (const DecayTreeVector &dtv) |
|
const RealIntegralElement | integral (const DecayTreeVectorIntegral &dtvi) |
|
const ComplexIntegralElementMatrix | cached_integrals (const DecayTreeVectorIntegral &dtvi) |
|
const ComplexIntegralElementMatrix | integrals (const DecayTreeVectorIntegral &dtvi) |
|
const RealIntegralElementVector | diagonal_integrals (const DecayTreeVectorIntegral &dtvi) |
|
const RealIntegralElementVector | fit_fractions (const DecayTreeVectorIntegral &dtvi) |
|
template<typename container > |
container::value_type | lone_elt (container &C) |
|
template<typename container > |
container::value_type | lone_elt (container &&C) |
|
template<typename T , typename Last , typename... UnaryPredicates> |
std::set< std::shared_ptr< T > > | filter (const std::set< std::shared_ptr< T > > &S, Last p, UnaryPredicates...P) |
|
template<typename T > |
const std::set
< std::shared_ptr< T > > & | filter (const std::set< std::shared_ptr< T > > &S) |
|
template<class F , typename T > |
const bool | by_ptr (const F &f, const std::shared_ptr< T > &ptr) |
|
template<class F , typename T > |
const bool | by_ptr (const F &f, const T *ptr) |
|
bool | valid_final_state (const std::shared_ptr< ParticleCombination > &pc, const FinalStateParticleVector &FSPs) |
|
std::vector< FourVector< double > > | calculate_four_momenta (double initial_mass, const FinalStateParticleVector &FPSs, const MassAxes &axes, const std::vector< double > &squared_masses) |
|
std::vector< FourVector< double > > | calculate_four_momenta (double initial_mass, const Model &M, const MassAxes &axes, const std::vector< double > &squared_masses) |
|
template<typename T > |
constexpr ThreeVector< T > | vect (const FourVector< T > &V) noexcept |
|
template<typename T > |
constexpr ThreeVector< T > | boost (const FourVector< T > &V) |
|
template<typename T > |
constexpr FourVector< T > | operator- (const FourVector< T > &V) |
|
template<typename T > |
const std::vector< FourVector
< T > > | operator- (const std::vector< FourVector< T > > &V) |
|
template<typename T > |
constexpr FourVector< T > | operator* (const FourMatrix< T > &R, const FourVector< T > &V) |
| multiply a 4x4 matrix times a FourVector
|
|
template<typename T > |
const std::vector< FourVector
< T > > | operator* (const FourMatrix< T > &R, const std::vector< FourVector< T > > &V) |
| multiply a 4x4 matrix times each of a vector of FourVector's
|
|
template<typename T > |
constexpr FourVector< T > | operator* (const ThreeMatrix< T > &R, const FourVector< T > &V) |
| apply a three-rotation to a FourVector (rotating only the spatial components)
|
|
template<typename T > |
const std::vector< FourVector
< T > > | operator* (const ThreeMatrix< T > &R, const std::vector< FourVector< T > > &V) |
| multiply a 3x3 matrix times the spacial components of each of a vector of FourVector's
|
|
template<typename T > |
const CoordinateSystem< T, 3 > | helicityFrame (const FourVector< T > &V, const CoordinateSystem< T, 3 > &C) |
|
std::string | to_string (const FreeAmplitude &fa) |
| convert to string
|
|
template<typename T > |
CoordinateSystem< T, 3 > | helicityFrame (const ThreeVector< T > &V, const CoordinateSystem< T, 3 > &C) |
|
template<typename T > |
const IntegralElement< T > | operator+ (IntegralElement< T > A, const IntegralElement< T > &B) |
|
template<typename T > |
const IntegralElement< T > | operator- (IntegralElement< T > A, const IntegralElement< T > &B) |
|
template<typename T > |
const IntegralElement< T > | operator* (IntegralElement< T > A, const IntegralElement< T > &B) |
|
template<typename T > |
const IntegralElement< T > | operator/ (IntegralElement< T > A, const IntegralElement< T > &B) |
|
template<typename T > |
std::string | to_string (const IntegralElement< T > &a) |
|
void | disableLogs (el::Level lvl) |
|
void | plainLogs (el::Level lvl) |
|
template<typename T > |
const FourMatrix< T > | lorentzTransformation (const ThreeMatrix< T > &R) |
|
template<typename T > |
const FourMatrix< T > | lorentzTransformation (const FourVector< T > &V) |
|
template<typename T > |
constexpr FourMatrix< T > | lorentzTransformation (const ThreeVector< T > &V) |
|
template<typename T > |
constexpr FourMatrix< T > | lorentzTransformation (const std::vector< FourVector< T > > &fourVecs) |
|
template<typename T > |
constexpr FourMatrix< T > | lorentzTransformation (const ThreeMatrix< T > &R, const FourVector< T > &V) |
|
template<typename T > |
constexpr FourMatrix< T > | lorentzTransformation (const ThreeMatrix< T > &R, const ThreeVector< T > &V) |
|
template<typename T > |
constexpr FourMatrix< T > | lorentzTransformation (const FourVector< T > &V, const ThreeMatrix< T > R) |
|
template<typename T > |
constexpr FourMatrix< T > | lorentzTransformation (const ThreeVector< T > &V, const ThreeMatrix< T > &R) |
|
std::string | to_string (const MassAxes &A) |
| convert to string
|
|
const MassRange | mass_range (double isp_mass, const std::shared_ptr< ParticleCombination > &pc, const FinalStateParticleVector &FSPs) |
|
const std::vector< MassRange > | mass_range (double isp_mass, const MassAxes &A, const FinalStateParticleVector &FSPs) |
|
const MassRange | squared (MassRange mr) |
|
const std::vector< MassRange > | squared (std::vector< MassRange > mr) |
|
constexpr bool | is_odd (int val) |
| Math Utilities. More...
|
|
constexpr bool | is_even (int val) |
|
template<typename T > |
std::enable_if< std::is_signed
< T >::value, T >::type
constexpr | signum (const T &val) |
| extracts sign from value
|
|
constexpr int | pow_negative_one (int exponent) |
| optimized function for (-1)^n
|
|
template<typename T , size_t R, size_t C> |
std::string | to_string (const Matrix< T, R, C > &M) |
|
template<typename T , size_t N> |
const SquareMatrix< T, N > | zeroMatrix () |
| zero square matrix
|
|
template<typename T , size_t R, size_t C> |
const Matrix< T, R, C > | zeroMatrix () |
| zero matrix
|
|
template<typename T , size_t N> |
const SquareMatrix< T, N > | unitMatrix () |
| unit matrix
|
|
template<typename T , size_t N> |
const SquareMatrix< T, N > | diagonalMatrix (std::array< T, N > d) |
| diagonal matrix
|
|
template<typename T , size_t N> |
const SquareMatrix< T, N > | symmetricMatrix (std::initializer_list< T > elements) |
|
template<typename T , size_t R, size_t C> |
const Matrix< T, C, R > | transpose (const Matrix< T, R, C > &M) |
| transpose a matrix
|
|
template<typename T , size_t R, size_t C> |
const Matrix< T, C, R > | operator- (const Matrix< T, R, C > &M) |
| unary minus
|
|
template<typename T , size_t R, size_t K, size_t C> |
std::enable_if< (R!=1) or(C!=1),
Matrix< T, R, C > >::type
const | operator* (const Matrix< T, R, K > &A, const Matrix< T, K, C > &B) |
| matrix multiplication
|
|
template<typename T1 , typename T2 , size_t R, size_t K, size_t C> |
auto | operator* (const Matrix< T1, R, K > &A, const Matrix< T2, K, C > &B) -> const typename std::enable_if< (R!=1) or(C!=1), Matrix< typename std::remove_cv< decltype(operator*(A[0][0], B[0][0]))>::type, R, C > >::type |
|
template<typename T , size_t K> |
const T | operator* (const Matrix< T, 1, K > &A, const Matrix< T, K, 1 > &B) |
| matrix multiplication yielding single value
|
|
template<typename T , size_t R, size_t C> |
Matrix< T, R, C > & | operator*= (Matrix< T, R, C > &M, const T &c) |
| assignment by multiplication by a single element
|
|
template<typename T1 , typename T2 , size_t R, size_t C> |
Matrix< T2, R, C > & | operator*= (Matrix< T2, R, C > &M, const T1 &c) |
| assignment by multiplication by a single element with different template types
|
|
template<typename T , size_t R, size_t C> |
const Matrix< T, R, C > | operator* (const T &c, const Matrix< T, R, C > &M) |
| multiplication by a single element
|
|
template<typename T1 , typename T2 , size_t R, size_t C> |
const Matrix< T2, R, C > | operator* (const T1 &c, const Matrix< T2, R, C > &M) |
| multiplication by a single element with different template types
|
|
template<typename T1 , typename T2 , size_t R, size_t C> |
const Matrix< T2, R, C > | operator* (const Matrix< T1, R, C > &M, const T2 &c) |
| multiplication by a single element with different template types
|
|
template<typename T , size_t R, size_t C> |
Matrix< T, R, C > & | operator+= (Matrix< T, R, C > &lhs, const Matrix< T, R, C > &rhs) |
| addition assignment
|
|
template<typename T , size_t R, size_t C> |
const Matrix< T, R, C > | operator+ (const Matrix< T, R, C > &lhs, const Matrix< T, R, C > &rhs) |
| addition
|
|
template<typename T , size_t R, size_t C> |
Matrix< T, R, C > & | operator-= (Matrix< T, R, C > &lhs, const Matrix< T, R, C > &rhs) |
| subtraction assignment
|
|
template<typename T , size_t R, size_t C> |
const Matrix< T, R, C > | operator- (const Matrix< T, R, C > &lhs, const Matrix< T, R, C > &rhs) |
| subtraction
|
|
template<typename T , size_t N> |
const SquareMatrix< T, N-1 > | minor_matrix (const SquareMatrix< T, N > &M, size_t r, size_t c) |
|
template<typename T , size_t N> |
const T | minor_det (const SquareMatrix< T, N > &M, size_t r, size_t c) |
|
template<typename T , size_t N> |
const T | cofactor (const SquareMatrix< T, N > &M, size_t r, size_t c) |
|
template<typename T , size_t N> |
const T | det (SquareMatrix< T, N > M) |
|
template<typename T , size_t M, size_t N> |
const SquareMatrix< T, M > | diagonal_minor (const SquareMatrix< T, N > m, std::vector< size_t > indices) |
| diagonal minor matrix
|
|
template<typename T , size_t N> |
const T | trace (const SquareMatrix< T, N > &M) |
| trace
|
|
constexpr double | squared_breakup_momentum (double m2_R, double m_a, double m_b) |
|
std::string | to_string (const AdmixtureMap &mix) |
|
const bool | decays_to_full_final_state (const Particle &p) |
|
std::vector< std::shared_ptr
< DecayingParticle > > | full_final_state_isp (const Model &M) |
|
const double | intensity (const InitialStateParticleMap::value_type &isp_mix, const DataPoint &d) |
|
const double | intensity (const InitialStateParticleMap &isp_map, const DataPoint &d) |
|
const double | sum_of_log_intensity (const Model &M, DataPartition &D, double ped=0) |
|
const double | sum_of_log_intensity (const Model &M, DataPartitionVector &DP, double ped=0) |
|
FreeAmplitudeSet | free_amplitudes (const Model &M) |
|
template<typename Last , typename... UnaryPredicates> |
FreeAmplitudeSet | free_amplitudes (const Model &M, Last p, UnaryPredicates...P) |
|
template<typename Last , typename... UnaryPredicates> |
FreeAmplitudeSet::value_type | free_amplitude (const Model &M, Last p, UnaryPredicates...P) |
|
ParticleSet | particles (const Model &M) |
|
template<typename Last , typename... UnaryPredicates> |
ParticleSet | particles (const Model &M, Last p, UnaryPredicates...P) |
|
template<typename Last , typename... UnaryPredicates> |
ParticleSet::value_type | particle (const Model &M, Last p, UnaryPredicates...P) |
|
const RealIntegralElement | integral (const ModelIntegral &MI) |
|
template<typename IterType > |
constexpr VariableStatus | variable_status (IterType first, IterType last) |
|
template<typename T > |
std::string | to_string (const Parameter< T > &P) |
|
const size_t | size (const ParameterVector &V) |
|
template<class InputIt > |
std::vector< double >
::const_iterator | set_value (ParameterBase &P, InputIt first) |
|
template<class InputIt > |
void | set_values (ParameterVector::iterator first_par, ParameterVector::iterator last_par, InputIt first_val, InputIt last_val) |
| set values in ParameterVector from iterators
|
|
void | set_values (ParameterVector &pars, const std::vector< double > &vals) |
| set values in ParameterVector from values in vector<double>
|
|
const SpinVector | spins (const ParticleVector &v) |
|
std::string | to_string (const Particle &p) |
| convert to string
|
|
std::string | to_string (const ParticleVector &p) |
| convert to string
|
|
std::ostream & | operator<< (std::ostream &os, const Particle &p) |
| streamer
|
|
bool | disjoint (const ParticleCombinationVector &pcv) |
|
const bool | is_final_state_particle_combination (const ParticleCombination &pc) |
|
const ParticleCombination & | origin (const ParticleCombination &pc) |
|
const bool | is_initial_state_particle_combination (const ParticleCombination &pc, const Model &m) |
|
const bool | is_from_initial_state_particle_combination (const ParticleCombination &pc, const Model &m) |
|
void | prune_particle_combinations (ParticleCombinationSet &PCs) |
| only keep particleCombinations with the highest number of indices in their top-most parent
|
|
std::string | indices_string (const ParticleCombination &pc, std::string before="(", std::string after=")") |
| Get indices listed as string.
|
|
std::string | to_string (const ParticleCombination &pc) |
| convert ParticleCombination to string
|
|
std::string | to_string_with_parent (const ParticleCombination &pc) |
| convert ParticleCombination with top-most parent to string
|
|
std::ostream & | operator<< (std::ostream &os, const ParticleCombination &PC) |
| streamer
|
|
const bool | operator!= (const PDLIterator &lhs, const PDLIterator &rhs) |
| inequality operator
|
|
ParticleFactory | read_pdl_file (const std::string &filename) |
|
std::vector< std::vector
< size_t > > | combinations (size_t N, size_t n, const std::vector< std::vector< size_t > > &C=std::vector< std::vector< size_t > >()) |
|
template<typename T , size_t N> |
T | delta (const SquareMatrix< T, N > &M, size_t l) |
|
template<typename T , size_t N> |
bool | check_deltas (const SquareMatrix< T, N > &M) |
|
template<class Generator > |
const std::vector< FourVector
< double > > | phsp (const Model &M, double initial_mass, const MassAxes &A, const std::vector< MassRange > &R2, Generator &g, unsigned max_attempts) |
|
bool | operator== (const QuantumNumbers &lhs, const QuantumNumbers &rhs) |
| equality operator
|
|
bool | operator!= (const QuantumNumbers &lhs, const QuantumNumbers &rhs) |
| inequality operator
|
|
std::string | to_string (const QuantumNumbers &Q) |
| convert to string
|
|
std::string | debug_string (const QuantumNumbers &Q) |
| convert to string
|
|
std::ostream & | operator<< (std::ostream &os, const QuantumNumbers &Q) |
| Overload << operator.
|
|
template<typename T > |
const ThreeMatrix< T > | rotation (const ThreeVector< T > &V, const T &theta) |
|
template<typename T > |
const ThreeMatrix< T > | eulerRotationZXZ (const CoordinateSystem< T, 3 > &C, const T &alpha, const T &beta, const T &gamma) |
|
template<typename T > |
const ThreeMatrix< T > | eulerRotationZYZ (const CoordinateSystem< T, 3 > &C, const T &alpha, const T &beta, const T &gamma) |
|
std::string | spin_to_string (int twoJ) |
| convert 2*J to string (e.g. 1/2, 1, 3/2, etc.)
|
|
std::string | to_string (const SpinVector &two_j) |
| convert SpinVector to string
|
|
std::string | to_string (const SpinProjectionVector &two_m) |
| convert SpinVector to string
|
|
constexpr bool | triangle (unsigned two_a, unsigned two_b, unsigned two_c) |
|
constexpr bool | conserves (unsigned two_J, unsigned two_j1, unsigned two_j2, int l) |
|
const SpinProjectionVector | projections (unsigned two_j) |
|
const std::vector
< SpinProjectionVector > | projections (const SpinVector &two_J) |
|
std::string | to_string (const SpinAmplitude &sa) |
| convert to string
|
|
std::ostream & | operator<< (std::ostream &os, const SpinAmplitude &sa) |
| << operator
|
|
std::string | to_string (const SpinAmplitudeVector &saV) |
| convert to string
|
|
void | remove_expired (StaticDataAccessorVector &S) |
| remove expired elements of set
|
|
template<typename T > |
constexpr ThreeVector< T > | cross (const ThreeVector< T > &A, const ThreeVector< T > &B) noexcept |
|
template<typename T > |
constexpr SquareMatrix< T, 3 > | skewSymmetric (const ThreeVector< T > V) noexcept |
| skew symmetric matrix formed from a 3 vector
|
|
std::string | to_string (const VariableStatus &s) |
|
template<typename T , size_t N> |
const VectorIterator< T, N > | operator+ (VectorIterator< T, N > a, typename VectorIterator< T, N >::difference_type n) |
| addition operator
|
|
template<typename T , size_t N> |
const VectorIterator< T, N > | operator+ (typename VectorIterator< T, N >::difference_type n, VectorIterator< T, N > a) |
| addition operator
|
|
template<typename T , size_t N> |
const VectorIterator< T, N > | operator- (VectorIterator< T, N > a, typename VectorIterator< T, N >::difference_type n) |
| subtraction operator
|
|
template<typename T , size_t N> |
bool | operator>= (VectorIterator< T, N > a, VectorIterator< T, N > b) |
| greater-than-or-equal operator
|
|
template<typename T , size_t N> |
bool | operator<= (VectorIterator< T, N > a, VectorIterator< T, N > b) |
| less-than-or-equal operator
|
|
template<typename T , size_t N, typename E1 , typename E2 > |
constexpr VectorAddition< T, N,
E1, E2 > | operator+ (const VectorExpression< T, N, E1 > &a, const VectorExpression< T, N, E2 > &b) |
| addition of two vectors
|
|
template<typename T , size_t N, typename E1 , typename E2 > |
constexpr VectorSubtraction< T,
N, E1, E2 > | operator- (const VectorExpression< T, N, E1 > &a, const VectorExpression< T, N, E2 > &b) |
| subtraction of two vectors
|
|
template<typename T , size_t N> |
std::string | to_string (const Vector< T, N > &V) |
|
template<typename T , size_t N> |
std::ostream & | operator<< (std::ostream &os, const Vector< T, N > &V) |
| streamer
|
|
template<typename T , size_t N> |
Vector< T, N > & | operator+= (Vector< T, N > &A, const Vector< T, N > &B) |
| addition assignment
|
|
template<typename T , size_t N> |
constexpr Vector< T, N > | operator- (const Vector< T, N > &V) |
| unary minus
|
|
template<typename T , size_t N> |
Vector< T, N > & | operator-= (Vector< T, N > &A, const Vector< T, N > &B) |
| subtraction assignment
|
|
template<typename T , size_t N> |
Vector< T, N > & | operator*= (Vector< T, N > &A, const T &B) |
| (assignment) multiplication by a single element
|
|
template<typename T , size_t N> |
const Vector< T, N > | operator* (const Vector< T, N > &A, const T &c) |
| multiplication: #Vector<T> * T
|
|
template<typename T , size_t N> |
constexpr Vector< T, N > | operator* (const T &c, const Vector< T, N > &A) |
| multiplication: T * #Vector<T>
|
|
template<typename T , size_t N> |
Vector< T, N > & | operator/= (Vector< T, N > &A, const T &B) |
| (assignment) division by a single element
|
|
template<typename T , size_t N> |
const Vector< T, N > | operator/ (const Vector< T, N > &A, const T &c) |
| division: #Vector<T> / T
|
|
template<typename T , size_t N> |
constexpr T | abs (const Vector< T, N > &A) |
|
template<typename T , size_t N> |
const Vector< T, N > | unit (const Vector< T, N > &V) |
|
template<typename T , size_t R, size_t C> |
const Vector< T, R > | operator* (const Matrix< T, R, C > &M, const Vector< T, C > &V) |
| Matrix * Vector.
|
|
template<typename T1 , typename T2 , size_t R, size_t C> |
auto | operator* (const Matrix< T1, R, C > &M, const Vector< T2, C > &V) -> const Vector< typename std::remove_cv< decltype(operator*(M[0][0], V[0]))>::type, R > |
| Matrix * Vector with different template types.
|
|
template<typename T , size_t N> |
const SquareMatrix< T, N > | outer (const Vector< T, N > &A, const Vector< T, N > &B) |
| outer product
|
|
template<class T > |
std::ostream & | operator<< (std::ostream &os, const WeakPtrCache< T > &C) |
| streamer
|
|
const double | dFunction (unsigned twoJ, int twoM, int twoN, double beta) |
|
const std::complex< double > | DFunction (unsigned twoJ, int twoM, int twoN, double alpha, double beta, double gamma) |
| Wigner D-function .
|
|
const DataIterator::difference_type | operator- (const DataIterator &lhs, const DataIterator &rhs) |
|
bool | equalStructure (const DataPoint &A, const DataPoint &B) |
|
ParticleSet | particles (const DecayChannel &dc) |
|
bool | is_decaying_particle (const Particle &p) |
|
std::shared_ptr< FreeAmplitude > | free_amplitude (const DecayTree &dt) |
|
bool | is_final_state_particle (const Particle &p) |
|
std::ostream & | print_mp_string (std::ostream &os, unsigned n, unsigned m_p, std::shared_ptr< ParticleCombination > pc, double m, FourVector< double > p, double M=-1) |
|
bool | check_invariant_masses (const MassAxes &axes, const std::vector< double > &squared_masses, const std::vector< FourVector< double > > &fourMomenta) |
|
const
FinalStateParticleVector::value_type & | fsp_with_index (const FinalStateParticleVector &FSPs, unsigned i) |
|
RealParameter & | mass_parameter (Particle &p) |
|
const double | sum_of_logs_of_intensities (const Model &M, DataPartition &D, double ped) |
|
AdmixtureMap | admixture_map (const DecayTreeVectorMap &dtvm) |
|
size_t | all_fixed (const AdmixtureMap &mix) |
|
std::ostream & | print_daughters (std::ostream &os, const ParticleCombinationCache &C, std::shared_ptr< ParticleCombination > pc, unsigned ndig, std::string prefix, std::set< unsigned > &used) |
|
const bool | is_resonance (const Particle &p) |
|
bool | equal_zemach (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
|
|
template<typename T = double> |
constexpr T | pi () |
| pi
|
|
template<typename T = double> |
constexpr T | rad_per_deg () |
| convert degrees to radians
|
|
template<typename T > |
constexpr T | rad (const T &d) |
| convert degrees to radians
|
|
template<typename T = double> |
constexpr T | deg_per_rad () |
| convert radians to degrees
|
|
template<typename T > |
constexpr T | deg (const T &r) |
| convert radians to degrees
|
|
|
template<typename T > |
constexpr bool | isRightHanded (const CoordinateSystem< T, 3 > &C) |
|
template<typename T > |
constexpr bool | isLeftHanded (const CoordinateSystem< T, 3 > &C) |
|
template<typename T > |
constexpr T | phi (const ThreeVector< T > &V, const CoordinateSystem< T, 3 > &C) |
|
template<typename T > |
constexpr T | theta (const ThreeVector< T > &V, const CoordinateSystem< T, 3 > &C) |
|
template<typename T > |
constexpr std::array< T, 2 > | angles (const ThreeVector< T > &V, const CoordinateSystem< T, 3 > &C) |
|
|
ComplexIntegralElement | conj (const ComplexIntegralElement &Z) |
|
RealIntegralElement | real (const ComplexIntegralElement &Z) |
|
RealIntegralElement | imag (const ComplexIntegralElement &Z) |
|
|
constexpr bool | equal_always (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination, returning true always
|
|
bool | equal_by_shared_pointer (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination by shared_ptr only
|
|
bool | equal_by_ordered_content (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination by indices only
|
|
bool | equal_by_orderless_content (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination by indices, disregarding order
|
|
bool | equal_down (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination by checking selves and then all daughters
|
|
bool | equal_up (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination by checking selves and then parents
|
|
bool | equal_up_and_down (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
| compare shared_ptr's to ParticleCombination by checking selves, daughters, and parents
|
|
bool | equal_down_by_orderless_content (const std::shared_ptr< const ParticleCombination > &A, const std::shared_ptr< const ParticleCombination > &B) |
|