Common Partial-Wave-Analysis Framework (ComPWA)
Contents
Common Partial-Wave-Analysis Framework (ComPWA)#
Warning
This C++ project is deprecated. ComPWA has migrated to several Python projects and has become an organization. Go to compwa.github.io for an overview of the new projects.
Welcome to the class documentation of ComPWA!
These pages are useful if you are working on the C++ backend of the ComPWA framework. See the repository on GitHub for the source code.
ComPWA is best used through it’s python interface (pycompwa
). You can
find all installation instructions and usage examples on our website,
compwa.github.io/pycompwa.
Note
The original Doxygen pages are still available and kept up-to-date at compwa.github.io/legacy-doxygen.
API#
Common Partial-Wave-Analysis Framework (ComPWA)#
- page index
Welcome to the class documentation of ComPWA!
These pages are useful if you are working on the C++ backend of the ComPWA framework. See the repository on GitHub for the source code.
ComPWA is best used through it’s python interface (
pycompwa
). You can find all installation instructions and usage examples on our website, compwa.github.io/pycompwa.A Sphinx version of these pages can be viewed at .
Page Hierarchy#
Full API#
Namespaces#
Namespace ComPWA#
Contents
Function ComPWA::findParticle(const ParticleList&, std::string)
Function ComPWA::insertParticles(ParticleList&, const boost::property_tree::ptree&)
Function ComPWA::insertParticles(ParticleList&, std::stringstream&)
Function ComPWA::insertParticles(ParticleList&, std::string)
Function ComPWA::operator<<(std::ostream&, const FitResult&)
Function ComPWA::operator<<(std::ostream&, const ParticleList&)
Function ComPWA::readParticles(boost::property_tree::ptree&)
Namespace ComPWA::Data::Root#
Namespace with read/write functions for ROOT files.
Namespace ComPWA::FunctionTree#
Function ComPWA::FunctionTree::createLeaf(std::shared_ptr<Parameter>)
Template Function ComPWA::FunctionTree::createLeaf(const T&, std::string)
Function ComPWA::FunctionTree::FindParameter(std::string, const ParameterList&)
Function ComPWA::FunctionTree::MComplex(std::string, size_t, std::complex<double>)
Function ComPWA::FunctionTree::MComplex(std::string, std::vector<std::complex<double>>)
Function ComPWA::FunctionTree::MDouble(std::string, size_t, double)
Function ComPWA::FunctionTree::MDouble(std::string, std::vector<double>)
Function ComPWA::FunctionTree::MInteger(std::string, size_t, int)
Function ComPWA::FunctionTree::MInteger(std::string, std::vector<int>)
Specialized Template Function ComPWA::FunctionTree::typeName< double >
Specialized Template Function ComPWA::FunctionTree::typeName< int >
Namespace ComPWA::Physics#
Contents
Function ComPWA::Physics::createHelicityKinematics(const std::string)
Function ComPWA::Physics::createHelicityKinematics(const ComPWA::ParticleList&, const std::string)
Function ComPWA::Physics::operator<<(std::ostream&, const SubSystem&)
Function ComPWA::Physics::operator<<(std::ostream&, const ParticleStateTransitionKinematicsInfo&)
Namespace ComPWA::Physics::Dynamics::Flatte#
Namespace ComPWA::Physics::HelicityFormalism::WignerD#
Angular distribution based on Namespace ComPWA::Physics::HelicityFormalism::WignerD functions.
Contents
Namespace ComPWA::Tools#
Contents
Namespace Voigtian#
Namespace Voigtian is the convolution of a non-relativisitc Breit-Wigner with a Gaussian, see Wikipedia :math:`[ mathrm{Voig}(x; sigma, gamma) = int Gaus(x’;sigma)BW(x - x’;gamma) dx’ = Re[w(z)]/(sigmasqrt{2pi}) and z = (x + igamma)/(sigmasqrt{s}) ` In the calculation of voigt function, a Faddeeva Package this page is a package for computation of w(z)) is used to calculate w(z).
Classes and Structs#
Struct BoolTranslator#
Defined in File Utils.hpp
-
struct BoolTranslator#
-
Public Functions
-
inline boost::optional<external_type> get_value(const internal_type &str)#
-
inline boost::optional<internal_type> put_value(const external_type &b)#
-
inline boost::optional<external_type> get_value(const internal_type &str)#
Struct DataSet#
Defined in File DataSet.hpp
-
struct DataSet#
Struct Event#
Defined in File Event.hpp
-
struct Event#
Data structure containing all kinematic information of a physics event.
The information is stored in form of a FourMomentum list.
Struct EventCollection#
Defined in File Event.hpp
Template Struct FitParameter#
Defined in File FitParameter.hpp
-
template<typename T>
struct FitParameter# Public Functions
-
FitParameter() = default#
Friends
-
inline friend std::ostream &operator<<(std::ostream &os, const FitParameter<double> &x)#
-
FitParameter() = default#
Struct FitResult#
Defined in File FitResult.hpp
public ComPWA::Optimizer::Geneva::GenevaResult
(Struct GenevaResult)public ComPWA::Optimizer::Minuit2::MinuitResult
(Struct MinuitResult)
-
struct FitResult#
Data structure which resembles a general fit result.
Optimizers should derive from this structure and append more information via inheritance.
Subclassed by ComPWA::Optimizer::Geneva::GenevaResult, ComPWA::Optimizer::Minuit2::MinuitResult
Public Functions
-
void write(std::string filename) const#
Public Members
-
FitParameterList InitialParameters#
-
FitParameterList FinalParameters#
-
unsigned int NumFreeParameters#
-
bool IsValid = false#
-
double InitialEstimatorValue = 0.0#
-
double FinalEstimatorValue = 0.0#
-
std::chrono::seconds FitDuration = std::chrono::seconds(0)#
-
std::vector<std::vector<double>> CovarianceMatrix#
-
void write(std::string filename) const#
Struct KahanSummation#
Defined in File Functions.cpp
-
struct KahanSummation#
Struct GenevaResult#
Defined in File GenevaResult.hpp
public ComPWA::FitResult
(Struct FitResult)
Struct MinuitResult#
Defined in File MinuitResult.hpp
public ComPWA::FitResult
(Struct FitResult)
-
struct MinuitResult : public ComPWA::FitResult#
-
Public Members
-
bool CovPosDef = false#
-
bool HasValidParameters = false#
-
bool HasValidCov = false#
-
bool HasAccCov = false#
-
bool HasReachedCallLimit = false#
-
bool EdmAboveMax = false#
-
bool HesseFailed = false#
-
double ErrorDef = false#
-
unsigned int NFcn = 0#
-
double Edm = 0.0#
-
std::vector<double> GlobalCC#
Friends
-
friend std::ostream &operator<<(std::ostream &os, const MinuitResult &Result)#
-
bool CovPosDef = false#
Struct Parameter#
Defined in File Function.hpp
-
struct Parameter#
Struct InputInfo#
Defined in File Flatte.hpp
public ComPWA::Physics::Dynamics::InputInfo
(Struct InputInfo)
Struct InputInfo#
Defined in File RelativisticBreitWigner.hpp
public ComPWA::Physics::Dynamics::Flatte::InputInfo
(Struct InputInfo)public ComPWA::Physics::Dynamics::RelativisticBreitWigner::InputInfo
(Struct InputInfo)
-
struct InputInfo#
Subclassed by ComPWA::Physics::Dynamics::Flatte::InputInfo, ComPWA::Physics::Dynamics::RelativisticBreitWigner::InputInfo
Public Members
-
std::string Type#
-
unsigned int L#
Orbital Angular Momentum between two daughters in Resonance decay.
-
std::pair<std::shared_ptr<ComPWA::FunctionTree::Value<std::vector<double>>>, std::shared_ptr<ComPWA::FunctionTree::Value<std::vector<double>>>> DaughterInvariantMasses#
Invariant Masses of daughter particles.
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> Mass#
Resonance mass.
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> MesonRadius#
Meson radius of resonant state.
-
std::shared_ptr<FormFactor> FormFactorFunctor#
Form factor function object.
-
std::string Type#
Struct InputInfo#
Defined in File RelativisticBreitWigner.hpp
public ComPWA::Physics::Dynamics::InputInfo
(Struct InputInfo)
public ComPWA::Physics::Dynamics::Voigtian::InputInfo
(Struct InputInfo)
-
struct InputInfo : public ComPWA::Physics::Dynamics::InputInfo#
Subclassed by ComPWA::Physics::Dynamics::Voigtian::InputInfo
Public Members
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> Width#
Decay width of resonant state.
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> Width#
Struct InputInfo#
Defined in File Voigtian.hpp
public ComPWA::Physics::Dynamics::RelativisticBreitWigner::InputInfo
(Struct InputInfo)
Struct IntensityBuilderXML::DataContainer#
Defined in File BuilderXML.hpp
This struct is a nested type of Class IntensityBuilderXML.
Struct TwoBodyDecayInfo#
Defined in File BuilderXML.hpp
-
struct TwoBodyDecayInfo#
Struct FitFraction#
Defined in File FitFractions.hpp
-
struct FitFraction#
Struct FitFractions::DerivativeData#
Defined in File FitFractions.hpp
This struct is a nested type of Class FitFractions.
-
struct DerivativeData#
Struct KahanSummation#
Defined in File Integration.cpp
Struct EnergyParameters#
Defined in File SimFit.cpp
-
struct EnergyParameters#
Public Members
-
size_t NumberOfEvents#
-
ComPWA::Physics::HelicityFormalism::HelicityKinematics Kinematics#
-
ComPWA::FunctionTree::FunctionTreeIntensity Intensity#
-
ComPWA::EventCollection DataSample#
-
ComPWA::EventCollection PhspSample#
-
size_t NumberOfEvents#
Class ChiOneD#
Defined in File ChiOneD.hpp
-
class ChiOneD#
Simple \(\chi^{2}\)-Estimator.
Class BadConfig#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class BadIndex#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class BadParameter#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class BeyondPhsp#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class CorruptFile#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class AsciiHeader#
Defined in File AsciiHeaderIO.hpp
-
class AsciiHeader#
Representation of data contained in an ASCII header.
This object takes care of reading and writing data concerning a set of events from and to a data file. The concept of a header was introduced to allow the user to document data files and facilitate comparison between Pawian and ComPWA.
Public Functions
-
inline AsciiHeader(std::vector<int> PIDs = {}, std::string Unit = "GeV", bool EnergyFirst = false)#
-
void importYAML(const std::string &HeaderContent)#
Set data members by reading a YAML-like string (including newlines).
Set data members by reading a YAML-like string (including newline characters).
Example:
Note that even though the syntax within the header is YAML-like, there is no full YAML support. In addition, key words are case-insensitive.Pids: [211, 421, -411] Unit: GeV Order: px py pz E
-
inline void importYAML(std::istream &InputStream)#
-
void dumpToYAML(std::ostream &os) const#
Serialise data members to YAML format, embedded in XML header tags.
See also
See also
-
inline const std::vector<int> getFinalStatePIDs() const#
-
inline bool isEnergyFirst() const#
-
inline const std::string &getUnit() const#
Public Static Functions
-
static std::string extractHeaderContent(std::istream &InputStream)#
Extract the part that is between the XML/HTML tags
<header>...</header>
including newlines.
-
inline AsciiHeader(std::vector<int> PIDs = {}, std::string Unit = "GeV", bool EnergyFirst = false)#
Class EvtGenGenerator#
Defined in File EvtGenGenerator.hpp
public ComPWA::PhaseSpaceEventGenerator
(Class PhaseSpaceEventGenerator)
-
class EvtGenGenerator : public ComPWA::PhaseSpaceEventGenerator#
Public Functions
-
EvtGenGenerator(const ComPWA::FourMomentum &CMSP4_, const std::vector<double> &FinalStateMasses_, const std::vector<ComPWA::pid> &FinalStatePIDs_)#
-
EvtGenGenerator(const Physics::ParticleStateTransitionKinematicsInfo &KinematicsInfo)#
Constructor: Information on the decay is obtained from Kinematics.
-
virtual ComPWA::EventCollection generate(unsigned int NumberOfEvents, UniformRealNumberGenerator &RandomGenerator) const final#
-
EvtGenGenerator(const ComPWA::FourMomentum &CMSP4_, const std::vector<double> &FinalStateMasses_, const std::vector<ComPWA::pid> &FinalStatePIDs_)#
Class EvtGenStdRandomEngine#
Defined in File EvtGenGenerator.hpp
public EvtRandomEngine
-
class EvtGenStdRandomEngine : public EvtRandomEngine#
Public Functions
-
EvtGenStdRandomEngine()#
-
void setRandomNumberGenerator(UniformRealNumberGenerator &NumberGenerator_)#
-
double random()#
-
EvtGenStdRandomEngine()#
Class RootAngleEfficiency#
Defined in File RootEfficiency.hpp
public ComPWA::Data::Root::RootEfficiency
(Class RootEfficiency)
-
class RootAngleEfficiency : public ComPWA::Data::Root::RootEfficiency#
Uses also TEfficiency object, but the variables are one invariant mass and the corresponding helicity angle.
This avoids binning effects near the phsp boundaries. ATTENTION: We assume that the invariant mass of particle 2 and 3 and the helicity angle between 1 and 2 are used!
Class RootEfficiency#
Defined in File RootEfficiency.hpp
public ComPWA::Efficiency
(Class Efficiency)
public ComPWA::Data::Root::RootAngleEfficiency
(Class RootAngleEfficiency)
-
class RootEfficiency : public ComPWA::Efficiency#
Efficiency provided by a histogram.
Subclassed by ComPWA::Data::Root::RootAngleEfficiency
Public Functions
-
RootEfficiency(TEfficiency *eff)#
Construct RootEfficiency from TEfficiency object.
-
RootEfficiency(TH1 *passed, TH1 *total)#
Construct RootEfficiency from two TH2 objects for passed and total events.
-
~RootEfficiency() = default#
Protected Attributes
-
std::shared_ptr<TEfficiency> effHist#
-
RootEfficiency(TEfficiency *eff)#
Class RootGenerator#
Defined in File RootGenerator.hpp
public ComPWA::PhaseSpaceEventGenerator
(Class PhaseSpaceEventGenerator)
-
class RootGenerator : public ComPWA::PhaseSpaceEventGenerator#
Public Functions
-
RootGenerator(const ComPWA::FourMomentum &CMSP4_, const std::vector<double> &FinalStateMasses_, const std::vector<ComPWA::pid> &FinalStatePIDs_)#
Constructor for a three particle decay with given masses.
-
RootGenerator(const Physics::ParticleStateTransitionKinematicsInfo &KinematicsInfo)#
Constructor: Information on the decay is obtained from Kinematics.
-
RootGenerator(const ComPWA::ParticleList &PartL, std::vector<pid> FinalS, std::vector<pid> InitialS)#
Constructor: Information on the decay is provides via lists of initial and final states.
-
inline virtual ~RootGenerator()#
-
virtual ComPWA::EventCollection generate(unsigned int NumberOfEvents, UniformRealNumberGenerator &RandomGenerator) const final#
-
RootGenerator(const ComPWA::FourMomentum &CMSP4_, const std::vector<double> &FinalStateMasses_, const std::vector<ComPWA::pid> &FinalStatePIDs_)#
Class RootUniformRealGenerator#
Defined in File RootGenerator.hpp
public ComPWA::UniformRealNumberGenerator
(Class UniformRealNumberGenerator)
-
class RootUniformRealGenerator : public ComPWA::UniformRealNumberGenerator#
Class Efficiency#
Defined in File Efficiency.hpp
public ComPWA::Data::Root::RootEfficiency
(Class RootEfficiency)public ComPWA::UnitEfficiency
(Class UnitEfficiency)
-
class Efficiency#
Base class for efficiency description over the phase space.
Subclassed by ComPWA::Data::Root::RootEfficiency, ComPWA::UnitEfficiency
Class ChiOneD#
Defined in File ChiOneD.hpp
public ComPWA::Estimator::Estimator< double >
(Template Class Estimator)
-
class ChiOneD : public ComPWA::Estimator::Estimator<double>#
Template Class Estimator#
Defined in File Estimator.hpp
public ComPWA::Function< OutputType >
(Template Class Function)
-
template<typename OutputType>
class Estimator : public ComPWA::Function<OutputType># This class template provides the interface to implementations, which estimate the “closeness” of a Function to a data set, with respect to the parameters of the Function.
The Estimator is defined as a Function with a return value, but without input arguments.
Optimizer implementations use the Estimator to find the parameter set, that model the data set optimally.
Class MinLogLH#
Defined in File MinLogLH.hpp
public ComPWA::Estimator::Estimator< double >
(Template Class Estimator)
-
class MinLogLH : public ComPWA::Estimator::Estimator<double>#
Negative Log Likelihood-Estimator.
This class calculates the negative log likelihood -log(LH) using an Intensity and data samples. Data data samples are retrieved from the DataStorage.
The sum over all weights is necessary to normalize the weights to one. Otherwise the error estimate would be incorrect. The Intensity does not have to be normalized. This is done automatically by the phase space integral.
- log likelihood
The negative log LH is given by:
\[ -log \mathcal{L} = N_{\mathrm{obs}} * \log(\lambda) - \sum_i^{N_{\mathrm{obs}}} \log(I(x_i)) \]with the Intensity \(I(x_i)\) for a given event \(x_i\) and the phase integral \( \lambda = \frac{V}{\sum w_i}\sum_i^{N_{\mathrm{phsp}}} I(x_i)\cdot \epsilon_i \cdot w_i \) \( \epsilon \) and \( w \) are the efficiency and weight for each event \( V \) is the phase space volume (in which the phase space events lie)
- Efficiency correction
It is assumed that the data already includes the efficiency.
Public Functions
-
MinLogLH(ComPWA::Intensity &intensity, const Data::DataSet &datasample, const Data::DataSet &phspdatasample)#
-
double evaluate() noexcept final#
Value of log likelihood function.
-
virtual void updateParametersFrom(const std::vector<double> ¶ms) final#
It is important to input the vector in the same length and order as defined in the getParameters() method.
So in other words, call getParameters() first, then use this ordering and to input new values in this method.
Class SumMinLogLH#
Defined in File SumMinLogLH.hpp
public ComPWA::Estimator::Estimator< double >
(Template Class Estimator)
-
class SumMinLogLH : public ComPWA::Estimator::Estimator<double>#
Calculates the combined likelihood of multiple MinLogLH.
Public Functions
-
double evaluate() noexcept final#
Value of minimum log likelihood function.
-
virtual void updateParametersFrom(const std::vector<double> ¶ms) final#
It is important to input the vector in the same length and order as defined in the getParameters() method.
So in other words, call getParameters() first, then use this ordering and to input new values in this method.
-
double evaluate() noexcept final#
Class Exception#
Defined in File Exceptions.hpp
public exception
public ComPWA::BadConfig
(Class BadConfig)public ComPWA::BadIndex
(Class BadIndex)public ComPWA::BadParameter
(Class BadParameter)public ComPWA::BeyondPhsp
(Class BeyondPhsp)public ComPWA::CorruptFile
(Class CorruptFile)public ComPWA::ParameterFixed
(Class ParameterFixed)public ComPWA::ParameterOutOfBound
(Class ParameterOutOfBound)public ComPWA::TreeBuildError
(Class TreeBuildError)public ComPWA::WrongParType
(Class WrongParType)public ComPWA::WrongVariableID
(Class WrongVariableID)
-
class Exception : public exception#
ComPWA Exceptions base class.
This class defines the ComPWA exception base-class and provides a set of standard exceptions.
Subclassed by ComPWA::BadConfig, ComPWA::BadIndex, ComPWA::BadParameter, ComPWA::BeyondPhsp, ComPWA::CorruptFile, ComPWA::ParameterFixed, ComPWA::ParameterOutOfBound, ComPWA::TreeBuildError, ComPWA::WrongParType, ComPWA::WrongVariableID
Protected Attributes
-
std::string what_#
-
std::string what_#
Class FourMomentum#
Defined in File FourMomentum.hpp
-
class FourMomentum#
ComPWA four momentum class.
Public Functions
-
inline FourMomentum()#
-
inline FourMomentum(double E)#
-
inline FourMomentum(double Px, double Py, double Pz, double E)#
-
inline FourMomentum(std::array<double, 4> P4_)#
-
inline FourMomentum(std::vector<double> P4_)#
-
inline double px() const#
-
inline double py() const#
-
inline double pz() const#
-
inline double e() const#
-
inline FourMomentum operator+(const FourMomentum &pB) const#
-
inline void operator+=(const FourMomentum &pB)#
-
inline bool operator==(const FourMomentum &pB) const#
-
inline double invariantMassSquared() const#
-
inline double invariantMass() const#
-
inline double threeMomentumSquared() const#
Friends
-
inline friend std::ostream &operator<<(std::ostream &stream, const FourMomentum &p4)#
-
inline FourMomentum()#
Template Class Function#
Defined in File Function.hpp
public ComPWA::FunctionTree::FunctionTreeIntensity
(Class FunctionTreeIntensity)public ComPWA::Physics::EvtGen::EvtGenIF
(Class EvtGenIF)
-
template<typename OutputType, typename ...InputTypes>
class Function# Interface template for a general Function of the form OutputType Function(InputTypes) The concept closely follows the mathematical definition of a function/mapping.
The parameters are stated by the Function and can be retrieved via getParameters(). The only difference to a mathematical function is that the evaluation and the setting of the parameters are separated. Parameter have to be altered with updateParametersFrom().
Subclassed by ComPWA::FunctionTree::FunctionTreeIntensity, ComPWA::Physics::EvtGen::EvtGenIF
Public Functions
-
virtual ~Function() = default#
-
virtual OutputType evaluate(const InputTypes&... args) noexcept = 0#
-
virtual void updateParametersFrom(const std::vector<double>&) = 0#
It is important to input the vector in the same length and order as defined in the getParameters() method.
So in other words, call getParameters() first, then use this ordering and to input new values in this method.
-
virtual ~Function() = default#
Class AbsSquare#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class AddAll#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
-
class AddAll : public ComPWA::FunctionTree::Strategy#
Calculates the square root of input double values and double parameters.
Complex parameters are currently not supported.
Public Functions
-
inline virtual ~AddAll()#
Add all values.
Depending on the output type the summation is a little different:
ParType::MCOMPLEX: all single complex, integer and double values are added to a std::complex<double>. Each multi value is added element by element and the previous result from the single values is added to each element.
ParType::MDOUBLE: same ad MCOMPLEX except that complex
-
inline virtual ~AddAll()#
Class ComplexConjugate#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class Complexify#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class Exp#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class FitParameter#
Defined in File FitParameter.hpp
public ComPWA::FunctionTree::Parameter
(Class Parameter)
-
class FitParameter : public ComPWA::FunctionTree::Parameter#
Public Functions
-
FitParameter(std::string inName = "")#
Standard constructor with no information provided.
Creates parameter with value 0 but without bounds or an error.
- Parameters
inName – internal string identifier of this parameter
-
FitParameter(const boost::property_tree::ptree &pt)#
Construct parameter from a property tree.
The expected tree layout is described in load().
-
FitParameter(std::string inName, const double value)#
Standard constructor with just a value provided.
Creates parameter with given value but without bounds or an error.
-
FitParameter(std::string inName, const double value, const double error)#
Standard constructor with value and error provided.
Creates parameter with given value and error but without bounds.
-
FitParameter(std::string inName, const double value, const double min, const double max)#
Standard constructor with value and bounds provided.
Creates parameter with given value and bounds but without error. If a check for valid bounds fails, just the value is used.
-
FitParameter(std::string inName, const double value, const double min, const double max, const double error)#
Standard constructor with value, bounds and error provided.
Creates parameter with the given information. If a check for valid bounds fails, just value and error are used.
-
FitParameter(ComPWA::FitParameter<double> par)#
-
inline virtual bool isParameter() const#
-
inline operator double() const#
-
inline virtual bool hasBounds() const#
-
inline virtual bool isFixed() const#
-
inline virtual void fixParameter(const bool fixed)#
Update member variables from other FitParameter.
Do to the Observer pattern we can’t use a copy constructor. Therefore we use this workaround. The function ignores if parameter is fixed!
-
inline virtual double value() const#
Getter for value of parameter.
-
virtual void setValue(const double inVal)#
Setter for value of parameter.
-
virtual std::pair<double, double> bounds() const#
Bounds of parameter.
-
virtual void setBounds(const double min, const double max)#
Bounds of parameter.
-
virtual void setBounds(const std::pair<double, double> r)#
Bounds of parameter.
-
virtual bool hasError() const#
Is an error set?
-
inline virtual double avgError() const#
Average parameter error (in case of asymmetric errors) or simply parameter error.
-
virtual void setError(double errLow, double errHigh)#
Set parameter error and assume that this parameter has asymmetric errors.
-
virtual void setError(std::pair<double, double> err)#
Set parameter error and assume that this parameter has asymmetric errors.
-
virtual void setError(double err)#
Setter parameter error and assume that this parameter has symmetric errors.
-
bool operator==(const FitParameter otherPar) const#
-
void load(const boost::property_tree::ptree &pt)#
Load parameters from a ptree.
This approach is more or less equivalent to the serialization of a parameter but provides a better readable format.
-
boost::property_tree::ptree save() const#
Save parameter to a ptree.
This approach is more or less equivalent to the serialization of a parameter but provides a better readable format.
-
virtual std::string to_str() const#
String with detailed information about the parameter.
Used in operator<<().
-
virtual std::string val_to_str() const#
String with detailed information about the parameter.
Used in operator<<().
Protected Functions
-
inline virtual std::string className() const#
Getter for typename of object, to be defined by the actual implementation.
-
bool check_bounds(const std::pair<double, double> bounds) const#
Check if
min
andmax
are valid bounds.
-
FitParameter(std::string inName = "")#
Class FunctionTreeEstimator#
Defined in File FunctionTreeEstimator.hpp
public ComPWA::Estimator::Estimator< double >
(Template Class Estimator)
-
class FunctionTreeEstimator : public ComPWA::Estimator::Estimator<double>#
Public Functions
-
FunctionTreeEstimator(const FunctionTreeEstimator &other) = delete#
-
FunctionTreeEstimator(FunctionTreeEstimator &&other) = default#
-
double evaluate() noexcept#
-
virtual void updateParametersFrom(const std::vector<double> ¶ms)#
It is important to input the vector in the same length and order as defined in the getParameters() method.
So in other words, call getParameters() first, then use this ordering and to input new values in this method.
-
std::string print(int level) const#
-
ParameterList getParameterList() const#
-
FunctionTreeEstimator(const FunctionTreeEstimator &other) = delete#
Class FunctionTreeIntensity#
Defined in File FunctionTreeIntensity.hpp
public ComPWA::Function< double >, DataMap >
(Template Class Function)
- ComPWA::FunctionTree::FunctionTreeIntensity : public ComPWA::Function< double >, DataMap >
Public Functions
-
FunctionTreeIntensity(const FunctionTreeIntensity &other) = delete#
-
FunctionTreeIntensity(FunctionTreeIntensity &&other) = default#
-
virtual void updateParametersFrom(const std::vector<double> ¶ms)#
It is important to input the vector in the same length and order as defined in the getParameters() method.
So in other words, call getParameters() first, then use this ordering and to input new values in this method.
-
std::tuple<std::shared_ptr<ComPWA::FunctionTree::TreeNode>, ComPWA::FunctionTree::ParameterList> bind(const ComPWA::DataMap &data)#
-
std::string print(int level) const#
-
FunctionTreeIntensity(const FunctionTreeIntensity &other) = delete#
Class Inverse#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class LogOf#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class MultAll#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class Parameter#
Defined in File Parameter.hpp
public ComPWA::FunctionTree::FitParameter
(Class FitParameter)public ComPWA::FunctionTree::Value< T >
(Template Class Value)
-
class Parameter#
Base class for internal parameter.
This class defines the internal container of a parameter. For the use in the function tree, the observer pattern is used and this class takes over the role of the Subject. Therefore the actual implementations of Parameter are the ConcreteSubjects of the observer pattern and the TreeNodes take the role of the observers.
Subclassed by ComPWA::FunctionTree::FitParameter, ComPWA::FunctionTree::Value< T >
Public Functions
-
inline Parameter(std::string name, ParType type = ParType::UNDEFINED)#
Constructor with name of parameter and optional type.
-
virtual ~Parameter() = default#
-
inline virtual std::string name() const#
Getter for name of object.
-
inline virtual void setName(std::string n)#
Getter for name of object.
-
virtual std::string className() const = 0#
Getter for typename of object, to be defined by the actual implementation.
-
inline virtual bool isParameter() const#
-
inline void attach(std::weak_ptr<ParObserver> newObserver)#
Attaches a new TreeNode as Observer.
-
inline void detachExpired()#
Removes TreeNodes not needed as Observer anymore.
-
inline void notify()#
Notify all observing TreeNodes that parameter changed.
-
virtual std::string to_str() const = 0#
A public function returning a string with parameter information.
-
virtual std::string val_to_str() const = 0#
A public function returning a string with parameter value.
Protected Attributes
-
std::string Name#
Name of parameter.
-
std::vector<std::weak_ptr<ParObserver>> ObservingNodes#
List of observers, e.g. TreeNodes.
-
inline Parameter(std::string name, ParType type = ParType::UNDEFINED)#
Class ParameterList#
Defined in File ParameterList.hpp
-
class ParameterList#
This class provides a list of parameters and values of different types.
Public Functions
-
inline ParameterList()#
-
ParameterList(const ParameterList &in) = default#
Only shared_ptr are copied.
Those still point to the same object. See DeepCopy(const ParameterList &in).
-
void DeepCopy(const ParameterList &in)#
Clear this parameter and deep-copy all parameters from
in
.Deep-copy means that for each parameter a new object is created (not only the shared_ptr is copied).
-
inline virtual ~ParameterList()#
-
virtual std::size_t numParameters() const#
-
virtual std::size_t numValues() const#
-
inline virtual std::shared_ptr<FitParameter> doubleParameter(size_t i) const#
-
inline virtual std::vector<std::shared_ptr<FitParameter>> &doubleParameters()#
-
inline virtual const std::vector<std::shared_ptr<FitParameter>> &doubleParameters() const#
-
inline virtual const std::vector<std::shared_ptr<Value<std::complex<double>>>> &complexValues() const#
-
inline virtual const std::vector<std::shared_ptr<Value<std::vector<double>>>> &mDoubleValues() const#
-
inline virtual std::shared_ptr<Value<std::vector<std::complex<double>>>> mComplexValue(size_t i) const#
-
inline virtual std::vector<std::shared_ptr<Value<std::vector<std::complex<double>>>>> &mComplexValues()#
-
inline virtual const std::vector<std::shared_ptr<Value<std::vector<std::complex<double>>>>> &mComplexValues() const#
-
virtual std::string to_str() const#
A public function returning a string with parameter information.
Protected Attributes
-
std::vector<std::shared_ptr<FitParameter>> FitParameters#
Friends
-
inline friend std::ostream &operator<<(std::ostream &out, const ParameterList &b)#
-
inline ParameterList()#
Class ParObserver#
Defined in File ParObserver.hpp
public ComPWA::FunctionTree::TreeNode
(Class TreeNode)
-
class ParObserver#
ParObserver Base class parameter observer.
For the use in the function tree, the observer pattern is used. This class takes the role of the Observer. It’s implemented by the TreeNode class, which then are able to observe a parameter and note changes.
Subclassed by ComPWA::FunctionTree::TreeNode
Public Functions
-
virtual void update() = 0#
Call this function to mark the observing node as modified.
-
virtual void update() = 0#
Class Pow#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class SquareRoot#
Defined in File Functions.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class Strategy#
Defined in File Functions.hpp
public ComPWA::FunctionTree::AbsSquare
(Class AbsSquare)public ComPWA::FunctionTree::AddAll
(Class AddAll)public ComPWA::FunctionTree::ComplexConjugate
(Class ComplexConjugate)public ComPWA::FunctionTree::Complexify
(Class Complexify)public ComPWA::FunctionTree::Exp
(Class Exp)public ComPWA::FunctionTree::Inverse
(Class Inverse)public ComPWA::FunctionTree::LogOf
(Class LogOf)public ComPWA::FunctionTree::MultAll
(Class MultAll)public ComPWA::FunctionTree::Pow
(Class Pow)public ComPWA::FunctionTree::SquareRoot
(Class SquareRoot)public ComPWA::Physics::Dynamics::BreitWignerStrategy
(Class BreitWignerStrategy)public ComPWA::Physics::Dynamics::FlatteStrategy
(Class FlatteStrategy)public ComPWA::Physics::Dynamics::FormFactorStrategy
(Class FormFactorStrategy)public ComPWA::Physics::Dynamics::VoigtianStrategy
(Class VoigtianStrategy)public ComPWA::Physics::HelicityFormalism::WignerDStrategy
(Class WignerDStrategy)
-
class Strategy#
Virtual base class for operations of FunctionTree nodes.
Subclassed by ComPWA::FunctionTree::AbsSquare, ComPWA::FunctionTree::AddAll, ComPWA::FunctionTree::ComplexConjugate, ComPWA::FunctionTree::Complexify, ComPWA::FunctionTree::Exp, ComPWA::FunctionTree::Inverse, ComPWA::FunctionTree::LogOf, ComPWA::FunctionTree::MultAll, ComPWA::FunctionTree::Pow, ComPWA::FunctionTree::SquareRoot, ComPWA::Physics::Dynamics::BreitWignerStrategy, ComPWA::Physics::Dynamics::FlatteStrategy, ComPWA::Physics::Dynamics::FormFactorStrategy, ComPWA::Physics::Dynamics::VoigtianStrategy, ComPWA::Physics::HelicityFormalism::WignerDStrategy
Class TreeNode#
Defined in File TreeNode.hpp
public std::enable_shared_from_this< TreeNode >
public ComPWA::FunctionTree::ParObserver
(Class ParObserver)
-
class TreeNode : public std::enable_shared_from_this<TreeNode>, public ComPWA::FunctionTree::ParObserver#
TreeNode is the basic building block of the FunctionTree.
A FunctionTree is merely a collection of TreeNodes that are connected to each other in a specific way via addNode(). The FunctionTree represents an arbitrary function. structure. Parts of the tree that were calculated before and have not been changed are cached. This reduces the amount of recalculation at evaluation time.
There are normal TreeNodes which perform a calculation. They have a Strategy to calculate its value. The other type of TreeNodes are leaves. They simply need an output parameter and acts as a data source. Leaves can be created via createLeaf().
Public Functions
Constructor for tree using a
strategy
.This will not cache the output value
Constructor for tree using a
parameter
and astrategy
.The output value will be cached.
-
virtual ~TreeNode()#
-
void removeExpiredParents()#
-
std::shared_ptr<Parameter> parameter()#
Obtain parameter of node.
In case child nodes have changed, child nodes are recalculated and Parameter is updated
-
void fillParameters(ParameterList &list)#
Fill ParameterList with parameters.
The function is intended to be filled with fit parameters, so we add only FitParameters.
-
virtual void update()#
Flags the node as modified. Should only be called from its child nodes.
-
std::string print(int level = -1, std::string prefix = "")#
Print node and its child nodes to std::string.
The recursion goes down until
level
is reached. Aprefix
can be added inorder to create a tree like output.
Friends
Template Class Value#
Defined in File Value.hpp
public ComPWA::FunctionTree::Parameter
(Class Parameter)
-
template<class T>
class Value : public ComPWA::FunctionTree::Parameter# Public Functions
-
inline Value(std::string name = "")#
-
inline virtual T &values()#
Reference on the value.
In case of T = std::vector<T2> a reference to the vector is returned.
-
inline virtual std::string to_str() const#
A public function returning a string with parameter information.
-
inline virtual std::string val_to_str() const#
A public function returning a string with parameter value.
Protected Functions
-
inline virtual std::string className() const#
Getter for typename of object, to be defined by the actual implementation.
-
inline Value(std::string name = "")#
Class Kinematics#
Defined in File Kinematics.hpp
public ComPWA::Physics::EvtGen::DalitzKinematics
(Class DalitzKinematics)public ComPWA::Physics::HelicityFormalism::HelicityKinematics
(Class HelicityKinematics)
-
class Kinematics#
The Kinematics interface defines the conversion of Events to a DataSet.
Subclassed by ComPWA::Physics::EvtGen::DalitzKinematics, ComPWA::Physics::HelicityFormalism::HelicityKinematics
Public Functions
-
virtual ~Kinematics() = default#
-
virtual ComPWA::Data::DataSet convert(const EventCollection &Events) const = 0#
-
virtual EventCollection reduceToPhaseSpace(const EventCollection &Events) const = 0#
checks if DataPoint is within phase space boundaries
-
virtual double phspVolume() const = 0#
-
virtual ~Kinematics() = default#
Class Logging#
Defined in File Logging.hpp
Class GenevaIF#
Defined in File GenevaIF.hpp
public ComPWA::Optimizer::Optimizer< GenevaResult >
(Template Class Optimizer)
-
class GenevaIF : public ComPWA::Optimizer::Optimizer<GenevaResult>#
Public Functions
-
GenevaIF(std::vector<ComPWA::Optimizer::Geneva::AlgorithmTypes> AlgorithmOrder_ = {AlgorithmTypes::EVOLUTIONARY, AlgorithmTypes::GRADIENT_DECENT}, std::string ConfigFileDir_ = "./")#
-
virtual GenevaResult optimize(Estimator::Estimator<double> &Estimator, FitParameterList FitParameters) final#
Finds the optimal value of the Estimator, by varying its parameters.
-
virtual ~GenevaIF() = default#
-
GenevaIF(std::vector<ComPWA::Optimizer::Geneva::AlgorithmTypes> AlgorithmOrder_ = {AlgorithmTypes::EVOLUTIONARY, AlgorithmTypes::GRADIENT_DECENT}, std::string ConfigFileDir_ = "./")#
Class MinuitIF#
Defined in File MinuitIF.hpp
public ComPWA::Optimizer::Optimizer< MinuitResult >
(Template Class Optimizer)
-
class MinuitIF : public ComPWA::Optimizer::Optimizer<MinuitResult>#
Wrapper of the Minuit2 Optimizer library.
This class provides a wrapper around the Minuit2 library. It fulfills the Optimizer interface to be easily adapted to other modules. The data needs to be provided with the ControlParameter interface.
Public Functions
-
inline MinuitIF()#
-
virtual MinuitResult optimize(ComPWA::Estimator::Estimator<double> &Estimator, ComPWA::FitParameterList InitialParameters)#
Finds the optimal value of the Estimator, by varying its parameters.
-
void setStrategy(std::string strategy)#
Minuit strategy (low, medium(default), high) See https://root.cern.ch/root/htmldoc/guides/minuit2/Minuit2.html#m-strategy Sets Minuit configuration variables to pre-defined values.
-
inline MinuitIF()#
Template Class Optimizer#
Defined in File Optimizer.hpp
-
template<typename FitResultType, typename EstimatorType = double>
class Optimizer# This class template provides the interface to optimization libraries.
Note: The dynamic polymorphism by inheriting from Optimizer is not useful within ComPWA, since Optimizers are not never passed to another part of the code.
Public Functions
-
virtual ~Optimizer() = default#
-
virtual FitResultType optimize(Estimator::Estimator<EstimatorType> &Estimator, FitParameterList FitParameters) = 0#
Finds the optimal value of the Estimator, by varying its parameters.
-
virtual ~Optimizer() = default#
Class ParameterFixed#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class ParameterOutOfBound#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class ParticleProperties#
Defined in File Properties.hpp
-
class ParticleProperties#
Public Functions
-
ParticleProperties(boost::property_tree::ptree pt)#
-
inline std::string getName() const#
-
inline ComPWA::FitParameter<double> getMass() const#
-
inline boost::property_tree::ptree getDecayInfo() const#
-
inline std::string getDecayType() const#
-
template<>
inline int getQuantumNumber(std::string type) const#
-
template<>
inline double getQuantumNumber(std::string type) const#
Friends
-
inline friend bool operator<(const ParticleProperties &l, const ParticleProperties &r)#
-
ParticleProperties(boost::property_tree::ptree pt)#
Class PhaseSpaceEventGenerator#
Defined in File Generator.hpp
public ComPWA::Data::EvtGen::EvtGenGenerator
(Class EvtGenGenerator)public ComPWA::Data::Root::RootGenerator
(Class RootGenerator)
-
class PhaseSpaceEventGenerator#
Interface class for PHSP event generators.
Subclassed by ComPWA::Data::EvtGen::EvtGenGenerator, ComPWA::Data::Root::RootGenerator
Public Functions
-
virtual ~PhaseSpaceEventGenerator() = default#
-
virtual EventCollection generate(unsigned int NumberOfEvents, UniformRealNumberGenerator &RandomGenerator) const = 0#
-
virtual ~PhaseSpaceEventGenerator() = default#
Class BlattWeisskopfFormFactor#
Defined in File FormFactor.hpp
public ComPWA::Physics::Dynamics::FormFactor
(Class FormFactor)
-
class BlattWeisskopfFormFactor : public ComPWA::Physics::Dynamics::FormFactor#
Blatt-Weisskopf form factors with normalization F(x=mR) = 1.
Reference: S.U.Chung Annalen der Physik 4(1995) 404-430 z = q / (interaction range). For the interaction range we assume 1/mesonRadius
Class BreitWignerStrategy#
Defined in File RelativisticBreitWigner.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class Coupling#
Defined in File Coupling.hpp
-
class Coupling#
Public Functions
-
inline Coupling()#
-
inline Coupling(double c, double massA, double massB)#
-
inline Coupling(const ComPWA::ParticleList &partL, const boost::property_tree::ptree tr)#
Public Members
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> G#
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> MassA#
-
std::shared_ptr<ComPWA::FunctionTree::FitParameter> MassB#
-
inline Coupling()#
Class CrystalBarrelFormFactor#
Defined in File FormFactor.hpp
public ComPWA::Physics::Dynamics::FormFactor
(Class FormFactor)
-
class CrystalBarrelFormFactor : public ComPWA::Physics::Dynamics::FormFactor#
Form factor for a0(980) used by Crystal Barrel (Phys.Rev.D78-074023)
Class FlatteStrategy#
Defined in File Flatte.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class FormFactor#
Defined in File FormFactor.hpp
public ComPWA::Physics::Dynamics::BlattWeisskopfFormFactor
(Class BlattWeisskopfFormFactor)public ComPWA::Physics::Dynamics::CrystalBarrelFormFactor
(Class CrystalBarrelFormFactor)public ComPWA::Physics::Dynamics::NoFormFactor
(Class NoFormFactor)
-
class FormFactor#
Defines interface for form factors It should be noted that when exchanging various form factor implementations in the code, no correctness of the mathematical description is guaranteed.
Subclassed by ComPWA::Physics::Dynamics::BlattWeisskopfFormFactor, ComPWA::Physics::Dynamics::CrystalBarrelFormFactor, ComPWA::Physics::Dynamics::NoFormFactor
Class FormFactorStrategy#
Defined in File FormFactor.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class NoFormFactor#
Defined in File FormFactor.hpp
public ComPWA::Physics::Dynamics::FormFactor
(Class FormFactor)
-
class NoFormFactor : public ComPWA::Physics::Dynamics::FormFactor#
Class VoigtianStrategy#
Defined in File Voigtian.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class DalitzKinematics#
Defined in File DalitzKinematics.hpp
public ComPWA::Kinematics
(Class Kinematics)
-
class DalitzKinematics : public ComPWA::Kinematics#
Implementation of the ComPWA::Kinematics interface for amplitude models using the helicity formalism.
The basic functionality is the calculation of the kinematics variables from four-momenta.
Public Functions
-
DalitzKinematics(ParticleStateTransitionKinematicsInfo KinInfo, double PhspVol)#
-
DalitzKinematics(ParticleStateTransitionKinematicsInfo kininfo)#
-
DalitzKinematics(ComPWA::ParticleList partL, std::vector<pid> initialState, std::vector<pid> finalState, ComPWA::FourMomentum cmsP4 = ComPWA::FourMomentum(0, 0, 0, 0))#
Create DalitzKinematics from inital and final state particle lists.
The lists contain the pid of initial and final state. The position of a particle in initial or final state list is used later on for identification.
-
DalitzKinematics(const DalitzKinematics &that) = delete#
Delete copy constructor.
For each Kinematics in the analysis only one instance should exist since Kinematics does the bookkeeping which SubSystems variables are needs to be calculated. That instance can then be passed as (smart) pointer.
-
DalitzKinematics(DalitzKinematics &&that) = default#
-
virtual ComPWA::Data::DataSet convert(const EventCollection &DataSample) const final#
-
virtual EventCollection reduceToPhaseSpace(const EventCollection &DataSample) const final#
Returns a subset of events that are within phase space boundaries.
-
virtual double phspVolume() const#
-
DalitzKinematics(ParticleStateTransitionKinematicsInfo KinInfo, double PhspVol)#
Class EvtGenIF#
Defined in File EvtGenIF.hpp
public ComPWA::Function< double >, DataMap >
(Template Class Function)
- ComPWA::Physics::EvtGen::EvtGenIF : public ComPWA::Function< double >, DataMap >
Public Functions
-
inline EvtGenIF()#
-
inline EvtGenIF(double mA, double mB, double mC, double bigM, double ldel = 0., double rdel = 0.)#
-
void addResonance(const std::string &name, double m0, double g0, double spin, const ComPWA::Physics::SubSystem &subsys)#
Add EvtGen Dalitz Resonance.
-
void addHeliResonance(const boost::property_tree::ptree &pt, const ComPWA::ParticleList &partL)#
Add EvtGen Dalitz Resonance.
Add EvtGen Dalitz Resonances from XML model.
-
std::vector<double> evaluate(const ComPWA::DataMap &data) noexcept
-
virtual void updateParametersFrom(const std::vector<double> &Parameters) final
It is important to input the vector in the same length and order as defined in the getParameters() method.
So in other words, call getParameters() first, then modify the contents and finally input them in this method.
-
virtual std::vector<ComPWA::Parameter> getParameters() const final
Set phase space sample.
We use a phase space sample to calculate the normalization and determine the maximum of the amplitude. In case that the efficiency is already applied to the sample set fEff to false.
-
inline virtual void setPhspVolume(double vol)#
-
inline EvtGenIF()#
Class HelicityKinematics#
Defined in File HelicityKinematics.hpp
public ComPWA::Kinematics
(Class Kinematics)
-
class HelicityKinematics : public ComPWA::Kinematics#
Implementation of the ComPWA::Kinematics interface for amplitude models using the helicity formalism.
The basic functionality is the calculation of the kinematics variables from four-momenta.
Each
SubSystem defines three kinematic variables: the invariant mass \(m^2\), and the helicity angles \(\Theta\) and \(\phi\) are calculatedSee also
ComPWA::Data::DataSet convert(const EventCollection &Events) const;
A SubSystem uniquely defines a two body decay based on the participating four-momenta: the two final states (which make up the decaying state), the decaying state recoil system, and the parents recoil). Since usually a large number of possible SubSystems can be defined in a particle decay but not all of them are used, bookkeeping system is introduced. This increases efficiency (cpu+memory) significantly. Kinematic variables can be registered for calculation via the register methods:
See also
See also
std::string registerInvariantMassSquared(IndexList System);
See also
std::pair<std::string, std::string> registerHelicityAngles(SubSystem System);
Public Functions
-
HelicityKinematics(ParticleStateTransitionKinematicsInfo KinInfo, double PhspVol)#
-
HelicityKinematics(ParticleStateTransitionKinematicsInfo KinInfo)#
-
HelicityKinematics(ComPWA::ParticleList partL, std::vector<pid> initialState, std::vector<pid> finalState, ComPWA::FourMomentum cmsP4 = ComPWA::FourMomentum(0, 0, 0, 0))#
Create HelicityKinematics from inital and final state particle lists.
The lists contain the pid of initial and final state. The position of a particle in initial or final state list is used later on for identification.
-
HelicityKinematics(const HelicityKinematics &that) = delete#
Delete copy constructor.
For each Kinematics in the analysis only one instance should exist since Kinematics does the bookkeeping which SubSystems variables are needs to be calculated. That instance can then be passed by reference.
-
HelicityKinematics(HelicityKinematics &&that) = default#
-
std::pair<double, double> calculateHelicityAngles(const Event &Event, const SubSystem &SubSys) const#
Calculates the pair of values \((\Theta, \phi)\) of the Event
Event
for SubSystemSubSys
.The step-by-step procedure to calculate the helicity angles is:
Calculate the four-momentum of center-of-mass system of the decay, by summing up all final state particle four-momenta.
Boost the the final state particles, the recoil and the parent recoil into the CMS of the decaying state.
Rotate the whole CMS system so that the recoil of the decaying state points in the -z-axis direction. This makes the z-axis the path of flight of the decaying state.
Then rotate the CMS system so that the parent recoil lies in the x-z plane. This defines the angle \(\phi\) of the current transformed final state particles as the angle difference with respect to the production plane.
The helicity angles \(\Theta\) and \(\phi\) can now simply be read of the momenta of the final state particles.
A (two-dimensional) illustration is given below
-
double calculateInvariantMassSquared(const Event &Event, const IndexList &FinalStateIDs) const#
Calculates the squared invariant mass \(m^2\) of list of final state particles
FinalStateIDs
.The actual final state four momenta are extracted from the
Event
.
-
virtual ComPWA::Data::DataSet convert(const EventCollection &Events) const final#
Creates a DataSet from
Events
.Calculates all registered kinematic variables for all Events. Kinematic variables can be registered for example via the registerSubSystem(const SubSystem &newSys) method (see also other register methods). In this way only the variables are calculated that are used by the model.
-
virtual EventCollection reduceToPhaseSpace(const EventCollection &Events) const final#
Returns a subset of
Events
that are within phase space boundaries.
-
void createAllSubsystems()#
-
std::tuple<std::string, std::string, std::string> registerSubSystem(const SubSystem &NewSys)#
Add
NewSys
to list of SubSystems and return a tuple of names, that id the registered kinematic variables.In case that this SubSystem is already in the list only the variable names is returned.
-
std::tuple<std::string, std::string, std::string> registerSubSystem(const std::vector<unsigned int> &FinalA, const std::vector<unsigned int> &FinalB, const std::vector<unsigned int> &Recoil, const std::vector<unsigned int> &ParentRecoil)#
Add SubSystem from
pos
indices of final state particles.
-
const std::pair<double, double> &getInvariantMassBounds(const std::string &InvariantMassName) const#
Get phase space bounds for the registered invariant mass with name
InvariantMassName
.
-
virtual double phspVolume() const#
-
inline const ParticleStateTransitionKinematicsInfo &getParticleStateTransitionKinematicsInfo() const#
Class WignerDStrategy#
Defined in File WignerD.hpp
public ComPWA::FunctionTree::Strategy
(Class Strategy)
Class IntegrationSample#
Defined in File PhspVolume.cpp
public std::vector< double >
Class IntensityBuilderXML#
Defined in File BuilderXML.hpp
-
class IntensityBuilderXML#
Public Functions
-
IntensityBuilderXML(ParticleList ParticleList, Kinematics &Kinematics, const boost::property_tree::ptree &ModelTree, const EventCollection &TruePhspSample = {}, const EventCollection &RecoPhspSample = {})#
-
ComPWA::FunctionTree::FunctionTreeIntensity createIntensity()#
-
std::vector<ComPWA::Tools::IntensityComponent> createIntensityComponents(std::vector<std::vector<std::string>> ComponentList = {})#
-
std::map<std::string, std::string> getAllComponentNames() const#
-
IntensityBuilderXML(ParticleList ParticleList, Kinematics &Kinematics, const boost::property_tree::ptree &ModelTree, const EventCollection &TruePhspSample = {}, const EventCollection &RecoPhspSample = {})#
Class ParticleStateTransitionKinematicsInfo#
-
class ParticleStateTransitionKinematicsInfo#
Public Functions
-
ParticleStateTransitionKinematicsInfo(std::vector<pid> InitialState_, std::vector<pid> FinalState_, ComPWA::ParticleList ParticleList_, ComPWA::FourMomentum InitialStateP4_, std::vector<unsigned int> FinalStateEventPositionMapping_)#
-
ParticleStateTransitionKinematicsInfo(std::vector<pid> InitialState_, std::vector<pid> FinalState_, ComPWA::ParticleList ParticleList_, std::vector<unsigned int> FinalStateEventPositionMapping_)#
-
unsigned int convertFinalStateIDToPositionIndex(unsigned int fs_id) const#
-
std::vector<unsigned int> convertFinalStateIDToPositionIndex(const std::vector<unsigned int> &fs_ids) const#
-
unsigned int convertPositionIndexToFinalStateID(unsigned int pos) const#
-
std::vector<unsigned int> convertPositionIndexToFinalStateID(const std::vector<unsigned int> &pos) const#
-
double calculateFinalStateIDMassSum(const std::vector<unsigned int> ids) const#
-
std::vector<double> getFinalStateMasses() const#
-
double getInitialStateInvariantMassSquared() const#
-
ComPWA::FourMomentum getInitialStateFourMomentum() const#
-
unsigned int getFinalStateParticleCount() const#
-
std::map<unsigned int, std::string> getFinalStateIDToNameMapping() const#
Friends
-
friend std::ostream &operator<<(std::ostream &outstream, const ParticleStateTransitionKinematicsInfo &kininfo)#
-
ParticleStateTransitionKinematicsInfo(std::vector<pid> InitialState_, std::vector<pid> FinalState_, ComPWA::ParticleList ParticleList_, ComPWA::FourMomentum InitialStateP4_, std::vector<unsigned int> FinalStateEventPositionMapping_)#
Class SubSystem#
Defined in File SubSystem.hpp
-
class SubSystem#
Definition of a two-body decay node within a sequential decay tree.
Class contains lists for both final states of the two-body decay and a list for all recoiling particles. This information is needed to calculate invariant mass and angles at a two-body decay node.
Public Functions
-
SubSystem(const std::vector<std::vector<unsigned int>> &FinalStates, const std::vector<unsigned int> &Recoil, const std::vector<unsigned int> &ParentRecoil)#
-
virtual ~SubSystem() = default#
-
virtual const std::vector<std::vector<unsigned int>> &getFinalStates() const#
-
virtual const std::vector<unsigned int> &getRecoilState() const#
-
virtual const std::vector<unsigned int> &getParentRecoilState() const#
-
SubSystem(const std::vector<std::vector<unsigned int>> &FinalStates, const std::vector<unsigned int> &Recoil, const std::vector<unsigned int> &ParentRecoil)#
Class ProgressBar#
Defined in File ProgressBar.hpp
Class Resolution#
Defined in File Resolution.hpp
public ComPWA::ZeroResolution
(Class ZeroResolution)
-
class Resolution#
Subclassed by ComPWA::ZeroResolution
Class StdUniformRealGenerator#
Defined in File Random.hpp
public ComPWA::UniformRealNumberGenerator
(Class UniformRealNumberGenerator)
-
class StdUniformRealGenerator : public ComPWA::UniformRealNumberGenerator#
Class TableFormatter#
Defined in File TableFormatter.hpp
-
class TableFormatter#
Public Functions
-
inline TableFormatter(std::ostream *output)#
-
inline virtual ~TableFormatter()#
-
virtual void reset()#
-
virtual void delim()#
-
virtual void header()#
-
virtual void addColumn(std::string title, unsigned int fixlength = 999)#
-
void trimString(std::string &src)#
-
template<typename T>
inline TableFormatter &operator<<(T in)#
-
inline TableFormatter(std::ostream *output)#
Class FitFractions#
Defined in File FitFractions.hpp
-
class FitFractions#
Public Functions
-
FitFractionList calculateFitFractionsWithCovarianceErrorPropagation(const std::vector<std::pair<IntensityComponent, IntensityComponent>> &Components, const ComPWA::Data::DataSet &PhspSample, const ComPWA::FitResult &Result)#
Calculates the fit fractions with errors via error propagation from the covariance matrix.
The gradients are calculated via numerical differentiation:
\[ f´(x) = \frac{f(x+h) - f(x-h)}{2h} + O(h^2) \]
-
FitFractionList calculateFitFractionsWithCovarianceErrorPropagation(const std::vector<std::pair<IntensityComponent, IntensityComponent>> &Components, const ComPWA::Data::DataSet &PhspSample, const ComPWA::FitResult &Result)#
Class DalitzHisto#
Defined in File DalitzPlot.hpp
-
class DalitzHisto#
Simple class to create and fill Dalitz plots.
Public Functions
-
DalitzHisto(const DalitzHisto &that) = delete#
Disable copy constructor since TTree is not copyable.
-
DalitzHisto(DalitzHisto &&other) = default#
Default move constructor.
-
DalitzHisto(ComPWA::Physics::HelicityFormalism::HelicityKinematics &Kinematics, std::string Name, std::string Title, unsigned int Bins, Color_t Color = kBlack)#
-
void setStats(bool b)#
Switch on/off stats.
-
void scale(double w)#
Scale all distributions.
-
TH1D *getHistogram(std::string Name)#
Get 1D histogram.
-
TH2D *getHistogram2D(std::pair<std::string, std::string> Names)#
Get 2D histogram.
-
void setColor(Color_t Color)#
set line color
-
void write()#
Write to TFile.
-
inline double integral()#
GetIntegral.
-
DalitzHisto(const DalitzHisto &that) = delete#
Class DalitzPlot#
Defined in File DalitzPlot.hpp
-
class DalitzPlot#
Public Functions
-
DalitzPlot(ComPWA::Physics::HelicityFormalism::HelicityKinematics &Kinematics, const std::string &Name, int bins = 100)#
-
virtual ~DalitzPlot() = default#
-
inline void setGlobalScale(double Scale)#
-
void fill(const ComPWA::EventCollection &Data, bool Normalize = false, const std::string &Name = "", const std::string &Title = "", Color_t Color = kBlack)#
-
void fill(const ComPWA::EventCollection &data, Intensity &intens, bool Normalize = false, const std::string &Name = "", const std::string &Title = "", Color_t Color = kBlack)#
-
void plot()#
-
DalitzPlot(ComPWA::Physics::HelicityFormalism::HelicityKinematics &Kinematics, const std::string &Name, int bins = 100)#
Class RootPlotData#
Defined in File RootPlotData.hpp
-
class RootPlotData#
Allows output of a data sample and an Intensity (and optionally its components) into a ROOT file via TTrees.
See the appropriate write functions. The Intensity is evaluated using a phase space sample, which is re-weighted accordingly.
Public Functions
-
RootPlotData(const Physics::ParticleStateTransitionKinematicsInfo &KinematicsInfo, const std::string &filename, const std::string &option = "RECREATE")#
-
void createDirectory(std::string Name)#
-
RootPlotData(const Physics::ParticleStateTransitionKinematicsInfo &KinematicsInfo, const std::string &filename, const std::string &option = "RECREATE")#
Class TreeBuildError#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class UniformRealNumberGenerator#
Defined in File Random.hpp
public ComPWA::Data::Root::RootUniformRealGenerator
(Class RootUniformRealGenerator)public ComPWA::StdUniformRealGenerator
(Class StdUniformRealGenerator)
-
class UniformRealNumberGenerator#
Subclassed by ComPWA::Data::Root::RootUniformRealGenerator, ComPWA::StdUniformRealGenerator
Class UnitEfficiency#
Defined in File Efficiency.hpp
public ComPWA::Efficiency
(Class Efficiency)
-
class UnitEfficiency : public ComPWA::Efficiency#
Efficiency object with unit efficiency all over the phase space.
Class WrongParType#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class WrongVariableID#
Defined in File Exceptions.hpp
public ComPWA::Exception
(Class Exception)
Class ZeroResolution#
Defined in File Resolution.hpp
public ComPWA::Resolution
(Class Resolution)
-
class ZeroResolution : public ComPWA::Resolution#
Class GenevaIF#
Defined in File GenevaIF.hpp
-
class GenevaIF#
Wrapper of the Geneva Optimizer library.
Class UniformRealDistribution#
Defined in File Random.hpp
-
class UniformRealDistribution#
Interface class for generating random doubles in the range [0,1)
Enums#
Enum ErrorType#
Defined in File FitParameter.hpp
Enum ParType#
Defined in File Parameter.hpp
Functions#
Function adaptiveBinning#
Defined in File HistTools.hpp
-
inline TH2Poly *adaptiveBinning(UInt_t DataSize, UInt_t DataDimension, Double_t *Data, UInt_t NBins = 100)#
Function calculateAIC#
Defined in File GoodnessOfFit.hpp
-
inline double calculateAIC(double LH, int sampleSize, int nFreePar)#
Calculate Akaike Information Criterium AICc https://en.wikipedia.org/wiki/Akaike_information_criterion.
- Parameters
LH – assuming -log(L) is passed
sampleSize – number of points in the data sample
nFreePar – number of free parameters
Function calculateBIC#
Defined in File GoodnessOfFit.hpp
-
inline double calculateBIC(double LH, int sampleSize, int nFreePar)#
Calculate Beyesian Information Criterium BIC https://en.wikipedia.org/wiki/Bayesian_information_criterion.
- Parameters
LH – assuming -log(L) is passed
sampleSize – number of points in the data sample
nFreePar – number of free parameters
Function ComPWA::calculateInvariantMass#
Defined in File Event.cpp
Function ComPWA::Data::addIntensityWeights#
Defined in File DataSet.cpp
Function ComPWA::Data::Ascii::readData#
Defined in File AsciiDataIO.cpp
-
EventCollection ComPWA::Data::Ascii::readData(const std::string &InputFilePath, long long NumberEventsToRead = -1)#
Read momentum tuples from an ASCII file.
The file should start with a header that defines the final state, like so:
Note that the section within the<header> Pids: [211, -211, 22] Order: E px Py pz Unit: GeV </header>
header
tags is YAML syntax.This header is followed by rows of momentum tuples, grouped per event. In this case, you would have a row for the \(\pi^+\), then for the \(\pi^-\), then one for the \(\gamma\), and finally back to \(\pi^+\). You may choose to start each event group with a weight value, but you don’t need to.
Function ComPWA::Data::Ascii::writeData#
Defined in File AsciiDataIO.cpp
-
void ComPWA::Data::Ascii::writeData(const EventCollection &DataSample, const std::string &OutputFilePath, bool OverwriteFile)#
Function ComPWA::Data::generate(unsigned int, const ComPWA::Kinematics&, const ComPWA::PhaseSpaceEventGenerator&, ComPWA::Intensity&, ComPWA::UniformRealNumberGenerator&)#
Defined in File Generate.cpp
-
EventCollection ComPWA::Data::generate(unsigned int NumberOfEvents, const ComPWA::Kinematics &Kinematics, const ComPWA::PhaseSpaceEventGenerator &Generator, ComPWA::Intensity &Intensity, ComPWA::UniformRealNumberGenerator &RandomGenerator)#
Function ComPWA::Data::generate(unsigned int, const ComPWA::Kinematics&, ComPWA::UniformRealNumberGenerator&, ComPWA::Intensity&, const EventCollection&, const EventCollection&)#
Defined in File Generate.cpp
-
EventCollection ComPWA::Data::generate(unsigned int NumberOfEvents, const ComPWA::Kinematics &Kinematics, ComPWA::UniformRealNumberGenerator &RandomGenerator, ComPWA::Intensity &Intensity, const EventCollection &PhspSample, const EventCollection &PhspSampleTrue)#
Function ComPWA::Data::generate(unsigned int, const ComPWA::Kinematics&, ComPWA::UniformRealNumberGenerator&, ComPWA::Intensity&, const EventCollection&)#
Defined in File Generate.hpp
-
inline ComPWA::EventCollection ComPWA::Data::generate(unsigned int NumberOfEvents, const ComPWA::Kinematics &Kinematics, ComPWA::UniformRealNumberGenerator &RandomGenerator, ComPWA::Intensity &Intensity, const EventCollection &PhspSample)#
Function ComPWA::Data::generateBunch#
Defined in File Generate.cpp
-
std::tuple<EventCollection, double> ComPWA::Data::generateBunch(unsigned int EventBunchSize, const ComPWA::Kinematics &Kinematics, ComPWA::Intensity &Intensity, ComPWA::UniformRealNumberGenerator &RandomGenerator, double generationMaxValue, std::vector<ComPWA::Event>::const_iterator PhspStartIterator, std::vector<ComPWA::Event>::const_iterator PhspTrueStartIterator, bool InverseIntensityWeighting = false)#
Function ComPWA::Data::generateImportanceSampledPhsp#
Defined in File Generate.cpp
-
EventCollection ComPWA::Data::generateImportanceSampledPhsp(unsigned int NumberOfEvents, const ComPWA::Kinematics &Kinematics, const ComPWA::PhaseSpaceEventGenerator &Generator, ComPWA::Intensity &Intensity, ComPWA::UniformRealNumberGenerator &RandomGenerator)#
Function ComPWA::Data::generatePhsp#
Defined in File Generate.cpp
-
EventCollection ComPWA::Data::generatePhsp(unsigned int NumberOfEvents, const ComPWA::PhaseSpaceEventGenerator &Generator, ComPWA::UniformRealNumberGenerator &RandomGenerator)#
Function ComPWA::Data::resize#
Defined in File DataSet.hpp
Function ComPWA::Data::Root::pidsToUniqueStrings#
Defined in File RootDataIO.cpp
Function ComPWA::Data::Root::readData#
Defined in File RootDataIO.cpp
-
ComPWA::EventCollection ComPWA::Data::Root::readData(const std::string &InputFileName, const std::string &TreeName, long long NumberEventsToRead = -1)#
Create a vector of
Event
s from a ROOT file.
Function ComPWA::Data::Root::uniqueStringsToPids#
Defined in File RootDataIO.cpp
Function ComPWA::Data::Root::writeData#
Defined in File RootDataIO.cpp
-
void ComPWA::Data::Root::writeData(const EventCollection &OutputSample, const std::string &OutputFilePath, const std::string &TreeName, bool OverwriteFile = true)#
Write a vector of
Event
s to a ROOT file.See
readData
for the structure of the output file.- Parameters
OutputSample – List of
Event
s including a info headerOutputFilePath – Path to the output ROOT file
TreeName – Name of the event-based output
TTree
in the fileOverwriteFile – Set to
true
if you do not want to append
Function ComPWA::Data::uniform#
Defined in File Generate.cpp
-
inline double ComPWA::Data::uniform(double random, double min, double max)#
Function ComPWA::enableDisableLvl#
Defined in File Logging.cpp
-
void ComPWA::enableDisableLvl(el::Logger *logger, std::array<std::string, 5> levels)#
Enable or disable levels TRACE, DEBUG, INFO, WARNING, ERROR, FATAL.
An array of strings is passed. E.g {“0”,”1”,”1”,”1”,”1”,”1”} to disable TRACE and enable all other levels.
Function ComPWA::Estimator::createMinLogLHFunctionTreeEstimator#
Defined in File MinLogLH.cpp
-
std::pair<ComPWA::FunctionTree::FunctionTreeEstimator, FitParameterList> ComPWA::Estimator::createMinLogLHFunctionTreeEstimator(ComPWA::FunctionTree::FunctionTreeIntensity &Intensity, const ComPWA::Data::DataSet &DataSample)#
Function ComPWA::Estimator::createSumMinLogLHFunctionTreeEstimator#
Defined in File SumMinLogLH.cpp
-
std::tuple<FunctionTreeEstimator, FitParameterList> ComPWA::Estimator::createSumMinLogLHFunctionTreeEstimator(std::vector<std::pair<ComPWA::FunctionTree::FunctionTreeEstimator, FitParameterList>> Estimators)#
Function ComPWA::findParticle(const ParticleList&, pid)#
Defined in File Properties.hpp
-
inline const ParticleProperties &ComPWA::findParticle(const ParticleList &list, pid Pid)#
Function ComPWA::findParticle(const ParticleList&, std::string)#
Defined in File Properties.hpp
-
inline const ParticleProperties &ComPWA::findParticle(const ParticleList &list, std::string refname)#
Function ComPWA::FunctionTree::createFitParameterList#
Defined in File FunctionTreeEstimator.cpp
-
FitParameterList ComPWA::FunctionTree::createFitParameterList(ComPWA::FunctionTree::ParameterList Parameters)#
Template Function ComPWA::FunctionTree::createLeaf(const T&, std::string)#
Defined in File TreeNode.hpp
helper function to create TreeNode leaves which are constants
Function ComPWA::FunctionTree::findMDoubleValue#
Defined in File ParameterList.hpp
-
inline std::shared_ptr<Value<std::vector<double>>> ComPWA::FunctionTree::findMDoubleValue(const std::string &name, const ParameterList &list)#
Function ComPWA::FunctionTree::FindParameter(std::string, const ParameterList&)#
Defined in File ParameterList.hpp
-
inline std::shared_ptr<FitParameter> ComPWA::FunctionTree::FindParameter(std::string name, const ParameterList &v)#
Search ParameterList for a FitParameter with
name
.The first match is returned. Be aware that name are not unique. In case no match is found a BadParameter exception is thrown.
Function ComPWA::FunctionTree::KahanSum#
Defined in File Functions.cpp
-
KahanSummation ComPWA::FunctionTree::KahanSum(KahanSummation accumulation, double value)#
KahanSummation keeps track of lost bits and reduced the uncertainty in the summation of many large/small numbers.
Function ComPWA::FunctionTree::MComplex(std::string, size_t, std::complex<double>)#
Defined in File Value.hpp
Function ComPWA::FunctionTree::MComplex(std::string, std::vector<std::complex<double>>)#
Defined in File Value.hpp
Function ComPWA::FunctionTree::MDouble(std::string, size_t, double)#
Defined in File Value.hpp
Function ComPWA::FunctionTree::MDouble(std::string, std::vector<double>)#
Defined in File Value.hpp
Function ComPWA::FunctionTree::MInteger(std::string, size_t, int)#
Defined in File Value.hpp
Function ComPWA::FunctionTree::MInteger(std::string, std::vector<int>)#
Defined in File Value.hpp
Template Function ComPWA::FunctionTree::operator<<#
Defined in File Value.hpp
Template Function ComPWA::FunctionTree::typeName#
Defined in File Parameter.hpp
Specialized Template Function ComPWA::FunctionTree::typeName< double >#
Defined in File Parameter.hpp
Specialized Template Function ComPWA::FunctionTree::typeName< int >#
Defined in File Parameter.hpp
Function ComPWA::FunctionTree::updateDataContainers#
Defined in File FunctionTreeIntensity.cpp
-
void ComPWA::FunctionTree::updateDataContainers(ParameterList Data, const ComPWA::DataMap &data)#
Function ComPWA::FunctionTree::ValueFactory#
Defined in File Value.hpp
Function ComPWA::getMaximumSampleWeight#
Defined in File Event.cpp
-
double ComPWA::getMaximumSampleWeight(const EventCollection &Sample)#
Function ComPWA::initializeWithFitResult#
Defined in File FitResult.cpp
Function ComPWA::insertParticles(ParticleList&, const boost::property_tree::ptree&)#
Defined in File Properties.cpp
-
void ComPWA::insertParticles(ParticleList &list, const boost::property_tree::ptree &pt)#
Read list of particles from a boost::property_tree.
insert particles from a boost::property_tree into a ParticleList
Function ComPWA::insertParticles(ParticleList&, std::stringstream&)#
Defined in File Properties.cpp
-
void ComPWA::insertParticles(ParticleList &list, std::stringstream &Stream)#
insert particles from a stringstream into a ParticleList
Function ComPWA::insertParticles(ParticleList&, std::string)#
Defined in File Properties.cpp
-
void ComPWA::insertParticles(ParticleList &list, std::string FileName)#
insert particles from a xml file into a ParticleList
Function ComPWA::isValid#
Defined in File FitParameter.hpp
-
inline bool ComPWA::isValid(const FitParameterList &FitParameters, const std::vector<ComPWA::Parameter> &EstimatorParameters)#
Function ComPWA::load#
Defined in File FitResult.cpp
Function ComPWA::makeFitParameterString#
Defined in File FitResult.cpp
-
std::string ComPWA::makeFitParameterString(ComPWA::FitParameter<double> p)#
Function ComPWA::operator<<(std::ostream&, const Event&)#
Defined in File Event.cpp
Function ComPWA::operator<<(std::ostream&, const FitResult&)#
Defined in File FitResult.cpp
Function ComPWA::operator<<(std::ostream&, const ParticleList&)#
Defined in File Properties.hpp
-
inline std::ostream &ComPWA::operator<<(std::ostream &os, const ParticleList &p)#
Function ComPWA::Optimizer::Minuit2::getCovarianceMatrix#
Defined in File MinuitIF.cpp
-
std::vector<std::vector<double>> ComPWA::Optimizer::Minuit2::getCovarianceMatrix(const ROOT::Minuit2::MnUserParameterState &minState)#
Function ComPWA::Optimizer::Minuit2::getFinalParameters#
Defined in File MinuitIF.cpp
-
FitParameterList ComPWA::Optimizer::Minuit2::getFinalParameters(const ROOT::Minuit2::MnUserParameterState &minState, FitParameterList InitialParameters)#
Function ComPWA::Optimizer::Minuit2::getGlobalCorrelations#
Defined in File MinuitResult.cpp
-
std::vector<double> ComPWA::Optimizer::Minuit2::getGlobalCorrelations(const ROOT::Minuit2::MnUserParameterState &minState)#
Function ComPWA::Optimizer::Minuit2::load#
Defined in File MinuitResult.cpp
-
MinuitResult ComPWA::Optimizer::Minuit2::load(std::string filename)#
Function ComPWA::Optimizer::Minuit2::operator<<#
Defined in File MinuitResult.cpp
-
std::ostream &ComPWA::Optimizer::Minuit2::operator<<(std::ostream &os, const MinuitResult &Result)#
Function ComPWA::Physics::createFourMomentum#
Defined in File BuilderXML.cpp
-
FourMomentum ComPWA::Physics::createFourMomentum(const boost::property_tree::ptree &pt)#
Function ComPWA::Physics::createHelicityKinematics(const std::string)#
Defined in File BuilderXML.cpp
-
HelicityKinematics ComPWA::Physics::createHelicityKinematics(const std::string XmlFile)#
Create HelicityKinematics object from an XML file that contains both a kinematics section and a particle section.
Function ComPWA::Physics::createHelicityKinematics(const ComPWA::ParticleList&, const std::string)#
Defined in File BuilderXML.cpp
-
HelicityKinematics ComPWA::Physics::createHelicityKinematics(const ComPWA::ParticleList &PartList, const std::string XmlFile)#
Create HelicityKinematics object from an XML file with a kinematics section and provide a particle list separately.
Function ComPWA::Physics::createHelicityKinematics(const ComPWA::ParticleList&, const boost::property_tree::ptree&)#
Defined in File BuilderXML.cpp
-
HelicityKinematics ComPWA::Physics::createHelicityKinematics(const ComPWA::ParticleList &ParticleList, const boost::property_tree::ptree &ptree)#
Function ComPWA::Physics::createKinematicsInfo#
Defined in File BuilderXML.cpp
-
ParticleStateTransitionKinematicsInfo ComPWA::Physics::createKinematicsInfo(const ComPWA::ParticleList &PartList, const boost::property_tree::ptree &pt)#
Function ComPWA::Physics::Dynamics::couplingToWidth#
Defined in File Coupling.hpp
-
inline std::complex<double> ComPWA::Physics::Dynamics::couplingToWidth(double mR, double g, std::complex<double> gamma, std::complex<double> phspFactor)#
Convert width to complex coupling.
This is the implementation of PDG2014, Chapter 47.2, Eq. 47.21 (inverted).
Function ComPWA::Physics::Dynamics::createFunctionTree#
Defined in File FormFactor.cpp
Function ComPWA::Physics::Dynamics::Flatte::createFunctionTree#
Defined in File Flatte.hpp
Function ComPWA::Physics::Dynamics::Flatte::dynamicalFunction(double, double, double, std::complex<double>, std::complex<double>, std::complex<double>)#
Defined in File Flatte.hpp
-
inline std::complex<double> ComPWA::Physics::Dynamics::Flatte::dynamicalFunction(double mSq, double mR, double gA, std::complex<double> termA, std::complex<double> termB, std::complex<double> termC = std::complex<double>(0, 0))#
Dynamical function for two coupled channel approach.
Function ComPWA::Physics::Dynamics::Flatte::flatteCouplingTerm#
Defined in File Flatte.hpp
Helper function to calculate the coupling terms for the Flatte formular.
Function ComPWA::Physics::Dynamics::phspFactor#
Defined in File FormFactor.hpp
-
inline double ComPWA::Physics::Dynamics::phspFactor(double sqrtS, double ma, double mb)#
Function ComPWA::Physics::Dynamics::phspFactorAC#
Defined in File FormFactor.hpp
-
inline std::complex<double> ComPWA::Physics::Dynamics::phspFactorAC(double sqrtS, double ma, double mb)#
Two body phsp factor.
From PDG2014 Eqn.47-2
- Parameters
sqrtS – invariant mass of particles A and B
ma – Mass of particle A
mb – Mass of particle B
Function ComPWA::Physics::Dynamics::qSquared#
Defined in File FormFactor.hpp
-
inline double ComPWA::Physics::Dynamics::qSquared(double S, double sqrtSA, double sqrtSB)#
Calculate Break-up momentum squared.
At energy
S
for particles with massessqrtSA
andsqrtSB
. From PDG2014 Eq.46-20a.- Parameters
S – squared invariant mass of decaying system
sqrtSA – invariant mass of decay product A
sqrtSB – invariant mass of decay product B
Function ComPWA::Physics::Dynamics::qValueAC#
Defined in File FormFactor.hpp
-
inline std::complex<double> ComPWA::Physics::Dynamics::qValueAC(double sqrtS, double ma, double mb)#
Calculate Break-up momentum.
At energy
sqrtS
for particles with massesma
andmb
. From PDG2014 Eq.46-20a. Below threshold the function is analytically continued.- Parameters
sqrtS – center-of-mass energy
ma – mass particle A
mb – mass particle B
Function ComPWA::Physics::Dynamics::RelativisticBreitWigner::createFunctionTree#
Defined in File RelativisticBreitWigner.hpp
Function ComPWA::Physics::Dynamics::RelativisticBreitWigner::relativisticBreitWigner#
Defined in File RelativisticBreitWigner.hpp
Relativistic Breit-Wigner model with barrier factors.
The dynamical function implemented here is taken from PDG2018 (Eq.48.22) for the one channel case. The dynamic reaction
\[ \mathcal{A}_R(s) = \frac{g_p*g}{s - M_R^2 + i \sqrt{s} \Gamma_R B^2} \]\( g_p, g\) are the coupling constants for production and decay and the barrier term \( B^2\) is parameterized according to Eq.48.23:\[ B^2 = \left( \frac{q(\sqrt{s})}{q(M_R)} \right)^{2L+1} \times \left( \frac{M_R}{\sqrt{s}} \right) \times \left( \frac{F(\sqrt{s})}{F(\sqrt{s_R})} \right)^{2} \]This corresponds to the Blatt Weisskopf form factors B_L like\[ B^2 = \left( \frac{q(\sqrt{s})}{q(M_R)} \right) \times \left( \frac{M_R}{\sqrt{s}} \right) \times \left( \frac{B_L(\sqrt{s})}{B_L(\sqrt{s_R})} \right)^{2} \]- Parameters
mSq – Invariant mass squared
mR – Mass of the resonant state
ma – Mass of daughter particle
mb – Mass of daughter particle
width – Decay width
L – Orbital angular momentum between two daughters a and b
mesonRadius – Meson Radius
FormFactorFunctor – Form factor functor
- Returns
Amplitude value
Function ComPWA::Physics::Dynamics::RelativisticBreitWigner::relativisticBreitWignerAnalyticCont#
Defined in File RelativisticBreitWigner.hpp
Relativistic Breit-Wigner model with barrier factors.
The dynamical function implemented here is taken from PDG2018 (Eq.48.22) for the one channel case. The dynamic reaction
\[ \mathcal{A}_R(s) = \frac{g_p*g}{s - M_R^2 + i \sqrt{s} \Gamma_R B^2} \]\( g_p, g\) are the coupling constants for production and decay and the barrier term \( B^2\) is parameterized according to Eq.48.23:\[ B^2 = \left( \frac{q(\sqrt{s})}{q(M_R)} \right)^{2L+1} \times \left( \frac{M_R}{\sqrt{s}} \right) \times \left( \frac{F(\sqrt{s})}{F(\sqrt{s_R})} \right)^{2} \]This corresponds to the Blatt Weisskopf form factors B_L like\[ B^2 = \left( \frac{q(\sqrt{s})}{q(M_R)} \right) \times \left( \frac{M_R}{\sqrt{s}} \right) \times \left( \frac{B_L(\sqrt{s})}{B_L(\sqrt{s_R})} \right)^{2} \]- Parameters
mSq – Invariant mass squared
mR – Mass of the resonant state
ma – Mass of daughter particle
mb – Mass of daughter particle
width – Decay width
L – Orbital angular momentum between two daughters a and b
mesonRadius – Meson Radius
FormFactorFunctor – Form factor functor
- Returns
Amplitude value
Function ComPWA::Physics::Dynamics::Voigtian::createFunctionTree#
Defined in File Voigtian.hpp
Function ComPWA::Physics::Dynamics::Voigtian::dynamicalFunction#
Defined in File Voigtian.hpp
-
inline std::complex<double> ComPWA::Physics::Dynamics::Voigtian::dynamicalFunction(double mSq, double mR, double wR, double sigma)#
Dynamical voigt function.
- Parameters
mSq – Invariant mass squared
mR – Mass of the resonant state
wR – Width of the resonant state
sigma – Width of the gaussian, i.e., the resolution of the mass spectrum at mR
- Returns
Amplitude value
Function ComPWA::Physics::Dynamics::widthToCoupling#
Defined in File Coupling.hpp
-
inline std::complex<double> ComPWA::Physics::Dynamics::widthToCoupling(double mR, double width, std::complex<double> gamma, std::complex<double> phspFactor)#
Convert width to complex coupling.
The form factor
formFactorR
, the normalized vertex functiongamma
(both evaluated at the resonance pole) and thephspFactor
(evaluated at sqrt(s)) can be passed in order to save computation time. This is the implementation of PDG2014, Chapter 47.2, Eq. 47.21. See also widthToCoupling(double mSq, double mR, double width, double ma, double mb, double spin, double mesonRadius, formFactorType type)
Function ComPWA::Physics::extractDecayInfo#
Defined in File BuilderXML.cpp
-
TwoBodyDecayInfo ComPWA::Physics::extractDecayInfo(const boost::property_tree::ptree &pt)#
Function ComPWA::Physics::HelicityFormalism::redistributeIndexLists#
Defined in File HelicityKinematics.cpp
Function ComPWA::Physics::HelicityFormalism::sortSubsystem#
Defined in File HelicityKinematics.cpp
-
IndexListTuple ComPWA::Physics::HelicityFormalism::sortSubsystem(const IndexListTuple &SubSys)#
Function ComPWA::Physics::HelicityFormalism::WignerD::createFunctionTree#
Defined in File WignerD.hpp
Function ComPWA::Physics::HelicityFormalism::WignerD::dynamicalFunction(double, double, double, double)#
Defined in File WignerD.hpp
-
inline double ComPWA::Physics::HelicityFormalism::WignerD::dynamicalFunction(double J, double muPrime, double mu, double beta)#
Function ComPWA::Physics::HelicityFormalism::WignerD::dynamicalFunction(double, double, double, double, double, double)#
Defined in File WignerD.hpp
-
inline std::complex<double> ComPWA::Physics::HelicityFormalism::WignerD::dynamicalFunction(double J, double muPrime, double mu, double alpha, double beta, double gamma)#
Function ComPWA::Physics::KallenFunction#
Defined in File PhspVolume.cpp
-
double ComPWA::Physics::KallenFunction(double x, double y, double z)#
Original Källén function, that is, not having square values in its argument.
We use this function instead of the one that can be factorised (see Heron’s formula), because we need to enter \(s\) without taking its square root.
Function ComPWA::Physics::operator<<(std::ostream&, const ParticleStateTransitionKinematicsInfo&)#
-
std::ostream &ComPWA::Physics::operator<<(std::ostream &outstream, const ParticleStateTransitionKinematicsInfo &kininfo)#
Function ComPWA::Physics::operator<<(std::ostream&, const SubSystem&)#
Defined in File SubSystem.cpp
Function ComPWA::Physics::PhspVolume#
Defined in File PhspVolume.cpp
-
std::pair<double, double> ComPWA::Physics::PhspVolume(double s, std::vector<double> &FSMasses, std::size_t SampleSize = 1000)#
Compute phasespace volume of momentum space for an arbitrary number of particles in the final state using Riemann integration.
- Todo:
Implement errors (second member of the pair).
Algorithm might be improved with Simpson’s rule, because we integrate over a function that is polynomial in the limit \(m_i\rightarrow 0\)
- Returns
A pair: first value is the volume, second is the error (currently set to
0.
)
Function ComPWA::Physics::PhspVolumeTwoParticles#
Defined in File PhspVolume.cpp
-
double ComPWA::Physics::PhspVolumeTwoParticles(double s, double m1, double m2)#
Phase space element for a two particle decay.
An analytic solution exists only for the volume of the phasespace of two-particle decays.
Function ComPWA::Physics::SRange#
Defined in File PhspVolume.cpp
-
std::pair<double, double> ComPWA::Physics::SRange(double s, std::vector<double> &masses)#
Function ComPWA::Physics::stringToVectInt#
Defined in File SubSystem.hpp
-
inline std::vector<unsigned int> ComPWA::Physics::stringToVectInt(std::string str)#
Helper funtions to transfor a string of space-separated numbers to a vector<unsigned int>.
E.g. “1 2 3” =? vector<unsigned int>({1,2,3})
Function ComPWA::Physics::updateDataContainerContent#
Defined in File BuilderXML.cpp
-
void ComPWA::Physics::updateDataContainerContent(ComPWA::FunctionTree::ParameterList &DataList, const EventCollection &DataSample, const Kinematics &Kinematics)#
Function ComPWA::Physics::updateDataContainerState#
Defined in File BuilderXML.cpp
-
void ComPWA::Physics::updateDataContainerState(ComPWA::FunctionTree::ParameterList &DataSample, const Kinematics &Kinematics)#
Function ComPWA::readParticles(std::stringstream&)#
Defined in File Properties.cpp
-
ParticleList ComPWA::readParticles(std::stringstream &Stream)#
Read list of particles from a stringstream For some reason the boost xml parser needs a non-const reference.
Function ComPWA::readParticles(std::string)#
Defined in File Properties.cpp
-
ParticleList ComPWA::readParticles(std::string FileName)#
Read list of particles from a xml file.
Function ComPWA::readParticles(boost::property_tree::ptree&)#
Defined in File Properties.cpp
-
ParticleList ComPWA::readParticles(boost::property_tree::ptree &pt)#
Read list of particles from a
boost::property_tree::ptree
Function ComPWA::Tools::Adapter::BOSS::createHelicityModel#
Defined in File BOSSAdapter.hpp
-
std::pair<FunctionTree::FunctionTreeIntensity, Physics::HelicityFormalism::HelicityKinematics> ComPWA::Tools::Adapter::BOSS::createHelicityModel(const char *modelXMLFile, int seed, const std::vector<pid> &initialState, const std::vector<pid> &finalState, const char *particleXMLFile)#
Function ComPWA::Tools::fixParameter#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::fixParameter(boost::property_tree::ptree &Tree, const std::string ParameterName, double Value = -999)#
Fix specified parameters of a ptree.
- Parameters
Tree – Property tree which contains parameters.
ParameterName – Parameters with same name will be updated.
Value – New value of parameter. Default means fix to current value.
Function ComPWA::Tools::integrate#
Defined in File Integration.cpp
Function ComPWA::Tools::integrateWithError#
Defined in File Integration.cpp
-
std::pair<double, double> ComPWA::Tools::integrateWithError(ComPWA::Intensity &intensity, const ComPWA::Data::DataSet &phspsample, double phspVolume = 1.0)#
Calculate integral and its error.
We follow https://en.wikipedia.org/wiki/Monte_Carlo_integration. The average intensity is given by:
\[ \langle f \rangle =\frac{1}{N} \sum_{i=1}^N f(\overline{\mathbf{x}}_i) \]and the integral estimate Q_N using a sample size of N events is given by:\[ I \approx Q_N = V*\langle f \rangle. \]The variance is given by\[ \mathrm{Var}(Q_N) = \frac{V^2}{N} \frac{1}{(N-1)} \sum_{i=1}^N \left (f(\overline{\mathbf{x}}_i) - \langle f \rangle \right )^2 \]We use a Kahan summation to improve numerical stability. We return \( \sqrt{\mathrm{Var}(Q_N)} \) as error.
Function ComPWA::Tools::KahanSum#
Defined in File Integration.cpp
-
KahanSummation ComPWA::Tools::KahanSum(KahanSummation accumulation, double value)#
KahanSummation keeps track of lost bits and reduced the uncertainty in the summation of many large/small numbers.
Function ComPWA::Tools::maximum#
Defined in File Integration.cpp
Function ComPWA::Tools::operator<<#
Defined in File FitFractions.cpp
-
std::ostream &ComPWA::Tools::operator<<(std::ostream &os, const FitFractionList &FFList)#
Function ComPWA::Tools::Plotting::phspContour#
Defined in File DalitzPlot.cpp
-
void ComPWA::Tools::Plotting::phspContour(unsigned int SysX, unsigned int SysY, unsigned int n, double *CoordX, double *CoordY)#
Function ComPWA::Tools::Plotting::writeDataSimple#
Defined in File RootPlotData.cpp
Function ComPWA::Tools::releaseParameter#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::releaseParameter(boost::property_tree::ptree &Tree, const std::string ParameterName, double Value = -999)#
Release specified parameters of a ptree.
- Parameters
Tree – Property tree which contains parameters.
ParameterName – Parameters with same name will be updated.
Value – New value of parameter. Default means the current value.
Function ComPWA::Tools::updateParameter(boost::property_tree::ptree&, const std::string&, const std::string&, double, bool, double, double, bool, bool, bool)#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::updateParameter(boost::property_tree::ptree &Tree, const std::string &KeyType, const std::string &KeyValue, double Value, bool Fix, double Min, double Max, bool UpdateValue, bool UpdateFix, bool UpdateRange)#
Update specified parameters of a ptree.
- Parameters
Tree – Property tree which contains parameters.
KeyType – The type(e.g., “Name” or “Type”) of ‘key’ used to find parameter in the ptree.
KeyValue – The value of ‘key’ used to find parameter in the ptree.
Value – New value of parameter.
Fix – Parameter will be fixed or not.
Min – Lower range of the parameter
Max – Upper range of the parameter
UpdateValue – If update value of the parameter or not.
UpdateFix – If update fix status of the parameter or not.
UpdateRange – If update range of the parameter or not.
Function ComPWA::Tools::updateParameter(boost::property_tree::ptree&, const FitParameterList&)#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::updateParameter(boost::property_tree::ptree &Tree, const FitParameterList &FitParameters)#
Update value, range, fix status of parameters of a ptree, the new values comes from
fitParameters
.- Parameters
Tree – Property tree which contains parameters.
FitParameters – Target parameters’ vector. Parameters appear both in
Tree
andFitParameters
will be updated according the parameter inFitParameters
Function ComPWA::Tools::updateParameterRangeByName#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::updateParameterRangeByName(boost::property_tree::ptree &Tree, const std::string &ParameterName, double Min, double Max)#
Update range of specified parameters of a ptree.
- Parameters
Tree – Property tree which contains parameters.
ParameterName – Parameters with same name will be updated.
Min – Minimum value of the range.
Max – Maximum value of the range.
Function ComPWA::Tools::updateParameterRangeByType#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::updateParameterRangeByType(boost::property_tree::ptree &Tree, const std::string &ParameterType, double Min, double Max)#
Update range of specified parameters of a ptree.
- Parameters
Tree – Property tree which contains parameters.
ParameterType – Parameters with same type (e.g., Magnitude) will be updated.
Min – Minimum value of the range.
Max – Maximum value of the range.
Function ComPWA::Tools::updateParameterValue#
Defined in File UpdatePTreeParameter.cpp
-
void ComPWA::Tools::updateParameterValue(boost::property_tree::ptree &Tree, const std::string ParameterName, double Value)#
Update value of specified parameters of a ptree.
- Parameters
Tree – Property tree which contains parameters.
ParameterName – Parameters with same name will be updated.
Value – New value of parameter.
Function ComPWA::Utils::equal#
Defined in File Utils.hpp
-
inline bool ComPWA::Utils::equal(double x, double y, int nEpsilon)#
Check of numbers
x
andare
equal withinnEpsion
times the numerical limit.
Function ComPWA::Utils::shiftAngle#
Defined in File Utils.hpp
-
inline double ComPWA::Utils::shiftAngle(double value)#
Function ComPWA::Utils::splitString#
Defined in File Utils.hpp
-
inline std::vector<std::string> ComPWA::Utils::splitString(const std::string &str, char separator = ' ')#
split the string into pieces, which are separated by the separator character (default separator: space)
Function cpolar#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “cpolar” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function createEnergyPar#
Defined in File SimFit.cpp
Warning
doxygenfunction: Cannot find function “createEnergyPar” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function Dawson(double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “Dawson” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function Dawson(cmplx, double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “Dawson” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function drawHist#
Defined in File HistTools.hpp
-
inline TPad *drawHist(std::vector<TH1D*> Histograms, std::vector<TString> DrawOption, double Min = 0, double Max = 0)#
Function drawPull(std::vector<TH1D *>, std::vector<TString>, double, double)#
Defined in File HistTools.hpp
-
inline TPad *drawPull(std::vector<TH1D*> Histogram, std::vector<TString> DrawOptions, double Min = 0, double Max = 0)#
Function drawPull(TH1D *, TH1D *, TString, TString, double, double)#
Defined in File HistTools.hpp
-
inline TPad *drawPull(TH1D *Histogram1, TH1D *Histogram2, TString DrawOption1, TString DrawOption2, double Min = 0, double Max = 0)#
Function drawResidual(std::vector<TH1D *>, std::vector<TString>, double, double)#
Defined in File HistTools.hpp
-
inline TPad *drawResidual(std::vector<TH1D*> Histograms, std::vector<TString> DrawOptions, double Min = 0, double Max = 0)#
Function drawResidual(TH1D *, TH1D *, TString, TString, double, double)#
Defined in File HistTools.hpp
-
inline TPad *drawResidual(TH1D *Histogram1, TH1D *Histogram2, TString DrawOption1, TString DrawOption2, double Min = 0, double Max = 0)#
Function erf(double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erf” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erf(cmplx, double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erf” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfc(double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfc” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfc(cmplx, double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfc” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfcx(cmplx, double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfcx” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfcx(double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfcx” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfcx_y100#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfcx_y100” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfi(cmplx, double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfi” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function erfi(double)#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “erfi” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function getPull#
Defined in File HistTools.hpp
-
inline TH1 *getPull(TH1 *Histogram1, TH1 *Histogram2, TString Name = "pull_")#
Function getResidual#
Defined in File HistTools.hpp
-
inline TH1 *getResidual(TH1 *Histogram1, TH1 *Histogram2, TString Name = "res_")#
Function getTH2PolyChi2#
Defined in File HistTools.hpp
-
inline void getTH2PolyChi2(TH2Poly *Histogram1, TH2Poly *Histogram2, double &Chi2, int &NDF, int &IGood)#
Function getTH2PolyPull#
Defined in File HistTools.hpp
-
inline TH2Poly *getTH2PolyPull(TH2Poly *Histogram1, TH2Poly *Histogram2, TString Name)#
Function main(int, char **)#
Defined in File DalitzFitApp.cpp
Warning
doxygenfunction: Cannot find function “main” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function main(int, char **)#
Defined in File SimFit.cpp
Warning
doxygenfunction: Cannot find function “main” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function sinc#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “sinc” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function sinh_taylor#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “sinh_taylor” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function sqr#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “sqr” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Template Function std::combineHash#
Defined in File SubSystem.hpp
Function w#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “w” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function w_im#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “w_im” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Function w_im_y100#
Defined in File Faddeeva.cc
Warning
doxygenfunction: Cannot find function “w_im_y100” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Variables#
Variable AmplitudeModel#
Defined in File DalitzFitApp.cpp
Warning
doxygenvariable: Cannot find variable “AmplitudeModel” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Variable ComPWA::FunctionTree::ParNames#
Defined in File Parameter.hpp
-
static const char *const ComPWA::FunctionTree::ParNames[7] = {"UNDEFINED", "COMPLEX", "DOUBLE", "INTEGER", "MCOMPLEX", "MDOUBLE", "MINTEGER"}#
Names of the parameter types, should be extended if an new parameter type is added.
Variable expa2n2#
Defined in File Faddeeva.cc
Warning
doxygenvariable: Cannot find variable “expa2n2” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Variable ModelSqrtS4230#
Defined in File SimFit.cpp
Warning
doxygenvariable: Cannot find variable “ModelSqrtS4230” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Variable ModelSqrtS4260#
Defined in File SimFit.cpp
Warning
doxygenvariable: Cannot find variable “ModelSqrtS4260” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Variable MyParticleList#
Defined in File DalitzFitApp.cpp
Warning
doxygenvariable: Cannot find variable “MyParticleList” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Variable MyParticleList#
Defined in File SimFit.cpp
Warning
doxygenvariable: Cannot find variable “MyParticleList” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Defines#
Define Inf#
Defined in File Faddeeva.cc
Warning
doxygendefine: Cannot find define “Inf” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Define NaN#
Defined in File Faddeeva.cc
Warning
doxygendefine: Cannot find define “NaN” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Define USE_CONTINUED_FRACTION#
Defined in File Faddeeva.cc
Warning
doxygendefine: Cannot find define “USE_CONTINUED_FRACTION” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Typedefs#
Typedef cmplx#
Defined in File Faddeeva.cc
Warning
doxygentypedef: Cannot find typedef “cmplx” in doxygen xml output for project “ComPWA” from directory: ./doxyoutput/xml
Typedef ComPWA::DataMap#
Defined in File Function.hpp
-
using ComPWA::DataMap = std::unordered_map<std::string, std::vector<double>>#
Typedef ComPWA::FitParameterList#
Defined in File FitParameter.hpp
-
using ComPWA::FitParameterList = std::vector<FitParameter<double>>#
Typedef ComPWA::IndexList#
Defined in File SubSystem.hpp
-
typedef std::vector<unsigned int> ComPWA::IndexList#
Typedef ComPWA::Intensity#
Defined in File Function.hpp
Typedef ComPWA::ParticleList#
Defined in File Properties.hpp
-
using ComPWA::ParticleList = std::set<ParticleProperties>#
Typedef ComPWA::Physics::Dynamics::RelativisticBreitWigner::BreitWignerFunction#
Defined in File RelativisticBreitWigner.hpp
-
using ComPWA::Physics::Dynamics::RelativisticBreitWigner::BreitWignerFunction = std::function<std::complex<double>(double, double, double, double, double, unsigned int, double, std::shared_ptr<FormFactor>)>#
Typedef ComPWA::Physics::HelicityFormalism::IndexListTuple#
Defined in File HelicityKinematics.cpp
Typedef ComPWA::pid#
Defined in File Properties.hpp
-
typedef int ComPWA::pid#
Particle ID.
Usually the PIDs from PDG are used here: http://pdg.lbl.gov/mc_particleId_contents.html
Typedef ComPWA::Tools::FitFractionList#
Defined in File FitFractions.hpp
-
using ComPWA::Tools::FitFractionList = std::vector<FitFraction>#
Typedef ComPWA::Tools::IntensityComponent#
Defined in File FitFractions.hpp