LORENE
|
Class for black holes in black hole-neutron star binaries. More...
#include <hole_bhns.h>
Public Member Functions | |
Hole_bhns (Map &mp_i, bool kerrschild_i, bool bc_lapconf_nd, bool bc_lapconf_fs, bool irrotational, double massbh) | |
Standard constructor. More... | |
Hole_bhns (const Hole_bhns &) | |
Copy constructor. More... | |
Hole_bhns (Map &mp_i, FILE *fich) | |
Constructor from a file (see sauve(FILE*) ) More... | |
virtual | ~Hole_bhns () |
Destructor. More... | |
void | operator= (const Hole_bhns &) |
Assignment to another Hole_bhns . More... | |
double & | set_omega_spin () |
Sets the spin angular velocity of the black hole [{ f_unit}]. More... | |
Scalar & | set_lapconf_auto_rs () |
Read/write of the lapconf function generated by the black hole. More... | |
Scalar & | set_lapconf_auto_bh () |
Read/write of the lapconf function generated by the black hole. More... | |
Scalar & | set_lapconf_auto () |
Read/write of the lapconf function generated by the black hole. More... | |
Scalar & | set_lapconf_comp () |
Read/write of the lapconf function generated by the companion star. More... | |
Scalar & | set_lapconf_tot () |
Read/write of the total lapconf function. More... | |
Scalar & | set_lapse_auto () |
Read/write of the lapse function generated by the black hole. More... | |
Scalar & | set_lapse_tot () |
Read/write of the total lapse function. More... | |
Vector & | set_shift_auto_rs () |
Read/write of the shift vector generated by the black hole. More... | |
Vector & | set_shift_auto_bh () |
Read/write of the shift vector generated by the black hole. More... | |
Vector & | set_shift_auto () |
Read/write of the shift vector generated by the black hole. More... | |
Vector & | set_shift_comp () |
Read/write of the shift vector generated by the companion star. More... | |
Vector & | set_shift_tot () |
Read/write of the total shift vector. More... | |
Scalar & | set_confo_auto_rs () |
Read/write of the conformal factor generated by the black hole. More... | |
Scalar & | set_confo_auto_bh () |
Read/write of the conformal factor generated by the black hole. More... | |
Scalar & | set_confo_auto () |
Read/write of the conformal factor generated by the black hole. More... | |
Scalar & | set_confo_comp () |
Read/write of the conformal factor generated by the companion star. More... | |
Scalar & | set_confo_tot () |
Read/write of the total conformal factor. More... | |
bool | has_bc_lapconf_nd () const |
Returns true for the Neumann type BC for the lapconf function, false for the Dirichlet type BH. More... | |
bool | has_bc_lapconf_fs () const |
Returns true for the first type BC for the lapconf function, false for the second type BH. More... | |
bool | is_irrotational () const |
Returns true for an irrotational black hole, false for a corotating one. More... | |
double | get_omega_spin () const |
Returns the spin angular velocity of the black hole [{ f_unit}]. More... | |
const Scalar & | get_lapconf_auto_rs () const |
Returns the part of the lapconf function from numerical computation. More... | |
const Scalar & | get_lapconf_auto () const |
Returns the part of the lapconf function generated by the black hole. More... | |
const Scalar & | get_lapconf_comp () const |
Returns the part of the lapconf function generated by the companion star. More... | |
const Scalar & | get_lapconf_tot () const |
Returns the total lapconf function. More... | |
const Scalar & | get_lapse_auto () const |
Returns the part of the lapse function generated by the black hole. More... | |
const Scalar & | get_lapse_tot () const |
Returns the total lapse function. More... | |
const Vector & | get_d_lapconf_auto_rs () const |
Returns the derivative of the lapconf function generated by the black hole. More... | |
const Vector & | get_d_lapconf_auto () const |
Returns the derivative of the lapconf function generated by the black hole. More... | |
const Vector & | get_d_lapconf_comp () const |
Returns the derivative of the lapconf function generated by the companion star. More... | |
const Vector & | get_shift_auto_rs () const |
Returns the part of the shift vector from numerical computation. More... | |
const Vector & | get_shift_auto () const |
Returns the part of the shift vector generated by the black hole. More... | |
const Vector & | get_shift_comp () const |
Returns the part of the shift vector generated by the companion star. More... | |
const Vector & | get_shift_tot () const |
Returns the total shift vector. More... | |
const Tensor & | get_d_shift_auto_rs () const |
Returns the derivative of the shift vector generated by the black hole. More... | |
const Tensor & | get_d_shift_auto () const |
Returns the derivative of the shift vector generated by the black hole. More... | |
const Tensor & | get_d_shift_comp () const |
Returns the derivative of the shift vector generated by the companion star. More... | |
const Scalar & | get_confo_auto_rs () const |
Returns the part of the conformal factor from numerical computation. More... | |
const Scalar & | get_confo_auto () const |
Returns the part of the conformal factor generated by the black hole. More... | |
const Scalar & | get_confo_comp () const |
Returns the part of the conformal factor generated by the companion star. More... | |
const Scalar & | get_confo_tot () const |
Returns the total conformal factor. More... | |
const Vector & | get_d_confo_auto_rs () const |
Returns the derivative of the conformal factor generated by the black hole. More... | |
const Vector & | get_d_confo_auto () const |
Returns the derivative of the conformal factor generated by the black hole. More... | |
const Vector & | get_d_confo_comp () const |
Returns the derivative of the conformal factor generated by the companion star. More... | |
const Sym_tensor & | get_taij_tot_rs () const |
Returns the part of rs of the extrinsic curvature tensor. More... | |
const Sym_tensor & | get_taij_tot () const |
Returns the total extrinsic curvature tensor. More... | |
const Sym_tensor & | get_taij_auto_rs () const |
Returns the part of rs of the extrinsic curvature tensor generated by the black hole. More... | |
const Sym_tensor & | get_taij_auto () const |
Returns the part of the extrinsic curvature tensor generated by the black hole. More... | |
const Sym_tensor & | get_taij_comp () const |
Returns the part of the extrinsic curvature tensor generated by the companion star. More... | |
const Scalar & | get_taij_quad_tot_rs () const |
Returns the part of rs. More... | |
const Scalar & | get_taij_quad_tot_rot () const |
Returns the part of rot. More... | |
const Scalar & | get_taij_quad_tot () const |
Returns the total scalar . More... | |
const Scalar & | get_taij_quad_auto () const |
Returns the part of rs generated by the black hole. More... | |
const Scalar & | get_taij_quad_comp () const |
Returns the part of rs generated by the companion star. More... | |
virtual void | sauve (FILE *) const |
Save in a file. More... | |
virtual double | mass_irr_bhns () const |
Irreducible mass of the black hole. More... | |
double | spin_am_bhns (const Tbl &xi_i, const double &phi_i, const double &theta_i, const int &nrk_phi, const int &nrk_theta) const |
Spin angular momentum of the black hole. More... | |
const Valeur | bc_lapconf () const |
Boundary condition on the apparent horizon of the black hole for the lapconf function: 2-D Valeur . More... | |
const Valeur | bc_shift_x (double ome_orb, double y_rot) const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur . More... | |
const Valeur | bc_shift_y (double ome_orb, double x_rot) const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur . More... | |
const Valeur | bc_shift_z () const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur . More... | |
const Valeur | bc_confo (double ome_orb, double x_rot, double y_rot) const |
Boundary condition on the apparent horizon of the black hole for the conformal factor: 2-D Valeur . More... | |
void | update_metric_bhns (const Star_bhns &star, const Hole_bhns &hole_prev, double relax) |
Computes metric coefficients from known potentials with relaxation when the companion is a black hole. More... | |
void | update_met_der_comp_bhns (const Star_bhns &star) |
Computes derivative of metric quantities from the companion neutron star. More... | |
void | extr_curv_bhns (double omega_orb, double x_rot, double y_rot) |
Computes taij_tot , taij_quad_tot from shift_tot , lapse_tot , confo_tot . More... | |
void | equilibrium_bhns (int mer, int mermax_bh, int filter_r, int filter_r_s, int filter_p_s, double x_rot, double y_rot, double precis, double omega_orb, double resize_bh, const Tbl &fact_resize, Tbl &diff) |
Computes a black-hole part in a black hole-neutron star binary by giving boundary conditions on the apparent horizon. More... | |
void | relax_bhns (const Hole_bhns &hole_prev, double relax_met, int mer, int fmer_met) |
Performs a relaxation on lapse_auto , shift_auto , confo_auto . More... | |
Tbl | runge_kutta_phi (const Tbl &xi_i, const double &phi_i, const int &nrk) const |
Compute a forth-order Runge-Kutta integration to the phi direction for the solution of the Killing vectors on the equator. More... | |
Tbl | runge_kutta_theta (const Tbl &xi_i, const double &theta_i, const double &phi, const int &nrk) const |
Compute a forth-order Runge-Kutta integration to the theta direction for the solution of the Killing vectors. More... | |
Vector | killing_vect (const Tbl &xi_i, const double &phi_i, const double &theta_i, const int &nrk_phi, const int &nrk_theta) const |
Compute the Killing vector of a black hole normalized so that its affine length is 2 M_PI. More... | |
Map & | set_mp () |
Read/write of the mapping. More... | |
double & | set_mass_bh () |
Read/write of the gravitational mass of BH [{ m_unit}]. More... | |
const Map & | get_mp () const |
Returns the mapping. More... | |
bool | is_kerrschild () const |
Returns true for a Kerr-Schild background, false for a Conformally flat one. More... | |
double | get_mass_bh () const |
Returns the gravitational mass of BH [{ m_unit}]. More... | |
const Scalar & | get_lapconf () const |
Returns lapconf generated by the black hole. More... | |
const Scalar & | get_lapconf_rs () const |
Returns the part of lapconf from the numerical computation. More... | |
const Scalar & | get_lapse () const |
Returns the lapse function generated by the black hole. More... | |
const Vector & | get_shift () const |
Returns the shift vector generated by the black hole. More... | |
const Vector & | get_shift_rs () const |
Returns the part of the shift vector from the numerical computation. More... | |
const Scalar & | get_confo () const |
Returns the conformal factor generated by the black hole. More... | |
virtual double | mass_irr () const |
Irreducible mass of the black hole. More... | |
virtual double | mass_adm () const |
ADM mass. More... | |
virtual double | mass_kom () const |
Komar mass. More... | |
virtual double | rad_ah () const |
Radius of the apparent horizon. More... | |
double | spin_am_bh (bool bclapconf_nd, bool bclapconf_fs, const Tbl &xi_i, const double &phi_i, const double &theta_i, const int &nrk_phi, const int &nrk_theta) const |
Spin angular momentum. More... | |
const Tbl & | angu_mom_bh () const |
Total angular momentum. More... | |
const Valeur | bc_lapconf (bool neumann, bool first) const |
Boundary condition on the apparent horizon of the black hole for the lapse function: 2-D Valeur . More... | |
const Valeur | bc_shift_x (double omega_r) const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur . More... | |
const Valeur | bc_shift_y (double omega_r) const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur . More... | |
const Valeur | bc_confo () const |
Boundary condition on the apparent horizon of the black hole for the conformal factor: 2-D Valeur . More... | |
void | extr_curv_bh () |
Computes taij , taij_quad from shift , lapse , confo . More... | |
void | equilibrium_spher (bool neumann, bool first, double spin_omega, double precis=1.e-14, double precis_shift=1.e-8) |
Computes a spherical, static black-hole by giving boundary conditions on the apparent horizon. More... | |
void | static_bh (bool neumann, bool first) |
Sets the metric quantities to a spherical, static blach-hole analytic solution. More... | |
double | rah_iso (bool neumann, bool first) const |
Computes a radius of apparent horizon (excised surface) in isotropic coordinates. More... | |
const Scalar | r_coord (bool neumann, bool first) const |
Expresses the areal radial coordinate by that in spatially isotropic coordinates. More... | |
Tbl | runge_kutta_phi_bh (const Tbl &xi_i, const double &phi_i, const int &nrk) const |
Compute a forth-order Runge-Kutta integration to the phi direction for the solution of the Killing vectors on the equator. More... | |
Tbl | runge_kutta_theta_bh (const Tbl &xi_i, const double &theta_i, const double &phi, const int &nrk) const |
Compute a forth-order Runge-Kutta integration to the theta direction for the solution of the Killing vectors. More... | |
Vector | killing_vect_bh (const Tbl &xi_i, const double &phi_i, const double &theta_i, const int &nrk_phi, const int &nrk_theta) const |
Compute the Killing vector of a black hole normalized so that its affine length is 2 M_PI. 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 ostream & | operator>> (ostream &) const |
Operator >> (virtual function called by the operator <<) More... | |
Protected Attributes | |
bool | bc_lapconf_nd |
true for the Neumann type BC for the lapconf function, false for the Dirichlet type BH More... | |
bool | bc_lapconf_fs |
true for the first type BC for the lapconf function, false for the second type BH More... | |
bool | irrotational |
true for an irrotational black hole, false for a corotating one More... | |
double | omega_spin |
Spin angular velocity of the black hole. More... | |
Scalar | lapconf_auto_rs |
Part of the lapconf function from the numerical computation. More... | |
Scalar | lapconf_auto_bh |
Part of the lapconf function from the analytic background. More... | |
Scalar | lapconf_auto |
Lapconf function generated by the black hole. More... | |
Scalar | lapconf_comp |
Lapconf function generated by the companion star. More... | |
Scalar | lapconf_tot |
Total lapconf function. More... | |
Scalar | lapse_auto |
Lapse function of the "black hole" part. More... | |
Scalar | lapse_tot |
Total lapse function. More... | |
Vector | d_lapconf_auto_rs |
Derivative of the part of the lapconf function from the numerical computation. More... | |
Vector | d_lapconf_auto_bh |
Derivative of the part of the lapconf function from the analytic background. More... | |
Vector | d_lapconf_auto |
Derivative of the lapconf function generated by the black hole. More... | |
Vector | d_lapconf_comp |
Derivative of the lapconf function generated by the companion star. More... | |
Vector | shift_auto_rs |
Part of the shift vector from the numerical computation. More... | |
Vector | shift_auto_bh |
Part of the shift vector from the analytic background. More... | |
Vector | shift_auto |
Shift vector generated by the black hole. More... | |
Vector | shift_comp |
Shift vector generated by the companion star. More... | |
Vector | shift_tot |
Total shift vector ;. More... | |
Tensor | d_shift_auto_rs |
Derivative of the part of the shift vector from the numerical computation. More... | |
Tensor | d_shift_auto_bh |
Derivative of the part of the shift vector from the analytic background. More... | |
Tensor | d_shift_auto |
Derivative of the shift vector generated by the black hole. More... | |
Tensor | d_shift_comp |
Derivative of the shift vector generated by the companion star. More... | |
Scalar | confo_auto_rs |
Part of the conformal factor from the numerical computation. More... | |
Scalar | confo_auto_bh |
Part of the conformal factor from the analytic background. More... | |
Scalar | confo_auto |
Conformal factor generated by the black hole. More... | |
Scalar | confo_comp |
Conformal factor generated by the companion star. More... | |
Scalar | confo_tot |
Total conformal factor. More... | |
Vector | d_confo_auto_rs |
Derivative of the part of the conformal factor from the numerical computation. More... | |
Vector | d_confo_auto_bh |
Derivative of the part of the conformal factor from the analytic background. More... | |
Vector | d_confo_auto |
Derivative of the conformal factor generated by the black hole. More... | |
Vector | d_confo_comp |
Derivative of the conformal factor generated by the companion star. More... | |
Sym_tensor | taij_tot_rs |
Part of the extrinsic curvature tensor from the numerical computation. More... | |
Sym_tensor | taij_tot_rot |
Part of the extrinsic curvature tensor from the rotation shift vector. More... | |
Sym_tensor | taij_tot_bh |
Part of the extrinsic curvature tensor from the analytic background. More... | |
Sym_tensor | taij_tot |
Total extrinsic curvature tensor generated by shift_tot , lapse_tot , and confo_tot . More... | |
Sym_tensor | taij_auto_rs |
Part of the extrinsic curvature tensor numericalty computed for the black hole. More... | |
Sym_tensor | taij_auto |
Part of the extrinsic curvature tensor generated by the black hole. More... | |
Sym_tensor | taij_comp |
Part of the extrinsic curvature tensor generated by the companion star. More... | |
Scalar | taij_quad_tot_rs |
Part of the scalar from the numerical computation. More... | |
Scalar | taij_quad_tot_rot |
Part of the scalar from the rotation shift vector. More... | |
Scalar | taij_quad_tot_bh |
Part of the scalar from the analytic background. More... | |
Scalar | taij_quad_tot |
Total scalar generated by . More... | |
Scalar | taij_quad_auto |
Part of the scalar from the black hole. More... | |
Scalar | taij_quad_comp |
Part of the scalar from the companion star. More... | |
double * | p_mass_irr_bhns |
double * | p_spin_am_bhns |
Irreducible mass of BH. More... | |
Map & | mp |
Mapping associated with the black hole. More... | |
bool | kerrschild |
true for a Kerr-Schild background, false for a conformally flat background More... | |
double | mass_bh |
Gravitational mass of BH. More... | |
Scalar | lapconf |
A function (lapse function * conformal factor) lapconf generated by the black hole. More... | |
Scalar | lapconf_rs |
Part of lapconf from the numerical computation. More... | |
Scalar | lapconf_bh |
Part of lapconf from the analytic background. More... | |
Scalar | lapse |
Lapse function generated by the black hole. More... | |
Vector | shift |
Shift vector generated by the black hole. More... | |
Vector | shift_rs |
Part of the shift vector from the numerical computation. More... | |
Vector | shift_bh |
Part of the shift vector from the analytic background. More... | |
Scalar | confo |
Conformal factor generated by the black hole. More... | |
Sym_tensor | taij |
Trace of the extrinsic curvature. More... | |
Sym_tensor | taij_rs |
Part of the extrinsic curvature tensor. More... | |
Scalar | taij_quad |
Part of the scalar generated by . More... | |
Scalar | taij_quad_rs |
Part of the scalar. More... | |
Metric_flat | flat |
Flat metric defined on the mapping (Spherical components with respect to the mapping of the black hole ). More... | |
double * | p_mass_irr |
Conformal metric . More... | |
double * | p_mass_adm |
Irreducible mass of the black hole. More... | |
double * | p_mass_kom |
ADM mass. More... | |
double * | p_rad_ah |
Komar mass. More... | |
double * | p_spin_am_bh |
Radius of the apparent horizon. More... | |
Tbl * | p_angu_mom_bh |
Spin angular momentum. More... | |
Friends | |
class | Bin_bhns |
Class for black holes in black hole-neutron star binaries.
()
Definition at line 65 of file hole_bhns.h.
Lorene::Hole_bhns::Hole_bhns | ( | Map & | mp_i, |
bool | kerrschild_i, | ||
bool | bc_lapconf_nd, | ||
bool | bc_lapconf_fs, | ||
bool | irrotational, | ||
double | massbh | ||
) |
Standard constructor.
mp_i | Mapping on which the black hole will be defined |
Definition at line 71 of file hole_bhns.C.
References confo_auto, confo_auto_bh, confo_auto_rs, confo_comp, confo_tot, d_confo_auto, d_confo_auto_bh, d_confo_auto_rs, d_confo_comp, d_lapconf_auto, d_lapconf_auto_bh, d_lapconf_auto_rs, d_lapconf_comp, d_shift_auto, d_shift_auto_bh, d_shift_auto_rs, d_shift_comp, lapconf_auto, lapconf_auto_bh, lapconf_auto_rs, lapconf_comp, lapconf_tot, lapse_auto, lapse_tot, omega_spin, set_der_0x0(), Lorene::Tensor::set_etat_zero(), shift_auto, shift_auto_bh, shift_auto_rs, shift_comp, shift_tot, Lorene::Scalar::std_spectral_base(), taij_auto, taij_auto_rs, taij_comp, taij_quad_auto, taij_quad_comp, taij_quad_tot, taij_quad_tot_bh, taij_quad_tot_rot, taij_quad_tot_rs, taij_tot, taij_tot_bh, taij_tot_rot, and taij_tot_rs.
Lorene::Hole_bhns::Hole_bhns | ( | const Hole_bhns & | hole | ) |
Lorene::Hole_bhns::Hole_bhns | ( | Map & | mp_i, |
FILE * | fich | ||
) |
Constructor from a file (see sauve(FILE*)
)
mp_i | Mapping on which the black hole will be defined |
fich | input file (must have been created by the function sauve ) |
Definition at line 254 of file hole_bhns.C.
References bc_lapconf_fs, bc_lapconf_nd, confo_auto, confo_auto_bh, confo_comp, confo_tot, d_confo_auto, d_confo_auto_bh, d_confo_auto_rs, d_confo_comp, d_lapconf_auto, d_lapconf_auto_bh, d_lapconf_auto_rs, d_lapconf_comp, d_shift_auto, d_shift_auto_bh, d_shift_auto_rs, d_shift_comp, irrotational, lapconf_auto, lapconf_auto_bh, lapconf_comp, lapconf_tot, lapse_auto, lapse_tot, omega_spin, set_der_0x0(), Lorene::Tensor::set_etat_zero(), shift_auto, shift_auto_bh, shift_comp, shift_tot, Lorene::Scalar::std_spectral_base(), taij_auto, taij_auto_rs, taij_comp, taij_quad_auto, taij_quad_comp, taij_quad_tot, taij_quad_tot_bh, taij_quad_tot_rot, taij_quad_tot_rs, taij_tot, taij_tot_bh, taij_tot_rot, and taij_tot_rs.
|
virtual |
|
inherited |
Total angular momentum.
Definition at line 637 of file blackhole_global.C.
References Lorene::Tensor::annule_domain(), Lorene::Tbl::annule_hard(), Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::dec_dzpuis(), Lorene::Map::get_bvect_cart(), Lorene::Map_af::integrale_surface(), Lorene::Black_hole::mp, Lorene::Black_hole::p_angu_mom_bh, Lorene::Scalar::raccord(), Lorene::Tbl::set(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::Scalar::std_spectral_base(), Lorene::Black_hole::taij, Lorene::Map::val_r(), Lorene::Map::x, Lorene::Map::y, and Lorene::Map::z.
|
inherited |
Boundary condition on the apparent horizon of the black hole for the conformal factor: 2-D Valeur
.
Definition at line 413 of file blackhole_bc.C.
References Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::dsdr(), Lorene::Mg3d::get_angu(), Lorene::Scalar::get_dzpuis(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Valeur::set(), Lorene::Scalar::set_dzpuis(), Lorene::Black_hole::shift, Lorene::Map::sinp, Lorene::Map::sint, Lorene::Valeur::std_base_scal(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
const Valeur Lorene::Hole_bhns::bc_confo | ( | double | ome_orb, |
double | x_rot, | ||
double | y_rot | ||
) | const |
Boundary condition on the apparent horizon of the black hole for the conformal factor: 2-D Valeur
.
ome_orb | orbital angular velocity |
x_rot | position of the rotation axis |
Definition at line 506 of file hole_bhns_bc.C.
References bc_lapconf_fs, bc_lapconf_nd, confo_auto_rs, confo_comp, confo_tot, Lorene::Map::cosp, Lorene::Map::cost, d_confo_comp, d_shift_comp, Lorene::Scalar::dec_dzpuis(), Lorene::Scalar::dsdr(), Lorene::Mg3d::get_angu(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Valeur::set(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), shift_auto_rs, shift_comp, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Valeur::std_base_scal(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
|
inherited |
Boundary condition on the apparent horizon of the black hole for the lapse function: 2-D Valeur
.
Definition at line 74 of file blackhole_bc.C.
References Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mp, Lorene::Map::r, Lorene::Valeur::set(), Lorene::Valeur::std_base_scal(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
const Valeur Lorene::Hole_bhns::bc_lapconf | ( | ) | const |
Boundary condition on the apparent horizon of the black hole for the lapconf function: 2-D Valeur
.
Definition at line 71 of file hole_bhns_bc.C.
References bc_lapconf_fs, bc_lapconf_nd, Lorene::Map::cosp, Lorene::Map::cost, d_lapconf_comp, Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Scalar::inc_dzpuis(), Lorene::Black_hole::kerrschild, lapconf_auto_rs, lapconf_comp, Lorene::Black_hole::mp, Lorene::Map::r, Lorene::Valeur::set(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::Valeur::std_base_scal(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
|
inherited |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur
.
Definition at line 214 of file blackhole_bc.C.
References Lorene::Valeur::base, Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Valeur::set(), Lorene::Map::sint, Lorene::Mg3d::std_base_vect_cart(), Lorene::Scalar::std_spectral_base(), Lorene::Scalar::val_grid_point(), and Lorene::Map::y.
const Valeur Lorene::Hole_bhns::bc_shift_x | ( | double | ome_orb, |
double | y_rot | ||
) | const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur
.
Definition at line 186 of file hole_bhns_bc.C.
References Lorene::Valeur::base, bc_lapconf_fs, bc_lapconf_nd, confo_tot, Lorene::Map::cosp, Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Map::get_ori_y(), Lorene::Black_hole::kerrschild, lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, omega_spin, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Valeur::set(), shift_comp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Mg3d::std_base_vect_cart(), Lorene::Scalar::std_spectral_base(), Lorene::Scalar::val_grid_point(), and Lorene::Map::y.
|
inherited |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur
.
Definition at line 284 of file blackhole_bc.C.
References Lorene::Valeur::base, Lorene::Black_hole::confo, Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Valeur::set(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::Mg3d::std_base_vect_cart(), Lorene::Scalar::std_spectral_base(), Lorene::Scalar::val_grid_point(), and Lorene::Map::x.
const Valeur Lorene::Hole_bhns::bc_shift_y | ( | double | ome_orb, |
double | x_rot | ||
) | const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur
.
Definition at line 296 of file hole_bhns_bc.C.
References Lorene::Valeur::base, bc_lapconf_fs, bc_lapconf_nd, confo_tot, Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Map::get_ori_x(), Lorene::Black_hole::kerrschild, lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, omega_spin, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Valeur::set(), shift_comp, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Mg3d::std_base_vect_cart(), Lorene::Scalar::std_spectral_base(), Lorene::Scalar::val_grid_point(), and Lorene::Map::x.
const Valeur Lorene::Hole_bhns::bc_shift_z | ( | ) | const |
Boundary condition on the apparent horizon of the black hole for the shift vector of the direction: 2-D Valeur
.
Definition at line 406 of file hole_bhns_bc.C.
References Lorene::Valeur::base, bc_lapconf_fs, bc_lapconf_nd, confo_tot, Lorene::Map::cost, Lorene::Mg3d::get_angu(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Valeur::set(), shift_comp, Lorene::sqrt(), Lorene::Mg3d::std_base_vect_cart(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
|
protectedvirtual |
Deletes all the derived quantities.
Reimplemented from Lorene::Black_hole.
Definition at line 395 of file hole_bhns.C.
References Lorene::Black_hole::del_deriv(), p_spin_am_bhns, and set_der_0x0().
void Lorene::Hole_bhns::equilibrium_bhns | ( | int | mer, |
int | mermax_bh, | ||
int | filter_r, | ||
int | filter_r_s, | ||
int | filter_p_s, | ||
double | x_rot, | ||
double | y_rot, | ||
double | precis, | ||
double | omega_orb, | ||
double | resize_bh, | ||
const Tbl & | fact_resize, | ||
Tbl & | diff | ||
) |
Computes a black-hole part in a black hole-neutron star binary by giving boundary conditions on the apparent horizon.
mer | [input] Number of iteration |
mermax_bh | [input] Maximum number of iteration steps |
filter_r | [input] No. points to be deleted for (r): lap,conf |
filter_r_s | [input] No. points to be deleted for (r): shift |
filter_p_s | [input] No. points to be deleted for (phi): shift |
x_rot | [input] Position of the rotation axis |
y_rot | [input] Position of the rotation axis |
precis | [input] threshold in the relative difference of a metric quantity between two succesive steps to stop the iterative procedure (default value: 1.e-14) |
omega_orb | [input] Orbital angular velocity |
resize_bh | [input] Resize factor for the first shell |
fact_resize | [input] 1-D Tbl for the input of some factors : \ fact(0) : A resizing factor for the first shell |
diff | [output] 1-D Tbl for the storage of some error indicators : |
Definition at line 72 of file hole_bhns_equilibrium.C.
References Lorene::Tensor::annule_domain(), bc_lapconf_fs, bc_lapconf_nd, confo_auto_rs, confo_comp, confo_tot, Lorene::Map::cosp, Lorene::Map::cost, d_confo_comp, d_lapconf_comp, Lorene::Scalar::deriv(), Lorene::Mg3d::get_angu(), Lorene::Map::get_bvect_cart(), Lorene::Scalar::get_etat(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Scalar::inc_dzpuis(), Lorene::Black_hole::kerrschild, lapconf_auto_rs, lapconf_comp, lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Scalar::raccord(), Lorene::Map::resize(), Lorene::Tbl::set(), Lorene::Vector::set(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), shift_auto_rs, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), taij_quad_auto, taij_quad_comp, and Lorene::Map::val_r().
|
inherited |
Computes a spherical, static black-hole by giving boundary conditions on the apparent horizon.
neumann | [input] true for the neumann bc, false for the dirichlet one for the lapse |
first | [input] true for the first type of bc, false for the second type |
spin_omega | [input] spin parameter of the black hole |
precis | [input] threshold in the relative difference of a metric quantity between two succesive steps to stop the iterative procedure (default value: 1.e-14) |
precis_shift | [input] threshold in the relative difference of the shift vector between two succesive steps to stop the iterative procedure (default value: 1.e-8) |
Definition at line 73 of file blackhole_eq_spher.C.
References Lorene::Tensor::annule_domain(), Lorene::Black_hole::bc_confo(), Lorene::Black_hole::bc_lapconf(), Lorene::Black_hole::confo, Lorene::contract(), Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::deriv(), Lorene::Black_hole::extr_curv_bh(), Lorene::Mg3d::get_angu(), Lorene::Map::get_bvect_cart(), Lorene::Scalar::get_dzpuis(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), Lorene::Scalar::inc_dzpuis(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::lapconf_bh, Lorene::Black_hole::lapconf_rs, Lorene::Black_hole::lapse, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::Scalar::poisson_dirichlet(), Lorene::Scalar::poisson_neumann(), Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Scalar::raccord(), Lorene::Vector::set(), Lorene::Tensor::set(), Lorene::Scalar::set_dzpuis(), Lorene::Scalar::set_etat_qcq(), Lorene::Tensor::set_etat_qcq(), Lorene::Tensor::set_etat_zero(), Lorene::Black_hole::shift, Lorene::Black_hole::shift_bh, Lorene::Black_hole::shift_rs, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Vector::std_spectral_base(), Lorene::Scalar::std_spectral_base(), Lorene::Black_hole::taij, and Lorene::Black_hole::taij_quad.
|
inherited |
Computes taij
, taij_quad
from shift
, lapse
, confo
.
Definition at line 65 of file blackhole_extr_curv.C.
References Lorene::Tensor::annule_domain(), Lorene::Metric_flat::con(), Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Metric_flat::cov(), Lorene::Black_hole::flat, Lorene::Map::get_bvect_cart(), Lorene::Scalar::inc_dzpuis(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Scalar::raccord(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Black_hole::shift, Lorene::Black_hole::shift_rs, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Tensor::std_spectral_base(), Lorene::Scalar::std_spectral_base(), Lorene::Black_hole::taij, Lorene::Black_hole::taij_quad, Lorene::Black_hole::taij_quad_rs, and Lorene::Black_hole::taij_rs.
void Lorene::Hole_bhns::extr_curv_bhns | ( | double | omega_orb, |
double | x_rot, | ||
double | y_rot | ||
) |
Computes taij_tot
, taij_quad_tot
from shift_tot
, lapse_tot
, confo_tot
.
omega_orb | [input] Orbital angular velocity |
x_rot | [input] Position of the rotation axis |
Definition at line 66 of file hole_bhns_extr_curv.C.
References Lorene::Tensor::annule_domain(), bc_lapconf_fs, bc_lapconf_nd, Lorene::Metric_flat::con(), confo_tot, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Metric_flat::cov(), d_shift_comp, Lorene::Black_hole::flat, Lorene::Map::get_bvect_cart(), Lorene::Map::get_ori_x(), Lorene::Map::get_ori_y(), Lorene::Tensor::inc_dzpuis(), Lorene::Scalar::inc_dzpuis(), Lorene::Black_hole::kerrschild, lapconf_auto, lapconf_auto_bh, lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), shift_auto_rs, shift_comp, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Tensor::std_spectral_base(), Lorene::Scalar::std_spectral_base(), taij_quad_tot, taij_quad_tot_bh, taij_quad_tot_rot, taij_quad_tot_rs, taij_tot, taij_tot_bh, taij_tot_rot, and taij_tot_rs.
|
inlineinherited |
Returns the conformal factor generated by the black hole.
Definition at line 241 of file blackhole.h.
References Lorene::Black_hole::confo.
|
inline |
Returns the part of the conformal factor generated by the black hole.
Definition at line 439 of file hole_bhns.h.
References confo_auto.
|
inline |
Returns the part of the conformal factor from numerical computation.
Definition at line 434 of file hole_bhns.h.
References confo_auto_rs.
|
inline |
Returns the part of the conformal factor generated by the companion star.
Definition at line 444 of file hole_bhns.h.
References confo_comp.
|
inline |
Returns the total conformal factor.
Definition at line 447 of file hole_bhns.h.
References confo_tot.
|
inline |
Returns the derivative of the conformal factor generated by the black hole.
Definition at line 457 of file hole_bhns.h.
References d_confo_auto.
|
inline |
Returns the derivative of the conformal factor generated by the black hole.
Definition at line 452 of file hole_bhns.h.
References d_confo_auto_rs.
|
inline |
Returns the derivative of the conformal factor generated by the companion star.
Definition at line 462 of file hole_bhns.h.
References d_confo_comp.
|
inline |
Returns the derivative of the lapconf function generated by the black hole.
Definition at line 397 of file hole_bhns.h.
References d_lapconf_auto.
|
inline |
Returns the derivative of the lapconf function generated by the black hole.
Definition at line 391 of file hole_bhns.h.
References d_lapconf_auto_rs.
|
inline |
Returns the derivative of the lapconf function generated by the companion star.
Definition at line 402 of file hole_bhns.h.
References d_lapconf_comp.
|
inline |
Returns the derivative of the shift vector generated by the black hole.
Definition at line 426 of file hole_bhns.h.
References d_shift_auto.
|
inline |
Returns the derivative of the shift vector generated by the black hole.
Definition at line 421 of file hole_bhns.h.
References d_shift_auto_rs.
|
inline |
Returns the derivative of the shift vector generated by the companion star.
Definition at line 431 of file hole_bhns.h.
References d_shift_comp.
|
inlineinherited |
Returns lapconf generated by the black hole.
Definition at line 224 of file blackhole.h.
References Lorene::Black_hole::lapconf.
|
inline |
Returns the part of the lapconf function generated by the black hole.
Definition at line 370 of file hole_bhns.h.
References lapconf_auto.
|
inline |
Returns the part of the lapconf function from numerical computation.
Definition at line 365 of file hole_bhns.h.
References lapconf_auto_rs.
|
inline |
Returns the part of the lapconf function generated by the companion star.
Definition at line 375 of file hole_bhns.h.
References lapconf_comp.
|
inlineinherited |
Returns the part of lapconf from the numerical computation.
Definition at line 227 of file blackhole.h.
References Lorene::Black_hole::lapconf_rs.
|
inline |
Returns the total lapconf function.
Definition at line 378 of file hole_bhns.h.
References lapconf_tot.
|
inlineinherited |
Returns the lapse function generated by the black hole.
Definition at line 230 of file blackhole.h.
References Lorene::Black_hole::lapse.
|
inline |
Returns the part of the lapse function generated by the black hole.
Definition at line 383 of file hole_bhns.h.
References lapse_auto.
|
inline |
|
inlineinherited |
Returns the gravitational mass of BH [{ m_unit}].
Definition at line 221 of file blackhole.h.
References Lorene::Black_hole::mass_bh.
|
inlineinherited |
|
inline |
Returns the spin angular velocity of the black hole [{ f_unit}].
Definition at line 362 of file hole_bhns.h.
References omega_spin.
|
inlineinherited |
Returns the shift vector generated by the black hole.
Definition at line 233 of file blackhole.h.
References Lorene::Black_hole::shift.
|
inline |
Returns the part of the shift vector generated by the black hole.
Definition at line 408 of file hole_bhns.h.
References shift_auto.
|
inline |
Returns the part of the shift vector from numerical computation.
Definition at line 405 of file hole_bhns.h.
References shift_auto_rs.
|
inline |
Returns the part of the shift vector generated by the companion star.
Definition at line 413 of file hole_bhns.h.
References shift_comp.
|
inlineinherited |
Returns the part of the shift vector from the numerical computation.
Definition at line 238 of file blackhole.h.
References Lorene::Black_hole::shift_rs.
|
inline |
|
inline |
Returns the part of the extrinsic curvature tensor generated by the black hole.
Definition at line 478 of file hole_bhns.h.
References taij_auto.
|
inline |
Returns the part of rs of the extrinsic curvature tensor generated by the black hole.
Definition at line 473 of file hole_bhns.h.
References taij_auto_rs.
|
inline |
Returns the part of the extrinsic curvature tensor generated by the companion star.
Definition at line 483 of file hole_bhns.h.
References taij_comp.
|
inline |
Returns the part of rs generated by the black hole.
Definition at line 494 of file hole_bhns.h.
References taij_quad_auto.
|
inline |
Returns the part of rs generated by the companion star.
Definition at line 497 of file hole_bhns.h.
References taij_quad_comp.
|
inline |
|
inline |
|
inline |
|
inline |
Returns the total extrinsic curvature tensor.
Definition at line 468 of file hole_bhns.h.
References taij_tot.
|
inline |
Returns the part of rs of the extrinsic curvature tensor.
Definition at line 465 of file hole_bhns.h.
References taij_tot_rs.
|
inline |
Returns true
for the first type BC for the lapconf function, false
for the second type BH.
Definition at line 354 of file hole_bhns.h.
References bc_lapconf_fs.
|
inline |
Returns true
for the Neumann type BC for the lapconf function, false
for the Dirichlet type BH.
Definition at line 349 of file hole_bhns.h.
References bc_lapconf_nd.
|
inline |
Returns true
for an irrotational black hole, false
for a corotating one.
Definition at line 359 of file hole_bhns.h.
References irrotational.
|
inlineinherited |
Returns true
for a Kerr-Schild background, false
for a Conformally flat one.
Definition at line 218 of file blackhole.h.
References Lorene::Black_hole::kerrschild.
Vector Lorene::Hole_bhns::killing_vect | ( | const Tbl & | xi_i, |
const double & | phi_i, | ||
const double & | theta_i, | ||
const int & | nrk_phi, | ||
const int & | nrk_theta | ||
) | const |
Compute the Killing vector of a black hole normalized so that its affine length is 2 M_PI.
xi_i | [input] initial set of the Killing vectors at the starting point on the equator |
phi_i | [input] initial phi coordinate at which the integration starts |
theta_i | [input] initial theta coordinate at which the integration starts |
nrk_phi | [input] number of the Runge-Kutta integration between two successive collocation points for the phi direction |
nrk_theta | [input] number of the Runge-Kutta integration between two successive collocation points for the theta direction |
Definition at line 69 of file hole_bhns_killing.C.
References confo_tot, Lorene::Scalar::dsdt(), Lorene::Map::get_bvect_spher(), Lorene::Tbl::get_dim(), Lorene::Map::get_mg(), Lorene::Tbl::get_ndim(), Lorene::Mg3d::get_nr(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::rad_ah(), runge_kutta_phi(), runge_kutta_theta(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::set_grid_point(), Lorene::Map::sint, Lorene::Scalar::std_spectral_base(), Lorene::Scalar::stdsdp(), Lorene::Scalar::val_grid_point(), and Lorene::Scalar::val_point().
|
inherited |
Compute the Killing vector of a black hole normalized so that its affine length is 2 M_PI.
xi_i | [input] initial set of the Killing vectors at the starting point on the equator |
phi_i | [input] initial phi coordinate at which the integration starts |
theta_i | [input] initial theta coordinate at which the integration starts |
nrk_phi | [input] number of the Runge-Kutta integration between two successive collocation points for the phi direction |
nrk_theta | [input] number of the Runge-Kutta integration between two successive collocation points for the theta direction |
Definition at line 69 of file blackhole_killing.C.
References Lorene::Black_hole::confo, Lorene::Map::get_bvect_spher(), Lorene::Tbl::get_dim(), Lorene::Map::get_mg(), Lorene::Tbl::get_ndim(), Lorene::Mg3d::get_nr(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::rad_ah(), Lorene::Black_hole::runge_kutta_phi_bh(), Lorene::Black_hole::runge_kutta_theta_bh(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::set_grid_point(), Lorene::Map::sint, Lorene::Scalar::std_spectral_base(), Lorene::Scalar::val_grid_point(), and Lorene::Scalar::val_point().
|
virtualinherited |
ADM mass.
Definition at line 106 of file blackhole_global.C.
References Lorene::Tensor::annule_domain(), Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::dec_dzpuis(), Lorene::Scalar::dsdr(), Lorene::Map::get_bvect_cart(), Lorene::Scalar::integrale(), Lorene::Map_af::integrale_surface(), Lorene::Map_af::integrale_surface_infini(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mp, Lorene::Black_hole::p_mass_adm, Lorene::pow(), Lorene::Map::r, Lorene::Scalar::raccord(), Lorene::Tensor::set(), Lorene::Scalar::set_etat_qcq(), Lorene::Tensor::set_etat_qcq(), Lorene::Black_hole::shift, Lorene::Map::sinp, Lorene::Map::sint, Lorene::Scalar::std_spectral_base(), Lorene::Black_hole::taij_quad, and Lorene::Map::val_r().
|
virtualinherited |
Irreducible mass of the black hole.
Definition at line 72 of file blackhole_global.C.
References Lorene::Tensor::annule_domain(), Lorene::Black_hole::confo, Lorene::Map_af::integrale_surface(), Lorene::Black_hole::mp, Lorene::Black_hole::p_mass_irr, Lorene::pow(), Lorene::Scalar::raccord(), Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), and Lorene::Map::val_r().
|
virtual |
Irreducible mass of the black hole.
Definition at line 72 of file hole_bhns_global.C.
References Lorene::Tensor::annule_domain(), confo_tot, Lorene::Map_af::integrale_surface(), Lorene::Black_hole::mp, Lorene::pow(), Lorene::Scalar::raccord(), Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), and Lorene::Map::val_r().
|
virtualinherited |
Komar mass.
Definition at line 292 of file blackhole_global.C.
References Lorene::Tensor::annule_domain(), Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::dec_dzpuis(), Lorene::Scalar::deriv(), Lorene::Scalar::dsdr(), Lorene::Map::get_bvect_cart(), Lorene::Scalar::integrale(), Lorene::Map_af::integrale_surface(), Lorene::Map_af::integrale_surface_infini(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::mp, Lorene::Black_hole::p_mass_kom, Lorene::pow(), Lorene::Map::r, Lorene::Scalar::raccord(), Lorene::Tensor::set(), Lorene::Scalar::set_etat_qcq(), Lorene::Tensor::set_etat_qcq(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::Scalar::std_spectral_base(), Lorene::Black_hole::taij_quad, and Lorene::Map::val_r().
void Lorene::Hole_bhns::operator= | ( | const Hole_bhns & | hole | ) |
Assignment to another Hole_bhns
.
Definition at line 422 of file hole_bhns.C.
References bc_lapconf_fs, bc_lapconf_nd, confo_auto, confo_auto_bh, confo_auto_rs, confo_comp, confo_tot, d_confo_auto, d_confo_auto_bh, d_confo_auto_rs, d_confo_comp, d_lapconf_auto, d_lapconf_auto_bh, d_lapconf_auto_rs, d_lapconf_comp, d_shift_auto, d_shift_auto_bh, d_shift_auto_rs, d_shift_comp, del_deriv(), irrotational, lapconf_auto, lapconf_auto_bh, lapconf_auto_rs, lapconf_comp, lapconf_tot, lapse_auto, lapse_tot, omega_spin, Lorene::Black_hole::operator=(), shift_auto, shift_auto_bh, shift_auto_rs, shift_comp, shift_tot, taij_auto, taij_auto_rs, taij_comp, taij_quad_auto, taij_quad_comp, taij_quad_tot, taij_quad_tot_bh, taij_quad_tot_rot, taij_quad_tot_rs, taij_tot, taij_tot_bh, taij_tot_rot, and taij_tot_rs.
|
protectedvirtual |
Operator >> (virtual function called by the operator <<)
Reimplemented from Lorene::Black_hole.
Definition at line 623 of file hole_bhns.C.
References confo_tot, Lorene::Map::get_mg(), Lorene::Mg3d::get_nt(), lapse_tot, Lorene::Black_hole::mass_bh, mass_irr_bhns(), Lorene::Black_hole::mp, omega_spin, Lorene::Black_hole::rad_ah(), shift_tot, and Lorene::Scalar::val_grid_point().
|
inherited |
Expresses the areal radial coordinate by that in spatially isotropic coordinates.
neumann | [input] true for the neumann bc, false for the dirichlet one for the lapse |
first | [input] true for the first type of bc, false for the second type |
Definition at line 69 of file blackhole_r_coord.C.
References Lorene::Tensor::annule_domain(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), Lorene::log(), Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::Map::r, Lorene::Scalar::raccord(), Lorene::Scalar::set_grid_point(), Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
|
virtualinherited |
Radius of the apparent horizon.
Definition at line 508 of file blackhole_global.C.
References Lorene::Black_hole::mp, Lorene::Black_hole::p_rad_ah, Lorene::Map::r, Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_grid_point().
|
inherited |
Computes a radius of apparent horizon (excised surface) in isotropic coordinates.
neumann | [input] true for the neumann bc, false for the dirichlet one for the lapse |
first | [input] true for the first type of bc, false for the second type |
Definition at line 72 of file blackhole_rah_iso.C.
References Lorene::exp(), and Lorene::sqrt().
void Lorene::Hole_bhns::relax_bhns | ( | const Hole_bhns & | hole_prev, |
double | relax_met, | ||
int | mer, | ||
int | fmer_met | ||
) |
Performs a relaxation on lapse_auto
, shift_auto
, confo_auto
.
hole_prev | [input] black hole at the previous step |
relax_met | [input] Relaxation factor for lapse_auto , shift_auto , confo_auto , only if (merfmer_met=0) . |
mer | [input] Step number |
fmer_met | [input] Step interval between metric updates |
Definition at line 662 of file hole_bhns.C.
References confo_auto_rs, del_deriv(), lapconf_auto_rs, and shift_auto_rs.
Tbl Lorene::Hole_bhns::runge_kutta_phi | ( | const Tbl & | xi_i, |
const double & | phi_i, | ||
const int & | nrk | ||
) | const |
Compute a forth-order Runge-Kutta integration to the phi direction for the solution of the Killing vectors on the equator.
xi_i | [input] initial set of the Killing vectors at the starting point on the equator |
phi_i | [input] initial phi coordinate at which the integration starts |
nrk | [input] number of the Runge-Kutta integration between two successive collocation points |
Definition at line 70 of file hole_bhns_rk_phi.C.
References confo_tot, Lorene::Scalar::dsdt(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Black_hole::kerrschild, Lorene::Scalar::lapang(), Lorene::Black_hole::mp, Lorene::Black_hole::rad_ah(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_point().
|
inherited |
Compute a forth-order Runge-Kutta integration to the phi direction for the solution of the Killing vectors on the equator.
xi_i | [input] initial set of the Killing vectors at the starting point on the equator |
phi_i | [input] initial phi coordinate at which the integration starts |
nrk | [input] number of the Runge-Kutta integration between two successive collocation points |
Definition at line 70 of file blackhole_rk_phi.C.
References Lorene::Black_hole::confo, Lorene::Scalar::dsdt(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Black_hole::kerrschild, Lorene::Scalar::lapang(), Lorene::Black_hole::mp, Lorene::Black_hole::rad_ah(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::std_spectral_base(), and Lorene::Scalar::val_point().
Tbl Lorene::Hole_bhns::runge_kutta_theta | ( | const Tbl & | xi_i, |
const double & | theta_i, | ||
const double & | phi, | ||
const int & | nrk | ||
) | const |
Compute a forth-order Runge-Kutta integration to the theta direction for the solution of the Killing vectors.
xi_i | [input] initial set of the Killing vectors at the starting point on the equator |
theta_i | [input] initial theta coordinate at which the integration starts |
phi | [input] fixed phi coordinate during integration to the theta direction |
nrk | [input] number of the Runge-Kutta integration between two successive collocation points |
Definition at line 70 of file hole_bhns_rk_theta.C.
References confo_tot, Lorene::Map::get_mg(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, Lorene::Scalar::lapang(), Lorene::Black_hole::mp, Lorene::Black_hole::rad_ah(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::std_spectral_base(), Lorene::Scalar::stdsdp(), and Lorene::Scalar::val_point().
|
inherited |
Compute a forth-order Runge-Kutta integration to the theta direction for the solution of the Killing vectors.
xi_i | [input] initial set of the Killing vectors at the starting point on the equator |
theta_i | [input] initial theta coordinate at which the integration starts |
phi | [input] fixed phi coordinate during integration to the theta direction |
nrk | [input] number of the Runge-Kutta integration between two successive collocation points |
Definition at line 70 of file blackhole_rk_theta.C.
References Lorene::Black_hole::confo, Lorene::Map::get_mg(), Lorene::Mg3d::get_nt(), Lorene::Black_hole::kerrschild, Lorene::Scalar::lapang(), Lorene::Black_hole::mp, Lorene::Black_hole::rad_ah(), Lorene::Tbl::set(), Lorene::Tbl::set_etat_qcq(), Lorene::Scalar::std_spectral_base(), Lorene::Scalar::stdsdp(), and Lorene::Scalar::val_point().
|
virtual |
Save in a file.
Reimplemented from Lorene::Black_hole.
Definition at line 606 of file hole_bhns.C.
References bc_lapconf_fs, bc_lapconf_nd, confo_auto_rs, irrotational, lapconf_auto_rs, omega_spin, Lorene::Black_hole::sauve(), Lorene::Tensor::sauve(), Lorene::Scalar::sauve(), and shift_auto_rs.
Scalar & Lorene::Hole_bhns::set_confo_auto | ( | ) |
Read/write of the conformal factor generated by the black hole.
Definition at line 578 of file hole_bhns.C.
References confo_auto, and del_deriv().
Scalar & Lorene::Hole_bhns::set_confo_auto_bh | ( | ) |
Read/write of the conformal factor generated by the black hole.
Definition at line 571 of file hole_bhns.C.
References confo_auto_bh, and del_deriv().
Scalar & Lorene::Hole_bhns::set_confo_auto_rs | ( | ) |
Read/write of the conformal factor generated by the black hole.
Definition at line 564 of file hole_bhns.C.
References confo_auto_rs, and del_deriv().
Scalar & Lorene::Hole_bhns::set_confo_comp | ( | ) |
Read/write of the conformal factor generated by the companion star.
Definition at line 585 of file hole_bhns.C.
References confo_comp, and del_deriv().
Scalar & Lorene::Hole_bhns::set_confo_tot | ( | ) |
Read/write of the total conformal factor.
Definition at line 592 of file hole_bhns.C.
References confo_tot, and del_deriv().
|
protected |
Sets to 0x0
all the pointers on derived quantities.
Definition at line 406 of file hole_bhns.C.
References p_spin_am_bhns, and Lorene::Black_hole::set_der_0x0().
Scalar & Lorene::Hole_bhns::set_lapconf_auto | ( | ) |
Read/write of the lapconf function generated by the black hole.
Definition at line 494 of file hole_bhns.C.
References del_deriv(), and lapconf_auto.
Scalar & Lorene::Hole_bhns::set_lapconf_auto_bh | ( | ) |
Read/write of the lapconf function generated by the black hole.
Definition at line 487 of file hole_bhns.C.
References del_deriv(), and lapconf_auto_bh.
Scalar & Lorene::Hole_bhns::set_lapconf_auto_rs | ( | ) |
Read/write of the lapconf function generated by the black hole.
Definition at line 480 of file hole_bhns.C.
References del_deriv(), and lapconf_auto_rs.
Scalar & Lorene::Hole_bhns::set_lapconf_comp | ( | ) |
Read/write of the lapconf function generated by the companion star.
Definition at line 501 of file hole_bhns.C.
References del_deriv(), and lapconf_comp.
Scalar & Lorene::Hole_bhns::set_lapconf_tot | ( | ) |
Read/write of the total lapconf function.
Definition at line 508 of file hole_bhns.C.
References del_deriv(), and lapconf_tot.
Scalar & Lorene::Hole_bhns::set_lapse_auto | ( | ) |
Read/write of the lapse function generated by the black hole.
Definition at line 515 of file hole_bhns.C.
References del_deriv(), and lapse_auto.
Scalar & Lorene::Hole_bhns::set_lapse_tot | ( | ) |
Read/write of the total lapse function.
Definition at line 522 of file hole_bhns.C.
References del_deriv(), and lapse_tot.
|
inlineinherited |
Read/write of the gravitational mass of BH [{ m_unit}].
Definition at line 207 of file blackhole.h.
References Lorene::Black_hole::mass_bh.
|
inlineinherited |
Read/write of the mapping.
Definition at line 204 of file blackhole.h.
References Lorene::Black_hole::mp.
|
inline |
Sets the spin angular velocity of the black hole [{ f_unit}].
Definition at line 290 of file hole_bhns.h.
References omega_spin.
Vector & Lorene::Hole_bhns::set_shift_auto | ( | ) |
Read/write of the shift vector generated by the black hole.
Definition at line 543 of file hole_bhns.C.
References del_deriv(), and shift_auto.
Vector & Lorene::Hole_bhns::set_shift_auto_bh | ( | ) |
Read/write of the shift vector generated by the black hole.
Definition at line 536 of file hole_bhns.C.
References del_deriv(), and shift_auto_bh.
Vector & Lorene::Hole_bhns::set_shift_auto_rs | ( | ) |
Read/write of the shift vector generated by the black hole.
Definition at line 529 of file hole_bhns.C.
References del_deriv(), and shift_auto_rs.
Vector & Lorene::Hole_bhns::set_shift_comp | ( | ) |
Read/write of the shift vector generated by the companion star.
Definition at line 550 of file hole_bhns.C.
References del_deriv(), and shift_comp.
Vector & Lorene::Hole_bhns::set_shift_tot | ( | ) |
Read/write of the total shift vector.
Definition at line 557 of file hole_bhns.C.
References del_deriv(), and shift_tot.
|
inherited |
Spin angular momentum.
Definition at line 531 of file blackhole_global.C.
References Lorene::Tensor::annule_domain(), Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::dec_dzpuis(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Map_af::integrale_surface(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::killing_vect_bh(), Lorene::Black_hole::mp, Lorene::Black_hole::p_spin_am_bh, Lorene::pow(), Lorene::Scalar::raccord(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::Scalar::std_spectral_base(), Lorene::Black_hole::taij, and Lorene::Map::val_r().
double Lorene::Hole_bhns::spin_am_bhns | ( | const Tbl & | xi_i, |
const double & | phi_i, | ||
const double & | theta_i, | ||
const int & | nrk_phi, | ||
const int & | nrk_theta | ||
) | const |
Spin angular momentum of the black hole.
Definition at line 105 of file hole_bhns_global.C.
References Lorene::Tensor::annule_domain(), bc_lapconf_fs, bc_lapconf_nd, confo_tot, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Scalar::dec_dzpuis(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Map_af::integrale_surface(), Lorene::Black_hole::kerrschild, killing_vect(), lapconf_tot, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, p_spin_am_bhns, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Scalar::raccord(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Scalar::std_spectral_base(), taij_tot_rs, and Lorene::Map::val_r().
|
inherited |
Sets the metric quantities to a spherical, static blach-hole analytic solution.
neumann | [input] true for the neumann bc, false for the dirichlet one for the lapse |
first | [input] true for the first type of bc, false for the second type |
Definition at line 63 of file blackhole_static.C.
References Lorene::Tensor::annule_domain(), Lorene::Black_hole::confo, Lorene::Map::cosp, Lorene::Map::cost, Lorene::Map::get_bvect_cart(), Lorene::Black_hole::kerrschild, Lorene::Black_hole::lapconf, Lorene::Black_hole::lapse, Lorene::Black_hole::mass_bh, Lorene::Black_hole::mp, Lorene::pow(), Lorene::Map::r, Lorene::Black_hole::r_coord(), Lorene::Scalar::raccord(), Lorene::Vector::set(), Lorene::Tensor::set(), Lorene::Tensor::set_etat_qcq(), Lorene::Black_hole::shift, Lorene::Map::sinp, Lorene::Map::sint, Lorene::sqrt(), Lorene::Vector::std_spectral_base(), and Lorene::Scalar::std_spectral_base().
void Lorene::Hole_bhns::update_met_der_comp_bhns | ( | const Star_bhns & | star | ) |
Computes derivative of metric quantities from the companion neutron star.
star | companion neutron star |
Definition at line 63 of file hole_bhns_upmetr_der.C.
References Lorene::Star_bhns::get_d_lapconf_auto().
void Lorene::Hole_bhns::update_metric_bhns | ( | const Star_bhns & | star, |
const Hole_bhns & | hole_prev, | ||
double | relax | ||
) |
Computes metric coefficients from known potentials with relaxation when the companion is a black hole.
The calculation is performed starting from the quantities lapse_auto
, shift_auto
, confo_auto
, comp.lapse_auto
, comp.confo_auto
which are supposed to be up to date. From these, the following fields are updated: lapse_comp
, lapse_tot
, confo_comp
, confo_tot
, psi4
,
star | companion neutron star |
hole_prev | previous value of the hole |
relax | relaxation parameter |
Definition at line 64 of file hole_bhns_upmetr.C.
References Lorene::Star_bhns::get_lapconf_auto(), Lorene::Star::get_mp(), and Lorene::Black_hole::mass_bh.
|
protected |
true
for the first type BC for the lapconf function, false
for the second type BH
Definition at line 78 of file hole_bhns.h.
|
protected |
true
for the Neumann type BC for the lapconf function, false
for the Dirichlet type BH
Definition at line 73 of file hole_bhns.h.
|
protectedinherited |
Conformal factor generated by the black hole.
Definition at line 118 of file blackhole.h.
|
protected |
Conformal factor generated by the black hole.
Definition at line 163 of file hole_bhns.h.
|
protected |
Part of the conformal factor from the analytic background.
Definition at line 160 of file hole_bhns.h.
|
protected |
Part of the conformal factor from the numerical computation.
Definition at line 157 of file hole_bhns.h.
|
protected |
Conformal factor generated by the companion star.
Definition at line 166 of file hole_bhns.h.
|
protected |
Total conformal factor.
Definition at line 169 of file hole_bhns.h.
|
protected |
Derivative of the conformal factor generated by the black hole.
Definition at line 182 of file hole_bhns.h.
|
protected |
Derivative of the part of the conformal factor from the analytic background.
Definition at line 179 of file hole_bhns.h.
|
protected |
Derivative of the part of the conformal factor from the numerical computation.
Definition at line 174 of file hole_bhns.h.
|
protected |
Derivative of the conformal factor generated by the companion star.
Definition at line 185 of file hole_bhns.h.
|
protected |
Derivative of the lapconf function generated by the black hole.
Definition at line 120 of file hole_bhns.h.
|
protected |
Derivative of the part of the lapconf function from the analytic background.
Definition at line 117 of file hole_bhns.h.
|
protected |
Derivative of the part of the lapconf function from the numerical computation.
Definition at line 112 of file hole_bhns.h.
|
protected |
Derivative of the lapconf function generated by the companion star.
Definition at line 123 of file hole_bhns.h.
|
protected |
Derivative of the shift vector generated by the black hole.
Definition at line 151 of file hole_bhns.h.
|
protected |
Derivative of the part of the shift vector from the analytic background.
Definition at line 148 of file hole_bhns.h.
|
protected |
Derivative of the part of the shift vector from the numerical computation.
Definition at line 143 of file hole_bhns.h.
|
protected |
Derivative of the shift vector generated by the companion star.
Definition at line 154 of file hole_bhns.h.
|
protectedinherited |
Flat metric defined on the mapping (Spherical components with respect to the mapping of the black hole ).
Definition at line 143 of file blackhole.h.
|
protected |
true
for an irrotational black hole, false
for a corotating one
Definition at line 83 of file hole_bhns.h.
|
protectedinherited |
true
for a Kerr-Schild background, false
for a conformally flat background
Definition at line 85 of file blackhole.h.
|
protectedinherited |
A function (lapse function * conformal factor) lapconf generated by the black hole.
Definition at line 97 of file blackhole.h.
|
protected |
Lapconf function generated by the black hole.
Definition at line 95 of file hole_bhns.h.
|
protected |
Part of the lapconf function from the analytic background.
Definition at line 92 of file hole_bhns.h.
|
protected |
Part of the lapconf function from the numerical computation.
Definition at line 89 of file hole_bhns.h.
|
protectedinherited |
Part of lapconf from the analytic background.
Definition at line 103 of file blackhole.h.
|
protected |
Lapconf function generated by the companion star.
Definition at line 98 of file hole_bhns.h.
|
protectedinherited |
Part of lapconf from the numerical computation.
Definition at line 100 of file blackhole.h.
|
protected |
Total lapconf function.
Definition at line 101 of file hole_bhns.h.
|
protectedinherited |
Lapse function generated by the black hole.
Definition at line 106 of file blackhole.h.
|
protected |
Lapse function of the "black hole" part.
Definition at line 104 of file hole_bhns.h.
|
protected |
Total lapse function.
Definition at line 107 of file hole_bhns.h.
|
protectedinherited |
Gravitational mass of BH.
Definition at line 88 of file blackhole.h.
|
protectedinherited |
Mapping associated with the black hole.
Definition at line 80 of file blackhole.h.
|
protected |
Spin angular velocity of the black hole.
Definition at line 86 of file hole_bhns.h.
|
mutableprotectedinherited |
Spin angular momentum.
Total angular momentum of the black hole
Definition at line 162 of file blackhole.h.
|
mutableprotectedinherited |
Irreducible mass of the black hole.
Definition at line 153 of file blackhole.h.
|
mutableprotectedinherited |
Conformal metric .
Definition at line 151 of file blackhole.h.
|
mutableprotectedinherited |
ADM mass.
Definition at line 155 of file blackhole.h.
|
mutableprotectedinherited |
Komar mass.
Definition at line 157 of file blackhole.h.
|
mutableprotectedinherited |
Radius of the apparent horizon.
Definition at line 159 of file blackhole.h.
|
mutableprotected |
Irreducible mass of BH.
Quasilocal spin angular momentum of BH
Definition at line 248 of file hole_bhns.h.
|
protectedinherited |
Shift vector generated by the black hole.
Definition at line 109 of file blackhole.h.
|
protected |
Shift vector generated by the black hole.
Definition at line 132 of file hole_bhns.h.
|
protected |
Part of the shift vector from the analytic background.
Definition at line 129 of file hole_bhns.h.
|
protected |
Part of the shift vector from the numerical computation.
Definition at line 126 of file hole_bhns.h.
|
protectedinherited |
Part of the shift vector from the analytic background.
Definition at line 115 of file blackhole.h.
|
protected |
Shift vector generated by the companion star.
Definition at line 135 of file hole_bhns.h.
|
protectedinherited |
Part of the shift vector from the numerical computation.
Definition at line 112 of file blackhole.h.
|
protected |
Total shift vector ;.
Definition at line 138 of file hole_bhns.h.
|
protectedinherited |
Trace of the extrinsic curvature.
Extrinsic curvature tensor generated by shift
, lapse
, and confo
.
Definition at line 127 of file blackhole.h.
|
protected |
Part of the extrinsic curvature tensor generated by the black hole.
Definition at line 216 of file hole_bhns.h.
|
protected |
Part of the extrinsic curvature tensor numericalty computed for the black hole.
Definition at line 211 of file hole_bhns.h.
|
protected |
Part of the extrinsic curvature tensor generated by the companion star.
Definition at line 221 of file hole_bhns.h.
|
protectedinherited |
Part of the scalar generated by .
Definition at line 135 of file blackhole.h.
|
protected |
Part of the scalar from the black hole.
Definition at line 238 of file hole_bhns.h.
|
protected |
Part of the scalar from the companion star.
Definition at line 241 of file hole_bhns.h.
|
protectedinherited |
Part of the scalar.
Definition at line 138 of file blackhole.h.
|
protected |
Total scalar generated by .
Definition at line 235 of file hole_bhns.h.
|
protected |
Part of the scalar from the analytic background.
Definition at line 230 of file hole_bhns.h.
|
protected |
Part of the scalar from the rotation shift vector.
Definition at line 227 of file hole_bhns.h.
|
protected |
Part of the scalar from the numerical computation.
Definition at line 224 of file hole_bhns.h.
|
protectedinherited |
Part of the extrinsic curvature tensor.
Definition at line 130 of file blackhole.h.
|
protected |
Total extrinsic curvature tensor generated by shift_tot
, lapse_tot
, and confo_tot
.
Definition at line 206 of file hole_bhns.h.
|
protected |
Part of the extrinsic curvature tensor from the analytic background.
Definition at line 200 of file hole_bhns.h.
|
protected |
Part of the extrinsic curvature tensor from the rotation shift vector.
Definition at line 195 of file hole_bhns.h.
|
protected |
Part of the extrinsic curvature tensor from the numerical computation.
Definition at line 190 of file hole_bhns.h.