|
typedef boost::numeric::ublas::vector< double > | ubvector |
|
virtual int | calc_p (fermion &ne, fermion &pr, thermo <h) |
| Equation of state as a function of chemical potential. More...
|
|
virtual int | calc_eq_p (fermion &neu, fermion &p, double sig, double ome, double rho, double &f1, double &f2, double &f3, thermo &th) |
| Equation of state and meson field equations as a function of chemical potentials. More...
|
|
virtual int | calc_eq_temp_p (fermion &ne, fermion &pr, double temper, double sig, double ome, double rho, double &f1, double &f2, double &f3, thermo &th) |
| Equation of state and meson field equations as a function of chemical potentials at finite temperature. More...
|
|
virtual int | calc_temp_p (fermion &ne, fermion &pr, double T, thermo <h) |
| Equation of state as a function of chemical potential. More...
|
|
int | calc_temp_e (fermion &ne, fermion &pr, double T, thermo <h) |
| Equation of state as a function of densities at finite temperature.
|
|
int | fix_saturation (double guess_cs=4.0, double guess_cw=3.0, double guess_b=0.001, double guess_c=-0.001) |
| Calculate cs, cw, cr, b, and c from the saturation properties. More...
|
|
virtual int | saturation () |
| Calculate properties of nuclear matter at the saturation density. More...
|
|
double | fesym_fields (double sig, double ome, double nb) |
| Calculate symmetry energy assuming the field equations have already been solved. More...
|
|
double | fcomp_fields (double sig, double ome, double nb) |
| Calculate the compressibility assuming the field equations have already been solved. More...
|
|
void | fkprime_fields (double sig, double ome, double nb, double &k, double &kprime) |
| Calculate compressibilty and kprime assuming the field equations have already been solved. More...
|
|
int | field_eqs (size_t nv, const ubvector &x, ubvector &y) |
| A function for solving the field equations. More...
|
|
int | field_eqsT (size_t nv, const ubvector &x, ubvector &y) |
| A function for solving the field equations at finite temperature. More...
|
|
virtual int | set_fields (double sig, double ome, double lrho) |
| Set a guess for the fields for the next call to calc_e(), calc_p(), or saturation()
|
|
int | get_fields (double &sig, double &ome, double &lrho) |
| Return the most recent values of the meson fields. More...
|
|
virtual const char * | type () |
| Return string denoting type ("eos_had_rmf")
|
|
| eos_had_rmf () |
|
virtual int | set_sat_mroot (mroot< mm_funct, ubvector, jac_funct > &mrx) |
| Set class mroot object for use calculating saturation density.
|
|
void | check_naturalness (eos_had_rmf &re) |
| Set the coefficients of a eos_had_rmf object to their limits from naturalness. More...
|
|
void | naturalness_limits (double value, eos_had_rmf &re) |
| Provide the maximum values of the couplings assuming a limit on naturalness. More...
|
|
virtual int | calc_liqgas_dens_temp_e (fermion &n1, fermion &p1, fermion &n2, fermion &p2, double T, thermo &th1, thermo &th2) |
| Compute liquid-gas phase transition densities using eos_had_temp_base::calc_temp_e() . More...
|
|
virtual int | calc_liqgas_temp_e (fermion &n1, fermion &p1, fermion &n2, fermion &p2, double nB, double Ye, double T, thermo &th1, thermo &th2, double &chi) |
| Compute the liquid-gas phase transition using eos_had_temp_base::calc_temp_e() . More...
|
|
virtual int | calc_liqgas_beta_temp_e (fermion &n1, fermion &p1, fermion &n2, fermion &p2, double nB, double T, thermo &th1, thermo &th2, double &Ye, double &chi) |
| Compute the liquid-gas phase transition in beta-equilibrium using eos_had_temp_base::calc_temp_e() . More...
|
|
virtual double | fesym_T (double nb, double T, double delta=0.0) |
| Compute the symmetry energy at finite temperature.
|
|
virtual double | fsyment_T (double nb, double T, double delta=0.0) |
| Compute the symmetry entropy at finite temperature.
|
|
virtual double | calc_temp_mun_e (double nn, double np, double T) |
| Neutron chemical potential as a function of the densities.
|
|
virtual double | calc_temp_mup_e (double nn, double np, double T) |
| Proton chemical potential as a function of the densities.
|
|
virtual double | calc_temp_nn_p (double mun, double mup, double T) |
| Neutron density as a function of the chemical potentials.
|
|
virtual double | calc_temp_np_p (double mun, double mup, double T) |
| Proton density as a function of the chemical potentials.
|
|
double | calc_fr (double nn, double np, double T) |
| Compute the free energy as a function of the temperature and the densities.
|
|
virtual void | f_number_suscept_T (double mun, double mup, double T, double &dPdnn, double &dPdnp, double &dPdpp) |
| Compute the number susceptibilities as a function of the chemical potentials, at a fixed temperature.
|
|
virtual void | f_inv_number_suscept_T (double mun, double mup, double T, double &dednn, double &dednp, double &dedpp) |
| Compute the 'inverse' number susceptibilities as a function of the densities, at a fixed temperature.
|
|
void | check_en (fermion &n, fermion &p, double T, thermo &th, double &en_deriv, double &en_err) |
| Check the entropy by computing the derivative numerically.
|
|
void | check_mu_T (fermion &n, fermion &p, double T, thermo &th, double &mun_deriv, double &mup_deriv, double &mun_err, double &mup_err) |
| Check the chemical potentials at finite temperature by computing the derivative numerically.
|
|
virtual void | set_fermion_thermo (fermion_thermo &f) |
| Computing finite-temperature integrals. More...
|
|
virtual double | fcomp (double nb, double delta=0.0) |
| Calculate the incompressibility in using calc_e() More...
|
|
virtual double | fcomp_err (double nb, double delta, double &unc) |
| Compute the incompressibility and its uncertainty. More...
|
|
virtual double | feoa (double nb, double delta=0.0) |
| Calculate the energy per baryon in using calc_e() More...
|
|
virtual double | fesym (double nb, double delta=0.0) |
| Calculate symmetry energy of matter in using calc_dmu_delta() . More...
|
|
virtual double | fesym_err (double nb, double delta, double &unc) |
| Calculate symmetry energy of matter and its uncertainty in . More...
|
|
virtual double | fesym_slope (double nb, double delta=0.0) |
| The symmetry energy slope parameter in . More...
|
|
virtual double | fesym_curve (double nb, double delta=0.0) |
| The curvature of the symmetry energy in .
|
|
virtual double | fesym_skew (double nb, double delta=0.0) |
| The skewness of the symmetry energy in .
|
|
virtual double | fesym_diff (double nb) |
| Calculate symmetry energy of matter as energy of neutron matter minus the energy of nuclear matter in . More...
|
|
virtual double | feta (double nb) |
| The strength parameter for quartic terms in the symmetry energy.
|
|
virtual double | feta_prime (double nb) |
| The derivative of the strength parameter for quartic terms in the symmetry energy.
|
|
virtual double | fkprime (double nb, double delta=0.0) |
| Calculate skewness of nuclear matter in using calc_e() More...
|
|
virtual double | fmsom (double nb, double delta=0.0) |
| Calculate reduced neutron effective mass using calc_e() More...
|
|
virtual double | f_effm_neut (double nb, double delta=0.0) |
| Neutron (reduced) effective mass.
|
|
virtual double | f_effm_prot (double nb, double delta=0.0) |
| Proton (reduced) effective mass.
|
|
virtual double | f_effm_scalar (double nb, double delta=0.0) |
| Scalar effective mass. More...
|
|
virtual double | f_effm_vector (double nb, double delta=1.0) |
| Vector effective mass. More...
|
|
virtual double | fn0 (double delta, double &leoa) |
| Calculate saturation density using calc_e() More...
|
|
virtual void | f_number_suscept (double mun, double mup, double &dPdnn, double &dPdnp, double &dPdpp) |
| Compute the number susceptibilities as a function of the chemical potentials, .
|
|
virtual void | f_inv_number_suscept (double mun, double mup, double &dednn, double &dednp, double &dedpp) |
| Compute the 'inverse' number susceptibilities as a function of the densities, .
|
|
double | calc_mun_e (double nn, double np) |
| Compute the neutron chemical potential at fixed density. More...
|
|
double | calc_ed (double nn, double np) |
| Compute the energy density as a function of the nucleon densities.
|
|
double | calc_pr (double nn, double np) |
| Compute the pressure as a function of the nucleon chemical potentials.
|
|
double | calc_mup_e (double nn, double np) |
| Compute the proton chemical potential at fixed density. More...
|
|
double | calc_nn_p (double mun, double mup) |
| Compute the neutron density at fixed chemical potential. More...
|
|
double | calc_np_p (double mun, double mup) |
| Compute the proton density at fixed chemical potential. More...
|
|
double | calc_dmu_delta (double delta, double nb) |
| Compute the difference between neutron and proton chemical potentials as a function of the isospin asymmetry. More...
|
|
double | calc_musum_delta (double delta, double nb) |
| Compute the sum of the neutron and proton chemical potentials as a function of the isospin asymmetry. More...
|
|
double | calc_pressure_nb (double nb, double delta=0.0) |
| Compute the pressure as a function of baryon density at fixed isospin asymmetry. More...
|
|
double | calc_edensity_nb (double nb, double delta=0.0) |
| Compute the energy density as a function of baryon density at fixed isospin asymmetry. More...
|
|
void | const_pf_derivs (double nb, double pf, double &dednb_pf, double &dPdnb_pf) |
| Compute derivatives at constant proton fraction.
|
|
double | calc_press_over_den2 (double nb, double delta=0.0) |
| Calculate pressure / baryon density squared in nuclear matter as a function of baryon density at fixed isospin asymmetry. More...
|
|
double | calc_edensity_delta (double delta, double nb) |
| Calculate energy density as a function of the isospin asymmetry at fixed baryon density. More...
|
|
int | nuc_matter_p (size_t nv, const ubvector &x, ubvector &y, double nn0, double np0) |
| Solve for the chemical potentials given the densities. More...
|
|
int | nuc_matter_e (size_t nv, const ubvector &x, ubvector &y, double mun0, double mup0) |
| Solve for the densities given the chemical potentials. More...
|
|
void | gradient_qij (fermion &n, fermion &p, thermo &th, double &qnn, double &qnp, double &qpp, double &dqnndnn, double &dqnndnp, double &dqnpdnn, double &dqnpdnp, double &dqppdnn, double &dqppdnp) |
| Calculate coefficients for gradient part of Hamiltonian. More...
|
|
virtual void | set_mroot (mroot<> &mr) |
| Set class mroot object for use in calculating chemical potentials from densities. More...
|
|
virtual void | set_sat_root (root<> &mr) |
| Set class mroot object for use calculating saturation density. More...
|
|
virtual void | set_sat_deriv (deriv_base<> &de) |
| Set deriv_base object to use to find saturation properties.
|
|
virtual void | set_sat_deriv2 (deriv_base<> &de) |
| Set the second deriv_base object to use to find saturation properties. More...
|
|
virtual void | set_n_and_p (fermion &n, fermion &p) |
| Set neutron and proton.
|
|
void | check_mu (fermion &n, fermion &p, thermo &th, double &mun_deriv, double &mup_deriv, double &mun_err, double &mup_err) |
| Check the chemical potentials by computing the derivatives numerically.
|
|
void | check_den (fermion &n, fermion &p, thermo &th, double &nn_deriv, double &np_deriv, double &nn_err, double &np_err) |
| Check the densities by computing the derivatives numerically.
|
|
virtual void | set_thermo (thermo &th) |
| Set class thermo object.
|
|
virtual const thermo & | get_thermo () |
| Get class thermo object.
|
|