LORENE
|
Class for relativistic rotating stars in Conformal Flatness Condition and maximal slicing. More...
#include <star_rot_cfc.h>
Public Member Functions | |
Star_rot_CFC (Map &mp_i, int nzet_i, const Eos &eos_i, int relat_i=3, int filter=0) | |
Standard constructor. More... | |
Star_rot_CFC (const Star_rot_CFC &) | |
Copy constructor. More... | |
Star_rot_CFC (Map &mp_i, const Eos &eos_i, FILE *fich) | |
Constructor from a file (see sauve(FILE*) ). More... | |
virtual | ~Star_rot_CFC () |
Destructor. More... | |
void | operator= (const Star_rot_CFC &) |
Assignment to another Star_rot_CFC . More... | |
int | get_relat () const |
Returns the relativity parameter. More... | |
bool | is_relativistic () const |
Checks whether the star is computed using a relativistic theory. More... | |
int | spectral_filter_order () const |
Returns the filtering order. More... | |
double | get_omega () const |
Returns the rotation angular velocity . More... | |
const Scalar & | get_psi4 () const |
Returns the conformal factor . More... | |
const Scalar & | get_psi2 () const |
Returns . More... | |
const Scalar & | get_psi () const |
Returns . More... | |
const Vector & | get_j_euler () const |
Returns the momentum density 3-vector with respect to the Eulerian observer. More... | |
const Scalar & | get_v2 () const |
Returns . More... | |
const Sym_tensor | get_hatA () const |
Returns . More... | |
const Scalar | get_hatA_quad () const |
Returns . More... | |
virtual void | sauve (FILE *) const |
Save in a file. More... | |
virtual double | mass_b () const |
Baryonic mass. More... | |
virtual double | mass_g () const |
Gravitational mass. More... | |
virtual double | angu_mom () const |
Angular momentum. More... | |
virtual double | grv2 () const |
Error on the virial identity GRV2. More... | |
virtual double | grv3 () const |
Error on the virial identity GRV3. More... | |
virtual double | tsw () const |
Ratio T/W. More... | |
virtual double | aplat () const |
Flattening r_pole/r_eq. More... | |
virtual double | r_circ () const |
Circumferential equatorial radius. More... | |
virtual double | rp_circ () const |
Circumferential polar radius. More... | |
virtual double | ellipt () const |
Ellipticity e. 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 quantities from known potentials. More... | |
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) |
Computes an equilibrium configuration. More... | |
void | solve_logn_f (Scalar &ln_f_new) const |
Solution of the `‘matter’' part of the Poisson equation for the lapse for rotating stars in CFC. More... | |
void | solve_logn_q (Scalar &ln_q_new) const |
Solution of the quadratic part of the Poisson equation for the lapse for rotating stars in CFC. More... | |
void | solve_psi (Scalar &psi_new) |
Solution of the equations for the conformal factor for rotating stars in CFC. More... | |
void | solve_shift (Vector &shift_new) const |
Solution of the shift equation for rotating stars in CFC. More... | |
Map & | set_mp () |
Read/write of the mapping. More... | |
void | set_enthalpy (const Scalar &) |
Assignment of the enthalpy field. More... | |
void | equation_of_state () |
Computes the proper baryon and energy density, as well as pressure from the enthalpy. 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... | |
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... | |
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... | |
Protected Member Functions | |
virtual void | del_deriv () const |
Deletes all the derived quantities. More... | |
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 ostream & | operator>> (ostream &) const |
Operator >> (virtual function called by the operator <<). More... | |
Protected Attributes | |
int | relat_type |
Relativistic flag. More... | |
int | spectral_filter |
Spectral exponential filtering order. More... | |
double | omega |
Rotation angular velocity ( [f_unit] ) More... | |
Scalar | psi |
Conformal factor . More... | |
Vector | j_euler |
Momentum density 3-vector with respect to the Eulerian observer. More... | |
Scalar | v2 |
More... | |
Scalar | psi4 |
Conformal factor . More... | |
Scalar | psi2 |
More... | |
const Metric_flat & | flat |
flat metric (spherical components) More... | |
Sym_tensor | hatA |
More... | |
Scalar | hatA_quad |
More... | |
double * | p_angu_mom |
Angular momentum. More... | |
double * | p_grv2 |
Error on the virial identity GRV2. More... | |
double * | p_grv3 |
Error on the virial identity GRV3. More... | |
double * | p_tsw |
Ratio T/W. More... | |
double * | p_r_circ |
Circumferential equatorial radius. More... | |
double * | p_rp_circ |
Circumferential polar radius. 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... | |
Class for relativistic rotating stars in Conformal Flatness Condition and maximal slicing.
()
Definition at line 39 of file star_rot_cfc.h.
Lorene::Star_rot_CFC::Star_rot_CFC | ( | Map & | mp_i, |
int | nzet_i, | ||
const Eos & | eos_i, | ||
int | relat_i = 3 , |
||
int | filter = 0 |
||
) |
Standard constructor.
mp_i | Mapping on which the star will be defined |
nzet_i | Number of domains occupied by the star |
eos_i | Equation of state of the stellar matter |
relat_i | Reltivity parameter (see relat_type ) |
filter | order for spectral exponential filtering |
Definition at line 44 of file star_rot_cfc.C.
References hatA, hatA_quad, j_euler, omega, psi, psi2, psi4, relat_type, set_der_0x0(), Lorene::Tensor::set_etat_zero(), spectral_filter, Lorene::Scalar::std_spectral_base(), and v2.
Lorene::Star_rot_CFC::Star_rot_CFC | ( | const Star_rot_CFC & | star | ) |
Copy constructor.
Definition at line 83 of file star_rot_cfc.C.
References omega, and set_der_0x0().
Constructor from a file (see sauve(FILE*)
).
mp_i | Mapping on which the star will be defined |
eos_i | Equation of state of the stellar matter |
fich | input file (must have been created by the function sauve ) |
Definition at line 107 of file star_rot_cfc.C.
References Lorene::Star::beta, Lorene::contract(), Lorene::Star::equation_of_state(), flat, Lorene::fread_be(), Lorene::Map::get_bvect_spher(), hatA, hatA_quad, hydro_euler(), j_euler, omega, Lorene::Vector::ope_killing_conf(), Lorene::Vector::poisson(), psi2, psi4, relat_type, set_der_0x0(), spectral_filter, Lorene::Tensor::up_down(), and update_metric().
|
virtual |
|
virtual |
Angular momentum.
Definition at line 92 of file strot_cfc_global.C.
References Lorene::contract(), Lorene::Metric::cov(), Lorene::Star::gamma, Lorene::Map::get_bvect_spher(), Lorene::Scalar::integrale(), j_euler, Lorene::Star::mp, p_angu_mom, psi2, psi4, Lorene::Vector::set(), Lorene::Scalar::set_etat_zero(), and Lorene::Scalar::std_spectral_base().
|
virtual |
Flattening r_pole/r_eq.
Definition at line 369 of file strot_cfc_global.C.
References Lorene::Star::ray_eq(), and Lorene::Star::ray_pole().
|
protectedvirtual |
Deletes all the derived quantities.
Reimplemented from Lorene::Star.
Definition at line 164 of file star_rot_cfc.C.
References Lorene::Star::del_deriv(), p_angu_mom, p_grv2, p_grv3, p_r_circ, p_rp_circ, p_tsw, and set_der_0x0().
|
protectedvirtual |
Sets to ETATNONDEF
(undefined state) the hydrodynamical quantities relative to the Eulerian observer.
Reimplemented from Lorene::Star.
Definition at line 192 of file star_rot_cfc.C.
References del_deriv(), Lorene::Star::del_hydro_euler(), j_euler, Lorene::Scalar::set_etat_nondef(), Lorene::Tensor::set_etat_nondef(), and v2.
|
virtual |
Ellipticity e.
Defined as , where and are, respectively, the equatorial and polar circumferential radius, given by r_circ()
and rp_circ()
.
Definition at line 379 of file strot_cfc_global.C.
References r_circ(), rp_circ(), and Lorene::sqrt().
|
inherited |
Computes the proper baryon and energy density, as well as pressure from the enthalpy.
Definition at line 465 of file star.C.
References Lorene::Param::add_int(), Lorene::Scalar::allocate_all(), Lorene::Star::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(), Lorene::Mtbl::set(), Lorene::Scalar::set_domain(), Lorene::Mtbl::set_etat_qcq(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::set_etat_qcq(), Lorene::Scalar::std_spectral_base(), Lorene::Mtbl::t, and Lorene::Grille3d::x.
void Lorene::Star_rot_CFC::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 | ||
) |
Computes an equilibrium configuration.
Definition at line 36 of file strot_cfc_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().
|
inlineinherited |
|
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 |
|
inline |
|
inline |
|
inline |
Returns the momentum density 3-vector with respect to the Eulerian observer.
Definition at line 202 of file star_rot_cfc.h.
References j_euler.
|
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 number of domains occupied by the star.
Definition at line 358 of file star.h.
References Lorene::Star::nzet.
|
inline |
Returns the rotation angular velocity .
Definition at line 177 of file star_rot_cfc.h.
References omega.
|
inlineinherited |
|
inline |
|
inline |
|
inline |
|
inline |
Returns the relativity parameter.
Definition at line 166 of file star_rot_cfc.h.
References relat_type.
|
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 fluid 3-velocity with respect to the Eulerian observer.
Definition at line 385 of file star.h.
References Lorene::Star::u_euler.
|
inline |
|
virtual |
Error on the virial identity GRV2.
Definition at line 153 of file strot_cfc_global.C.
References Lorene::Metric::con(), Lorene::Metric::cov(), Lorene::Scalar::div_r_dzpuis(), Lorene::Scalar::dsdr(), Lorene::Scalar::dsdt(), Lorene::Star::ener_euler, Lorene::Star::gamma, hatA, Lorene::Star::logn, p_grv2, Lorene::Star::press, psi4, Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), and v2.
|
virtual |
Error on the virial identity GRV3.
Definition at line 223 of file strot_cfc_global.C.
References Lorene::Metric::con(), Lorene::Metric::connect(), Lorene::contract(), Lorene::Scalar::derive_con(), Lorene::Scalar::derive_cov(), Lorene::Star::gamma, Lorene::Connection::get_delta(), hatA_quad, Lorene::Scalar::integrale(), Lorene::Star::logn, p_grv3, psi2, psi4, Lorene::Star::s_euler, and Lorene::Scalar::std_spectral_base().
|
virtual |
Computes the hydrodynamical quantities relative to the Eulerian observer from those in the fluid frame.
More later......
Reimplemented from Lorene::Star.
Definition at line 33 of file strot_cfc_hydro.C.
References Lorene::Star::beta, Lorene::Metric::con(), Lorene::contract(), Lorene::Metric::cov(), del_deriv(), Lorene::Star::ener, Lorene::Star::ener_euler, Lorene::Vector::exponential_filter_r(), Lorene::Sym_tensor::exponential_filter_r(), Lorene::Scalar::exponential_filter_r(), Lorene::Star::gam_euler, Lorene::Star::gamma, j_euler, Lorene::Scalar::mult_rsint(), Lorene::Star::nn, Lorene::Star::nzet, omega, Lorene::Star::press, Lorene::Star::s_euler, Lorene::Vector::set(), Lorene::Scalar::set_etat_zero(), spectral_filter, Lorene::sqrt(), Lorene::Vector::std_spectral_base(), Lorene::Tensor::std_spectral_base(), Lorene::Scalar::std_spectral_base(), Lorene::Star::stress_euler, Lorene::Star::u_euler, and v2.
|
inline |
Checks whether the star is computed using a relativistic theory.
Definition at line 169 of file star_rot_cfc.h.
References relat_type.
|
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 in Lorene::Star_rot.
Definition at line 66 of file star_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.
|
virtual |
Baryonic mass.
Implements Lorene::Star.
Definition at line 44 of file strot_cfc_global.C.
References Lorene::Star::gam_euler, Lorene::Scalar::integrale(), Lorene::Star::nbar, Lorene::Star::p_mass_b, psi2, psi4, and Lorene::Scalar::std_spectral_base().
|
virtual |
Gravitational mass.
Implements Lorene::Star.
Definition at line 67 of file strot_cfc_global.C.
References Lorene::Star::beta, Lorene::contract(), Lorene::Metric::cov(), Lorene::Star::ener_euler, Lorene::Star::gamma, Lorene::Scalar::integrale(), j_euler, Lorene::Star::nn, Lorene::Star::p_mass_g, psi2, psi4, Lorene::Star::s_euler, and Lorene::Scalar::std_spectral_base().
void Lorene::Star_rot_CFC::operator= | ( | const Star_rot_CFC & | star | ) |
Assignment to another Star_rot_CFC
.
Definition at line 212 of file star_rot_cfc.C.
References del_deriv(), flat, hatA, hatA_quad, j_euler, omega, Lorene::Star::operator=(), psi, psi2, psi4, relat_type, spectral_filter, and v2.
|
protectedvirtual |
Operator >> (virtual function called by the operator <<).
Reimplemented from Lorene::Star.
Definition at line 260 of file star_rot_cfc.C.
References angu_mom(), aplat(), ellipt(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), grv2(), grv3(), mass_g(), Lorene::Star::mp, omega, Lorene::Star::operator>>(), Lorene::pow(), r_circ(), Lorene::Star::ray_eq(), relat_type, rp_circ(), spectral_filter, and tsw().
|
virtual |
Circumferential equatorial radius.
Definition at line 282 of file strot_cfc_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_type_t(), Lorene::Star::mp, Lorene::Star::nzet, and p_r_circ.
|
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.
|
virtual |
Circumferential polar radius.
Definition at line 308 of file strot_cfc_global.C.
References Lorene::Scalar::annule(), Lorene::Scalar::annule_hard(), Lorene::Valeur::c_cf, Lorene::Valeur::coef(), Lorene::Metric::cov(), Lorene::Scalar::dsdt(), Lorene::Star::gamma, 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::Star::l_surf(), Lorene::Star::mp, Lorene::Star::nzet, p_rp_circ, Lorene::Scalar::set_grid_point(), Lorene::Scalar::set_spectral_va(), Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), Lorene::Map::tet, Lorene::Valeur::val_point_jk(), Lorene::Map::val_r(), and Lorene::Star::xi_surf().
|
virtual |
Save in a file.
Reimplemented from Lorene::Star.
Definition at line 243 of file star_rot_cfc.C.
References Lorene::Star::beta, Lorene::fwrite_be(), omega, psi, relat_type, Lorene::Star::sauve(), Lorene::Tensor::sauve(), Lorene::Scalar::sauve(), and spectral_filter.
|
protectedvirtual |
Sets to 0x0
all the pointers on derived quantities.
Reimplemented from Lorene::Star.
Definition at line 180 of file star_rot_cfc.C.
References p_angu_mom, p_grv2, p_grv3, p_r_circ, p_rp_circ, and p_tsw.
|
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 |
void Lorene::Star_rot_CFC::solve_logn_f | ( | Scalar & | ln_f_new | ) | const |
Solution of the `‘matter’' part of the Poisson equation for the lapse for rotating stars in CFC.
Definition at line 39 of file strot_cfc_metric.C.
References Lorene::Star::ener_euler, Lorene::Scalar::poisson(), psi4, and Lorene::Star::s_euler.
void Lorene::Star_rot_CFC::solve_logn_q | ( | Scalar & | ln_q_new | ) | const |
Solution of the quadratic part of the Poisson equation for the lapse for rotating stars in CFC.
Definition at line 53 of file strot_cfc_metric.C.
References Lorene::contract(), Lorene::Scalar::derive_con(), Lorene::Scalar::derive_cov(), flat, hatA_quad, Lorene::log(), Lorene::Star::logn, Lorene::Scalar::poisson(), psi, psi4, Lorene::Scalar::std_spectral_base(), and Lorene::Tensor::up_down().
void Lorene::Star_rot_CFC::solve_psi | ( | Scalar & | psi_new | ) |
Solution of the equations for the conformal factor for rotating stars in CFC.
Definition at line 72 of file strot_cfc_metric.C.
References Lorene::contract(), Lorene::Star::ener_euler, flat, Lorene::Scalar::get_etat(), hatA, hatA_quad, j_euler, Lorene::Vector::ope_killing_conf(), Lorene::Vector::poisson(), Lorene::Scalar::poisson(), psi, psi2, psi4, Lorene::Scalar::std_spectral_base(), and Lorene::Tensor::up_down().
void Lorene::Star_rot_CFC::solve_shift | ( | Vector & | shift_new | ) | const |
Solution of the shift equation for rotating stars in CFC.
Definition at line 106 of file strot_cfc_metric.C.
References Lorene::Sym_tensor::divergence(), flat, hatA, Lorene::Tensor::inc_dzpuis(), Lorene::Star::nn, Lorene::Vector::poisson(), psi2, psi4, and Lorene::Vector::set().
|
inline |
Returns the filtering order.
Definition at line 172 of file star_rot_cfc.h.
References spectral_filter.
|
virtual |
Ratio T/W.
Definition at line 126 of file strot_cfc_global.C.
References angu_mom(), Lorene::Star::ener, Lorene::Star::gam_euler, Lorene::Scalar::integrale(), mass_g(), omega, p_tsw, psi2, psi4, and Lorene::Scalar::std_spectral_base().
void Lorene::Star_rot_CFC::update_metric | ( | ) |
Computes metric quantities from known potentials.
The calculation is performed starting from psi
, logn
, hatA
, which are supposed to be up to date. From these, the following fields are updated: nnn
, psi4
, psi2
,shift
, and hatA_quad
.
Definition at line 125 of file strot_cfc_metric.C.
References Lorene::Metric_flat::cov(), del_deriv(), Lorene::exp(), flat, Lorene::Star::gamma, Lorene::Star::logn, Lorene::Star::nn, psi, psi2, psi4, and Lorene::Scalar::std_spectral_base().
|
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.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protected |
flat metric (spherical components)
Definition at line 85 of file star_rot_cfc.h.
|
protectedinherited |
|
protected |
Definition at line 87 of file star_rot_cfc.h.
|
protected |
Definition at line 88 of file star_rot_cfc.h.
|
protected |
Momentum density 3-vector with respect to the Eulerian observer.
Definition at line 75 of file star_rot_cfc.h.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protected |
Rotation angular velocity ([f_unit] )
Definition at line 60 of file star_rot_cfc.h.
|
mutableprotected |
Angular momentum.
Definition at line 97 of file star_rot_cfc.h.
|
mutableprotected |
Error on the virial identity GRV2.
Definition at line 98 of file star_rot_cfc.h.
|
mutableprotected |
Error on the virial identity GRV3.
Definition at line 99 of file star_rot_cfc.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotected |
Circumferential equatorial radius.
Definition at line 101 of file star_rot_cfc.h.
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotected |
Circumferential polar radius.
Definition at line 102 of file star_rot_cfc.h.
|
mutableprotected |
Ratio T/W.
Definition at line 100 of file star_rot_cfc.h.
|
mutableprotectedinherited |
|
protectedinherited |
|
protected |
Conformal factor .
Definition at line 65 of file star_rot_cfc.h.
|
protected |
Definition at line 82 of file star_rot_cfc.h.
|
protected |
Conformal factor .
Definition at line 81 of file star_rot_cfc.h.
|
protected |
Relativistic flag.
0
: Newtonian theory (not implemented) 3
: CFC with (see Cordero-Carrion et al. 2009).
Definition at line 50 of file star_rot_cfc.h.
|
protectedinherited |
|
protected |
Spectral exponential filtering order.
If 0, no filtering is done (see also Scalar::exponential_filter_r
). Filtering is performed only in shells containing matter, i.e. for domain numbers l such that nzet
.
Definition at line 58 of file star_rot_cfc.h.
|
protectedinherited |
|
protectedinherited |
|
protected |
Definition at line 76 of file star_rot_cfc.h.