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. More... | |
Gravastar (const Gravastar &) | |
Copy constructor. More... | |
Gravastar (Map &mp_i, const Eos &eos_i, FILE *fich) | |
Constructor from a file (see sauve(FILE*) ). More... | |
~Gravastar () | |
Destructor. More... | |
void | operator= (const Gravastar &) |
Assignment to another Gravastar . More... | |
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) More... | |
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. More... | |
bool | is_relativistic () const |
Returns true for a relativistic star, false for a Newtonian one. More... | |
virtual double | get_omega_c () const |
Returns the central value of the rotation angular velocity ( [f_unit] ) More... | |
const Scalar & | get_bbb () const |
Returns the metric factor B. More... | |
const Scalar & | get_a_car () const |
Returns the square of the metric factor A. More... | |
const Scalar & | get_b_car () const |
Returns the square of the metric factor B. More... | |
const Scalar & | get_nphi () const |
Returns the metric coefficient . More... | |
const Scalar & | get_tnphi () const |
Returns the component of the shift vector. More... | |
const Scalar & | get_uuu () const |
Returns the norm of u_euler . More... | |
const Scalar & | get_nuf () const |
Returns the part of the Metric potential = logn generated by the matter terms. More... | |
const Scalar & | get_nuq () const |
Returns the Part of the Metric potential = logn generated by the quadratic terms. More... | |
const Scalar & | get_dzeta () const |
Returns the Metric potential . More... | |
const Scalar & | get_tggg () const |
Returns the Metric potential . More... | |
const Vector & | get_w_shift () const |
Returns the vector used in the decomposition of shift , following Shibata's prescription [Prog. More... | |
const Scalar & | get_khi_shift () const |
Returns the scalar used in the decomposition of shift following Shibata's prescription [Prog. More... | |
const Sym_tensor & | get_tkij () const |
Returns the tensor related to the extrinsic curvature tensor by . More... | |
const Scalar & | get_ak_car () const |
Returns the scalar . More... | |
virtual void | sauve (FILE *) const |
Save in a file. More... | |
virtual void | display_poly (ostream &) const |
Display in polytropic units. More... | |
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 . More... | |
virtual double | mass_b () const |
Baryon mass. More... | |
virtual double | mass_g () const |
Gravitational mass. More... | |
virtual double | angu_mom () const |
Angular momentum. More... | |
virtual double | tsw () const |
Ratio T/W. More... | |
virtual double | grv2 () const |
Error on the virial identity GRV2. More... | |
virtual double | grv3 (ostream *ost=0x0) const |
Error on the virial identity GRV3. More... | |
virtual double | r_circ () const |
Circumferential equatorial radius. More... | |
virtual double | r_circ_merid () const |
Crcumferential meridional radius. More... | |
virtual double | aplat () const |
Flatening r_pole/r_eq. More... | |
virtual double | area () const |
Integrated surface area in . More... | |
virtual double | mean_radius () const |
Mean star radius from the area . More... | |
virtual double | z_eqf () const |
Forward redshift factor at equator. More... | |
virtual double | z_eqb () const |
Backward redshift factor at equator. More... | |
virtual double | z_pole () const |
Redshift factor at North pole. More... | |
virtual double | mom_quad () const |
Quadrupole moment. More... | |
virtual const Tbl & | surf_grav () const |
Surface gravity (table along the theta direction) More... | |
virtual double | r_isco (ostream *ost=0x0) const |
Circumferential radius of the innermost stable circular orbit (ISCO). More... | |
virtual double | f_isco () const |
Orbital frequency at the innermost stable circular orbit (ISCO). More... | |
virtual double | espec_isco () const |
Energy of a particle on the ISCO. More... | |
virtual double | lspec_isco () const |
Angular momentum of a particle on the ISCO. More... | |
virtual double | f_eq () const |
Orbital frequency at the equator. More... | |
virtual void | hydro_euler () |
Computes the hydrodynamical quantities relative to the Eulerian observer from those in the fluid frame. More... | |
void | update_metric () |
Computes metric coefficients from known potentials. More... | |
void | fait_shift () |
Computes shift from w_shift and khi_shift according to Shibata's prescription [Prog. More... | |
void | fait_nphi () |
Computes tnphi and nphi from the Cartesian components of the shift, stored in shift . More... | |
void | extrinsic_curvature () |
Computes tkij and ak_car from shift , nnn and b_car . More... | |
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. More... | |
Map & | set_mp () |
Read/write of the mapping. More... | |
void | set_enthalpy (const Scalar &) |
Assignment of the enthalpy field. More... | |
virtual void | equilibrium_spher (double ent_c, double precis=1.e-14, const Tbl *pent_limit=0x0) |
Computes a spherical static configuration. More... | |
const Map & | get_mp () const |
Returns the mapping. More... | |
int | get_nzet () const |
Returns the number of domains occupied by the star. More... | |
const Eos & | get_eos () const |
Returns the equation of state. More... | |
const Scalar & | get_ent () const |
Returns the enthalpy field. More... | |
const Scalar & | get_nbar () const |
Returns the proper baryon density. More... | |
const Scalar & | get_ener () const |
Returns the proper total energy density. More... | |
const Scalar & | get_press () const |
Returns the fluid pressure. More... | |
const Scalar & | get_ener_euler () const |
Returns the total energy density with respect to the Eulerian observer. More... | |
const Scalar & | get_s_euler () const |
Returns the trace of the stress tensor in the Eulerian frame. More... | |
const Scalar & | get_gam_euler () const |
Returns the Lorentz factor between the fluid and Eulerian observers. More... | |
const Vector & | get_u_euler () const |
Returns the fluid 3-velocity with respect to the Eulerian observer. More... | |
const Tensor & | get_stress_euler () const |
Returns the spatial part of the stress-energy tensor with respect to the Eulerian observer. More... | |
const Scalar & | get_logn () const |
Returns the logarithm of the lapse N. More... | |
const Scalar & | get_nn () const |
Returns the lapse function N. More... | |
const Vector & | get_beta () const |
Returns the shift vector . More... | |
const Scalar & | get_lnq () const |
const Metric & | get_gamma () const |
Returns the 3-metric . More... | |
double | ray_eq () const |
Coordinate radius at , [r_unit]. More... | |
double | ray_eq_pis2 () const |
Coordinate radius at , [r_unit]. More... | |
double | ray_eq_pi () const |
Coordinate radius at , [r_unit]. More... | |
double | ray_eq_3pis2 () const |
Coordinate radius at , [r_unit]. More... | |
double | ray_pole () const |
Coordinate radius at [r_unit]. More... | |
const Tbl & | xi_surf () const |
Description of the stellar surface: returns a 2-D Tbl containing the values of the radial coordinate on the surface at the collocation points in . More... | |
Static Public Member Functions | |
static double | lambda_grv2 (const Scalar &sou_m, const Scalar &sou_q) |
Computes the coefficient which ensures that the GRV2 virial identity is satisfied. More... | |
Protected Member Functions | |
virtual ostream & | operator>> (ostream &) const |
Operator >> (virtual function called by the operator <<). More... | |
virtual void | del_deriv () const |
Deletes all the derived quantities. More... | |
virtual void | set_der_0x0 () const |
Sets to 0x0 all the pointers on derived quantities. More... | |
virtual void | del_hydro_euler () |
Sets to ETATNONDEF (undefined state) the hydrodynamical quantities relative to the Eulerian observer. More... | |
virtual void | partial_display (ostream &) const |
Printing of some informations, excluding all global quantities. More... | |
Protected Attributes | |
double | rho_core |
Energy density in gravastar's core. More... | |
bool | relativistic |
Indicator of relativity: true for a relativistic star, false for a Newtonian one. More... | |
double | unsurc2 |
: unsurc2=1 for a relativistic star, 0 for a Newtonian one. More... | |
double | omega |
Rotation angular velocity ( [f_unit] ) More... | |
Scalar | a_car |
Square of the metric factor A. More... | |
Scalar | bbb |
Metric factor B. More... | |
Scalar | b_car |
Square of the metric factor B. More... | |
Scalar | nphi |
Metric coefficient . More... | |
Scalar | tnphi |
Component of the shift vector. More... | |
Scalar | uuu |
Norm of u_euler . More... | |
Scalar | nuf |
Part of the Metric potential = logn generated by the matter terms. More... | |
Scalar | nuq |
Part of the Metric potential = logn generated by the quadratic terms. More... | |
Scalar | dzeta |
Metric potential . More... | |
Scalar | tggg |
Metric potential . More... | |
Vector | w_shift |
Vector used in the decomposition of shift , following Shibata's prescription [Prog. More... | |
Scalar | khi_shift |
Scalar used in the decomposition of shift , following Shibata's prescription [Prog. More... | |
Sym_tensor | tkij |
Tensor related to the extrinsic curvature tensor by . More... | |
Scalar | ak_car |
Scalar . More... | |
Scalar | ssjm1_nuf |
Effective source at the previous step for the resolution of the Poisson equation for nuf by means of Map_et::poisson . More... | |
Scalar | ssjm1_nuq |
Effective source at the previous step for the resolution of the Poisson equation for nuq by means of Map_et::poisson . More... | |
Scalar | ssjm1_dzeta |
Effective source at the previous step for the resolution of the Poisson equation for dzeta . More... | |
Scalar | ssjm1_tggg |
Effective source at the previous step for the resolution of the Poisson equation for tggg . More... | |
Scalar | ssjm1_khi |
Effective source at the previous step for the resolution of the Poisson equation for the scalar by means of Map_et::poisson . More... | |
Vector | ssjm1_wshift |
Effective source at the previous step for the resolution of the vector Poisson equation for . More... | |
double * | p_angu_mom |
Angular momentum. More... | |
double * | p_tsw |
Ratio T/W. More... | |
double * | p_grv2 |
Error on the virial identity GRV2. More... | |
double * | p_grv3 |
Error on the virial identity GRV3. More... | |
double * | p_r_circ |
Circumferential radius (equator) More... | |
double * | p_r_circ_merid |
Circumferential radius (meridian) More... | |
double * | p_aplat |
Flatening r_pole/r_eq. More... | |
double * | p_area |
Integrated surface area. More... | |
double * | p_z_eqf |
Forward redshift factor at equator. More... | |
double * | p_z_eqb |
Backward redshift factor at equator. More... | |
double * | p_z_pole |
Redshift factor at North pole. More... | |
double * | p_mom_quad |
Quadrupole moment. More... | |
double * | p_r_isco |
Circumferential radius of the ISCO. More... | |
double * | p_f_isco |
Orbital frequency of the ISCO. More... | |
double * | p_espec_isco |
Specific energy of a particle on the ISCO. More... | |
double * | p_lspec_isco |
Specific angular momentum of a particle on the ISCO. More... | |
double * | p_f_eq |
Orbital frequency at the equator. More... | |
Tbl * | p_surf_grav |
Surface gravity (along the theta direction) More... | |
Map & | mp |
Mapping associated with the star. More... | |
int | nzet |
Number of domains of *mp occupied by the star. More... | |
const Eos & | eos |
Equation of state of the stellar matter. More... | |
Scalar | ent |
Log-enthalpy. More... | |
Scalar | nbar |
Baryon density in the fluid frame. More... | |
Scalar | ener |
Total energy density in the fluid frame. More... | |
Scalar | press |
Fluid pressure. More... | |
Scalar | ener_euler |
Total energy density in the Eulerian frame. More... | |
Scalar | s_euler |
Trace of the stress scalar in the Eulerian frame. More... | |
Scalar | gam_euler |
Lorentz factor between the fluid and Eulerian observers. More... | |
Vector | u_euler |
Fluid 3-velocity with respect to the Eulerian observer. More... | |
Sym_tensor | stress_euler |
Spatial part of the stress-energy tensor with respect to the Eulerian observer. More... | |
Scalar | logn |
Logarithm of the lapse N . More... | |
Scalar | nn |
Lapse function N . More... | |
Vector | beta |
Shift vector. More... | |
Scalar | lnq |
Metric | gamma |
3-metric More... | |
double * | p_ray_eq |
Coordinate radius at , . More... | |
double * | p_ray_eq_pis2 |
Coordinate radius at , . More... | |
double * | p_ray_eq_pi |
Coordinate radius at , . More... | |
double * | p_ray_eq_3pis2 |
Coordinate radius at , . More... | |
double * | p_ray_pole |
Coordinate radius at . More... | |
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 . More... | |
Tbl * | p_xi_surf |
Description of the stellar surface: 2-D Tbl containing the values of the radial coordinate on the surface at the collocation points in . More... | |
double * | p_mass_b |
Baryon mass. More... | |
double * | p_mass_g |
Gravitational mass. More... | |
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.
Lorene::Gravastar::Gravastar | ( | const Gravastar & | ) |
Copy constructor.
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 168 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::b_car, Lorene::Star::ener_euler, Lorene::Scalar::get_spectral_va(), Lorene::Scalar::integrale(), Lorene::Scalar::mult_r(), Lorene::Star::nbar, Lorene::Star_rot::p_angu_mom, Lorene::Star::press, Lorene::Star_rot::relativistic, Lorene::Scalar::set_spectral_va(), and Lorene::Star_rot::uuu.
|
virtualinherited |
Flatening r_pole/r_eq.
Definition at line 489 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 429 of file star_rot_global.C.
References Lorene::Valeur::annule_hard(), Lorene::Valeur::c_cf, Lorene::Valeur::dsdt(), 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::Scalar::get_spectral_va(), Lorene::Star_rot::l_surf(), Lorene::Star::mp, Lorene::Valeur::mult_st(), Lorene::Star_rot::p_area, Lorene::sqrt(), Lorene::Valeur::std_base_scal(), Lorene::Valeur::val_point_jk(), Lorene::Map_radial::val_r_jk(), and Lorene::Star::xi_surf().
|
protectedvirtualinherited |
Deletes all the derived quantities.
Reimplemented from Lorene::Star.
Definition at line 310 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_circ_merid, Lorene::Star_rot::p_r_isco, Lorene::Star_rot::p_surf_grav, 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 362 of file star_rot.C.
References Lorene::Star_rot::del_deriv(), and Lorene::Star::del_hydro_euler().
|
virtualinherited |
Display in polytropic units.
Definition at line 675 of file star_rot.C.
References Lorene::Star_rot::angu_mom(), Lorene::Star::ener, Lorene::Star::eos, Lorene::Eos_poly::get_gam(), Lorene::Eos_poly::get_kap(), 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_rot::r_circ_merid(), 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.
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::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Mg3d::get_type_t(), and Lorene::Star::mp.
|
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 77 of file star_rot_equil.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Mg3d::get_type_t(), and Lorene::Star::mp.
|
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 101 of file star_equil_spher.C.
References Lorene::Star_rot::a_car, Lorene::Map_et::adapt(), Lorene::Param::add_double(), Lorene::Param::add_int(), Lorene::Param::add_int_mod(), Lorene::Param::add_tbl(), Lorene::Scalar::annule(), Lorene::Star_rot::b_car, Lorene::Star_rot::bbb, Lorene::diffrel(), Lorene::Scalar::dsdr(), Lorene::Map_af::dsdr(), Lorene::Star_rot::dzeta, 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_af::get_alpha(), Lorene::Map_et::get_alpha(), Lorene::Map_af::get_beta(), Lorene::Map_et::get_beta(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Map_af::homothetie(), Lorene::Scalar::integrale(), Lorene::Star::logn, Lorene::Star::mass_b(), Lorene::Star::mass_g(), Lorene::Star::mp, Lorene::Star::nn, Lorene::norme(), Lorene::Star::nzet, Lorene::Map_af::poisson(), Lorene::Star::press, Lorene::Star::s_euler, Lorene::Vector::set(), Lorene::Map_af::set_alpha(), Lorene::Map_af::set_beta(), Lorene::Scalar::set_dzpuis(), Lorene::Cmp::set_etat_qcq(), Lorene::Tensor::set_etat_zero(), 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 292 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 113 of file star_rot_upmetr.C.
References Lorene::Scalar::dsdr(), Lorene::Scalar::get_etat(), Lorene::Map::get_mg(), Lorene::Star::mp, Lorene::Star_rot::nphi, Lorene::Tensor::set_etat_zero(), Lorene::Scalar::srdsdt(), and Lorene::Star_rot::tkij.
|
virtualinherited |
Orbital frequency at the equator.
Definition at line 310 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 258 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 779 of file star_rot.C.
References Lorene::Star::beta.
|
inherited |
Computes shift
from w_shift
and khi_shift
according to Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
Definition at line 730 of file star_rot.C.
References Lorene::Star::beta, Lorene::contract(), Lorene::Map::cosp, Lorene::Map::cost, Lorene::Tensor::dec_dzpuis(), Lorene::Tensor::derive_con(), Lorene::Scalar::derive_con(), Lorene::Scalar::domain(), Lorene::Map::flat_met_cart(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nzone(), Lorene::Star_rot::khi_shift, Lorene::Star::mp, Lorene::Tbl::set(), Lorene::Vector::set(), Lorene::Tensor::set(), Lorene::Scalar::set_domain(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::Star_rot::w_shift, Lorene::Map::x, Lorene::Map::y, and Lorene::Map::z.
|
inlineinherited |
Returns the square of the metric factor A.
Definition at line 333 of file star_rot.h.
References Lorene::Star_rot::a_car.
|
inlineinherited |
Returns the scalar .
For axisymmetric stars, this quantity is related to the derivatives of by
In particular it is related to the quantities and introduced by Eqs. (3.7) and (3.8) of Bonazzola et al. Astron. Astrophys. 278 , 421 (1993) by
Definition at line 417 of file star_rot.h.
References Lorene::Star_rot::ak_car.
|
inlineinherited |
Returns the square of the metric factor B.
Definition at line 336 of file star_rot.h.
References Lorene::Star_rot::b_car.
|
inlineinherited |
Returns the metric factor B.
Definition at line 330 of file star_rot.h.
References Lorene::Star_rot::bbb.
|
inlineinherited |
|
inlineinherited |
Returns the Metric potential .
Definition at line 360 of file star_rot.h.
References Lorene::Star_rot::dzeta.
|
inlineinherited |
Returns the proper total energy density.
Definition at line 370 of file star.h.
References Lorene::Star::ener.
|
inlineinherited |
Returns the total energy density with respect to the Eulerian observer.
Definition at line 376 of file star.h.
References Lorene::Star::ener_euler.
|
inlineinherited |
|
inlineinherited |
|
inlineinherited |
Returns the Lorentz factor between the fluid and Eulerian observers.
Definition at line 382 of file star.h.
References Lorene::Star::gam_euler.
|
inlineinherited |
|
inlineinherited |
Returns the scalar used in the decomposition of shift
following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of with respect to the Cartesian triad associated with the mapping mp
.
Definition at line 391 of file star_rot.h.
References Lorene::Star_rot::khi_shift.
|
inlineinherited |
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.
|
inlineinherited |
|
inlineinherited |
Returns the proper baryon density.
Definition at line 367 of file star.h.
References Lorene::Star::nbar.
|
inlineinherited |
|
inlineinherited |
Returns the metric coefficient .
Definition at line 339 of file star_rot.h.
References Lorene::Star_rot::nphi.
|
inlineinherited |
Returns the part of the Metric potential = logn
generated by the matter terms.
Definition at line 352 of file star_rot.h.
References Lorene::Star_rot::nuf.
|
inlineinherited |
Returns the Part of the Metric potential = logn
generated by the quadratic terms.
Definition at line 357 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 666 of file star_rot.C.
References Lorene::Star_rot::omega.
|
inlineinherited |
|
inlineinherited |
Returns the trace of the stress tensor in the Eulerian frame.
Definition at line 379 of file star.h.
References Lorene::Star::s_euler.
|
inlineinherited |
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.
|
inlineinherited |
Returns the Metric potential .
Definition at line 363 of file star_rot.h.
References Lorene::Star_rot::tggg.
|
inlineinherited |
Returns the tensor related to the extrinsic curvature tensor by .
tkij
contains the Cartesian components of .
Definition at line 398 of file star_rot.h.
References Lorene::Star_rot::tkij.
|
inlineinherited |
Returns the component of the shift vector.
Definition at line 344 of file star_rot.h.
References Lorene::Star_rot::tnphi.
|
inlineinherited |
Returns the fluid 3-velocity with respect to the Eulerian observer.
Definition at line 385 of file star.h.
References Lorene::Star::u_euler.
|
inlineinherited |
Returns the norm of u_euler
.
Definition at line 347 of file star_rot.h.
References Lorene::Star_rot::uuu.
|
inlineinherited |
Returns the vector used in the decomposition of shift
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of with respect to the Cartesian triad associated with the mapping mp
.
Definition at line 377 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 222 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.
|
virtualinherited |
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 253 of file star_rot_global.C.
References Lorene::Star_rot::ak_car, Lorene::Star_rot::bbb, Lorene::Scalar::derive_cov(), Lorene::Star_rot::dzeta, Lorene::Map::flat_met_spher(), Lorene::Scalar::get_etat(), Lorene::log(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Star_rot::p_grv3, Lorene::Star_rot::relativistic, Lorene::Scalar::srdsdt(), and Lorene::Scalar::std_spectral_base().
|
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 60 of file star_rot_hydro.C.
References Lorene::Tensor::annule_domain(), Lorene::Star::beta, Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Star::mp, Lorene::Star::nn, Lorene::Star_rot::omega, Lorene::Vector::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Tensor::set_triad(), Lorene::Vector::std_spectral_base(), Lorene::Star::u_euler, Lorene::Map::x, and Lorene::Map::y.
|
inlineinherited |
Returns true
for a relativistic star, false
for a Newtonian one.
Definition at line 322 of file star_rot.h.
References Lorene::Star_rot::relativistic.
|
virtualinherited |
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 86 of file star_rot_global.C.
References Lorene::Star::ent, Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), 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 which ensures that the GRV2 virial identity is satisfied.
is the coefficient by which one must multiply the quadratic source term of the 2-D Poisson equation
in order that the total source does not contain any monopolar term, i.e. in order that
where . is computed according to the formula
Then, by construction, the new source has a vanishing monopolar term.
sou_m | [input] matter source term |
sou_q | [input] quadratic source term |
Definition at line 69 of file star_rot_lambda_grv2.C.
References Lorene::Scalar::check_dzpuis(), Lorene::Map::get_mg(), Lorene::Tensor::get_mp(), Lorene::Mg3d::get_nzone(), Lorene::Mg3d::get_type_r(), and Lorene::Map::val_r().
|
virtualinherited |
Angular momentum of a particle on the ISCO.
Definition at line 275 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 116 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 142 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::Scalar::std_spectral_base(), Lorene::Star_rot::tnphi, and Lorene::Star_rot::uuu.
|
virtualinherited |
Mean star radius from the area .
Definition at line 479 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 of the MTW (1973) reduced quadrupole moment by: . Note that Q is the negative of the quadrupole moment defined by Laarakkers and Poisson, Astrophys. J. 512 , 282 (1999).
Definition at line 586 of file star_rot_global.C.
References Lorene::Star_rot::a_car, Lorene::Star_rot::ak_car, Lorene::Star_rot::bbb, Lorene::Scalar::check_dzpuis(), Lorene::Scalar::derive_cov(), Lorene::Star::ener_euler, Lorene::Map::flat_met_spher(), Lorene::Scalar::get_etat(), Lorene::Scalar::inc_dzpuis(), Lorene::log(), Lorene::Star::logn, Lorene::Star::mp, Lorene::Scalar::mult_r(), Lorene::Star::nbar, Lorene::Star_rot::p_mom_quad, Lorene::Star_rot::relativistic, Lorene::Star::s_euler, and Lorene::Scalar::std_spectral_base().
|
protectedvirtual |
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().
|
protectedvirtualinherited |
Printing of some informations, excluding all global quantities.
Definition at line 613 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::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), 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_rot::r_circ(), Lorene::Star_rot::r_circ_merid(), Lorene::Star::ray_eq(), Lorene::Star_rot::uuu, and Lorene::Scalar::val_grid_point().
|
virtualinherited |
Circumferential equatorial radius.
Definition at line 360 of file star_rot_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, and Lorene::Star_rot::p_r_circ.
|
virtualinherited |
Crcumferential meridional radius.
Definition at line 380 of file star_rot_global.C.
References Lorene::Valeur::annule_hard(), Lorene::Valeur::dsdt(), Lorene::Star_rot::get_a_car(), Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Scalar::get_spectral_va(), Lorene::Star_rot::l_surf(), Lorene::Star::mp, Lorene::Star_rot::p_r_circ_merid, Lorene::sqrt(), Lorene::Valeur::std_base_scal(), Lorene::Cmp::std_base_scal(), Lorene::Valeur::val_point_jk(), Lorene::Map_radial::val_r_jk(), and Lorene::Star::xi_surf().
|
virtualinherited |
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 74 of file star_rot_isco.C.
References Lorene::Param::add_int(), Lorene::Param::add_scalar(), Lorene::Tensor::annule_domain(), Lorene::Star_rot::bbb, Lorene::Scalar::dsdr(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), 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::Scalar::std_spectral_base(), Lorene::Valeur::val_point(), Lorene::Map::val_r(), and Lorene::zerosec().
|
inherited |
Coordinate radius at , [r_unit].
Definition at line 111 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::mp, and Lorene::Star::p_ray_eq.
|
inherited |
Coordinate radius at , [r_unit].
Definition at line 236 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::mp, and Lorene::Star::p_ray_eq_3pis2.
|
inherited |
Coordinate radius at , [r_unit].
Definition at line 189 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::mp, and Lorene::Star::p_ray_eq_pi.
|
inherited |
Coordinate radius at , [r_unit].
Definition at line 141 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::mp, and Lorene::Star::p_ray_eq_pis2.
|
inherited |
Coordinate radius at [r_unit].
Definition at line 281 of file star_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, and Lorene::Star::p_ray_pole.
|
virtualinherited |
Save in a file.
Reimplemented from Lorene::Star.
Definition at line 418 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::Star::sauve(), Lorene::Tensor::sauve(), Lorene::Scalar::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 337 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_circ_merid, Lorene::Star_rot::p_r_isco, Lorene::Star_rot::p_surf_grav, 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().
|
inherited |
Assignment of the enthalpy field.
Definition at line 382 of file star.C.
References Lorene::Star::del_deriv(), Lorene::Star::ent, and Lorene::Star::equation_of_state().
|
inlineinherited |
|
virtualinherited |
Surface gravity (table along the theta direction)
Definition at line 671 of file star_rot_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, and Lorene::Star_rot::p_surf_grav.
|
virtualinherited |
Ratio T/W.
Definition at line 194 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::Scalar::integrale(), 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 54 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::Scalar::div_rsint(), 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.
|
inherited |
Description of the stellar surface: returns a 2-D Tbl
containing the values of the radial coordinate on the surface at the collocation points in .
The stellar surface is defined as the location where the enthalpy (member ent
) vanishes.
Definition at line 92 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 534 of file star_rot_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, and Lorene::Star_rot::p_z_eqb.
|
virtualinherited |
Forward redshift factor at equator.
Definition at line 506 of file star_rot_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, and Lorene::Star_rot::p_z_eqf.
|
virtualinherited |
Redshift factor at North pole.
Definition at line 565 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 116 of file star_rot.h.
|
protectedinherited |
Scalar .
For axisymmetric stars, this quantity is related to the derivatives of by
In particular it is related to the quantities and introduced by Eqs.~(3.7) and (3.8) of Bonazzola et al. Astron. Astrophys. 278 , 421 (1993) by
Definition at line 198 of file star_rot.h.
|
protectedinherited |
Square of the metric factor B.
Definition at line 122 of file star_rot.h.
|
protectedinherited |
Metric factor B.
Definition at line 119 of file star_rot.h.
|
protectedinherited |
Metric potential .
Definition at line 146 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
Scalar used in the decomposition of shift
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
Definition at line 172 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
Metric coefficient .
Definition at line 125 of file star_rot.h.
|
protectedinherited |
Part of the Metric potential = logn
generated by the matter terms.
Definition at line 138 of file star_rot.h.
|
protectedinherited |
Part of the Metric potential = logn
generated by the quadratic terms.
Definition at line 143 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
Rotation angular velocity ([f_unit] )
Definition at line 113 of file star_rot.h.
|
mutableprotectedinherited |
Angular momentum.
Definition at line 244 of file star_rot.h.
|
mutableprotectedinherited |
Flatening r_pole/r_eq.
Definition at line 250 of file star_rot.h.
|
mutableprotectedinherited |
Integrated surface area.
Definition at line 251 of file star_rot.h.
|
mutableprotectedinherited |
Specific energy of a particle on the ISCO.
Definition at line 259 of file star_rot.h.
|
mutableprotectedinherited |
Orbital frequency at the equator.
Definition at line 262 of file star_rot.h.
|
mutableprotectedinherited |
Orbital frequency of the ISCO.
Definition at line 257 of file star_rot.h.
|
mutableprotectedinherited |
Error on the virial identity GRV2.
Definition at line 246 of file star_rot.h.
|
mutableprotectedinherited |
Error on the virial identity GRV3.
Definition at line 247 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Specific angular momentum of a particle on the ISCO.
Definition at line 261 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Quadrupole moment.
Definition at line 255 of file star_rot.h.
|
mutableprotectedinherited |
Circumferential radius (equator)
Definition at line 248 of file star_rot.h.
|
mutableprotectedinherited |
Circumferential radius (meridian)
Definition at line 249 of file star_rot.h.
|
mutableprotectedinherited |
Circumferential radius of the ISCO.
Definition at line 256 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Surface gravity (along the theta direction)
Definition at line 263 of file star_rot.h.
|
mutableprotectedinherited |
Ratio T/W.
Definition at line 245 of file star_rot.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
Backward redshift factor at equator.
Definition at line 253 of file star_rot.h.
|
mutableprotectedinherited |
Forward redshift factor at equator.
Definition at line 252 of file star_rot.h.
|
mutableprotectedinherited |
Redshift factor at North pole.
Definition at line 254 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
Indicator of relativity: true
for a relativistic star, false
for a Newtonian one.
Definition at line 106 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 215 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for the scalar by means of Map_et::poisson
.
is an intermediate quantity for the resolution of the elliptic equation for the shift vector
Definition at line 228 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 204 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 210 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the Poisson equation for tggg
.
Definition at line 220 of file star_rot.h.
|
protectedinherited |
Effective source at the previous step for the resolution of the vector Poisson equation for .
is an intermediate quantity for the resolution of the elliptic equation for the shift vector (Components with respect to the Cartesian triad associated with the mapping mp
)
Definition at line 237 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
Metric potential .
Definition at line 149 of file star_rot.h.
|
protectedinherited |
Tensor related to the extrinsic curvature tensor by .
tkij
contains the Cartesian components of .
Definition at line 179 of file star_rot.h.
|
protectedinherited |
Component of the shift vector.
Definition at line 130 of file star_rot.h.
|
protectedinherited |
|
protectedinherited |
: unsurc2=1
for a relativistic star, 0 for a Newtonian one.
Definition at line 111 of file star_rot.h.
|
protectedinherited |
Norm of u_euler
.
Definition at line 133 of file star_rot.h.
|
protectedinherited |
Vector used in the decomposition of shift
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of with respect to the Cartesian triad associated with the mapping mp
.
Definition at line 162 of file star_rot.h.