LORENE
|
Class for perfect fluid rotating gravastar. More...
#include <gravastar.h>
Public Member Functions | |
Gravastar (Map &mp_i, int nzet_i, const Eos &eos_i, const double rho_core_i) | |
Standard constructor. | |
Gravastar (const Gravastar &) | |
Copy constructor. | |
Gravastar (Map &mp_i, const Eos &eos_i, FILE *fich) | |
Constructor from a file (see sauve(FILE*) ). | |
~Gravastar () | |
Destructor. | |
void | operator= (const Gravastar &) |
Assignment to another Gravastar . | |
void | equation_of_state () |
Allows to computes the proper baryon and energy density, as well as pressure from the enthalpy, in the gravastar's crust only (in the core, p=-rho=cst) | |
void | equilibrium (double omega0, double fact_omega, int nzadapt, const Tbl &ent_limit, const Itbl &icontrol, const Tbl &control, Tbl &diff, Param *=0x0) |
Computes an equilibrium configuration. | |
bool | is_relativistic () const |
Returns true for a relativistic star, false for a Newtonian one. | |
virtual double | get_omega_c () const |
Returns the central value of the rotation angular velocity ( [f_unit] ) | |
const Scalar & | get_bbb () const |
Returns the metric factor B. | |
const Scalar & | get_a_car () const |
Returns the square of the metric factor A. | |
const Scalar & | get_b_car () const |
Returns the square of the metric factor B. | |
const Scalar & | get_nphi () const |
Returns the metric coefficient ![]() | |
const Scalar & | get_tnphi () const |
Returns the component ![]() | |
const Scalar & | get_uuu () const |
Returns the norm of u_euler . | |
const Scalar & | get_nuf () const |
Returns the part of the Metric potential ![]() logn generated by the matter terms. | |
const Scalar & | get_nuq () const |
Returns the Part of the Metric potential ![]() logn generated by the quadratic terms. | |
const Scalar & | get_dzeta () const |
Returns the Metric potential ![]() | |
const Scalar & | get_tggg () const |
Returns the Metric potential ![]() | |
const Vector & | get_w_shift () const |
Returns the vector ![]() shift , following Shibata's prescription [Prog. | |
const Scalar & | get_khi_shift () const |
Returns the scalar ![]() shift following Shibata's prescription [Prog. | |
const Sym_tensor & | get_tkij () const |
Returns the tensor ![]() ![]() | |
const Scalar & | get_ak_car () const |
Returns the scalar ![]() | |
virtual void | sauve (FILE *) const |
Save in a file. | |
virtual void | display_poly (ostream &) const |
Display in polytropic units. | |
virtual const Itbl & | l_surf () const |
Description of the stellar surface: returns a 2-D Itbl containing the values of the domain index l on the surface at the collocation points in ![]() | |
virtual double | mass_b () const |
Baryon mass. | |
virtual double | mass_g () const |
Gravitational mass. | |
virtual double | angu_mom () const |
Angular momentum. | |
virtual double | tsw () const |
Ratio T/W. | |
virtual double | grv2 () const |
Error on the virial identity GRV2. | |
virtual double | grv3 (ostream *ost=0x0) const |
Error on the virial identity GRV3. | |
virtual double | r_circ () const |
Circumferential radius. | |
virtual double | aplat () const |
Flatening r_pole/r_eq. | |
virtual double | area () const |
Integrated surface area in ![]() | |
virtual double | mean_radius () const |
Mean star radius from the area ![]() | |
virtual double | z_eqf () const |
Forward redshift factor at equator. | |
virtual double | z_eqb () const |
Backward redshift factor at equator. | |
virtual double | z_pole () const |
Redshift factor at North pole. | |
virtual double | mom_quad () const |
Quadrupole moment. | |
virtual double | r_isco (ostream *ost=0x0) const |
Circumferential radius of the innermost stable circular orbit (ISCO). | |
virtual double | f_isco () const |
Orbital frequency at the innermost stable circular orbit (ISCO). | |
virtual double | espec_isco () const |
Energy of a particle on the ISCO. | |
virtual double | lspec_isco () const |
Angular momentum of a particle on the ISCO. | |
virtual double | f_eq () const |
Orbital frequency at the equator. | |
virtual void | hydro_euler () |
Computes the hydrodynamical quantities relative to the Eulerian observer from those in the fluid frame. | |
void | update_metric () |
Computes metric coefficients from known potentials. | |
void | fait_shift () |
Computes shift from w_shift and khi_shift according to Shibata's prescription [Prog. | |
void | fait_nphi () |
Computes tnphi and nphi from the Cartesian components of the shift, stored in shift . | |
void | extrinsic_curvature () |
Computes tkij and ak_car from shift , nnn and b_car . | |
virtual void | equilibrium (double ent_c, double omega0, double fact_omega, int nzadapt, const Tbl &ent_limit, const Itbl &icontrol, const Tbl &control, double mbar_wanted, double aexp_mass, Tbl &diff, Param *=0x0) |
Computes an equilibrium configuration. | |
Map & | set_mp () |
Read/write of the mapping. | |
void | set_enthalpy (const Scalar &) |
Assignment of the enthalpy field. | |
virtual void | equilibrium_spher (double ent_c, double precis=1.e-14, const Tbl *pent_limit=0x0) |
Computes a spherical static configuration. | |
const Map & | get_mp () const |
Returns the mapping. | |
int | get_nzet () const |
Returns the number of domains occupied by the star. | |
const Eos & | get_eos () const |
Returns the equation of state. | |
const Scalar & | get_ent () const |
Returns the enthalpy field. | |
const Scalar & | get_nbar () const |
Returns the proper baryon density. | |
const Scalar & | get_ener () const |
Returns the proper total energy density. | |
const Scalar & | get_press () const |
Returns the fluid pressure. | |
const Scalar & | get_ener_euler () const |
Returns the total energy density with respect to the Eulerian observer. | |
const Scalar & | get_s_euler () const |
Returns the trace of the stress tensor in the Eulerian frame. | |
const Scalar & | get_gam_euler () const |
Returns the Lorentz factor between the fluid and Eulerian observers. | |
const Vector & | get_u_euler () const |
Returns the fluid 3-velocity with respect to the Eulerian observer. | |
const Tensor & | get_stress_euler () const |
Returns the spatial part of the stress-energy tensor with respect to the Eulerian observer. | |
const Scalar & | get_logn () const |
Returns the logarithm of the lapse N. | |
const Scalar & | get_nn () const |
Returns the lapse function N. | |
const Vector & | get_beta () const |
Returns the shift vector ![]() | |
const Scalar & | get_lnq () const |
const Metric & | get_gamma () const |
Returns the 3-metric ![]() | |
double | ray_eq () const |
Coordinate radius at ![]() ![]() | |
double | ray_eq_pis2 () const |
Coordinate radius at ![]() ![]() | |
double | ray_eq_pi () const |
Coordinate radius at ![]() ![]() | |
double | ray_eq_3pis2 () const |
Coordinate radius at ![]() ![]() | |
double | ray_pole () const |
Coordinate radius at ![]() | |
const Tbl & | xi_surf () const |
Description of the stellar surface: returns a 2-D Tbl containing the values of the radial coordinate ![]() ![]() | |
Static Public Member Functions | |
static double | lambda_grv2 (const Scalar &sou_m, const Scalar &sou_q) |
Computes the coefficient ![]() | |
Protected Member Functions | |
virtual ostream & | operator>> (ostream &) const |
Operator >> (virtual function called by the operator <<). | |
virtual void | del_deriv () const |
Deletes all the derived quantities. | |
virtual void | set_der_0x0 () const |
Sets to 0x0 all the pointers on derived quantities. | |
virtual void | del_hydro_euler () |
Sets to ETATNONDEF (undefined state) the hydrodynamical quantities relative to the Eulerian observer. | |
virtual void | partial_display (ostream &) const |
Printing of some informations, excluding all global quantities. | |
Protected Attributes | |
double | rho_core |
Energy density in gravastar's core. | |
bool | relativistic |
Indicator of relativity: true for a relativistic star, false for a Newtonian one. | |
double | unsurc2 |
![]() unsurc2=1 for a relativistic star, 0 for a Newtonian one. | |
double | omega |
Rotation angular velocity ( [f_unit] ) | |
Scalar | a_car |
Square of the metric factor A. | |
Scalar | bbb |
Metric factor B. | |
Scalar | b_car |
Square of the metric factor B. | |
Scalar | nphi |
Metric coefficient ![]() | |
Scalar | tnphi |
Component ![]() | |
Scalar | uuu |
Norm of u_euler . | |
Scalar | nuf |
Part of the Metric potential ![]() logn generated by the matter terms. | |
Scalar | nuq |
Part of the Metric potential ![]() logn generated by the quadratic terms. | |
Scalar | dzeta |
Metric potential ![]() | |
Scalar | tggg |
Metric potential ![]() | |
Vector | w_shift |
Vector ![]() shift , following Shibata's prescription [Prog. | |
Scalar | khi_shift |
Scalar ![]() shift , following Shibata's prescription [Prog. | |
Sym_tensor | tkij |
Tensor ![]() ![]() | |
Scalar | ak_car |
Scalar ![]() | |
Scalar | ssjm1_nuf |
Effective source at the previous step for the resolution of the Poisson equation for nuf by means of Map_et::poisson . | |
Scalar | ssjm1_nuq |
Effective source at the previous step for the resolution of the Poisson equation for nuq by means of Map_et::poisson . | |
Scalar | ssjm1_dzeta |
Effective source at the previous step for the resolution of the Poisson equation for dzeta . | |
Scalar | ssjm1_tggg |
Effective source at the previous step for the resolution of the Poisson equation for tggg . | |
Scalar | ssjm1_khi |
Effective source at the previous step for the resolution of the Poisson equation for the scalar ![]() Map_et::poisson . | |
Vector | ssjm1_wshift |
Effective source at the previous step for the resolution of the vector Poisson equation for ![]() | |
double * | p_angu_mom |
Angular momentum. | |
double * | p_tsw |
Ratio T/W. | |
double * | p_grv2 |
Error on the virial identity GRV2. | |
double * | p_grv3 |
Error on the virial identity GRV3. | |
double * | p_r_circ |
Circumferential radius. | |
double * | p_aplat |
Flatening r_pole/r_eq. | |
double * | p_area |
Integrated surface area. | |
double * | p_z_eqf |
Forward redshift factor at equator. | |
double * | p_z_eqb |
Backward redshift factor at equator. | |
double * | p_z_pole |
Redshift factor at North pole. | |
double * | p_mom_quad |
Quadrupole moment. | |
double * | p_r_isco |
Circumferential radius of the ISCO. | |
double * | p_f_isco |
Orbital frequency of the ISCO. | |
double * | p_espec_isco |
Specific energy of a particle on the ISCO. | |
double * | p_lspec_isco |
Specific angular momentum of a particle on the ISCO. | |
double * | p_f_eq |
Orbital frequency at the equator. | |
Map & | mp |
Mapping associated with the star. | |
int | nzet |
Number of domains of *mp occupied by the star. | |
const Eos & | eos |
Equation of state of the stellar matter. | |
Scalar | ent |
Log-enthalpy. | |
Scalar | nbar |
Baryon density in the fluid frame. | |
Scalar | ener |
Total energy density in the fluid frame. | |
Scalar | press |
Fluid pressure. | |
Scalar | ener_euler |
Total energy density in the Eulerian frame. | |
Scalar | s_euler |
Trace of the stress scalar in the Eulerian frame. | |
Scalar | gam_euler |
Lorentz factor between the fluid and Eulerian observers. | |
Vector | u_euler |
Fluid 3-velocity with respect to the Eulerian observer. | |
Sym_tensor | stress_euler |
Spatial part of the stress-energy tensor with respect to the Eulerian observer. | |
Scalar | logn |
Logarithm of the lapse N . | |
Scalar | nn |
Lapse function N . | |
Vector | beta |
Shift vector. | |
Scalar | lnq |
Metric | gamma |
3-metric | |
double * | p_ray_eq |
Coordinate radius at ![]() ![]() | |
double * | p_ray_eq_pis2 |
Coordinate radius at ![]() ![]() | |
double * | p_ray_eq_pi |
Coordinate radius at ![]() ![]() | |
double * | p_ray_eq_3pis2 |
Coordinate radius at ![]() ![]() | |
double * | p_ray_pole |
Coordinate radius at ![]() | |
Itbl * | p_l_surf |
Description of the stellar surface: 2-D Itbl containing the values of the domain index l on the surface at the collocation points in ![]() | |
Tbl * | p_xi_surf |
Description of the stellar surface: 2-D Tbl containing the values of the radial coordinate ![]() ![]() | |
double * | p_mass_b |
Baryon mass. | |
double * | p_mass_g |
Gravitational mass. | |
Standard constructor.
mp_i | Mapping on which the gravastar is contructed |
nzet_i | Number of domains occupied by the gravastar |
eos_i | Equation of state of the crust matter |
rho_core_i | Energy density in gravastar's core (constant, =-p_core) NB:pas de choix pour l'EOS en fait : a virer?? |
Definition at line 51 of file gravastar.C.
Constructor from a file (see sauve(FILE*)
).
mp_i | Mapping on which the gravastar is constructed |
eos_i | Equation of state of the crust matter |
fich | input file (must have been created by the function Gravastar::sauve ) |
Lorene::Gravastar::~Gravastar | ( | ) |
|
virtualinherited |
Angular momentum.
Definition at line 150 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::b_car, Lorene::Star::ener_euler, Lorene::Star::nbar, Lorene::Star_rot::p_angu_mom, Lorene::Star::press, Lorene::Star_rot::relativistic, and Lorene::Star_rot::uuu.
|
virtualinherited |
Flatening r_pole/r_eq.
Definition at line 426 of file star_rot_global.C.
References Lorene::Star_rot::p_aplat, Lorene::Star::ray_eq(), and Lorene::Star::ray_pole().
|
virtualinherited |
Integrated surface area in
Definition at line 366 of file star_rot_global.C.
References Lorene::Star_rot::get_a_car(), Lorene::Mg3d::get_angu(), Lorene::Star_rot::get_bbb(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Star_rot::l_surf(), Lorene::Star::mp, Lorene::Star_rot::p_area, Lorene::sqrt(), Lorene::Valeur::std_base_scal(), Lorene::Valeur::val_point_jk(), and Lorene::Star::xi_surf().
|
protectedvirtualinherited |
Deletes all the derived quantities.
Reimplemented from Lorene::Star.
Definition at line 297 of file star_rot.C.
References Lorene::Star::del_deriv(), Lorene::Star_rot::p_angu_mom, Lorene::Star_rot::p_aplat, Lorene::Star_rot::p_area, Lorene::Star_rot::p_espec_isco, Lorene::Star_rot::p_f_eq, Lorene::Star_rot::p_f_isco, Lorene::Star_rot::p_grv2, Lorene::Star_rot::p_grv3, Lorene::Star_rot::p_lspec_isco, Lorene::Star_rot::p_mom_quad, Lorene::Star_rot::p_r_circ, Lorene::Star_rot::p_r_isco, Lorene::Star_rot::p_tsw, Lorene::Star_rot::p_z_eqb, Lorene::Star_rot::p_z_eqf, Lorene::Star_rot::p_z_pole, and Lorene::Star_rot::set_der_0x0().
|
protectedvirtualinherited |
Sets to ETATNONDEF
(undefined state) the hydrodynamical quantities relative to the Eulerian observer.
Reimplemented from Lorene::Star.
Definition at line 345 of file star_rot.C.
References Lorene::Star_rot::del_deriv(), and Lorene::Star::del_hydro_euler().
Display in polytropic units.
Definition at line 649 of file star_rot.C.
References Lorene::Star_rot::angu_mom(), Lorene::Star::ener, Lorene::Star::eos, Lorene::Star_rot::get_omega_c(), Lorene::Star_rot::mass_b(), Lorene::Star_rot::mass_g(), Lorene::Star_rot::mean_radius(), Lorene::Star::nbar, Lorene::pow(), Lorene::Star_rot::r_circ(), Lorene::Star::ray_eq(), Lorene::sqrt(), and Lorene::Scalar::val_grid_point().
void Lorene::Gravastar::equation_of_state | ( | ) |
Allows to computes the proper baryon and energy density, as well as pressure from the enthalpy, in the gravastar's crust only (in the core, p=-rho=cst)
Definition at line 67 of file gravastar.C.
References Lorene::Param::add_int(), Lorene::Scalar::allocate_all(), Lorene::Scalar::annule(), Lorene::Star_rot::del_deriv(), Lorene::Star::ener, Lorene::Eos::ener_ent(), Lorene::Star::ent, Lorene::Star::eos, Lorene::Mg3d::get_grille3d(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Star::mp, Lorene::Star::nbar, Lorene::Eos::nbar_ent(), Lorene::Star::nzet, Lorene::Star::press, Lorene::Eos::press_ent(), rho_core, Lorene::Mtbl::set(), Lorene::Scalar::set_domain(), Lorene::Mtbl::set_etat_qcq(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::std_spectral_base(), Lorene::Mtbl::t, and Lorene::Grille3d::x.
|
virtualinherited |
Computes an equilibrium configuration.
ent_c | [input] Central enthalpy |
omega0 | [input] Requested angular velocity (if fact_omega=1 . ) |
fact_omega | [input] 1.01 = search for the Keplerian frequency,
|
nzadapt | [input] Number of (inner) domains where the mapping adaptation to an iso-enthalpy surface should be performed |
ent_limit | [input] 1-D Tbl of dimension nzet which defines the enthalpy at the outer boundary of each domain |
icontrol | [input] Set of integer parameters (stored as a 1-D Itbl of size 8) to control the iteration:
|
control | [input] Set of parameters (stored as a 1-D Tbl of size 7) to control the iteration:
|
mbar_wanted | [input] Requested baryon mass (effective only if mer_mass > mer_max ) |
aexp_mass | [input] Exponent for the increase factor of the central enthalpy to converge to the requested baryon mass |
diff | [output] 1-D Tbl of size 7 for the storage of some error indicators :
|
Definition at line 71 of file star_rot_equil.C.
References Lorene::Star_rot::a_car, Lorene::abs(), Lorene::Map::adapt(), Lorene::Star_rot::ak_car, Lorene::Star_rot::bbb, Lorene::Star::beta, Lorene::Map::cmp_zero(), Lorene::contract(), Lorene::cos(), Lorene::Scalar::derive_con(), Lorene::Scalar::derive_cov(), Lorene::diffrel(), Lorene::Scalar::dsdr(), Lorene::Star_rot::dzeta, Lorene::Star::ener_euler, Lorene::Star::ent, Lorene::Star::equation_of_state(), Lorene::Star_rot::fait_nphi(), Lorene::Map::flat_met_cart(), Lorene::Map::flat_met_spher(), Lorene::Star::gam_euler, Lorene::Map::get_bvect_cart(), Lorene::Scalar::get_etat(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Scalar::get_spectral_va(), Lorene::Mg3d::get_type_t(), Lorene::Star_rot::grv2(), Lorene::Star_rot::hydro_euler(), Lorene::Star_rot::khi_shift, Lorene::log(), Lorene::log10(), Lorene::Star::logn, Lorene::Star_rot::mass_b(), Lorene::Star_rot::mass_g(), Lorene::Star::mp, Lorene::Star::nbar, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star_rot::nuf, Lorene::Star_rot::nuq, Lorene::Star::nzet, Lorene::Star_rot::omega, Lorene::Star_rot::partial_display(), Lorene::Map::phi, Lorene::Map::poisson2d(), Lorene::pow(), Lorene::Star::press, Lorene::Star::ray_eq(), Lorene::Star::ray_pole(), Lorene::Map::reevaluate(), Lorene::Star_rot::relativistic, Lorene::Star::s_euler, Lorene::Vector::set(), Lorene::Scalar::set_dzpuis(), Lorene::Scalar::set_spectral_va(), Lorene::Map::sint, Lorene::sqrt(), Lorene::Star_rot::ssjm1_khi, Lorene::Star_rot::ssjm1_nuf, Lorene::Star_rot::ssjm1_nuq, Lorene::Star_rot::ssjm1_tggg, Lorene::Star_rot::ssjm1_wshift, Lorene::Scalar::std_spectral_base(), Lorene::Star_rot::tggg, Lorene::Star_rot::tkij, Lorene::Star::u_euler, Lorene::Star_rot::update_metric(), Lorene::Star_rot::uuu, Lorene::Scalar::val_grid_point(), and Lorene::Star_rot::w_shift.
void Lorene::Gravastar::equilibrium | ( | double | omega0, |
double | fact_omega, | ||
int | nzadapt, | ||
const Tbl & | ent_limit, | ||
const Itbl & | icontrol, | ||
const Tbl & | control, | ||
Tbl & | diff, | ||
Param * | = 0x0 |
||
) |
Computes an equilibrium configuration.
omega0 | [input] Requested angular velocity (if fact_omega=1 . ) |
fact_omega | [input] 1.01 = search for the Keplerian frequency,
|
nzadapt | [input] Number of (inner) domains where the mapping adaptation to an iso-enthalpy surface should be performed |
ent_limit | [input] 1-D Tbl of dimension nzet which defines the enthalpy at the outer boundary of each domain |
icontrol | [input] Set of integer parameters (stored as a 1-D Itbl of size 8) to control the iteration:
|
control | [input] Set of parameters (stored as a 1-D Tbl of size 7) to control the iteration:
|
diff | [output] 1-D Tbl of size 7 for the storage of some error indicators :
|
Definition at line 47 of file gravastar_equil.C.
References Lorene::Star_rot::a_car, Lorene::Map::adapt(), Lorene::Param::add_cmp_mod(), Lorene::Param::add_double(), Lorene::Param::add_double_mod(), Lorene::Param::add_int(), Lorene::Param::add_int_mod(), Lorene::Param::add_tbl(), Lorene::Param::add_tenseur_mod(), Lorene::Star_rot::ak_car, Lorene::Tensor::annule_domain(), Lorene::Star_rot::bbb, Lorene::Star::beta, Lorene::Vector::change_triad(), Lorene::Map::cmp_zero(), Lorene::contract(), Lorene::Scalar::derive_con(), Lorene::Scalar::derive_cov(), des_profile(), Lorene::diffrel(), Lorene::Scalar::dsdr(), Lorene::Star_rot::dzeta, Lorene::Star::ener_euler, Lorene::Star::ent, equation_of_state(), Lorene::Star_rot::fait_nphi(), Lorene::Map::flat_met_cart(), Lorene::Map::flat_met_spher(), Lorene::Star::gam_euler, Lorene::Valeur::get_base(), Lorene::Map::get_bvect_cart(), Lorene::Scalar::get_etat(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Scalar::get_spectral_va(), Lorene::Mg3d::get_type_t(), Lorene::Star_rot::grv2(), Lorene::Map_et::homothetie(), Lorene::Star_rot::hydro_euler(), Lorene::Star_rot::khi_shift, Lorene::log(), Lorene::log10(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Scalar::mult_rsint(), Lorene::Star::nbar, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star_rot::nuf, Lorene::Star_rot::nuq, Lorene::Star::nzet, Lorene::Star_rot::omega, Lorene::Star_rot::partial_display(), Lorene::Scalar::poisson(), Lorene::Map::poisson2d(), Lorene::Tenseur::poisson_vect(), Lorene::Star::press, Lorene::Star::ray_eq(), Lorene::Star::ray_pole(), Lorene::Map::reevaluate(), Lorene::Star_rot::relativistic, Lorene::Star::s_euler, Lorene::Tenseur::set(), Lorene::Tbl::set(), Lorene::Vector::set(), Lorene::Scalar::set_dzpuis(), Lorene::Tbl::set_etat_qcq(), Lorene::Tenseur::set_etat_qcq(), Lorene::Cmp::set_etat_zero(), Lorene::Scalar::set_spectral_va(), Lorene::sqrt(), Lorene::Star_rot::ssjm1_khi, Lorene::Star_rot::ssjm1_nuf, Lorene::Star_rot::ssjm1_nuq, Lorene::Star_rot::ssjm1_tggg, Lorene::Star_rot::ssjm1_wshift, Lorene::Scalar::std_spectral_base(), Lorene::Scalar::test_poisson(), Lorene::Star_rot::tggg, Lorene::Star_rot::tkij, Lorene::Star::u_euler, Lorene::Tensor::up(), Lorene::Star_rot::update_metric(), Lorene::Star_rot::uuu, Lorene::Scalar::val_grid_point(), and Lorene::Star_rot::w_shift.
|
virtualinherited |
Computes a spherical static configuration.
ent_c | [input] central value of the enthalpy |
precis | [input] threshold in the relative difference between the enthalpy fields of two consecutive steps to stop the iterative procedure (default value: 1.e-14) |
ent_limit | [input] : array of enthalpy values to be set at the boundaries between the domains; if set to 0x0 (default), the initial values will be kept. |
Definition at line 95 of file star_equil_spher.C.
References Lorene::Scalar::annule(), Lorene::diffrel(), Lorene::Scalar::dsdr(), Lorene::Star::ener, Lorene::Star::ener_euler, Lorene::Star::ent, Lorene::Star::equation_of_state(), Lorene::exp(), Lorene::Star::gam_euler, Lorene::Star::gamma, Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Star::logn, Lorene::Star::mass_b(), Lorene::Star::mass_g(), Lorene::Star::mp, Lorene::Star::nn, Lorene::norme(), Lorene::Star::nzet, Lorene::Star::press, Lorene::Star::s_euler, Lorene::Vector::set(), Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), Lorene::Star::u_euler, Lorene::Scalar::val_grid_point(), and Lorene::Map::val_r().
|
virtualinherited |
Energy of a particle on the ISCO.
Definition at line 289 of file star_rot_isco.C.
References Lorene::Star_rot::p_espec_isco, and Lorene::Star_rot::r_isco().
|
inherited |
Computes tkij
and ak_car
from shift
, nnn
and b_car
.
Definition at line 110 of file star_rot_upmetr.C.
References Lorene::Star_rot::ak_car, Lorene::Star_rot::b_car, Lorene::Star::beta, Lorene::contract(), Lorene::Tensor::derive_cov(), Lorene::Scalar::dsdr(), Lorene::Map::flat_met_cart(), Lorene::Map::get_mg(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Tensor::set_etat_zero(), Lorene::Scalar::srdsdt(), and Lorene::Star_rot::tkij.
|
virtualinherited |
Orbital frequency at the equator.
Definition at line 307 of file star_rot_isco.C.
References Lorene::Star_rot::p_f_eq, and Lorene::Star_rot::r_isco().
|
virtualinherited |
Orbital frequency at the innermost stable circular orbit (ISCO).
Definition at line 255 of file star_rot_isco.C.
References Lorene::Star_rot::p_f_isco, and Lorene::Star_rot::r_isco().
|
inherited |
Computes tnphi
and nphi
from the Cartesian components of the shift, stored in shift
.
Definition at line 748 of file star_rot.C.
References Lorene::Star::beta, Lorene::Map::comp_p_from_cartesian(), Lorene::Scalar::div_rsint(), Lorene::Star::mp, Lorene::Star_rot::nphi, and Lorene::Star_rot::tnphi.
|
inherited |
Computes shift
from w_shift
and khi_shift
according to Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
Definition at line 703 of file star_rot.C.
References Lorene::Star::beta, Lorene::contract(), Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::derive_con(), Lorene::Tensor::derive_con(), Lorene::Scalar::domain(), Lorene::Map::flat_met_cart(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Star_rot::khi_shift, Lorene::Star::mp, Lorene::Map::sinp, Lorene::Map::sint, Lorene::Star_rot::w_shift, Lorene::Map::x, Lorene::Map::y, and Lorene::Map::z.
Returns the square of the metric factor A.
Definition at line 319 of file star_rot.h.
References Lorene::Star_rot::a_car.
Returns the scalar
For axisymmetric stars, this quantity is related to the derivatives of
In particular it is related to the quantities
Definition at line 403 of file star_rot.h.
References Lorene::Star_rot::ak_car.
Returns the square of the metric factor B.
Definition at line 322 of file star_rot.h.
References Lorene::Star_rot::b_car.
Returns the metric factor B.
Definition at line 316 of file star_rot.h.
References Lorene::Star_rot::bbb.
Returns the Metric potential
Definition at line 346 of file star_rot.h.
References Lorene::Star_rot::dzeta.
Returns the proper total energy density.
Definition at line 370 of file star.h.
References Lorene::Star::ener.
Returns the total energy density with respect to the Eulerian observer.
Definition at line 376 of file star.h.
References Lorene::Star::ener_euler.
Returns the Lorentz factor between the fluid and Eulerian observers.
Definition at line 382 of file star.h.
References Lorene::Star::gam_euler.
Returns the scalar shift
following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of mp
.
Definition at line 377 of file star_rot.h.
References Lorene::Star_rot::khi_shift.
Returns the logarithm of the lapse N.
In the Newtonian case, this is the Newtonian gravitational potential (in units of
Definition at line 396 of file star.h.
References Lorene::Star::logn.
Returns the proper baryon density.
Definition at line 367 of file star.h.
References Lorene::Star::nbar.
Returns the metric coefficient
Definition at line 325 of file star_rot.h.
References Lorene::Star_rot::nphi.
Returns the part of the Metric potential logn
generated by the matter terms.
Definition at line 338 of file star_rot.h.
References Lorene::Star_rot::nuf.
Returns the Part of the Metric potential logn
generated by the quadratic terms.
Definition at line 343 of file star_rot.h.
References Lorene::Star_rot::nuq.
|
inlineinherited |
Returns the number of domains occupied by the star.
Definition at line 358 of file star.h.
References Lorene::Star::nzet.
|
virtualinherited |
Returns the central value of the rotation angular velocity ([f_unit] )
Definition at line 640 of file star_rot.C.
References Lorene::Star_rot::omega.
Returns the trace of the stress tensor in the Eulerian frame.
Definition at line 379 of file star.h.
References Lorene::Star::s_euler.
Returns the spatial part of the stress-energy tensor with respect to the Eulerian observer.
Definition at line 390 of file star.h.
References Lorene::Star::stress_euler.
Returns the Metric potential
Definition at line 349 of file star_rot.h.
References Lorene::Star_rot::tggg.
|
inlineinherited |
Returns the tensor
tkij
contains the Cartesian components of
Definition at line 384 of file star_rot.h.
References Lorene::Star_rot::tkij.
Returns the component
Definition at line 330 of file star_rot.h.
References Lorene::Star_rot::tnphi.
Returns the fluid 3-velocity with respect to the Eulerian observer.
Definition at line 385 of file star.h.
References Lorene::Star::u_euler.
Returns the norm of u_euler
.
Definition at line 333 of file star_rot.h.
References Lorene::Star_rot::uuu.
Returns the vector shift
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of mp
.
Definition at line 363 of file star_rot.h.
References Lorene::Star_rot::w_shift.
|
virtualinherited |
Error on the virial identity GRV2.
This indicator is only valid for relativistic computations.
Definition at line 204 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::ak_car, Lorene::Scalar::derive_cov(), Lorene::Star::ener_euler, Lorene::Map::flat_met_spher(), Lorene::Star_rot::lambda_grv2(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Star::nbar, Lorene::Star_rot::p_grv2, Lorene::Star::press, Lorene::Star_rot::relativistic, and Lorene::Star_rot::uuu.
Error on the virial identity GRV3.
The error is computed as the integral defined by Eq. (43) of [Gourgoulhon and Bonazzola, Class. Quantum Grav. 11, 443 (1994)] divided by the integral of the matter terms.
ost | output stream to give details of the computation; if set to 0x0 [default value], no details will be given. |
Definition at line 235 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::ak_car, Lorene::Star_rot::bbb, Lorene::Scalar::derive_cov(), Lorene::Star_rot::dzeta, Lorene::Map::flat_met_spher(), Lorene::log(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Star::nbar, Lorene::Star_rot::p_grv3, Lorene::Star::press, Lorene::Star_rot::relativistic, Lorene::Star::s_euler, and Lorene::Star_rot::uuu.
|
virtualinherited |
Computes the hydrodynamical quantities relative to the Eulerian observer from those in the fluid frame.
The calculation is performed starting from the quantities ent
, ener
, press
, and a_car
,
which are supposed to be up to date.
From these, the following fields are updated: gam_euler
, u_euler
, ener_euler
, s_euler
.
Reimplemented from Lorene::Star.
Definition at line 57 of file star_rot_hydro.C.
References Lorene::Star_rot::a_car, Lorene::Tensor::annule_domain(), Lorene::Star_rot::b_car, Lorene::Star::beta, Lorene::Star_rot::del_deriv(), Lorene::Star::ener, Lorene::Star::ener_euler, Lorene::Star::gam_euler, Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Scalar::get_etat(), Lorene::Map::get_mg(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::omega, Lorene::Star::press, Lorene::Star::s_euler, Lorene::Vector::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Tensor::set_etat_zero(), Lorene::Scalar::set_spectral_va(), Lorene::Tensor::set_triad(), Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), Lorene::Vector::std_spectral_base(), Lorene::Star::u_euler, Lorene::Star_rot::unsurc2, Lorene::Star_rot::uuu, Lorene::Map::x, and Lorene::Map::y.
|
inlineinherited |
Returns true
for a relativistic star, false
for a Newtonian one.
Definition at line 308 of file star_rot.h.
References Lorene::Star_rot::relativistic.
Description of the stellar surface: returns a 2-D Itbl
containing the values of the domain index l on the surface at the collocation points in
The stellar surface is defined as the location where the enthalpy (member ent
) vanishes.
Reimplemented from Lorene::Star.
Definition at line 68 of file star_rot_global.C.
References Lorene::Star::ent, Lorene::Map::get_mg(), Lorene::Scalar::get_spectral_va(), Lorene::Star::mp, Lorene::Star::nzet, Lorene::Star::p_l_surf, and Lorene::Star::p_xi_surf.
Computes the coefficient
in order that the total source does not contain any monopolar term, i.e. in order that
where
Then, by construction, the new source
sou_m | [input] matter source term ![]() |
sou_q | [input] quadratic source term ![]() |
Definition at line 62 of file star_rot_lambda_grv2.C.
References Lorene::Mg3d::get_grille3d(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), and Lorene::Mg3d::get_type_r().
|
virtualinherited |
Angular momentum of a particle on the ISCO.
Definition at line 272 of file star_rot_isco.C.
References Lorene::Star_rot::p_lspec_isco, and Lorene::Star_rot::r_isco().
|
virtualinherited |
Baryon mass.
Implements Lorene::Star.
Definition at line 98 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::bbb, Lorene::Star::gam_euler, Lorene::Scalar::get_etat(), Lorene::Scalar::integrale(), Lorene::Star::nbar, Lorene::Star::p_mass_b, and Lorene::Star_rot::relativistic.
|
virtualinherited |
Gravitational mass.
Implements Lorene::Star.
Definition at line 124 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::bbb, Lorene::Star::ener_euler, Lorene::Star_rot::mass_b(), Lorene::Star::nn, Lorene::Star::p_mass_g, Lorene::Star::press, Lorene::Star_rot::relativistic, Lorene::Star::s_euler, Lorene::Star_rot::tnphi, and Lorene::Star_rot::uuu.
|
virtualinherited |
Mean star radius from the area
Definition at line 416 of file star_rot_global.C.
References Lorene::Star_rot::area(), and Lorene::sqrt().
|
virtualinherited |
Quadrupole moment.
The quadrupole moment Q is defined according to Eq. (7) of [Salgado, Bonazzola, Gourgoulhon and Haensel, Astron. Astrophys. 291 , 155 (1994)]. At the Newtonian limit it is related to the component
Definition at line 521 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::ak_car, Lorene::Star_rot::bbb, Lorene::Scalar::derive_cov(), Lorene::Star::ener_euler, Lorene::Map::flat_met_spher(), Lorene::log(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Star::nbar, Lorene::Star_rot::p_mom_quad, Lorene::Star_rot::relativistic, and Lorene::Star::s_euler.
Operator >> (virtual function called by the operator <<).
Reimplemented from Lorene::Star_rot.
Definition at line 185 of file gravastar.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::angu_mom(), Lorene::Star_rot::aplat(), Lorene::Star_rot::b_car, Lorene::diffrel(), Lorene::Star_rot::dzeta, Lorene::Star::ener, Lorene::Star::ent, Lorene::Star::eos, Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Star_rot::get_omega_c(), Lorene::Tbl::get_taille(), Lorene::Star_rot::grv2(), Lorene::Star_rot::grv3(), Lorene::Star_rot::khi_shift, Lorene::Star::logn, Lorene::Star_rot::mom_quad(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star::nzet, Lorene::Star_rot::omega, Lorene::pow(), Lorene::Star::press, Lorene::Star_rot::r_circ(), Lorene::Star::ray_eq(), Lorene::Star::ray_eq_pi(), Lorene::Star::ray_eq_pis2(), Lorene::Star::ray_pole(), Lorene::Star_rot::tsw(), Lorene::Star_rot::uuu, Lorene::Scalar::val_grid_point(), Lorene::Star_rot::w_shift, Lorene::Star_rot::z_eqb(), Lorene::Star_rot::z_eqf(), and Lorene::Star_rot::z_pole().
Printing of some informations, excluding all global quantities.
Definition at line 590 of file star_rot.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::aplat(), Lorene::Star_rot::b_car, Lorene::Star_rot::dzeta, Lorene::Star::ener, Lorene::Star::ent, Lorene::Map::get_mg(), Lorene::Star_rot::get_omega_c(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Star::nbar, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star::nzet, Lorene::Star::press, Lorene::Star::ray_eq(), Lorene::Star_rot::uuu, and Lorene::Scalar::val_grid_point().
|
virtualinherited |
Circumferential radius.
Definition at line 342 of file star_rot_global.C.
References Lorene::Star_rot::bbb, Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, Lorene::Star::nzet, Lorene::Star_rot::p_r_circ, Lorene::Star::ray_eq(), and Lorene::Scalar::val_grid_point().
Circumferential radius of the innermost stable circular orbit (ISCO).
ost | output stream to give details of the computation; if set to 0x0 [default value], no details will be given. |
Definition at line 71 of file star_rot_isco.C.
References Lorene::Tensor::annule_domain(), Lorene::Star_rot::bbb, Lorene::Scalar::dsdr(), Lorene::Map::get_mg(), Lorene::Scalar::get_spectral_va(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star::nzet, Lorene::Star_rot::p_espec_isco, Lorene::Star_rot::p_f_eq, Lorene::Star_rot::p_f_isco, Lorene::Star_rot::p_lspec_isco, Lorene::Star_rot::p_r_isco, Lorene::Map::r, Lorene::Star::ray_eq(), Lorene::sqrt(), Lorene::Map::val_r(), and Lorene::zerosec().
|
inherited |
Coordinate radius at
Definition at line 108 of file star_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_p(), Lorene::Mg3d::get_type_t(), Lorene::Star::l_surf(), Lorene::Star::mp, Lorene::Star::p_ray_eq, Lorene::Map::val_r(), and Lorene::Star::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 233 of file star_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_p(), Lorene::Mg3d::get_type_t(), Lorene::Star::l_surf(), Lorene::Star::mp, Lorene::Star::p_ray_eq_3pis2, Lorene::Star::ray_eq_pis2(), Lorene::Map::val_r(), and Lorene::Star::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 186 of file star_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_p(), Lorene::Mg3d::get_type_t(), Lorene::Star::l_surf(), Lorene::Star::mp, Lorene::Star::p_ray_eq_pi, Lorene::Star::ray_eq(), Lorene::Map::val_r(), and Lorene::Star::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 138 of file star_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_p(), Lorene::Mg3d::get_type_t(), Lorene::Star::l_surf(), Lorene::Star::mp, Lorene::Star::p_ray_eq_pis2, Lorene::Map::val_r(), and Lorene::Star::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 278 of file star_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Star::l_surf(), Lorene::Star::mp, Lorene::Star::p_ray_pole, Lorene::Map::val_r(), and Lorene::Star::xi_surf().
Save in a file.
Reimplemented from Lorene::Star.
Definition at line 401 of file star_rot.C.
References Lorene::Star_rot::dzeta, Lorene::fwrite_be(), Lorene::Star_rot::khi_shift, Lorene::Star_rot::nuf, Lorene::Star_rot::nuq, Lorene::Star_rot::omega, Lorene::Star_rot::relativistic, Lorene::Scalar::sauve(), Lorene::Star::sauve(), Lorene::Tensor::sauve(), Lorene::Star_rot::ssjm1_dzeta, Lorene::Star_rot::ssjm1_khi, Lorene::Star_rot::ssjm1_nuf, Lorene::Star_rot::ssjm1_nuq, Lorene::Star_rot::ssjm1_tggg, Lorene::Star_rot::ssjm1_wshift, Lorene::Star_rot::tggg, and Lorene::Star_rot::w_shift.
|
protectedvirtualinherited |
Sets to 0x0
all the pointers on derived quantities.
Reimplemented from Lorene::Star.
Definition at line 322 of file star_rot.C.
References Lorene::Star_rot::p_angu_mom, Lorene::Star_rot::p_aplat, Lorene::Star_rot::p_area, Lorene::Star_rot::p_espec_isco, Lorene::Star_rot::p_f_eq, Lorene::Star_rot::p_f_isco, Lorene::Star_rot::p_grv2, Lorene::Star_rot::p_grv3, Lorene::Star_rot::p_lspec_isco, Lorene::Star_rot::p_mom_quad, Lorene::Star_rot::p_r_circ, Lorene::Star_rot::p_r_isco, Lorene::Star_rot::p_tsw, Lorene::Star_rot::p_z_eqb, Lorene::Star_rot::p_z_eqf, Lorene::Star_rot::p_z_pole, and Lorene::Star::set_der_0x0().
Assignment of the enthalpy field.
Definition at line 379 of file star.C.
References Lorene::Star::del_deriv(), Lorene::Star::ent, and Lorene::Star::equation_of_state().
|
inlineinherited |
|
virtualinherited |
Ratio T/W.
Definition at line 176 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::angu_mom(), Lorene::Star_rot::bbb, Lorene::Star::ener, Lorene::Star::gam_euler, Lorene::Star::logn, Lorene::Star_rot::mass_g(), Lorene::Star::nbar, Lorene::Star_rot::omega, Lorene::Star_rot::p_tsw, and Lorene::Star_rot::relativistic.
|
inherited |
Computes metric coefficients from known potentials.
The calculation is performed starting from the quantities logn
, dzeta
, tggg
and shift
, which are supposed to be up to date.
From these, the following fields are updated: nnn
, a_car
, bbb
and b_car
, as well as the 3-metric gamma
.
Definition at line 51 of file star_rot_upmetr.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::b_car, Lorene::Star_rot::bbb, Lorene::Star_rot::del_deriv(), Lorene::Star_rot::dzeta, Lorene::exp(), Lorene::Star_rot::extrinsic_curvature(), Lorene::Star::gamma, Lorene::Map::get_bvect_spher(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Star::nn, Lorene::Tensor::set(), Lorene::Scalar::std_spectral_base(), Lorene::Star_rot::tggg, and Lorene::Star_rot::unsurc2.
Description of the stellar surface: returns a 2-D Tbl
containing the values of the radial coordinate
The stellar surface is defined as the location where the enthalpy (member ent
) vanishes.
Definition at line 89 of file star_global.C.
References Lorene::Star::l_surf(), Lorene::Star::p_l_surf, and Lorene::Star::p_xi_surf.
|
virtualinherited |
Backward redshift factor at equator.
Definition at line 471 of file star_rot_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star::nzet, Lorene::Star_rot::p_z_eqb, Lorene::Star_rot::r_circ(), Lorene::sqrt(), Lorene::Star_rot::uuu, and Lorene::Scalar::val_grid_point().
|
virtualinherited |
Forward redshift factor at equator.
Definition at line 443 of file star_rot_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::nphi, Lorene::Star::nzet, Lorene::Star_rot::p_z_eqf, Lorene::Star_rot::r_circ(), Lorene::sqrt(), Lorene::Star_rot::uuu, and Lorene::Scalar::val_grid_point().
|
virtualinherited |
Redshift factor at North pole.
Definition at line 502 of file star_rot_global.C.
References Lorene::Star::nn, Lorene::Star_rot::p_z_pole, Lorene::Star::ray_pole(), and Lorene::Scalar::val_point().
|
protectedinherited |
Square of the metric factor A.
Definition at line 104 of file star_rot.h.
|
protectedinherited |
Scalar
For axisymmetric stars, this quantity is related to the derivatives of
In particular it is related to the quantities
Definition at line 186 of file star_rot.h.
|
protectedinherited |
Square of the metric factor B.
Definition at line 110 of file star_rot.h.
|
protectedinherited |
Metric factor B.
Definition at line 107 of file star_rot.h.
|
protectedinherited |
Metric potential
Definition at line 134 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
Scalar shift
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
Definition at line 160 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
Metric coefficient
Definition at line 113 of file star_rot.h.
|
protectedinherited |
Part of the Metric potential logn
generated by the matter terms.
Definition at line 126 of file star_rot.h.
|
protectedinherited |
Part of the Metric potential logn
generated by the quadratic terms.
Definition at line 131 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
Rotation angular velocity ([f_unit] )
Definition at line 101 of file star_rot.h.
|
mutableprotectedinherited |
Angular momentum.
Definition at line 232 of file star_rot.h.
|
mutableprotectedinherited |
Flatening r_pole/r_eq.
Definition at line 237 of file star_rot.h.
|
mutableprotectedinherited |
Integrated surface area.
Definition at line 238 of file star_rot.h.
|
mutableprotectedinherited |
Specific energy of a particle on the ISCO.
Definition at line 246 of file star_rot.h.
|
mutableprotectedinherited |
Orbital frequency at the equator.
Definition at line 249 of file star_rot.h.
|
mutableprotectedinherited |
Orbital frequency of the ISCO.
Definition at line 244 of file star_rot.h.
|
mutableprotectedinherited |
Error on the virial identity GRV2.
Definition at line 234 of file star_rot.h.
|
mutableprotectedinherited |
Error on the virial identity GRV3.
Definition at line 235 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Specific angular momentum of a particle on the ISCO.
Definition at line 248 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Quadrupole moment.
Definition at line 242 of file star_rot.h.
|
mutableprotectedinherited |
Circumferential radius.
Definition at line 236 of file star_rot.h.
|
mutableprotectedinherited |
Circumferential radius of the ISCO.
Definition at line 243 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Ratio T/W.
Definition at line 233 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Backward redshift factor at equator.
Definition at line 240 of file star_rot.h.
|
mutableprotectedinherited |
Forward redshift factor at equator.
Definition at line 239 of file star_rot.h.
|
mutableprotectedinherited |
Redshift factor at North pole.
Definition at line 241 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
Indicator of relativity: true
for a relativistic star, false
for a Newtonian one.
Definition at line 94 of file star_rot.h.
|
protected |
Energy density in gravastar's core.
Definition at line 57 of file gravastar.h.
|
protectedinherited |
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for dzeta
.
Definition at line 203 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for the scalar Map_et::poisson
.
Definition at line 216 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for nuf
by means of Map_et::poisson
.
Definition at line 192 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for nuq
by means of Map_et::poisson
.
Definition at line 198 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for tggg
.
Definition at line 208 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the vector Poisson equation for
mp
)
Definition at line 225 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
Metric potential
Definition at line 137 of file star_rot.h.
|
protectedinherited |
Tensor
tkij
contains the Cartesian components of
Definition at line 167 of file star_rot.h.
|
protectedinherited |
Component
Definition at line 118 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
unsurc2=1
for a relativistic star, 0 for a Newtonian one.
Definition at line 99 of file star_rot.h.
|
protectedinherited |
Norm of u_euler
.
Definition at line 121 of file star_rot.h.
|
protectedinherited |
Vector shift
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of mp
.
Definition at line 150 of file star_rot.h.