Thermal-FIST
1.3
Package for hadron resonance gas model applications
|
Abstract base class for an HRG model implementation. More...
#include <ThermalModelBase.h>
Public Types | |
enum | ThermalModelEnsemble { GCE = 0, CE = 1, SCE = 2, CCE = 3 } |
The list of statistical ensembles. More... | |
enum | ThermalModelInteraction { Ideal = 0, DiagonalEV = 1, CrosstermsEV = 2, QvdW = 3, RealGas = 4, MeanField = 5 } |
Type of interactions included in the HRG model. More... | |
Public Member Functions | |
ThermalModelBase (ThermalParticleSystem *TPS, const ThermalModelParameters ¶ms=ThermalModelParameters()) | |
Construct a new ThermalModelBase object. More... | |
virtual | ~ThermalModelBase (void) |
int | ComponentsNumber () const |
Number of different particle species in the list. More... | |
virtual void | FillVirial (const std::vector< double > &ri=std::vector< double >(0)) |
Fills the excluded volume coefficients \( \tilde{b}_{ij} \) based on the provided radii parameters for all species. More... | |
bool | UseWidth () const |
Whether finite resonance widths are considered. More... | |
void | SetUseWidth (bool useWidth) |
Sets whether finite resonance widths are used. Deprecated. More... | |
void | SetUseWidth (ThermalParticle::ResonanceWidthIntegration type) |
Sets the finite resonance widths scheme to use. More... | |
void | SetOMP (bool openMP) |
OpenMP support. Currently not used. More... | |
void | UpdateParameters () |
Calls SetParameters() with current m_Parameters. More... | |
virtual void | SetTemperature (double T) |
Set the temperature. More... | |
virtual void | SetBaryonChemicalPotential (double muB) |
Set the baryon chemical potential. More... | |
virtual void | SetElectricChemicalPotential (double muQ) |
Set the electric chemical potential. More... | |
virtual void | SetStrangenessChemicalPotential (double muS) |
Set the strangeness chemical potential. More... | |
virtual void | SetCharmChemicalPotential (double muC) |
Set the charm chemical potential. More... | |
virtual void | SetGammaq (double gammaq) |
Set the light quark fugacity factor. More... | |
virtual void | SetGammaS (double gammaS) |
Set the strange quark fugacity factor. More... | |
virtual void | SetGammaC (double gammaC) |
Set the charm quark fugacity factor. More... | |
virtual void | SetBaryonCharge (int B) |
Set the total baryon number (for canonical ensemble only) More... | |
virtual void | SetElectricCharge (int Q) |
Set the total electric charge (for canonical ensemble only) More... | |
virtual void | SetStrangeness (int S) |
Set the total strangeness (for canonical ensemble only) More... | |
virtual void | SetCharm (int C) |
Set the total charm (for canonical ensemble only) More... | |
virtual void | SetRadius (double) |
Set the same excluded volume radius parameter for all species. More... | |
virtual void | SetRadius (int, double) |
Set the radius parameter for particle species i. More... | |
virtual void | SetVirial (int, int, double) |
Set the excluded volume coefficient \( \tilde{b}_{ij} \). More... | |
virtual void | SetAttraction (int, int, double) |
Set the vdW mean field attraction coefficient \( a_{ij} \). More... | |
virtual void | DisableMesonMesonAttraction () |
virtual void | DisableMesonBaryonAttraction () |
virtual void | DisableBaryonBaryonAttraction () |
virtual void | DisableBaryonAntiBaryonAttraction () |
virtual void | ReadInteractionParameters (const std::string &) |
Reads the QvdW interaction parameters from a file. More... | |
virtual void | WriteInteractionParameters (const std::string &) |
Write the QvdW interaction parameters to a file. More... | |
virtual void | ChangeTPS (ThermalParticleSystem *TPS) |
Change the particle list. More... | |
virtual double | AttractionCoefficient (int, int) const |
QvdW mean field attraction coefficient \( a_{ij} \). More... | |
bool | QuantumStatistics () const |
virtual void | SetStatistics (bool stats) |
virtual void | SetCalculationType (IdealGasFunctions::QStatsCalculationType type) |
Sets the CalculationType() method to evaluate quantum statistics. Calls the corresponding method in TPS(). More... | |
virtual void | SetClusterExpansionOrder (int order) |
Set the number of terms in the cluster expansion method. Calls the corresponding method in TPS(). More... | |
void | SetResonanceWidthShape (ThermalParticle::ResonanceWidthShape shape) |
Set the ThermalParticle::ResonanceWidthShape for all particles. Calls the corresponding method in TPS(). More... | |
void | SetResonanceWidthIntegrationType (ThermalParticle::ResonanceWidthIntegration type) |
Set the ThermalParticle::ResonanceWidthIntegration scheme for all particles. Calls the corresponding method in TPS(). More... | |
virtual void | FillChemicalPotentials () |
Sets the chemical potentials of all particles. More... | |
virtual void | SetChemicalPotentials (const std::vector< double > &chem=std::vector< double >(0)) |
Sets the chemical potentials of all particles. More... | |
const std::vector< double > & | ChemicalPotentials () const |
A vector of chemical potentials of all particles. More... | |
double | ChemicalPotential (int i) const |
Chemical potential of particle species i. More... | |
virtual double | FullIdealChemicalPotential (int i) const |
Chemical potential entering the ideal gas expressions of particle species i. More... | |
bool | ConstrainMuB () const |
void | ConstrainMuB (bool constrain) |
bool | ConstrainMuQ () const |
void | ConstrainMuQ (bool constrain) |
bool | ConstrainMuS () const |
void | ConstrainMuS (bool constrain) |
bool | ConstrainMuC () const |
void | ConstrainMuC (bool constrain) |
void | UsePartialChemicalEquilibrium (bool usePCE) |
Sets whether partial chemical equilibrium with additional chemical potentials is used. More... | |
bool | UsePartialChemicalEquilibrium () |
Whether partial chemical equilibrium with additional chemical potentials is used. More... | |
void | SetVolume (double Volume) |
Sets the system volume. More... | |
double | Volume () const |
System volume (fm \(^3\)) More... | |
void | SetVolumeRadius (double R) |
Sets the system radius. More... | |
double | CanonicalVolume () const |
The canonical correlation volume V \(_c\) (fm \(^3\)) More... | |
void | SetCanonicalVolume (double Volume) |
Set the canonical correlation volume V \(_c\). More... | |
void | SetCanonicalVolumeRadius (double Rc) |
Set the canonical correlation system radius. More... | |
void | ConstrainChemicalPotentials (bool resetInitialValues=true) |
Constrains the chemical potentials \( \mu_B,\,\mu_Q,\,\mu_S,\,\mu_C \) by the conservation laws imposed. More... | |
virtual void | FixParameters () |
Method which actually implements ConstrainChemicalPotentials() (for backward compatibility). More... | |
virtual void | FixParametersNoReset () |
Method which actually implements ConstrainChemicalPotentialsNoReset() (for backward compatibility). More... | |
virtual bool | SolveChemicalPotentials (double totB=0., double totQ=0., double totS=0., double totC=0., double muBinit=0., double muQinit=0., double muSinit=0., double muCinit=0., bool ConstrMuB=true, bool ConstrMuQ=true, bool ConstrMuS=true, bool ConstrMuC=true) |
The procedure which calculates the chemical potentials \( \mu_B,\,\mu_Q,\,\mu_S,\,\mu_Q \) which reproduce the specified total baryon, electric, strangeness, and charm charges of the system. More... | |
virtual void | CalculatePrimordialDensities ()=0 |
Calculates the primordial densities of all species. More... | |
virtual void | CalculateDensities () |
Calculates the primordial and total (after decays) densities of all species. More... | |
virtual void | ValidateCalculation () |
Checks whether issues have occured during the calculation of particle densities in the CalculateDensities() method. More... | |
std::string | ValidityCheckLog () const |
All messaged which occured during the validation procedure in the ValidateCalculation() method. More... | |
virtual void | CalculateDensitiesGCE () |
Calculates the particle densities in a grand-canonical ensemble. More... | |
virtual void | CalculateFeeddown () |
Calculates the total densities which include feeddown contributions. More... | |
virtual void | CalculateFluctuations () |
Computes the fluctuation observables. More... | |
virtual void | CalculateTwoParticleCorrelations () |
Computes the fluctuations and correlations of the primordial particle numbers. More... | |
virtual void | CalculateTwoParticleFluctuationsDecays () |
Computes particle number correlations and fluctuations for all final-state particles which are marked stable. More... | |
virtual double | TwoParticleSusceptibilityPrimordial (int i, int j) const |
Returns the computed primordial particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with ids i and j. CalculateFluctuations() must be called beforehand. More... | |
virtual double | TwoParticleSusceptibilityPrimordialByPdg (long long id1, long long id2) |
Returns the computed primordial particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with pdg codes id1 and id2. CalculateFluctuations() must be called beforehand. More... | |
virtual double | NetParticleSusceptibilityPrimordialByPdg (long long id1, long long id2) |
Returns the computed (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) between primordial net-particle numbers for pdg codes id1 and id2. CalculateFluctuations() must be called beforehand. More... | |
virtual double | TwoParticleSusceptibilityFinal (int i, int j) const |
Returns the computed final particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with ids i and j. CalculateFluctuations() must be called beforehand. Both particle species must be those marked stable. More... | |
virtual double | TwoParticleSusceptibilityFinalByPdg (long long id1, long long id2) |
Returns the computed final particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with pdg codes id1 and id2. CalculateFluctuations() must be called beforehand. Both particle species must be those marked stable. More... | |
virtual double | NetParticleSusceptibilityFinalByPdg (long long id1, long long id2) |
Returns the computed (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) between final net-particle numbers for pdg codes id1 and id2. CalculateFluctuations() must be called beforehand. More... | |
virtual double | PrimordialParticleChargeSusceptibility (int i, ConservedCharge::Name chg) const |
Returns the computed primordial particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with id i and conserved charge chg. CalculateFluctuations() must be called beforehand. More... | |
virtual double | PrimordialParticleChargeSusceptibilityByPdg (long long id1, ConservedCharge::Name chg) |
Returns the computed primordial particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand. More... | |
virtual double | PrimordialNetParticleChargeSusceptibilityByPdg (long long id1, ConservedCharge::Name chg) |
Returns the computed primordial net particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand. More... | |
virtual double | FinalParticleChargeSusceptibility (int i, ConservedCharge::Name chg) const |
Returns the computed final (after decays) particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with id i and conserved charge chg. CalculateFluctuations() must be called beforehand. More... | |
virtual double | FinalParticleChargeSusceptibilityByPdg (long long id1, ConservedCharge::Name chg) |
Returns the computed final (after decays) particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand. More... | |
virtual double | FinalNetParticleChargeSusceptibilityByPdg (long long id1, ConservedCharge::Name chg) |
Returns the computed final (after decays) net particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand. More... | |
virtual void | CalculateSusceptibilityMatrix () |
Calculates the conserved charges susceptibility matrix. More... | |
virtual void | CalculateProxySusceptibilityMatrix () |
Calculates the susceptibility matrix of conserved charges proxies. More... | |
virtual void | CalculateParticleChargeCorrelationMatrix () |
Calculates the matrix of correlators between primordial (and also final) particle numbers and conserved charges. More... | |
virtual std::vector< double > | CalculateChargeFluctuations (const std::vector< double > &chgs, int order=4) |
Calculates fluctuations (diagonal susceptibilities) of an arbitrary "conserved" charge. More... | |
double | Pressure () |
System pressure (GeV fm \(^{-3}\)) More... | |
double | EnergyDensity () |
Energy density (GeV fm \(^{-3}\)) More... | |
double | EntropyDensity () |
Entropy density (fm \(^{-3}\)) More... | |
double | HadronDensity () |
Total number density of all particle (fm \(^{-3}\)) More... | |
double | BaryonDensity () |
Net baryon density (fm \(^{-3}\)) More... | |
double | ElectricChargeDensity () |
Electric charge density (fm \(^{-3}\)) More... | |
double | StrangenessDensity () |
Net strangeness density (fm \(^{-3}\)) More... | |
double | CharmDensity () |
Net charm density (fm \(^{-3}\)) More... | |
double | AbsoluteBaryonDensity () |
Absolute baryon number density (baryons + antibaryons) (fm \(^{-3}\)) More... | |
double | AbsoluteElectricChargeDensity () |
Absolute electric charge density (Q+ + Q-) (fm \(^{-3}\)) More... | |
double | AbsoluteStrangenessDensity () |
Absolute strange quark content density (fm \(^{-3}\)) More... | |
double | AbsoluteCharmDensity () |
Absolute charm quark content density (fm \(^{-3}\)) More... | |
virtual double | CalculateArbitraryChargeDensity () |
Computes the density of the auxiliary ArbitraryCharge() More... | |
virtual double | CalculateBaryonMatterEntropyDensity () |
The fraction of entropy carried by baryons (Ideal GCE only) More... | |
virtual double | CalculateMesonMatterEntropyDensity () |
The fraction of entropy carried by mesons (Ideal GCE only) More... | |
virtual double | ParticleScaledVariance (int) |
Scaled variance of primordial particle number fluctuations for species i. More... | |
virtual double | ParticleSkewness (int) |
Skewness of primordial particle number fluctuations for species i. More... | |
virtual double | ParticleKurtosis (int) |
Kurtosis of primordial particle number fluctuations for species i. More... | |
virtual double | CalculateEigenvolumeFraction () |
virtual double | ParticleScalarDensity (int i)=0 |
The scalar density of the particle species i. More... | |
virtual double | GetMaxDiff () const |
virtual bool | IsLastSolutionOK () const |
double | GetDensity (long long PDGID, int feeddown) |
Same as GetDensity(int,Feeddown::Type) More... | |
double | GetDensity (long long PDGID, Feeddown::Type feeddown) |
Particle number density of species with a specified PDG ID and feeddown. More... | |
double | GetYield (long long PDGID, Feeddown::Type feeddown) |
Particle number yield of species with a specified PDG ID and feeddown. More... | |
std::vector< double > | GetIdealGasDensities () const |
ThermalParticleSystem * | TPS () |
const std::vector< double > & | Densities () const |
const std::vector< double > & | TotalDensities () const |
const std::vector< std::vector< double > > & | AllDensities () const |
void | SetTAG (const std::string &tag) |
Set the tag for this ThermalModelBase object. More... | |
const std::string & | TAG () const |
The tag of this ThermalModelBase object. More... | |
void | ResetCalculatedFlags () |
Reset all flags which correspond to a calculation status. More... | |
bool | IsCalculated () const |
bool | IsFluctuationsCalculated () const |
bool | IsGCECalculated () const |
double | ScaledVariancePrimordial (int id) const |
Scaled variance of primordial particle number fluctuations for particle species id. More... | |
double | ScaledVarianceTotal (int id) const |
Scaled variance of final particle number fluctuations for particle species id. More... | |
double | SkewnessPrimordial (int id) const |
Normalized skewness of primordial particle number fluctuations for particle species id. More... | |
double | SkewnessTotal (int id) const |
Normalized skewness of final particle number fluctuations for particle species id. More... | |
double | KurtosisPrimordial (int id) const |
Normalized excess kurtosis of primordial particle number fluctuations for particle species id. More... | |
double | KurtosisTotal (int id) const |
Normalized excess kurtosis of final particle number fluctuations for particle species id. More... | |
double | ConservedChargeDensity (ConservedCharge::Name chg) |
A density of a conserved charge (in fm^-3) More... | |
double | Susc (ConservedCharge::Name i, ConservedCharge::Name j) const |
A 2nd order susceptibility of conserved charges. More... | |
double | ProxySusc (ConservedCharge::Name i, ConservedCharge::Name j) const |
A 2nd order susceptibility of conserved charges proxies. More... | |
double | ChargedMultiplicity (int type=0) |
Multiplicity of charged particles. More... | |
double | ChargedScaledVariance (int type=0) |
Scaled variance of charged particles. More... | |
double | ChargedMultiplicityFinal (int type=0) |
Multiplicity of charged particles including the feeddown contributions in accordance with the stability flags. More... | |
double | ChargedScaledVarianceFinal (int type=0) |
Scaled variance of charged particles including the feeddown contributions in accordance with the stability flags. More... | |
ThermalModelEnsemble | Ensemble () |
The statistical ensemble of the current HRG model. More... | |
virtual bool | IsConservedChargeCanonical (ConservedCharge::Name charge) const |
Whether the given conserved charge is treated canonically. More... | |
ThermalModelInteraction | InteractionModel () |
The interactions present in the current HRG model. More... | |
void | SetNormBratio (bool normBratio) |
Whether branching ratios are renormalized to 100%. More... | |
bool | NormBratio () const |
virtual void | SetParameters (const ThermalModelParameters ¶ms) |
The thermal parameters. More... | |
const ThermalModelParameters & | Parameters () const |
virtual void | DisableMesonMesonVirial () |
void | DisableMesonMesonRepulsion () |
virtual void | DisableMesonBaryonVirial () |
void | DisableMesonBaryonRepulsion () |
virtual void | DisableBaryonBaryonVirial () |
void | DisableBaryonBaryonRepulsion () |
virtual void | DisableBaryonAntiBaryonVirial () |
void | DisableBaryonAntiBaryonRepulsion () |
virtual double | VirialCoefficient (int, int) const |
Excluded volume coefficient \( \tilde{b}_{ij} = 0 \). More... | |
double | RepulsionCoefficient (int i, int j) const |
void | SetSoverB (double SB) |
The entropy per baryon ratio to be used to constrain the baryon chemical potential. More... | |
double | SoverB () const |
void | SetQoverB (double QB) |
The electric-to-baryon charge ratio to be used to constrain the electric chemical potential. More... | |
double | QoverB () const |
virtual double | CalculatePressure ()=0 |
Implementation of the equation of state functions. More... | |
virtual double | CalculateEnergyDensity ()=0 |
virtual double | CalculateEntropyDensity ()=0 |
virtual double | CalculateHadronDensity () |
virtual double | CalculateBaryonDensity () |
virtual double | CalculateChargeDensity () |
virtual double | CalculateStrangenessDensity () |
virtual double | CalculateCharmDensity () |
virtual double | CalculateAbsoluteBaryonDensity () |
virtual double | CalculateAbsoluteChargeDensity () |
virtual double | CalculateAbsoluteStrangenessDensity () |
virtual double | CalculateAbsoluteCharmDensity () |
Protected Member Functions | |
virtual double | MuShift (int) const |
Shift in chemical potential of particle species id due to interactions. More... | |
Protected Attributes | |
ThermalModelParameters | m_Parameters |
ThermalParticleSystem * | m_TPS |
bool | m_LastCalculationSuccessFlag |
double | m_MaxDiff |
bool | m_Calculated |
bool | m_FeeddownCalculated |
bool | m_FluctuationsCalculated |
bool | m_GCECalculated |
bool | m_UseWidth |
bool | m_NormBratio |
bool | m_QuantumStats |
double | m_QBgoal |
double | m_SBgoal |
double | m_Volume |
bool | m_ConstrainMuB |
bool | m_ConstrainMuQ |
bool | m_ConstrainMuS |
bool | m_ConstrainMuC |
bool | m_PCE |
bool | m_useOpenMP |
std::vector< double > | m_densities |
std::vector< double > | m_densitiestotal |
std::vector< std::vector< double > > | m_densitiesbyfeeddown |
std::vector< double > | m_Chem |
std::vector< double > | m_wprim |
std::vector< double > | m_wtot |
std::vector< double > | m_skewprim |
std::vector< double > | m_skewtot |
std::vector< double > | m_kurtprim |
std::vector< double > | m_kurttot |
std::vector< std::vector< double > > | m_PrimCorrel |
std::vector< std::vector< double > > | m_TotalCorrel |
std::vector< std::vector< double > > | m_PrimChargesCorrel |
std::vector< std::vector< double > > | m_FinalChargesCorrel |
std::vector< std::vector< double > > | m_Susc |
std::vector< std::vector< double > > | m_ProxySusc |
std::string | m_ValidityLog |
double | m_wnSum |
std::string | m_TAG |
ThermalModelEnsemble | m_Ensemble |
ThermalModelInteraction | m_InteractionModel |
Abstract base class for an HRG model implementation.
Contains the base implementation of an arbitrary HRG model. The actual calculations of thermodynamic functions are implemented in derived classes.
Definition at line 28 of file ThermalModelBase.h.
The list of statistical ensembles.
Enumerator | |
---|---|
GCE |
Grand canonical ensemble. |
CE |
Canonical ensemble. |
SCE |
Strangeness-canonical ensemble. |
CCE |
Charm-canonical ensemble. |
Definition at line 35 of file ThermalModelBase.h.
Type of interactions included in the HRG model.
Definition at line 46 of file ThermalModelBase.h.
thermalfist::ThermalModelBase::ThermalModelBase | ( | ThermalParticleSystem * | TPS, |
const ThermalModelParameters & | params = ThermalModelParameters() |
||
) |
Construct a new ThermalModelBase object.
TPS | A pointer to the ThermalParticleSystem object containing the particle list |
params | ThermalModelParameters object with current thermal parameters |
Definition at line 24 of file ThermalModelBase.cpp.
|
inlinevirtual |
Definition at line 63 of file ThermalModelBase.h.
|
inline |
Absolute baryon number density (baryons + antibaryons) (fm \(^{-3}\))
Definition at line 862 of file ThermalModelBase.h.
|
inline |
Absolute charm quark content density (fm \(^{-3}\))
Definition at line 871 of file ThermalModelBase.h.
|
inline |
Absolute electric charge density (Q+ + Q-) (fm \(^{-3}\))
Definition at line 865 of file ThermalModelBase.h.
|
inline |
Absolute strange quark content density (fm \(^{-3}\))
Definition at line 868 of file ThermalModelBase.h.
|
inline |
A vector of vectors of particle number densities with the different feeddown contributions listed in Feeddown::Type
Definition at line 971 of file ThermalModelBase.h.
|
inlinevirtual |
QvdW mean field attraction coefficient \( a_{ij} \).
i | 0-based index of the first particle species |
j | 0-based index of the second particle species |
Reimplemented in thermalfist::ThermalModelVDW, and thermalfist::ThermalModelVDWCanonicalStrangeness.
Definition at line 341 of file ThermalModelBase.h.
|
inline |
Net baryon density (fm \(^{-3}\))
Definition at line 850 of file ThermalModelBase.h.
|
virtual |
Definition at line 656 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 664 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 680 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 672 of file ThermalModelBase.cpp.
|
virtual |
Computes the density of the auxiliary ArbitraryCharge()
Definition at line 688 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 621 of file ThermalModelBase.cpp.
|
inlinevirtual |
The fraction of entropy carried by baryons (Ideal GCE only)
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 893 of file ThermalModelBase.h.
|
virtual |
Definition at line 630 of file ThermalModelBase.cpp.
|
virtual |
Calculates fluctuations (diagonal susceptibilities) of an arbitrary "conserved" charge.
Each particle specie is assumed to carry a conserved charge with a value provided by an input vector.
Restricted to the grand canonical ensemble.
chgs | A vector with conserved charge values for all species. 0-based indices of the vector must correspond to the 0-based indices of the particle list TPS() |
order | Up to which order the susceptibilities are computed |
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 606 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 648 of file ThermalModelBase.cpp.
|
virtual |
Calculates the primordial and total (after decays) densities of all species.
Definition at line 579 of file ThermalModelBase.cpp.
|
inlinevirtual |
Calculates the particle densities in a grand-canonical ensemble.
A non-GCE based derived class will override this method.
Reimplemented in thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, and thermalfist::ThermalModelVDWCanonicalStrangeness.
Definition at line 642 of file ThermalModelBase.h.
|
inlinevirtual |
Fraction of the total volume occupied by the finite-sizes particles (Diagonal excluded volume model only)
Reimplemented in thermalfist::ThermalModelEVDiagonal, and thermalfist::ThermalModelEVCanonicalStrangeness.
Definition at line 909 of file ThermalModelBase.h.
|
pure virtual |
Implemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
|
pure virtual |
Implemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
|
virtual |
Calculates the total densities which include feeddown contributions.
Calculation is based on the primordial densities computed by CalculateDensities().
Definition at line 397 of file ThermalModelBase.cpp.
|
virtual |
Computes the fluctuation observables.
Includes the matrix of 2nd order susceptibilities of conserved charges, as well as particle number correlations and fluctuations, both for primordial yields and after decays.
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 1264 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 612 of file ThermalModelBase.cpp.
|
inlinevirtual |
The fraction of entropy carried by mesons (Ideal GCE only)
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 896 of file ThermalModelBase.h.
|
virtual |
Calculates the matrix of correlators between primordial (and also final) particle numbers and conserved charges.
Correlators are normalized by VT^3.
The calculation results are accessible through PrimordialParticleChargeCorrelation() and FinalParticleChargeCorrelation().
Definition at line 1234 of file ThermalModelBase.cpp.
|
pure virtual |
Implementation of the equation of state functions.
Implemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
|
pure virtual |
Calculates the primordial densities of all species.
Implemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
|
virtual |
Calculates the susceptibility matrix of conserved charges proxies.
The following proxies are used: final net proton number for baryon number, net charge as is, and net kaon number for net strangeness. Charm not yet considered.
Decay feeddown contributions are in accordance with the stability flags.
The calculation results are accessible through ProxySusc()
Definition at line 1193 of file ThermalModelBase.cpp.
|
virtual |
Definition at line 639 of file ThermalModelBase.cpp.
|
virtual |
Calculates the conserved charges susceptibility matrix.
Computes \( \chi_{lmnk}^{BSQC}~=~\frac{\partial^{l+m+n+k}p/T^4}{\partial(\mu_B/T)^l \,\partial(\mu_S/T)^m \,\partial(\mu_Q/T)^n\,\partial(\mu_C/T)^k} \) where i+j+k+l = 2.
The calculation results are accessible through Susc()
Definition at line 1165 of file ThermalModelBase.cpp.
|
virtual |
Computes the fluctuations and correlations of the primordial particle numbers.
More specifically, computes the susceptibility matrix \( \frac{1}{VT^3} \, \langle \Delta N_i^* \Delta N_j^* \rangle \), where \( N_i^* \) is the primordial yield of species i.
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 868 of file ThermalModelBase.cpp.
|
virtual |
Computes particle number correlations and fluctuations for all final-state particles which are marked stable.
More specifically, computes the susceptibility matrix \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \), where \( N_i \) is the final yield of species i, and indices i and j corresponds to stable particles only.
To incorporate probabilistic decays uses the formalism from paper V.V. Begun, M.I. Gorenstein, M. Hauer, V. Konchakovski, O.S. Zozulya, Phys.Rev. C 74, 044903 (2006), https://arxiv.org/pdf/nucl-th/0606036.pdf
Definition at line 873 of file ThermalModelBase.cpp.
|
inline |
The canonical correlation volume V \(_c\) (fm \(^3\))
Definition at line 518 of file ThermalModelBase.h.
|
virtual |
Change the particle list.
TPS | A pointer to new particle list. |
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, and thermalfist::ThermalModelEVCrossterms.
Definition at line 318 of file ThermalModelBase.cpp.
double thermalfist::ThermalModelBase::ChargedMultiplicity | ( | int | type = 0 | ) |
Multiplicity of charged particles.
type | Type of charged particle multiplicity: 0 – multiplicity of all charged particles, \( \pm 1 \) – multiplicity of positively (negatively) charged particles, \( \pm 2 \) – total charge of all positively (negatively) charged particles |
Definition at line 779 of file ThermalModelBase.cpp.
double thermalfist::ThermalModelBase::ChargedMultiplicityFinal | ( | int | type = 0 | ) |
Multiplicity of charged particles including the feeddown contributions in accordance with the stability flags.
The meaning is the same as for ChargedMultiplicity()
Definition at line 834 of file ThermalModelBase.cpp.
double thermalfist::ThermalModelBase::ChargedScaledVariance | ( | int | type = 0 | ) |
Scaled variance of charged particles.
type | Type of the scaled variance: 0 – scaled variance of all charged particles, \( \pm 1 \) – scaled variance of positively (negatively) charged particles, \( \pm 2 \) – scaled variance of total charge of all positively (negatively) charged particles |
Definition at line 798 of file ThermalModelBase.cpp.
double thermalfist::ThermalModelBase::ChargedScaledVarianceFinal | ( | int | type = 0 | ) |
Scaled variance of charged particles including the feeddown contributions in accordance with the stability flags.
The meaning is the same as for ChargedScaledVariance()
Definition at line 849 of file ThermalModelBase.cpp.
|
inline |
Net charm density (fm \(^{-3}\))
Definition at line 859 of file ThermalModelBase.h.
double thermalfist::ThermalModelBase::ChemicalPotential | ( | int | i | ) | const |
Chemical potential of particle species i.
i | 0-based index of particle species |
Definition at line 368 of file ThermalModelBase.cpp.
|
inline |
A vector of chemical potentials of all particles.
Definition at line 415 of file ThermalModelBase.h.
|
inline |
Number of different particle species in the list.
Definition at line 66 of file ThermalModelBase.h.
double thermalfist::ThermalModelBase::ConservedChargeDensity | ( | ConservedCharge::Name | chg | ) |
A density of a conserved charge (in fm^-3)
\( \rho_{c_i} \)
i | Conserved charge |
Definition at line 766 of file ThermalModelBase.cpp.
void thermalfist::ThermalModelBase::ConstrainChemicalPotentials | ( | bool | resetInitialValues = true | ) |
Constrains the chemical potentials \( \mu_B,\,\mu_Q,\,\mu_S,\,\mu_C \) by the conservation laws imposed.
This procedure uses the Broyden's method to solve the system of equations corresponding to the conservation laws. The actual implementation of the procedure is in FixParameters() and FixParametersNoReset() methods.
resetInitialValues | Whether initial guess values for \( \mu_B,\,\mu_Q,\,\mu_S,\,\mu_C \) are reset or current values will be used |
Definition at line 437 of file ThermalModelBase.cpp.
|
inline |
Whether the baryon chemical potential is to be constrained by a fixed entropy per baryon ratio SoverB().
Definition at line 438 of file ThermalModelBase.h.
|
inline |
Sets whether the baryon chemical potential is to be constrained by a fixed entropy per baryon ratio SoverB().
Definition at line 442 of file ThermalModelBase.h.
|
inline |
Whether the charm chemical potential is to be constrained by the condition of charm neutrality
Definition at line 462 of file ThermalModelBase.h.
|
inline |
Sets whether the charm chemical potential is to be constrained by the condition of charm neutrality
Definition at line 466 of file ThermalModelBase.h.
|
inline |
Whether the electric chemical potential is to be constrained by a fixed electric-to-baryon ratio QoverB().
Definition at line 446 of file ThermalModelBase.h.
|
inline |
Sets whether the electric chemical potential is to be constrained by a fixed electric-to-baryon ratio QoverB().
Definition at line 450 of file ThermalModelBase.h.
|
inline |
Whether the strangeness chemical potential is to be constrained by the condition of strangeness neutrality
Definition at line 454 of file ThermalModelBase.h.
|
inline |
Sets whether the strangeness chemical potential is to be constrained by the condition of strangeness neutrality
Definition at line 458 of file ThermalModelBase.h.
|
inline |
A vector with primordial particle number densities. Each entry corresponds to a density of single species, in accordance with the 0-based index of each specie. PdgToId() maps PDG ID to the 0-based index.
Definition at line 958 of file ThermalModelBase.h.
|
virtual |
Switches off QvdW attraction terms for all baryon-antibaryon pairs i.e. \( a_{ij} = 0 \) for baryon-antibaryon pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 298 of file ThermalModelBase.cpp.
|
inline |
Definition at line 287 of file ThermalModelBase.h.
|
virtual |
Switches off eigenvolume terms for all baryon-antibaryon pairs i.e. \( \tilde{b}_{ij} = 0 \) for baryon-antibaryon pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 285 of file ThermalModelBase.cpp.
|
virtual |
Switches off QvdW attraction terms for all baryon-baryon pairs i.e. \( a_{ij} = 0 \) for baryon-baryon pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 272 of file ThermalModelBase.cpp.
|
inline |
Definition at line 276 of file ThermalModelBase.h.
|
virtual |
Switches off excluded volume terms for all baryon-baryon pairs i.e. \( \tilde{b}_{ij} = 0 \) for baryon-baryon pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 259 of file ThermalModelBase.cpp.
|
virtual |
Switches off QvdW attraction terms for all meson-baryon pairs i.e. \( a_{ij} = 0 \) for meson-baryon pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 246 of file ThermalModelBase.cpp.
|
inline |
Definition at line 265 of file ThermalModelBase.h.
|
virtual |
Switches off excluded volume terms for all meson-baryon pairs i.e. \( \tilde{b}_{ij} = 0 \) for meson-baryon pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 233 of file ThermalModelBase.cpp.
|
virtual |
Switches off QvdW attraction terms for all meson-meson pairs i.e. \( a_{ij} = 0 \) for meson-meson pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 221 of file ThermalModelBase.cpp.
|
inline |
Definition at line 254 of file ThermalModelBase.h.
|
virtual |
Switches off excluded volume terms for all meson-meson pairs i.e. \( \tilde{b}_{ij} = 0 \) for meson-meson pairs
Reimplemented in thermalfist::ThermalModelEVDiagonal.
Definition at line 209 of file ThermalModelBase.cpp.
|
inline |
Electric charge density (fm \(^{-3}\))
Definition at line 853 of file ThermalModelBase.h.
|
inline |
Energy density (GeV fm \(^{-3}\))
Definition at line 841 of file ThermalModelBase.h.
|
inline |
The statistical ensemble of the current HRG model.
Definition at line 1146 of file ThermalModelBase.h.
|
inline |
Entropy density (fm \(^{-3}\))
Definition at line 844 of file ThermalModelBase.h.
|
virtual |
Sets the chemical potentials of all particles.
Uses the current values of \( \mu_B,\,\mu_Q,\,\mu_S,\,\mu_Q \) to set \( \mu_i \).
Reimplemented in thermalfist::ThermalModelVDW.
Definition at line 353 of file ThermalModelBase.cpp.
|
virtual |
Fills the excluded volume coefficients \( \tilde{b}_{ij} \) based on the provided radii parameters for all species.
Fills the coefficients in accordance with Eqs. (5) and (7) here https://arxiv.org/pdf/1606.06218.pdf
ri | A vector with radii parameters for all species. 0-based indices of the vector must corresponds to the 0-based indices of the particle list TPS() |
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, and thermalfist::ThermalModelEVCrossterms.
Definition at line 90 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed final (after decays) net particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand.
Definition at line 1150 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed final (after decays) particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with id i and conserved charge chg. CalculateFluctuations() must be called beforehand.
Definition at line 1129 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed final (after decays) particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand.
Definition at line 1139 of file ThermalModelBase.cpp.
|
virtual |
Method which actually implements ConstrainChemicalPotentials() (for backward compatibility).
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelCanonicalStrangeness, and thermalfist::ThermalModelCanonicalCharm.
Definition at line 445 of file ThermalModelBase.cpp.
|
virtual |
Method which actually implements ConstrainChemicalPotentialsNoReset() (for backward compatibility).
Reimplemented in thermalfist::ThermalModelCanonical.
Definition at line 478 of file ThermalModelBase.cpp.
|
virtual |
Chemical potential entering the ideal gas expressions of particle species i.
Includes chemical non-equilibrium and EV/vdW effects
i | 0-based index of particle species |
Definition at line 377 of file ThermalModelBase.cpp.
|
inline |
Same as GetDensity(int,Feeddown::Type)
Definition at line 926 of file ThermalModelBase.h.
double thermalfist::ThermalModelBase::GetDensity | ( | long long | PDGID, |
Feeddown::Type | feeddown | ||
) |
Particle number density of species with a specified PDG ID and feeddown.
PDGID | Particle Data Group ID of the needed specie |
feeddown | Which decay feeddown contributions to take into account |
Definition at line 726 of file ThermalModelBase.cpp.
std::vector< double > thermalfist::ThermalModelBase::GetIdealGasDensities | ( | ) | const |
Definition at line 750 of file ThermalModelBase.cpp.
|
inlinevirtual |
Definition at line 914 of file ThermalModelBase.h.
|
inline |
Particle number yield of species with a specified PDG ID and feeddown.
PDGID | Particle Data Group ID of the needed specie |
feeddown | Which decay feeddown contributions to take into account |
Definition at line 946 of file ThermalModelBase.h.
|
inline |
Total number density of all particle (fm \(^{-3}\))
Definition at line 847 of file ThermalModelBase.h.
|
inline |
The interactions present in the current HRG model.
Definition at line 1159 of file ThermalModelBase.h.
|
inline |
Whether densities had been calculated with the CalculateDensities() method
Definition at line 988 of file ThermalModelBase.h.
|
inlinevirtual |
Whether the given conserved charge is treated canonically.
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCanonicalStrangeness, and thermalfist::ThermalModelVDWCanonicalStrangeness.
Definition at line 1152 of file ThermalModelBase.h.
|
inline |
Whether fluctuations were calculated with the CalculateFluctuations() method
Definition at line 992 of file ThermalModelBase.h.
|
inline |
Whether the grand-canonical ensemble particle number densities were calculated
Definition at line 996 of file ThermalModelBase.h.
|
inlinevirtual |
Whether particle densities calculation in the CalculateDensities() method were successfull
Reimplemented in thermalfist::ThermalModelVDW.
Definition at line 919 of file ThermalModelBase.h.
|
inline |
Normalized excess kurtosis of primordial particle number fluctuations for particle species id.
id | 0-based index of particle species |
Definition at line 1047 of file ThermalModelBase.h.
|
inline |
Normalized excess kurtosis of final particle number fluctuations for particle species id.
Decay feeddown is in accordance with the stability flags.
id | 0-based index of particle species |
Definition at line 1059 of file ThermalModelBase.h.
|
inlineprotectedvirtual |
Shift in chemical potential of particle species id due to interactions.
Reimplemented in thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVCrossterms, thermalfist::ThermalModelVDWCanonicalStrangeness, and thermalfist::ThermalModelEVCanonicalStrangeness.
Definition at line 1236 of file ThermalModelBase.h.
|
virtual |
Returns the computed (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) between final net-particle numbers for pdg codes id1 and id2. CalculateFluctuations() must be called beforehand.
Definition at line 1057 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) between primordial net-particle numbers for pdg codes id1 and id2. CalculateFluctuations() must be called beforehand.
Definition at line 986 of file ThermalModelBase.cpp.
|
inline |
Definition at line 108 of file ThermalModelBase.h.
|
inline |
Definition at line 121 of file ThermalModelBase.h.
|
inlinevirtual |
Kurtosis of primordial particle number fluctuations for species i.
Reimplemented in thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 905 of file ThermalModelBase.h.
|
pure virtual |
The scalar density of the particle species i.
Implemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
|
inlinevirtual |
Scaled variance of primordial particle number fluctuations for species i.
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelCanonicalStrangeness, thermalfist::ThermalModelCanonicalCharm, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 899 of file ThermalModelBase.h.
|
inlinevirtual |
Skewness of primordial particle number fluctuations for species i.
Reimplemented in thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelIdeal.
Definition at line 902 of file ThermalModelBase.h.
|
inline |
System pressure (GeV fm \(^{-3}\))
Definition at line 838 of file ThermalModelBase.h.
|
virtual |
Returns the computed primordial net particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand.
Definition at line 1114 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed primordial particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with id i and conserved charge chg. CalculateFluctuations() must be called beforehand.
Definition at line 1093 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed primordial particle vs conserved charge (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_chg \rangle \) for particle with pdg code id1 and conserved charge chg. CalculateFluctuations() must be called beforehand.
Definition at line 1103 of file ThermalModelBase.cpp.
|
inline |
A 2nd order susceptibility of conserved charges proxies.
The following proxies are used: final net proton number for baryon number, net charge as is, and net kaon number for net strangeness. Charm not yet considered.
Decay feeddown contributions are in accordance with the stability flags.
i | First proxy charge |
j | Second proxy charge |
Definition at line 1097 of file ThermalModelBase.h.
|
inline |
Definition at line 495 of file ThermalModelBase.h.
|
inline |
Whether quantum statistics is used, 0 - Boltzmann, 1 - Quantum
Definition at line 345 of file ThermalModelBase.h.
|
inlinevirtual |
Reads the QvdW interaction parameters from a file.
Actual implementation is in a derived class.
filename | File with interaction parameters. |
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, and thermalfist::ThermalModelEVCrossterms.
Definition at line 301 of file ThermalModelBase.h.
|
inline |
Definition at line 331 of file ThermalModelBase.h.
void thermalfist::ThermalModelBase::ResetCalculatedFlags | ( | ) |
Reset all flags which correspond to a calculation status.
Definition at line 758 of file ThermalModelBase.cpp.
|
inline |
Scaled variance of primordial particle number fluctuations for particle species id.
id | 0-based index of particle species |
Definition at line 1005 of file ThermalModelBase.h.
|
inline |
Scaled variance of final particle number fluctuations for particle species id.
Decay feeddown is in accordance with the stability flags.
id | 0-based index of particle species |
Definition at line 1017 of file ThermalModelBase.h.
|
inlinevirtual |
Set the vdW mean field attraction coefficient \( a_{ij} \).
i | 0-based index of the first particle species |
j | 0-based index of the second particle species |
a | vdW mean field attraction parameter \( a_{ij} \) (GeV fm \(^3\)) |
Reimplemented in thermalfist::ThermalModelVDW, and thermalfist::ThermalModelVDWCanonicalStrangeness.
Definition at line 248 of file ThermalModelBase.h.
|
virtual |
Set the total baryon number (for canonical ensemble only)
B | Total baryon number |
Definition at line 185 of file ThermalModelBase.cpp.
|
virtual |
Set the baryon chemical potential.
muB | Baryon chemical potential (GeV) |
Definition at line 145 of file ThermalModelBase.cpp.
|
inlinevirtual |
Sets the CalculationType() method to evaluate quantum statistics. Calls the corresponding method in TPS().
type | Method to evaluate quantum statistics. |
Definition at line 357 of file ThermalModelBase.h.
|
inline |
Set the canonical correlation volume V \(_c\).
Volume | Canonical correlation volume (fm \(^3\)) |
Definition at line 525 of file ThermalModelBase.h.
|
inline |
Set the canonical correlation system radius.
The canonical correlation volume is computed as \(V_c = \frac{4\pi}{3} \, R_c^3\)
Radius |
Definition at line 535 of file ThermalModelBase.h.
|
virtual |
Set the total charm (for canonical ensemble only)
B | Total charm |
Definition at line 203 of file ThermalModelBase.cpp.
|
virtual |
Set the charm chemical potential.
muC | Charm chemical potential (GeV) |
Reimplemented in thermalfist::ThermalModelCanonicalCharm.
Definition at line 166 of file ThermalModelBase.cpp.
|
virtual |
Sets the chemical potentials of all particles.
chem | A vector with chemical potentials of all species. 0-based indices of the vector must corresponds to the 0-based indices of the particle list TPS() |
Reimplemented in thermalfist::ThermalModelVDW.
Definition at line 359 of file ThermalModelBase.cpp.
|
inlinevirtual |
Set the number of terms in the cluster expansion method. Calls the corresponding method in TPS().
Sets the same value for all particles. To set individually for each particle use ThermalParticle::SetClusterExpansionOrder().
order | Number of terms. |
Definition at line 369 of file ThermalModelBase.h.
|
virtual |
Set the total electric charge (for canonical ensemble only)
B | Total electric charge |
Definition at line 191 of file ThermalModelBase.cpp.
|
virtual |
Set the electric chemical potential.
muQ | Electric chemical potential (GeV) |
Definition at line 152 of file ThermalModelBase.cpp.
|
virtual |
Set the charm quark fugacity factor.
gammaC | Charm quark fugacity factor |
Definition at line 179 of file ThermalModelBase.cpp.
|
virtual |
Set the light quark fugacity factor.
gammaq | Light quark fugacity factor |
Definition at line 311 of file ThermalModelBase.cpp.
|
virtual |
Set the strange quark fugacity factor.
gammaS | Strange quark fugacity factor |
Definition at line 173 of file ThermalModelBase.cpp.
void thermalfist::ThermalModelBase::SetNormBratio | ( | bool | normBratio | ) |
Whether branching ratios are renormalized to 100%.
normBratio | Whether branching ratios shoul be renormalized to 100%. |
Definition at line 113 of file ThermalModelBase.cpp.
|
inline |
OpenMP support. Currently not used.
Definition at line 112 of file ThermalModelBase.h.
|
virtual |
The thermal parameters.
params | The thermal parameters to be used |
Reimplemented in thermalfist::ThermalModelCanonicalStrangeness, and thermalfist::ThermalModelCanonicalCharm.
Definition at line 133 of file ThermalModelBase.cpp.
|
inline |
The electric-to-baryon charge ratio to be used to constrain the electric chemical potential.
QB | The electric-to-baryon charge ratio |
Definition at line 494 of file ThermalModelBase.h.
|
inlinevirtual |
Set the same excluded volume radius parameter for all species.
rad | Radius parameter (fm) |
Reimplemented in thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCanonicalStrangeness, and thermalfist::ThermalModelEVCrossterms.
Definition at line 219 of file ThermalModelBase.h.
|
inlinevirtual |
Set the radius parameter for particle species i.
i | 0-based index of particle species |
rad | Radius parameter (fm) |
Reimplemented in thermalfist::ThermalModelEVDiagonal, and thermalfist::ThermalModelEVCanonicalStrangeness.
Definition at line 227 of file ThermalModelBase.h.
void thermalfist::ThermalModelBase::SetResonanceWidthIntegrationType | ( | ThermalParticle::ResonanceWidthIntegration | type | ) |
Set the ThermalParticle::ResonanceWidthIntegration scheme for all particles. Calls the corresponding method in TPS().
type | ThermalParticle::ResonanceWidthIntegration |
Definition at line 343 of file ThermalModelBase.cpp.
|
inline |
Set the ThermalParticle::ResonanceWidthShape for all particles. Calls the corresponding method in TPS().
This global setting can be overriden for individual particles by ThermalParticle::SetResonanceWidthShape().
shape | ThermalParticle::ResonanceWidthShape |
Definition at line 380 of file ThermalModelBase.h.
|
inline |
The entropy per baryon ratio to be used to constrain the baryon chemical potential.
SB | The entropy per baryon |
Definition at line 482 of file ThermalModelBase.h.
|
virtual |
Set whether quantum statistics is used, 0 - Boltzmann, 1 - Quantum
Reimplemented in thermalfist::ThermalModelCanonical, thermalfist::ThermalModelCanonicalStrangeness, and thermalfist::ThermalModelCanonicalCharm.
Definition at line 337 of file ThermalModelBase.cpp.
|
virtual |
Set the total strangeness (for canonical ensemble only)
B | Total strangeness |
Definition at line 197 of file ThermalModelBase.cpp.
|
virtual |
Set the strangeness chemical potential.
muS | Strangeness chemical potential (GeV) |
Reimplemented in thermalfist::ThermalModelCanonicalStrangeness.
Definition at line 159 of file ThermalModelBase.cpp.
|
inline |
Set the tag for this ThermalModelBase object.
tag | Tag. |
Definition at line 978 of file ThermalModelBase.h.
|
virtual |
Set the temperature.
T | Temperature (GeV) |
Definition at line 139 of file ThermalModelBase.cpp.
void thermalfist::ThermalModelBase::SetUseWidth | ( | bool | useWidth | ) |
Sets whether finite resonance widths are used. Deprecated.
If the widths are to be used, the ThermalParticle::ResonanceWidthIntegration::BWTwoGamma scheme will be used.
useWidth | Whether to use the finite resonance widths. |
Definition at line 94 of file ThermalModelBase.cpp.
void thermalfist::ThermalModelBase::SetUseWidth | ( | ThermalParticle::ResonanceWidthIntegration | type | ) |
Sets the finite resonance widths scheme to use.
type | ThermalParticle::ResonanceWidthIntegration scheme |
Definition at line 106 of file ThermalModelBase.cpp.
|
inlinevirtual |
Set the excluded volume coefficient \( \tilde{b}_{ij} \).
Excluded parameter for repulsive interaction between particle species i and j.
i | 0-based index of the first particle species |
j | 0-based index of the second particle species |
b | Excluded volume parameter \( \tilde{b}_{ij} \) (fm \(^3\)) |
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCrossterms, and thermalfist::ThermalModelVDWCanonicalStrangeness.
Definition at line 239 of file ThermalModelBase.h.
|
inline |
Sets the system volume.
Volume | System volume (fm \(^3\)) |
Definition at line 503 of file ThermalModelBase.h.
|
inline |
Sets the system radius.
The system volume is computed as \(V = \frac{4\pi}{3} \, R^3\)
Volume | System radius (fm) |
Definition at line 515 of file ThermalModelBase.h.
|
inline |
Normalized skewness of primordial particle number fluctuations for particle species id.
id | 0-based index of particle species |
Definition at line 1026 of file ThermalModelBase.h.
|
inline |
Normalized skewness of final particle number fluctuations for particle species id.
Decay feeddown is in accordance with the stability flags.
id | 0-based index of particle species |
Definition at line 1038 of file ThermalModelBase.h.
|
virtual |
The procedure which calculates the chemical potentials \( \mu_B,\,\mu_Q,\,\mu_S,\,\mu_Q \) which reproduce the specified total baryon, electric, strangeness, and charm charges of the system.
Uses the Broyden's method to determine the chemical potentials. The resulting chemical potentials are stored in Parameters(). Useful for canonical ensemble applications.
totB | The total desired net baryon charge of the system. |
totQ | The total desired electric charge of the system. |
totS | The total desired net strangeness of the system. |
totC | The total desired net charm of the system. |
muBinit | The initial guess for the baryon chemical potential. |
muQinit | The initial guess for the electric chemical potential. |
muSinit | The initial guess for the strangeness chemical potential. |
muCinit | The initial guess for the charm chemical potential. |
ConstrMuB | Whether the baryon chemical potential should be constrained. |
ConstrMuQ | Whether the electric chemical potential should be constrained. |
ConstrMuS | Whether the strangeness chemical potential should be constrained. |
ConstrMuC | Whether the charm chemical potential should be constrained. |
Definition at line 512 of file ThermalModelBase.cpp.
|
inline |
Definition at line 483 of file ThermalModelBase.h.
|
inline |
Net strangeness density (fm \(^{-3}\))
Definition at line 856 of file ThermalModelBase.h.
|
inline |
A 2nd order susceptibility of conserved charges.
\( \chi_{11}^{c_i c_j} \)
i | First conserved charge |
j | Second conserved charge |
Definition at line 1080 of file ThermalModelBase.h.
|
inline |
The tag of this ThermalModelBase object.
Definition at line 981 of file ThermalModelBase.h.
|
inline |
A vector with total particle number densities, which include the feeddown contribution in accordance with the stability flags. Each entry corresponds to a density of single species, in accordance with the 0-based index of each specie. PdgToId() maps PDG ID to the 0-based index.
Definition at line 966 of file ThermalModelBase.h.
|
inline |
A pointer to the ThermalParticleSystem object with the particle list.
Definition at line 952 of file ThermalModelBase.h.
|
virtual |
Returns the computed final particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with ids i and j. CalculateFluctuations() must be called beforehand. Both particle species must be those marked stable.
Definition at line 1022 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed final particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with pdg codes id1 and id2. CalculateFluctuations() must be called beforehand. Both particle species must be those marked stable.
Definition at line 1040 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed primordial particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with ids i and j. CalculateFluctuations() must be called beforehand.
Definition at line 959 of file ThermalModelBase.cpp.
|
virtual |
Returns the computed primordial particle number (cross-)susceptibility \( \frac{1}{VT^3} \, \langle \Delta N_i \Delta N_j \rangle \) for particles with pdg codes id1 and id2. CalculateFluctuations() must be called beforehand.
Definition at line 969 of file ThermalModelBase.cpp.
|
inline |
Calls SetParameters() with current m_Parameters.
Definition at line 128 of file ThermalModelBase.h.
|
inline |
Sets whether partial chemical equilibrium with additional chemical potentials is used.
Definition at line 469 of file ThermalModelBase.h.
|
inline |
Whether partial chemical equilibrium with additional chemical potentials is used.
Definition at line 472 of file ThermalModelBase.h.
|
inline |
Whether finite resonance widths are considered.
Definition at line 82 of file ThermalModelBase.h.
|
virtual |
Checks whether issues have occured during the calculation of particle densities in the CalculateDensities() method.
Reimplemented in thermalfist::ThermalModelCanonical.
Definition at line 586 of file ThermalModelBase.cpp.
|
inline |
All messaged which occured during the validation procedure in the ValidateCalculation() method.
Definition at line 634 of file ThermalModelBase.h.
|
inlinevirtual |
Excluded volume coefficient \( \tilde{b}_{ij} = 0 \).
Excluded parameter for repulsive interaction between particle species i and j.
i | 0-based index of the first particle species |
j | 0-based index of the second particle species |
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelVDWCanonicalStrangeness, and thermalfist::ThermalModelEVCrossterms.
Definition at line 330 of file ThermalModelBase.h.
|
inline |
System volume (fm \(^3\))
Definition at line 505 of file ThermalModelBase.h.
|
inlinevirtual |
Write the QvdW interaction parameters to a file.
Actual implementation is in a derived class.
filename | Output file. |
Reimplemented in thermalfist::ThermalModelVDW, thermalfist::ThermalModelEVDiagonal, thermalfist::ThermalModelEVCanonicalStrangeness, thermalfist::ThermalModelVDWCanonicalStrangeness, and thermalfist::ThermalModelEVCrossterms.
Definition at line 310 of file ThermalModelBase.h.
|
protected |
Definition at line 1168 of file ThermalModelBase.h.
|
protected |
Definition at line 1192 of file ThermalModelBase.h.
|
protected |
Definition at line 1179 of file ThermalModelBase.h.
|
protected |
Definition at line 1182 of file ThermalModelBase.h.
|
protected |
Definition at line 1180 of file ThermalModelBase.h.
|
protected |
Definition at line 1181 of file ThermalModelBase.h.
|
protected |
Definition at line 1188 of file ThermalModelBase.h.
|
protected |
Definition at line 1191 of file ThermalModelBase.h.
|
protected |
Definition at line 1189 of file ThermalModelBase.h.
|
protected |
Definition at line 1230 of file ThermalModelBase.h.
|
protected |
Definition at line 1169 of file ThermalModelBase.h.
|
protected |
Definition at line 1212 of file ThermalModelBase.h.
|
protected |
Definition at line 1170 of file ThermalModelBase.h.
|
protected |
Definition at line 1171 of file ThermalModelBase.h.
|
protected |
Definition at line 1231 of file ThermalModelBase.h.
|
protected |
Definition at line 1203 of file ThermalModelBase.h.
|
protected |
Definition at line 1204 of file ThermalModelBase.h.
|
protected |
Definition at line 1165 of file ThermalModelBase.h.
|
protected |
Definition at line 1166 of file ThermalModelBase.h.
|
protected |
Definition at line 1173 of file ThermalModelBase.h.
|
protected |
Definition at line 1162 of file ThermalModelBase.h.
|
protected |
Definition at line 1184 of file ThermalModelBase.h.
|
protected |
Definition at line 1211 of file ThermalModelBase.h.
|
protected |
Definition at line 1207 of file ThermalModelBase.h.
|
protected |
Definition at line 1218 of file ThermalModelBase.h.
|
protected |
Definition at line 1175 of file ThermalModelBase.h.
|
protected |
Definition at line 1174 of file ThermalModelBase.h.
|
protected |
Definition at line 1176 of file ThermalModelBase.h.
|
protected |
Definition at line 1199 of file ThermalModelBase.h.
|
protected |
Definition at line 1200 of file ThermalModelBase.h.
|
protected |
Definition at line 1215 of file ThermalModelBase.h.
|
protected |
Definition at line 1228 of file ThermalModelBase.h.
|
protected |
Definition at line 1208 of file ThermalModelBase.h.
|
protected |
Definition at line 1163 of file ThermalModelBase.h.
|
protected |
Definition at line 1186 of file ThermalModelBase.h.
|
protected |
Definition at line 1172 of file ThermalModelBase.h.
|
protected |
Definition at line 1224 of file ThermalModelBase.h.
|
protected |
Definition at line 1177 of file ThermalModelBase.h.
|
protected |
Definition at line 1226 of file ThermalModelBase.h.
|
protected |
Definition at line 1195 of file ThermalModelBase.h.
|
protected |
Definition at line 1196 of file ThermalModelBase.h.