LORENE
|
Class for stars in binary system. More...
#include <etoile.h>
Public Member Functions | |
Etoile_bin (Map &mp_i, int nzet_i, bool relat, const Eos &eos_i, bool irrot, const Base_vect &ref_triad_i) | |
Standard constructor. | |
Etoile_bin (const Etoile_bin &) | |
Copy constructor. | |
Etoile_bin (Map &mp_i, const Eos &eos_i, const Base_vect &ref_triad_i, FILE *fich) | |
Constructor from a file (see sauve(FILE*) ). | |
virtual | ~Etoile_bin () |
Destructor. | |
void | operator= (const Etoile_bin &) |
Assignment to another Etoile_bin . | |
Tenseur & | set_logn_comp () |
Read/write the part of the lapse logarithm (gravitational potential at the Newtonian limit) generated principaly by the companion star. | |
Tenseur & | set_pot_centri () |
Read/write the centrifugal potential. | |
Tenseur & | set_w_shift () |
Read/write of w_shift . | |
Tenseur & | set_khi_shift () |
Read/write of khi_shift . | |
bool | is_irrotational () const |
Returns true for an irrotational motion, false for a corotating one. | |
const Tenseur & | get_psi0 () const |
Returns the non-translational part of the velocity potential. | |
const Tenseur & | get_d_psi () const |
Returns the gradient of the velocity potential (Cartesian components with respect to ref_triad ) | |
const Tenseur & | get_wit_w () const |
Returns the spatial projection of the fluid 3-velocity with respect to the co-orbiting observer. | |
const Tenseur & | get_loggam () const |
Returns the logarithm of the Lorentz factor between the fluid and the co-orbiting observer. | |
const Tenseur & | get_logn_comp () const |
Returns the part of the lapse logarithm (gravitational potential at the Newtonian limit) generated principaly by the companion star. | |
const Tenseur & | get_d_logn_auto () const |
Returns the gradient of logn_auto (Cartesian components with respect to ref_triad ) | |
const Tenseur & | get_d_logn_auto_regu () const |
Returns the gradient of logn_auto_regu (Cartesian components with respect to ref_triad ) | |
const Tenseur & | get_d_logn_comp () const |
Returns the gradient of logn_comp (Cartesian components with respect to ref_triad ) | |
const Tenseur & | get_beta_comp () const |
Returns the part of the logarithm of AN generated principaly by the companion star. | |
const Tenseur & | get_d_beta_auto () const |
Returns the gradient of beta_auto (Cartesian components with respect to ref_triad ) | |
const Tenseur & | get_d_beta_comp () const |
Returns the gradient of beta_comp (Cartesian components with respect to ref_triad ) | |
const Tenseur & | get_shift_auto () const |
Returns the part of the shift vector ![]() | |
const Tenseur & | get_shift_comp () const |
Returns the part of the shift vector ![]() | |
const Tenseur & | get_w_shift () const |
Returns the vector ![]() shift_auto , following Shibata's prescription [Prog. | |
const Tenseur & | get_khi_shift () const |
Returns the scalar ![]() shift_auto following Shibata's prescription [Prog. | |
const Tenseur_sym & | get_tkij_auto () const |
Returns the part of the extrinsic curvature tensor ![]() shift_auto . | |
const Tenseur_sym & | get_tkij_comp () const |
Returns the part of the extrinsic curvature tensor ![]() shift_comp . | |
const Tenseur & | get_akcar_auto () const |
Returns the part of the scalar ![]() shift_auto , i.e. | |
const Tenseur & | get_akcar_comp () const |
Returns the part of the scalar ![]() shift_auto and shift_comp , i.e. | |
const Tenseur & | get_bsn () const |
Returns the shift vector, divided by N , of the rotating coordinates, ![]() | |
const Tenseur & | get_pot_centri () const |
Returns the centrifugal potential. | |
const Cmp | get_decouple () const |
Returns the function used to construct tkij_auto from tkij_tot . | |
virtual void | sauve (FILE *) const |
Save in a file. | |
virtual double | mass_b () const |
Baryon mass. | |
virtual double | mass_g () const |
Gravitational mass. | |
virtual double | xa_barycenter () const |
Absolute coordinate X of the barycenter of the baryon density, defined according to the formula. | |
virtual Tenseur | sprod (const Tenseur &t1, const Tenseur &t2) const |
Performs the scalar product of two tensors by contracting the last index of t1 with the first index of t2 . | |
virtual void | hydro_euler () |
Computes the hydrodynamical quantities relative to the Eulerian observer from those in the fluid frame, as well as wit_w and loggam . | |
void | update_metric (const Etoile_bin &comp) |
Computes metric coefficients from known potentials, when the companion is another star. | |
void | update_metric (const Etoile_bin &comp, const Etoile_bin &star_prev, double relax) |
Same as update_metric (const Etoile_bin& ) but with relaxation. | |
void | update_metric_der_comp (const Etoile_bin &comp) |
Computes the derivative of metric functions related to the companion star. | |
virtual void | kinematics (double omega, double x_axe) |
Computes the quantities bsn and pot_centri . | |
void | fait_d_psi () |
Computes the gradient of the total velocity potential ![]() | |
void | fait_shift_auto () |
Computes shift_auto from w_shift and khi_shift according to Shibata's prescription [Prog. | |
virtual void | extrinsic_curvature () |
Computes tkij_auto and akcar_auto from shift_auto , nnn and a_car . | |
void | equilibrium (double ent_c, int mermax, int mermax_poisson, double relax_poisson, int mermax_potvit, double relax_potvit, double thres_adapt, const Tbl &fact, Tbl &diff, const Tbl *ent_limit=0x0) |
Computes an equilibrium configuration. | |
void | equil_regular (double ent_c, int mermax, int mermax_poisson, double relax_poisson, int mermax_potvit, double relax_potvit, double thres_adapt, const Tbl &fact, Tbl &diff) |
Computes an equilibrium configuration by regularizing the diverging source. | |
double | velocity_potential (int mermax, double precis, double relax) |
Computes the non-translational part of the velocity scalar potential ![]() | |
void | relaxation (const Etoile_bin &star_prev, double relax_ent, double relax_met, int mer, int fmer_met) |
Performs a relaxation on ent , logn_auto , beta_auto and shift_auto . | |
Map & | set_mp () |
Read/write of the mapping. | |
void | set_enthalpy (const Cmp &) |
Assignment of the enthalpy field. | |
virtual void | equation_of_state () |
Computes the proper baryon and energy density, as well as pressure from the enthalpy. | |
virtual void | equilibrium_spher (double ent_c, double precis=1.e-14, const Tbl *ent_limit=0x0) |
Computes a spherical static configuration. | |
void | equil_spher_regular (double ent_c, double precis=1.e-14) |
Computes a spherical static configuration. | |
virtual void | equil_spher_falloff (double ent_c, double precis=1.e-14) |
Computes a spherical static configuration with the outer boundary condition at a finite radius. | |
const Map & | get_mp () const |
Returns the mapping. | |
int | get_nzet () const |
Returns the number of domains occupied by the star. | |
bool | is_relativistic () const |
Returns true for a relativistic star, false for a Newtonian one. | |
const Eos & | get_eos () const |
Returns the equation of state. | |
const Tenseur & | get_ent () const |
Returns the enthalpy field. | |
const Tenseur & | get_nbar () const |
Returns the proper baryon density. | |
const Tenseur & | get_ener () const |
Returns the proper total energy density. | |
const Tenseur & | get_press () const |
Returns the fluid pressure. | |
const Tenseur & | get_ener_euler () const |
Returns the total energy density with respect to the Eulerian observer. | |
const Tenseur & | get_s_euler () const |
Returns the trace of the stress tensor in the Eulerian frame. | |
const Tenseur & | get_gam_euler () const |
Returns the Lorentz factor between the fluid and Eulerian observers. | |
const Tenseur & | get_u_euler () const |
Returns the fluid 3-velocity with respect to the Eulerian observer. | |
const Tenseur & | get_logn_auto () const |
Returns the logarithm of the part of the lapse N generated principaly by the star. | |
const Tenseur & | get_logn_auto_regu () const |
Returns the regular part of the logarithm of the part of the lapse N generated principaly by the star. | |
const Tenseur & | get_logn_auto_div () const |
Returns the divergent part of the logarithm of the part of the lapse N generated principaly by the star. | |
const Tenseur & | get_d_logn_auto_div () const |
Returns the gradient of logn_auto_div . | |
const Tenseur & | get_beta_auto () const |
Returns the logarithm of the part of the product AN generated principaly by the star. | |
const Tenseur & | get_nnn () const |
Returns the total lapse function N. | |
const Tenseur & | get_shift () const |
Returns the total shift vector ![]() | |
const Tenseur & | get_a_car () const |
Returns the total conformal factor ![]() | |
double | ray_eq () const |
Coordinate radius at ![]() ![]() | |
double | ray_eq (int kk) 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 ![]() | |
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 ![]() | |
const Tbl & | xi_surf () const |
Description of the stellar surface: returns a 2-D Tbl containing the values of the radial coordinate ![]() ![]() | |
Protected Member Functions | |
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 ostream & | operator>> (ostream &) const |
Operator >> (virtual function called by the operator <<). | |
Protected Attributes | |
bool | irrotational |
true for an irrotational star, false for a corotating one | |
const Base_vect & | ref_triad |
Reference triad ("absolute frame"), with respect to which the components of all the member Tenseur 's are defined, except for w_shift and ssjm1_wshift . | |
Tenseur | psi0 |
Scalar potential ![]() | |
Tenseur | d_psi |
Gradient of ![]() ref_triad ) | |
Tenseur | wit_w |
Spatial projection of the fluid 3-velocity with respect to the co-orbiting observer. | |
Tenseur | loggam |
Logarithm of the Lorentz factor between the fluid and the co-orbiting observer. | |
Tenseur | logn_comp |
Part of the lapse logarithm (gravitational potential at the Newtonian limit) generated principaly by the companion star. | |
Tenseur | d_logn_auto |
Gradient of logn_auto (Cartesian components with respect to ref_triad ) | |
Tenseur | d_logn_auto_regu |
Gradient of logn_auto_regu (Cartesian components with respect to ref_triad ) | |
Tenseur | d_logn_comp |
Gradient of logn_comp (Cartesian components with respect to ref_triad ) | |
Tenseur | beta_comp |
Part of the logarithm of AN generated principaly by the companion star. | |
Tenseur | d_beta_auto |
Gradient of beta_auto (Cartesian components with respect to ref_triad ) | |
Tenseur | d_beta_comp |
Gradient of beta_comp (Cartesian components with respect to ref_triad ) | |
Tenseur | shift_auto |
Part of the shift vector ![]() | |
Tenseur | shift_comp |
Part of the shift vector ![]() | |
Tenseur | w_shift |
Vector ![]() shift_auto , following Shibata's prescription [Prog. | |
Tenseur | khi_shift |
Scalar ![]() shift_auto , following Shibata's prescription [Prog. | |
Tenseur_sym | tkij_auto |
Part of the extrinsic curvature tensor ![]() shift_auto . | |
Tenseur_sym | tkij_comp |
Part of the extrinsic curvature tensor ![]() shift_comp . | |
Tenseur | akcar_auto |
Part of the scalar ![]() shift_auto , i.e. | |
Tenseur | akcar_comp |
Part of the scalar ![]() shift_auto and shift_comp , i.e. | |
Tenseur | bsn |
3-vector shift, divided by N , of the rotating coordinates, ![]() | |
Tenseur | pot_centri |
Centrifugal potential. | |
Cmp | ssjm1_logn |
Effective source at the previous step for the resolution of the Poisson equation for logn_auto by means of Map_et::poisson . | |
Cmp | ssjm1_beta |
Effective source at the previous step for the resolution of the Poisson equation for beta_auto by means of Map_et::poisson . | |
Cmp | ssjm1_khi |
Effective source at the previous step for the resolution of the Poisson equation for the scalar ![]() Map_et::poisson . | |
Tenseur | ssjm1_wshift |
Effective source at the previous step for the resolution of the vector Poisson equation for ![]() Map_et::poisson . | |
Cmp | ssjm1_psi |
Effective source at the previous step for the resolution of the Poisson equation for the scalar ![]() Map_et::poisson_interne . | |
Cmp | decouple |
Function used to construct the part of ![]() ![]() | |
double * | p_xa_barycenter |
Absolute coordinate X of the barycenter of the baryon density. | |
Map & | mp |
Mapping associated with the star. | |
int | nzet |
Number of domains of *mp occupied by the star. | |
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. | |
int | k_div |
Index of regularity of the gravitational potential logn_auto . | |
const Eos & | eos |
Equation of state of the stellar matter. | |
Tenseur | ent |
Log-enthalpy (relativistic case) or specific enthalpy (Newtonian case) | |
Tenseur | nbar |
Baryon density in the fluid frame. | |
Tenseur | ener |
Total energy density in the fluid frame. | |
Tenseur | press |
Fluid pressure. | |
Tenseur | ener_euler |
Total energy density in the Eulerian frame. | |
Tenseur | s_euler |
Trace of the stress tensor in the Eulerian frame. | |
Tenseur | gam_euler |
Lorentz factor between the fluid and Eulerian observers. | |
Tenseur | u_euler |
Fluid 3-velocity with respect to the Eulerian observer. | |
Tenseur | logn_auto |
Total of the logarithm of the part of the lapse N generated principaly by the star. | |
Tenseur | logn_auto_regu |
Regular part of the logarithm of the part of the lapse N generated principaly by the star. | |
Tenseur | logn_auto_div |
Divergent part (if k_div!=0 ) of the logarithm of the part of the lapse N generated principaly by the star. | |
Tenseur | d_logn_auto_div |
Gradient of logn_auto_div (if k_div!=0 ) | |
Tenseur | beta_auto |
Logarithm of the part of the product AN generated principaly by by the star. | |
Tenseur | nnn |
Total lapse function. | |
Tenseur | shift |
Total shift vector. | |
Tenseur | a_car |
Total conformal factor ![]() | |
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. | |
Friends | |
class | Bin_ns_bh |
Friend class Bin_ns_bh. | |
Class for stars in binary system.
()
This class implements the formalism for corotating or irrotational systems presented in Bonazzola, Gourgoulhon & Marck Phys. Rev. Lett. 82 , 892 (1999). In particular, the conformal 3-metric
An Etoile_bin
can be construted in two states, represented by the bool
member irrotational
: (i) irrotational (i.e. the fluid motion is irrotational) or (ii) rigidly corotating with respect to the orbital motion (synchronized binary).
Lorene::Etoile_bin::Etoile_bin | ( | Map & | mp_i, |
int | nzet_i, | ||
bool | relat, | ||
const Eos & | eos_i, | ||
bool | irrot, | ||
const Base_vect & | ref_triad_i | ||
) |
Standard constructor.
mp_i | Mapping on which the star will be defined |
nzet_i | Number of domains occupied by the star |
relat | should be true for a relativistic star, false for a Newtonian one |
eos_i | Equation of state of the stellar matter |
irrot | should be true for an irrotational star, false for a corotating one |
ref_triad_i | Reference triad ("absolute frame"), with respect to which the components of all the member Tenseur 's are defined, except for w_shift and ssjm1_wshift whose components are defined with respect to the mapping mp Cartesian triad. |
Definition at line 207 of file etoile_bin.C.
References akcar_auto, akcar_comp, beta_comp, bsn, d_beta_auto, d_beta_comp, d_logn_auto, d_logn_auto_regu, d_logn_comp, d_psi, khi_shift, loggam, logn_comp, pot_centri, psi0, ref_triad, Lorene::Tenseur::set(), set_der_0x0(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_etat_zero(), Lorene::Tenseur::set_triad(), Lorene::Etoile::shift, shift_auto, shift_comp, ssjm1_beta, ssjm1_khi, ssjm1_logn, ssjm1_psi, ssjm1_wshift, tkij_auto, tkij_comp, Lorene::Etoile::u_euler, w_shift, and wit_w.
Lorene::Etoile_bin::Etoile_bin | ( | const Etoile_bin & | et | ) |
Lorene::Etoile_bin::Etoile_bin | ( | Map & | mp_i, |
const Eos & | eos_i, | ||
const Base_vect & | ref_triad_i, | ||
FILE * | fich | ||
) |
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 |
ref_triad_i | Reference triad ("absolute frame"), with respect to which the components of all the member Tenseur 's are defined, except for w_shift and ssjm1_wshift whose components are defined with respect to the mapping mp Cartesian triad. |
fich | input file (must have been created by the function sauve ) |
Definition at line 329 of file etoile_bin.C.
References akcar_auto, akcar_comp, beta_comp, bsn, d_beta_auto, d_beta_comp, d_logn_auto, d_logn_auto_regu, d_logn_comp, d_psi, fait_shift_auto(), Lorene::Etoile::gam_euler, Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), irrotational, khi_shift, loggam, logn_comp, Lorene::Etoile::mp, pot_centri, psi0, ref_triad, set_der_0x0(), Lorene::Tenseur::set_etat_zero(), Lorene::Tenseur::set_triad(), Lorene::Etoile::shift, shift_comp, ssjm1_beta, ssjm1_khi, ssjm1_logn, ssjm1_psi, ssjm1_wshift, tkij_auto, tkij_comp, Lorene::Etoile::u_euler, w_shift, and wit_w.
|
virtual |
|
protectedvirtual |
Deletes all the derived quantities.
Reimplemented from Lorene::Etoile.
Definition at line 447 of file etoile_bin.C.
References Lorene::Etoile::del_deriv(), p_xa_barycenter, and set_der_0x0().
|
protectedvirtual |
Sets to ETATNONDEF
(undefined state) the hydrodynamical quantities relative to the Eulerian observer.
Reimplemented from Lorene::Etoile.
Definition at line 467 of file etoile_bin.C.
References del_deriv(), and Lorene::Etoile::del_hydro_euler().
|
virtualinherited |
Computes the proper baryon and energy density, as well as pressure from the enthalpy.
Reimplemented in Lorene::Et_rot_bifluid, and Lorene::Et_magnetisation.
Definition at line 566 of file etoile.C.
References Lorene::Param::add_int(), Lorene::Cmp::allocate_all(), Lorene::Etoile::del_deriv(), Lorene::Etoile::ener, Lorene::Eos::ener_ent(), Lorene::Etoile::ent, Lorene::Etoile::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::Etoile::mp, Lorene::Etoile::nbar, Lorene::Eos::nbar_ent(), Lorene::Etoile::nzet, Lorene::Etoile::press, Lorene::Eos::press_ent(), Lorene::Tenseur::set(), Lorene::Cmp::set(), Lorene::Mtbl::set(), Lorene::Mtbl::set_etat_qcq(), Lorene::Tbl::set_etat_qcq(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), Lorene::Cmp::std_base_scal(), Lorene::Mtbl::t, and Lorene::Grille3d::x.
void Lorene::Etoile_bin::equil_regular | ( | double | ent_c, |
int | mermax, | ||
int | mermax_poisson, | ||
double | relax_poisson, | ||
int | mermax_potvit, | ||
double | relax_potvit, | ||
double | thres_adapt, | ||
const Tbl & | fact, | ||
Tbl & | diff | ||
) |
Computes an equilibrium configuration by regularizing the diverging source.
The values of logn_comp
, beta_comp
, pot_centri
are held fixed during the iteration.
ent_c | [input] Central enthalpy |
ent_limit | is the table of enthalpy values on the domain borders |
mermax | [input] Maximum number of steps |
mermax_poisson | [input] Maximum number of steps in Map_et::poisson |
relax_poisson | [input] Relaxation factor in Map_et::poisson |
mermax_potvit | [input] Maximum number of steps in Map_radial::poisson_compact |
relax_potvit | [input] Relaxation factor in Map_radial::poisson_compact |
thres_adapt | [input] Threshold on dH/dr for the adaptation of the mapping |
fact | [input] 1-D Tbl for the input of some factors :
|
diff | [output] 1-D Tbl for the storage of some error indicators :
|
Definition at line 144 of file et_bin_equil_regu.C.
References Lorene::Etoile::a_car, Lorene::abs(), Lorene::Map::adapt(), Lorene::Param::add_cmp_mod(), Lorene::Param::add_double(), Lorene::Param::add_int(), Lorene::Param::add_int_mod(), Lorene::Param::add_tbl(), Lorene::Param::add_tenseur_mod(), akcar_auto, akcar_comp, Lorene::Etoile::beta_auto, Lorene::Tenseur::change_triad(), Lorene::contract(), d_beta_auto, d_beta_comp, d_logn_auto, Lorene::Etoile::d_logn_auto_div, d_logn_comp, Lorene::Tenseur::dec2_dzpuis(), Lorene::Eos::der_ener_ent_p(), Lorene::Eos::der_nbar_ent_p(), Lorene::diffrel(), Lorene::Etoile::ener_euler, Lorene::Etoile::ent, Lorene::Etoile::eos, Lorene::Etoile::equation_of_state(), Lorene::Cmp::filtre(), Lorene::flat_scalar_prod_desal(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Tenseur::gradient(), Lorene::Map_et::homothetie(), hydro_euler(), Lorene::Tenseur::inc2_dzpuis(), irrotational, Lorene::Etoile::k_div, khi_shift, loggam, Lorene::Etoile::logn_auto, Lorene::Etoile::logn_auto_div, Lorene::Etoile::logn_auto_regu, logn_comp, Lorene::max(), Lorene::Etoile::mp, Lorene::Etoile::nbar, Lorene::Etoile::nnn, Lorene::Etoile::nzet, Lorene::Tenseur::poisson_vect_regu(), pot_centri, Lorene::Etoile::press, Lorene::Etoile::ray_eq(), Lorene::Etoile::ray_pole(), Lorene::Map::reevaluate_symy(), ref_triad, Lorene::Etoile::relativistic, Lorene::Map::resize(), Lorene::Etoile::s_euler, Lorene::Tenseur::set(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), shift_auto, Lorene::sqrt(), ssjm1_beta, ssjm1_khi, ssjm1_logn, ssjm1_wshift, Lorene::Cmp::std_base_scal(), tkij_auto, Lorene::Etoile::u_euler, Lorene::Map::val_r(), velocity_potential(), and w_shift.
Computes a spherical static configuration with the outer boundary condition at a finite radius.
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) |
Definition at line 57 of file etoile_eqsph_falloff.C.
References Lorene::Etoile::a_car, Lorene::Tenseur::annule(), Lorene::Etoile::beta_auto, Lorene::diffrel(), Lorene::Cmp::dsdr(), Lorene::Map_af::dsdr(), Lorene::Etoile::ener, Lorene::Etoile::ener_euler, Lorene::Etoile::ent, Lorene::Etoile::equation_of_state(), Lorene::exp(), Lorene::Etoile::gam_euler, Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Map_af::homothetie(), Lorene::Etoile::logn_auto, Lorene::Etoile::mass_b(), Lorene::Etoile::mass_g(), Lorene::Etoile::mp, Lorene::Etoile::nbar, Lorene::Etoile::nnn, Lorene::norme(), Lorene::Etoile::nzet, Lorene::Etoile::press, Lorene::Etoile::relativistic, Lorene::Etoile::s_euler, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), Lorene::Etoile::shift, Lorene::sqrt(), Lorene::Etoile::u_euler, Lorene::Etoile::unsurc2, and Lorene::Map::val_r().
Computes a spherical static configuration.
The sources for Poisson equations are regularized by extracting analytical diverging parts.
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) |
Definition at line 115 of file et_equil_spher_regu.C.
References Lorene::Etoile::a_car, Lorene::Tenseur::annule(), Lorene::Etoile::beta_auto, Lorene::Etoile::d_logn_auto_div, Lorene::Eos::der_ener_ent_p(), Lorene::Eos::der_nbar_ent_p(), Lorene::diffrel(), Lorene::Map_af::dsdr(), Lorene::Etoile::ener, Lorene::Etoile::ener_euler, Lorene::Etoile::ent, Lorene::Etoile::eos, Lorene::Etoile::equation_of_state(), Lorene::exp(), Lorene::Etoile::gam_euler, Lorene::Map::get_bvect_spher(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Tenseur::gradient_spher(), Lorene::Map_af::homothetie(), Lorene::Etoile::k_div, Lorene::Etoile::logn_auto, Lorene::Etoile::logn_auto_div, Lorene::Etoile::logn_auto_regu, Lorene::Etoile::mass_b(), Lorene::Etoile::mass_g(), Lorene::Etoile::mp, Lorene::Etoile::nbar, Lorene::Etoile::nnn, Lorene::norme(), Lorene::Etoile::nzet, Lorene::Map_af::poisson(), Lorene::Map_af::poisson_regular(), Lorene::Etoile::press, Lorene::Etoile::relativistic, Lorene::Etoile::s_euler, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), Lorene::Tenseur::set_triad(), Lorene::Etoile::shift, Lorene::sqrt(), Lorene::Cmp::std_base_scal(), Lorene::Etoile::u_euler, Lorene::Etoile::unsurc2, and Lorene::Map::val_r().
void Lorene::Etoile_bin::equilibrium | ( | double | ent_c, |
int | mermax, | ||
int | mermax_poisson, | ||
double | relax_poisson, | ||
int | mermax_potvit, | ||
double | relax_potvit, | ||
double | thres_adapt, | ||
const Tbl & | fact, | ||
Tbl & | diff, | ||
const Tbl * | ent_limit = 0x0 |
||
) |
Computes an equilibrium configuration.
The values of logn_comp
, beta_comp
, pot_centri
are held fixed during the iteration.
ent_c | [input] Central enthalpy |
mermax | [input] Maximum number of steps |
mermax_poisson | [input] Maximum number of steps in Map_et::poisson |
relax_poisson | [input] Relaxation factor in Map_et::poisson |
mermax_potvit | [input] Maximum number of steps in Map_radial::poisson_compact |
relax_potvit | [input] Relaxation factor in Map_radial::poisson_compact |
thres_adapt | [input] Threshold on dH/dr for the adaptation of the mapping |
fact | [input] 1-D Tbl for the input of some factors :
|
diff | [output] 1-D Tbl for the storage of some error indicators :
|
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 184 of file et_bin_equilibrium.C.
References Lorene::Etoile::a_car, Lorene::abs(), Lorene::Map::adapt(), Lorene::Param::add_cmp_mod(), Lorene::Param::add_double(), Lorene::Param::add_int(), Lorene::Param::add_int_mod(), Lorene::Param::add_tbl(), Lorene::Param::add_tenseur_mod(), akcar_auto, akcar_comp, Lorene::Etoile::beta_auto, Lorene::Tenseur::change_triad(), Lorene::contract(), d_beta_auto, d_beta_comp, d_logn_auto, d_logn_comp, Lorene::Tenseur::dec2_dzpuis(), Lorene::diffrel(), Lorene::Etoile::ener_euler, Lorene::Etoile::ent, Lorene::Etoile::equation_of_state(), Lorene::Cmp::filtre(), Lorene::flat_scalar_prod_desal(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Tenseur::gradient(), Lorene::Map_et::homothetie(), hydro_euler(), Lorene::Tenseur::inc2_dzpuis(), irrotational, khi_shift, loggam, Lorene::Etoile::logn_auto, Lorene::Etoile::logn_auto_regu, logn_comp, Lorene::max(), Lorene::Etoile::mp, Lorene::Etoile::nbar, Lorene::Etoile::nnn, Lorene::Etoile::nzet, Lorene::Tenseur::poisson_vect(), pot_centri, Lorene::Etoile::press, Lorene::Etoile::ray_eq(), Lorene::Etoile::ray_pole(), Lorene::Map::reevaluate_symy(), ref_triad, Lorene::Etoile::relativistic, Lorene::Map::resize(), Lorene::Etoile::s_euler, Lorene::Tenseur::set(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), shift_auto, Lorene::sqrt(), ssjm1_beta, ssjm1_khi, ssjm1_logn, ssjm1_wshift, tkij_auto, Lorene::Etoile::u_euler, Lorene::Map::val_r(), velocity_potential(), and 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 87 of file etoile_equil_spher.C.
References Lorene::Etoile::a_car, Lorene::Map_et::adapt(), Lorene::Param::add_double(), Lorene::Param::add_int(), Lorene::Param::add_int_mod(), Lorene::Param::add_tbl(), Lorene::Tenseur::annule(), Lorene::Etoile::beta_auto, Lorene::diffrel(), Lorene::Cmp::dsdr(), Lorene::Map_af::dsdr(), Lorene::Etoile::ener, Lorene::Etoile::ener_euler, Lorene::Etoile::ent, Lorene::Etoile::equation_of_state(), Lorene::exp(), Lorene::Etoile::gam_euler, Lorene::Map_af::get_alpha(), Lorene::Map_et::get_alpha(), Lorene::Map_af::get_beta(), Lorene::Map_et::get_beta(), Lorene::Etoile::get_ent(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Etoile::get_press(), Lorene::Map_af::homothetie(), Lorene::Etoile::logn_auto, Lorene::Etoile::mass_b(), Lorene::Etoile::mass_g(), Lorene::Etoile::mp, Lorene::Etoile::nbar, Lorene::Etoile::nnn, Lorene::norme(), Lorene::Etoile::nzet, Lorene::Map_af::poisson(), Lorene::Etoile::press, Lorene::Etoile::relativistic, Lorene::Etoile::s_euler, Lorene::Tenseur::set(), Lorene::Map_af::set_alpha(), Lorene::Map_af::set_beta(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), Lorene::Etoile::shift, Lorene::sqrt(), Lorene::Etoile::u_euler, Lorene::Etoile::unsurc2, and Lorene::Map::val_r().
|
virtual |
Computes tkij_auto
and akcar_auto
from shift_auto
, nnn
and a_car
.
Definition at line 64 of file et_bin_extr_curv.C.
References Lorene::Etoile::a_car, akcar_auto, Lorene::Tenseur::change_triad(), Lorene::contract(), Lorene::Map::get_bvect_cart(), Lorene::Tenseur::gradient(), Lorene::Etoile::mp, Lorene::Etoile::nnn, ref_triad, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), shift_auto, and tkij_auto.
void Lorene::Etoile_bin::fait_d_psi | ( | ) |
Computes the gradient of the total velocity potential
Definition at line 764 of file etoile_bin.C.
References Lorene::Etoile::a_car, Lorene::Cmp::annule(), Lorene::Tenseur::annule(), bsn, Lorene::Tenseur::change_triad(), d_psi, Lorene::Etoile::ent, Lorene::exp(), Lorene::Etoile::gam_euler, Lorene::Tenseur::get_etat(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Tenseur::get_triad(), Lorene::Tenseur::gradient(), irrotational, Lorene::Etoile::mp, Lorene::Etoile::nzet, psi0, ref_triad, Lorene::Tenseur::set(), Lorene::Valeur::set_base(), Lorene::Tenseur::set_etat_nondef(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_triad(), Lorene::Etoile::unsurc2, and Lorene::Cmp::va.
void Lorene::Etoile_bin::fait_shift_auto | ( | ) |
Computes shift_auto
from w_shift
and khi_shift
according to Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
Definition at line 826 of file etoile_bin.C.
References Lorene::Tenseur::change_triad(), Lorene::Tenseur::dec2_dzpuis(), Lorene::Tenseur::dec_dzpuis(), Lorene::Tenseur::get_etat(), Lorene::Tenseur::get_triad(), Lorene::Tenseur::gradient(), khi_shift, ref_triad, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_triad(), shift_auto, Lorene::skxk(), and w_shift.
Returns the total conformal factor
Definition at line 733 of file etoile.h.
References Lorene::Etoile::a_car.
Returns the part of the scalar shift_auto
, i.e.
Definition at line 1204 of file etoile.h.
References akcar_auto.
Returns the part of the scalar shift_auto
and shift_comp
, i.e.
Definition at line 1210 of file etoile.h.
References akcar_comp.
Returns the logarithm of the part of the product AN generated principaly by the star.
Definition at line 724 of file etoile.h.
References Lorene::Etoile::beta_auto.
Returns the gradient of beta_auto
(Cartesian components with respect to ref_triad
)
Definition at line 1141 of file etoile.h.
References d_beta_auto.
Returns the gradient of beta_comp
(Cartesian components with respect to ref_triad
)
Definition at line 1146 of file etoile.h.
References d_beta_comp.
Returns the gradient of logn_auto
(Cartesian components with respect to ref_triad
)
Definition at line 1121 of file etoile.h.
References d_logn_auto.
Returns the gradient of logn_auto_div
.
Definition at line 719 of file etoile.h.
References Lorene::Etoile::d_logn_auto_div.
Returns the gradient of logn_auto_regu
(Cartesian components with respect to ref_triad
)
Definition at line 1126 of file etoile.h.
References d_logn_auto_regu.
Returns the gradient of logn_comp
(Cartesian components with respect to ref_triad
)
Definition at line 1131 of file etoile.h.
References d_logn_comp.
Returns the proper total energy density.
Definition at line 679 of file etoile.h.
References Lorene::Etoile::ener.
Returns the total energy density with respect to the Eulerian observer.
Definition at line 685 of file etoile.h.
References Lorene::Etoile::ener_euler.
Returns the enthalpy field.
Definition at line 673 of file etoile.h.
References Lorene::Etoile::ent.
Returns the equation of state.
Definition at line 670 of file etoile.h.
References Lorene::Etoile::eos.
Returns the Lorentz factor between the fluid and Eulerian observers.
Definition at line 691 of file etoile.h.
References Lorene::Etoile::gam_euler.
Returns the scalar shift_auto
following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of mp
.
Definition at line 1186 of file etoile.h.
References khi_shift.
Returns the logarithm of the part of the lapse N generated principaly by the star.
In the Newtonian case, this is the Newtonian gravitational potential (in units of
Definition at line 701 of file etoile.h.
References Lorene::Etoile::logn_auto.
Returns the divergent part of the logarithm of the part of the lapse N generated principaly by the star.
In the Newtonian case, this is the diverging part of the Newtonian gravitational potential (in units of
Definition at line 715 of file etoile.h.
References Lorene::Etoile::logn_auto_div.
Returns the regular part of the logarithm of the part of the lapse N generated principaly by the star.
In the Newtonian case, this is the Newtonian gravitational potential (in units of
Definition at line 708 of file etoile.h.
References Lorene::Etoile::logn_auto_regu.
Returns the proper baryon density.
Definition at line 676 of file etoile.h.
References Lorene::Etoile::nbar.
Returns the total lapse function N.
Definition at line 727 of file etoile.h.
References Lorene::Etoile::nnn.
|
inlineinherited |
Returns the number of domains occupied by the star.
Definition at line 662 of file etoile.h.
References Lorene::Etoile::nzet.
Returns the fluid pressure.
Definition at line 682 of file etoile.h.
References Lorene::Etoile::press.
Returns the trace of the stress tensor in the Eulerian frame.
Definition at line 688 of file etoile.h.
References Lorene::Etoile::s_euler.
Returns the total shift vector
Definition at line 730 of file etoile.h.
References Lorene::Etoile::shift.
Returns the part of the shift vector
(Cartesian components with respect to ref_triad
)
Definition at line 1152 of file etoile.h.
References shift_auto.
Returns the part of the shift vector
(Cartesian components with respect to ref_triad
)
Definition at line 1158 of file etoile.h.
References shift_comp.
|
inline |
|
inline |
Returns the fluid 3-velocity with respect to the Eulerian observer.
Definition at line 694 of file etoile.h.
References Lorene::Etoile::u_euler.
Returns the vector shift_auto
, following Shibata's prescription [Prog.
Theor. Phys. 101 , 1199 (1999)] :
NB: w_shift
contains the components of mp
.
Definition at line 1172 of file etoile.h.
References w_shift.
|
virtual |
Computes the hydrodynamical quantities relative to the Eulerian observer from those in the fluid frame, as well as wit_w
and loggam
.
The calculation is performed starting from the quantities ent
, ener
, press
, a_car
and bsn
,
which are supposed to be up to date.
From these, the following fields are updated: gam_euler
, u_euler
, ener_euler
, s_euler
, wit_w
and loggam
.
Reimplemented from Lorene::Etoile.
Definition at line 106 of file et_bin_hydro.C.
References Lorene::Etoile::a_car, Lorene::Tenseur::annule(), bsn, d_psi, del_deriv(), Lorene::Etoile::ener, Lorene::Etoile::ener_euler, Lorene::Etoile::ent, Lorene::exp(), Lorene::flat_scalar_prod_desal(), Lorene::Etoile::gam_euler, Lorene::Tenseur::get_etat(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Tenseur::get_triad(), irrotational, Lorene::log(), loggam, Lorene::Etoile::mp, Lorene::Etoile::press, Lorene::Etoile::relativistic, Lorene::Etoile::s_euler, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_etat_zero(), Lorene::Tenseur::set_std_base(), Lorene::Tenseur::set_triad(), sprod(), Lorene::sqrt(), Lorene::Etoile::u_euler, Lorene::Etoile::unsurc2, and wit_w.
|
inline |
Returns true
for an irrotational motion, false
for a corotating one.
Definition at line 1092 of file etoile.h.
References irrotational.
|
inlineinherited |
Returns true
for a relativistic star, false
for a Newtonian one.
Definition at line 667 of file etoile.h.
References Lorene::Etoile::relativistic.
Computes the quantities bsn
and pot_centri
.
The calculation is performed starting from the quantities nnn
, shift
, a_car
,
which are supposed to be up to date.
omega | angular velocity with respect to an asymptotically inertial observer |
x_axe | absolute X coordinate of the rotation axis |
Reimplemented in Lorene::Et_bin_nsbh.
Definition at line 81 of file et_bin_kinema.C.
References Lorene::Tenseur::annule(), bsn, del_deriv(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::log(), Lorene::Etoile::mp, Lorene::Etoile::nnn, pot_centri, Lorene::Etoile::relativistic, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_std_base(), Lorene::Etoile::shift, sprod(), Lorene::sqrt(), Lorene::Map::xa, and Lorene::Map::ya.
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::Et_rot_bifluid, and Lorene::Etoile_rot.
Definition at line 75 of file etoile_global.C.
References Lorene::Etoile::ent, Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Etoile::mp, Lorene::Etoile::nzet, Lorene::Etoile::p_l_surf, and Lorene::Etoile::p_xi_surf.
|
virtual |
Baryon mass.
Reimplemented from Lorene::Etoile.
Definition at line 100 of file et_bin_global.C.
References Lorene::Etoile::a_car, Lorene::Etoile::gam_euler, Lorene::Tenseur::get_etat(), Lorene::Cmp::integrale(), Lorene::Etoile::nbar, Lorene::Etoile::p_mass_b, Lorene::Etoile::relativistic, Lorene::sqrt(), and Lorene::Cmp::std_base_scal().
|
virtual |
Gravitational mass.
Reimplemented from Lorene::Etoile.
Definition at line 137 of file et_bin_global.C.
References Lorene::Etoile::a_car, Lorene::Etoile::ener_euler, Lorene::Cmp::integrale(), mass_b(), Lorene::Etoile::nnn, Lorene::Etoile::p_mass_g, Lorene::Etoile::relativistic, Lorene::Etoile::s_euler, Lorene::sqrt(), and Lorene::Cmp::std_base_scal().
void Lorene::Etoile_bin::operator= | ( | const Etoile_bin & | et | ) |
Assignment to another Etoile_bin
.
Definition at line 482 of file etoile_bin.C.
References akcar_auto, akcar_comp, beta_comp, bsn, d_beta_auto, d_beta_comp, d_logn_auto, d_logn_auto_regu, d_logn_comp, d_psi, decouple, del_deriv(), irrotational, khi_shift, loggam, logn_comp, Lorene::Etoile::operator=(), pot_centri, psi0, ref_triad, shift_auto, shift_comp, ssjm1_beta, ssjm1_khi, ssjm1_logn, ssjm1_psi, ssjm1_wshift, tkij_auto, tkij_comp, w_shift, and wit_w.
Operator >> (virtual function called by the operator <<).
Reimplemented from Lorene::Etoile.
Reimplemented in Lorene::Et_bin_nsbh.
Definition at line 582 of file etoile_bin.C.
References akcar_auto, akcar_comp, Lorene::Etoile::beta_auto, beta_comp, bsn, d_beta_auto, d_beta_comp, d_logn_auto, d_logn_comp, d_psi, Lorene::Etoile::gam_euler, Lorene::Map::get_ori_x(), Lorene::Map::get_rot_phi(), irrotational, khi_shift, loggam, Lorene::Etoile::logn_auto, logn_comp, Lorene::max(), Lorene::min(), Lorene::Etoile::mp, Lorene::Etoile::operator>>(), Lorene::Etoile::ray_eq(), Lorene::Etoile::ray_eq_pi(), Lorene::Etoile::shift, shift_auto, shift_comp, tkij_auto, tkij_comp, Lorene::Etoile::u_euler, Lorene::Map::val_r(), w_shift, wit_w, and xa_barycenter().
|
inherited |
Coordinate radius at
Definition at line 120 of file etoile_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_type_p(), Lorene::Mg3d::get_type_t(), Lorene::Etoile::l_surf(), Lorene::Etoile::mp, Lorene::Etoile::p_ray_eq, Lorene::Map::val_r(), and Lorene::Etoile::xi_surf().
Coordinate radius at
Definition at line 440 of file etoile_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::Etoile::l_surf(), Lorene::Etoile::mp, Lorene::Map::val_r(), and Lorene::Etoile::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 335 of file etoile_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::Etoile::l_surf(), Lorene::Etoile::mp, Lorene::Etoile::p_ray_eq_3pis2, Lorene::Etoile::ray_eq_pis2(), Lorene::Map::val_r(), and Lorene::Etoile::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 256 of file etoile_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::Etoile::l_surf(), Lorene::Etoile::mp, Lorene::Etoile::p_ray_eq_pi, Lorene::Etoile::ray_eq(), Lorene::Map::val_r(), and Lorene::Etoile::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 169 of file etoile_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::Etoile::l_surf(), Lorene::Etoile::mp, Lorene::Etoile::p_ray_eq_pis2, Lorene::Map::val_r(), and Lorene::Etoile::xi_surf().
|
inherited |
Coordinate radius at
Definition at line 415 of file etoile_global.C.
References Lorene::Map::get_mg(), Lorene::Mg3d::get_type_t(), Lorene::Etoile::l_surf(), Lorene::Etoile::mp, Lorene::Etoile::p_ray_pole, Lorene::Map::val_r(), and Lorene::Etoile::xi_surf().
void Lorene::Etoile_bin::relaxation | ( | const Etoile_bin & | star_prev, |
double | relax_ent, | ||
double | relax_met, | ||
int | mer, | ||
int | fmer_met | ||
) |
Performs a relaxation on ent
, logn_auto
, beta_auto
and shift_auto
.
star_prev | [input] star at the previous step. |
relax_ent | [input] Relaxation factor for ent |
relax_met | [input] Relaxation factor for logn_auto , beta_auto , shift_auto , only if (mer % fmer_met == 0) . |
mer | [input] Step number |
fmer_met | [input] Step interval between metric updates |
Definition at line 863 of file etoile_bin.C.
References Lorene::Etoile::beta_auto, Lorene::Etoile::d_logn_auto_div, del_deriv(), Lorene::Etoile::ent, Lorene::Etoile::equation_of_state(), Lorene::Etoile::logn_auto, Lorene::Etoile::logn_auto_div, Lorene::Etoile::logn_auto_regu, and shift_auto.
Save in a file.
Reimplemented from Lorene::Etoile.
Reimplemented in Lorene::Et_bin_bhns_extr, and Lorene::Et_bin_nsbh.
Definition at line 559 of file etoile_bin.C.
References Lorene::Etoile::gam_euler, irrotational, khi_shift, psi0, Lorene::Cmp::sauve(), Lorene::Etoile::sauve(), Lorene::Tenseur::sauve(), ssjm1_beta, ssjm1_khi, ssjm1_logn, ssjm1_wshift, and w_shift.
|
protectedvirtual |
Sets to 0x0
all the pointers on derived quantities.
Reimplemented from Lorene::Etoile.
Definition at line 459 of file etoile_bin.C.
References p_xa_barycenter, and Lorene::Etoile::set_der_0x0().
Assignment of the enthalpy field.
Definition at line 465 of file etoile.C.
References Lorene::Etoile::del_deriv(), Lorene::Etoile::ent, and Lorene::Etoile::equation_of_state().
Tenseur & Lorene::Etoile_bin::set_khi_shift | ( | ) |
Read/write of khi_shift
.
Definition at line 545 of file etoile_bin.C.
References del_deriv(), and khi_shift.
Tenseur & Lorene::Etoile_bin::set_logn_comp | ( | ) |
Read/write the part of the lapse logarithm (gravitational potential at the Newtonian limit) generated principaly by the companion star.
Definition at line 524 of file etoile_bin.C.
References del_deriv(), and logn_comp.
|
inlineinherited |
Tenseur & Lorene::Etoile_bin::set_pot_centri | ( | ) |
Read/write the centrifugal potential.
Definition at line 531 of file etoile_bin.C.
References del_deriv(), and pot_centri.
Tenseur & Lorene::Etoile_bin::set_w_shift | ( | ) |
Read/write of w_shift
.
Definition at line 538 of file etoile_bin.C.
References del_deriv(), and w_shift.
Performs the scalar product of two tensors by contracting the last index of t1
with the first index of t2
.
Both indices are supposed to be contravariant, so that a multiplication by
Definition at line 748 of file etoile_bin.C.
References Lorene::Etoile::a_car, Lorene::flat_scalar_prod(), Lorene::Tenseur::get_type_indice(), and Lorene::Tenseur::get_valence().
void Lorene::Etoile_bin::update_metric | ( | const Etoile_bin & | comp | ) |
Computes metric coefficients from known potentials, when the companion is another star.
The calculation is performed starting from the quantities logn_auto
, beta_auto
, shift_auto
, comp.logn_auto
, comp.beta_auto
, comp.shift_auto
which are supposed to be up to date. From these, the following fields are updated: logn_comp
, beta_comp
, shift_comp
, nnn
, a_car
, shift
, d_logn_auto
, d_beta_auto
, tkij_auto
, akcar_auto
.
comp | companion star. |
Definition at line 100 of file et_bin_upmetr.C.
References Lorene::Etoile::a_car, Lorene::Etoile::beta_auto, beta_comp, Lorene::Tenseur::change_triad(), d_beta_auto, d_logn_auto, Lorene::Etoile::d_logn_auto_div, d_logn_auto_regu, del_deriv(), Lorene::exp(), extrinsic_curvature(), Lorene::Map::get_bvect_cart(), Lorene::Tenseur::get_triad(), Lorene::Tenseur::gradient(), Lorene::Etoile::logn_auto, Lorene::Etoile::logn_auto_regu, logn_comp, Lorene::Etoile::mp, Lorene::Etoile::nnn, ref_triad, Lorene::Etoile::relativistic, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_etat_zero(), Lorene::Tenseur::set_std_base(), Lorene::Tenseur::set_triad(), Lorene::Etoile::shift, shift_auto, shift_comp, and Lorene::Etoile::unsurc2.
void Lorene::Etoile_bin::update_metric | ( | const Etoile_bin & | comp, |
const Etoile_bin & | star_prev, | ||
double | relax | ||
) |
Same as update_metric
(const Etoile_bin& ) but with relaxation.
comp | companion star. |
star_prev | previous value of the star. |
relax | relaxation parameter. |
Definition at line 204 of file et_bin_upmetr.C.
References Lorene::Etoile::a_car, Lorene::Etoile::beta_auto, beta_comp, Lorene::Tenseur::change_triad(), d_beta_auto, d_logn_auto, Lorene::Etoile::d_logn_auto_div, d_logn_auto_regu, del_deriv(), Lorene::exp(), extrinsic_curvature(), get_beta_comp(), Lorene::Map::get_bvect_cart(), get_logn_comp(), get_shift_comp(), Lorene::Tenseur::get_triad(), Lorene::Tenseur::gradient(), Lorene::Etoile::logn_auto, Lorene::Etoile::logn_auto_regu, logn_comp, Lorene::Etoile::mp, Lorene::Etoile::nnn, ref_triad, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_etat_zero(), Lorene::Tenseur::set_std_base(), Lorene::Tenseur::set_triad(), Lorene::Etoile::shift, shift_auto, shift_comp, and Lorene::Etoile::unsurc2.
void Lorene::Etoile_bin::update_metric_der_comp | ( | const Etoile_bin & | comp | ) |
Computes the derivative of metric functions related to the companion star.
The calculation is performed starting from the quantities comp.d_logn_auto
, comp.d_beta_auto
, comp.tkij_auto
which are supposed to be up to date. From these, the following fields are updated: d_logn_comp
, d_beta_comp
, tkij_comp
, akcar_comp
.
comp | companion star. |
Definition at line 84 of file et_bin_upmetr_der.C.
References Lorene::Etoile::a_car, akcar_comp, beta_comp, Lorene::Tenseur::change_triad(), Lorene::contract(), d_beta_auto, d_beta_comp, d_logn_auto, d_logn_comp, del_deriv(), Lorene::Map::get_bvect_cart(), Lorene::Tenseur::gradient(), logn_comp, Lorene::Etoile::mp, Lorene::Etoile::nnn, ref_triad, Lorene::Etoile::relativistic, Lorene::Tenseur::set(), Lorene::Tenseur::set_etat_qcq(), Lorene::Tenseur::set_etat_zero(), Lorene::Tenseur::set_std_base(), Lorene::Tenseur::set_triad(), shift_comp, tkij_auto, and tkij_comp.
Computes the non-translational part of the velocity scalar potential
mermax | [input] Maximum number of steps in the iteration |
precis | [input] Required precision: the iteration will be stopped when the relative difference on ![]() precis . |
relax | [input] Relaxation factor. |
Definition at line 142 of file et_bin_vel_pot.C.
References Lorene::Etoile::a_car, Lorene::Param::add_cmp_mod(), Lorene::Param::add_double(), Lorene::Param::add_int(), Lorene::Param::add_int_mod(), Lorene::Cmp::annule(), Lorene::Tenseur::annule(), Lorene::Valeur::annule_hard(), Lorene::Etoile::beta_auto, beta_comp, bsn, Lorene::Tenseur::change_triad(), Lorene::contract(), d_psi, Lorene::Eos::der_nbar_ent(), Lorene::Tenseur::derive_cov(), Lorene::diffrel(), Lorene::Cmp::dsdr(), Lorene::Etoile::ent, Lorene::Etoile::eos, Lorene::exp(), Lorene::flat_scalar_prod(), Lorene::Etoile::gam_euler, Lorene::Mg3d::get_angu(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Tenseur::get_etat(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::Tenseur::get_triad(), Lorene::Tenseur::gradient(), Lorene::Tenseur::gradient_spher(), Lorene::Eos::identify(), Lorene::log(), Lorene::Etoile::mp, Lorene::Etoile::nnn, Lorene::norme(), Lorene::Etoile::nzet, Lorene::Map::poisson_compact(), psi0, Lorene::Map::r, ref_triad, Lorene::Tenseur::set(), Lorene::Cmp::set(), Lorene::Valeur::set(), Lorene::Scalar::set_domain(), Lorene::Tenseur::set_etat_qcq(), Lorene::Scalar::set_outer_boundary(), Lorene::Tenseur::set_std_base(), Lorene::Tenseur::set_triad(), Lorene::sqrt(), ssjm1_psi, Lorene::Valeur::std_base_scal(), Lorene::Etoile::unsurc2, Lorene::Cmp::va, Lorene::Valeur::ylm(), and Lorene::Valeur::ylm_i().
|
virtual |
Absolute coordinate X of the barycenter of the baryon density, defined according to the formula.
where
Definition at line 170 of file et_bin_global.C.
References Lorene::Etoile::a_car, Lorene::Etoile::gam_euler, Lorene::Cmp::integrale(), mass_b(), Lorene::Etoile::mp, Lorene::Etoile::nbar, p_xa_barycenter, Lorene::sqrt(), Lorene::Cmp::std_base_scal(), and Lorene::Map::xa.
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 101 of file etoile_global.C.
References Lorene::Etoile::l_surf(), Lorene::Etoile::p_l_surf, and Lorene::Etoile::p_xi_surf.
|
protectedinherited |
|
protected |
|
protected |
|
protectedinherited |
|
protected |
|
protected |
|
protected |
|
protected |
|
protected |
|
protectedinherited |
|
protected |
|
protected |
|
protected |
|
protected |
Function used to construct the part of
Only used for a binary system where the other member is a black hole.
Mainly this Cmp
is 1 around the hole and 0 around the companion and the sum of decouple
for the hole and his companion is 1 everywhere.
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protected |
|
protectedinherited |
|
protected |
|
protected |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protected |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotectedinherited |
|
mutableprotected |
|
mutableprotectedinherited |
|
protected |
|
protectedinherited |
|
protected |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protected |
|
protected |
|
protected |
Effective source at the previous step for the resolution of the Poisson equation for beta_auto
by means of Map_et::poisson
.
|
protected |
Effective source at the previous step for the resolution of the Poisson equation for the scalar Map_et::poisson
.
|
protected |
Effective source at the previous step for the resolution of the Poisson equation for logn_auto
by means of Map_et::poisson
.
|
protected |
Effective source at the previous step for the resolution of the Poisson equation for the scalar Map_et::poisson_interne
.
|
protected |
Effective source at the previous step for the resolution of the vector Poisson equation for Map_et::poisson
.
mp
)
|
protected |
|
protected |
|
protectedinherited |
|
protectedinherited |
|
protected |
|
protected |