Hole_bhns Class Reference
[Stars and black holes]

Class for black holes in black hole-neutron star binaries. More...

#include <hole_bhns.h>

Inheritance diagram for Hole_bhns:
Black_hole

List of all members.

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.
 Hole_bhns (const Hole_bhns &)
 Copy constructor.
 Hole_bhns (Map &mp_i, FILE *fich)
 Constructor from a file (see sauve(FILE*) ).
virtual ~Hole_bhns ()
 Destructor.
void operator= (const Hole_bhns &)
 Assignment to another Hole_bhns.
double & set_omega_spin ()
 Sets the spin angular velocity of the black hole [{ f}].
Scalarset_lapconf_auto_rs ()
 Read/write of the lapconf function generated by the black hole.
Scalarset_lapconf_auto_bh ()
 Read/write of the lapconf function generated by the black hole.
Scalarset_lapconf_auto ()
 Read/write of the lapconf function generated by the black hole.
Scalarset_lapconf_comp ()
 Read/write of the lapconf function generated by the companion star.
Scalarset_lapconf_tot ()
 Read/write of the total lapconf function.
Scalarset_lapse_auto ()
 Read/write of the lapse function generated by the black hole.
Scalarset_lapse_tot ()
 Read/write of the total lapse function.
Vectorset_shift_auto_rs ()
 Read/write of the shift vector generated by the black hole.
Vectorset_shift_auto_bh ()
 Read/write of the shift vector generated by the black hole.
Vectorset_shift_auto ()
 Read/write of the shift vector generated by the black hole.
Vectorset_shift_comp ()
 Read/write of the shift vector generated by the companion star.
Vectorset_shift_tot ()
 Read/write of the total shift vector.
Scalarset_confo_auto_rs ()
 Read/write of the conformal factor generated by the black hole.
Scalarset_confo_auto_bh ()
 Read/write of the conformal factor generated by the black hole.
Scalarset_confo_auto ()
 Read/write of the conformal factor generated by the black hole.
Scalarset_confo_comp ()
 Read/write of the conformal factor generated by the companion star.
Scalarset_confo_tot ()
 Read/write of the total conformal factor.
bool has_bc_lapconf_nd () const
 Returns true for the Neumann type BC for the lapconf function, false for the Dirichlet type BH.
bool has_bc_lapconf_fs () const
 Returns true for the first type BC for the lapconf function, false for the second type BH.
bool is_irrotational () const
 Returns true for an irrotational black hole, false for a corotating one.
double get_omega_spin () const
 Returns the spin angular velocity of the black hole [{ f}].
const Scalarget_lapconf_auto_rs () const
 Returns the part of the lapconf function from numerical computation.
const Scalarget_lapconf_auto () const
 Returns the part of the lapconf function generated by the black hole.
const Scalarget_lapconf_comp () const
 Returns the part of the lapconf function generated by the companion star.
const Scalarget_lapconf_tot () const
 Returns the total lapconf function.
const Scalarget_lapse_auto () const
 Returns the part of the lapse function generated by the black hole.
const Scalarget_lapse_tot () const
 Returns the total lapse function.
const Vectorget_d_lapconf_auto_rs () const
 Returns the derivative of the lapconf function generated by the black hole.
const Vectorget_d_lapconf_auto () const
 Returns the derivative of the lapconf function generated by the black hole.
const Vectorget_d_lapconf_comp () const
 Returns the derivative of the lapconf function generated by the companion star.
const Vectorget_shift_auto_rs () const
 Returns the part of the shift vector from numerical computation.
const Vectorget_shift_auto () const
 Returns the part of the shift vector generated by the black hole.
const Vectorget_shift_comp () const
 Returns the part of the shift vector generated by the companion star.
const Vectorget_shift_tot () const
 Returns the total shift vector.
const Tensorget_d_shift_auto_rs () const
 Returns the derivative of the shift vector generated by the black hole.
const Tensorget_d_shift_auto () const
 Returns the derivative of the shift vector generated by the black hole.
const Tensorget_d_shift_comp () const
 Returns the derivative of the shift vector generated by the companion star.
const Scalarget_confo_auto_rs () const
 Returns the part of the conformal factor from numerical computation.
const Scalarget_confo_auto () const
 Returns the part of the conformal factor generated by the black hole.
const Scalarget_confo_comp () const
 Returns the part of the conformal factor generated by the companion star.
const Scalarget_confo_tot () const
 Returns the total conformal factor.
const Vectorget_d_confo_auto_rs () const
 Returns the derivative of the conformal factor generated by the black hole.
const Vectorget_d_confo_auto () const
 Returns the derivative of the conformal factor generated by the black hole.
const Vectorget_d_confo_comp () const
 Returns the derivative of the conformal factor generated by the companion star.
const Sym_tensorget_taij_tot_rs () const
 Returns the part of rs of the extrinsic curvature tensor.
const Sym_tensorget_taij_tot () const
 Returns the total extrinsic curvature tensor.
const Sym_tensorget_taij_auto_rs () const
 Returns the part of rs of the extrinsic curvature tensor generated by the black hole.
const Sym_tensorget_taij_auto () const
 Returns the part of the extrinsic curvature tensor generated by the black hole.
const Sym_tensorget_taij_comp () const
 Returns the part of the extrinsic curvature tensor generated by the companion star.
const Scalarget_taij_quad_tot_rs () const
 Returns the part of rs.
const Scalarget_taij_quad_tot_rot () const
 Returns the part of rot.
const Scalarget_taij_quad_tot () const
 Returns the total scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$.
const Scalarget_taij_quad_auto () const
 Returns the part of rs generated by the black hole.
const Scalarget_taij_quad_comp () const
 Returns the part of rs generated by the companion star.
virtual void sauve (FILE *) const
 Save in a file.
virtual double mass_irr_bhns () const
 Irreducible mass of the black hole.
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.
const Valeur bc_lapconf () const
 Boundary condition on the apparent horizon of the black hole for the lapconf function: 2-D Valeur.
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.
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.
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.
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.
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.
void update_met_der_comp_bhns (const Star_bhns &star)
 Computes derivative of metric quantities from the companion neutron star.
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 .
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.
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 .
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.
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.
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.
Mapset_mp ()
 Read/write of the mapping.
double & set_mass_bh ()
 Read/write of the gravitational mass of BH [{ m}].
const Mapget_mp () const
 Returns the mapping.
bool is_kerrschild () const
 Returns true for a Kerr-Schild background, false for a Conformally flat one.
double get_mass_bh () const
 Returns the gravitational mass of BH [{ m}].
const Scalarget_lapconf () const
 Returns lapconf generated by the black hole.
const Scalarget_lapconf_rs () const
 Returns the part of lapconf from the numerical computation.
const Scalarget_lapse () const
 Returns the lapse function generated by the black hole.
const Vectorget_shift () const
 Returns the shift vector generated by the black hole.
const Vectorget_shift_rs () const
 Returns the part of the shift vector from the numerical computation.
const Scalarget_confo () const
 Returns the conformal factor generated by the black hole.
virtual double mass_irr () const
 Irreducible mass of the black hole.
virtual double mass_adm () const
 ADM mass.
virtual double mass_kom () const
 Komar mass.
virtual double rad_ah () const
 Radius of the apparent horizon.
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.
const Tblangu_mom_bh () const
 Total angular momentum.
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.
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.
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.
const Valeur bc_confo () const
 Boundary condition on the apparent horizon of the black hole for the conformal factor: 2-D Valeur.
void extr_curv_bh ()
 Computes taij , taij_quad from shift , lapse , confo .
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.
void static_bh (bool neumann, bool first)
 Sets the metric quantities to a spherical, static blach-hole analytic solution.
double rah_iso (bool neumann, bool first) const
 Computes a radius of apparent horizon (excised surface) in isotropic coordinates.
const Scalar r_coord (bool neumann, bool first) const
 Expresses the areal radial coordinate by that in spatially isotropic coordinates.
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.
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.
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.

Protected Member Functions

virtual void del_deriv () const
 Deletes all the derived quantities.
void set_der_0x0 () const
 Sets to 0x0 all the pointers on derived quantities.
virtual ostream & operator>> (ostream &) const
 Operator >> (virtual function called by the operator <<).

Protected Attributes

bool bc_lapconf_nd
 true for the Neumann type BC for the lapconf function, false for the Dirichlet type BH
bool bc_lapconf_fs
 true for the first type BC for the lapconf function, false for the second type BH
bool irrotational
 true for an irrotational black hole, false for a corotating one
double omega_spin
 Spin angular velocity of the black hole.
Scalar lapconf_auto_rs
 Part of the lapconf function from the numerical computation.
Scalar lapconf_auto_bh
 Part of the lapconf function from the analytic background.
Scalar lapconf_auto
 Lapconf function generated by the black hole.
Scalar lapconf_comp
 Lapconf function generated by the companion star.
Scalar lapconf_tot
 Total lapconf function.
Scalar lapse_auto
 Lapse function of the "black hole" part.
Scalar lapse_tot
 Total lapse function.
Vector d_lapconf_auto_rs
 Derivative of the part of the lapconf function from the numerical computation.
Vector d_lapconf_auto_bh
 Derivative of the part of the lapconf function from the analytic background.
Vector d_lapconf_auto
 Derivative of the lapconf function generated by the black hole.
Vector d_lapconf_comp
 Derivative of the lapconf function generated by the companion star.
Vector shift_auto_rs
 Part of the shift vector from the numerical computation.
Vector shift_auto_bh
 Part of the shift vector from the analytic background.
Vector shift_auto
 Shift vector generated by the black hole.
Vector shift_comp
 Shift vector generated by the companion star.
Vector shift_tot
 Total shift vector ;.
Tensor d_shift_auto_rs
 Derivative of the part of the shift vector from the numerical computation.
Tensor d_shift_auto_bh
 Derivative of the part of the shift vector from the analytic background.
Tensor d_shift_auto
 Derivative of the shift vector generated by the black hole.
Tensor d_shift_comp
 Derivative of the shift vector generated by the companion star.
Scalar confo_auto_rs
 Part of the conformal factor from the numerical computation.
Scalar confo_auto_bh
 Part of the conformal factor from the analytic background.
Scalar confo_auto
 Conformal factor generated by the black hole.
Scalar confo_comp
 Conformal factor generated by the companion star.
Scalar confo_tot
 Total conformal factor.
Vector d_confo_auto_rs
 Derivative of the part of the conformal factor from the numerical computation.
Vector d_confo_auto_bh
 Derivative of the part of the conformal factor from the analytic background.
Vector d_confo_auto
 Derivative of the conformal factor generated by the black hole.
Vector d_confo_comp
 Derivative of the conformal factor generated by the companion star.
Sym_tensor taij_tot_rs
 Part of the extrinsic curvature tensor from the numerical computation.
Sym_tensor taij_tot_rot
 Part of the extrinsic curvature tensor from the rotation shift vector.
Sym_tensor taij_tot_bh
 Part of the extrinsic curvature tensor from the analytic background.
Sym_tensor taij_tot
 Total extrinsic curvature tensor $\ A^{ij}$ generated by shift_tot , lapse_tot , and confo_tot .
Sym_tensor taij_auto_rs
 Part of the extrinsic curvature tensor numericalty computed for the black hole.
Sym_tensor taij_auto
 Part of the extrinsic curvature tensor generated by the black hole.
Sym_tensor taij_comp
 Part of the extrinsic curvature tensor generated by the companion star.
Scalar taij_quad_tot_rs
 Part of the scalar from the numerical computation.
Scalar taij_quad_tot_rot
 Part of the scalar from the rotation shift vector.
Scalar taij_quad_tot_bh
 Part of the scalar from the analytic background.
Scalar taij_quad_tot
 Total scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$ generated by $A_{ij}^{\rm tot}$.
Scalar taij_quad_auto
 Part of the scalar from the black hole.
Scalar taij_quad_comp
 Part of the scalar from the companion star.
double * p_mass_irr_bhns
double * p_spin_am_bhns
 Irreducible mass of BH.
Mapmp
 Mapping associated with the black hole.
bool kerrschild
 true for a Kerr-Schild background, false for a conformally flat background
double mass_bh
 Gravitational mass of BH.
Scalar lapconf
 A function (lapse function * conformal factor) lapconf generated by the black hole.
Scalar lapconf_rs
 Part of lapconf from the numerical computation.
Scalar lapconf_bh
 Part of lapconf from the analytic background.
Scalar lapse
 Lapse function generated by the black hole.
Vector shift
 Shift vector generated by the black hole.
Vector shift_rs
 Part of the shift vector from the numerical computation.
Vector shift_bh
 Part of the shift vector from the analytic background.
Scalar confo
 Conformal factor generated by the black hole.
Sym_tensor taij
 Trace of the extrinsic curvature.
Sym_tensor taij_rs
 Part of the extrinsic curvature tensor.
Scalar taij_quad
 Part of the scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$ generated by $A_{ij}$.
Scalar taij_quad_rs
 Part of the scalar.
Metric_flat flat
 Flat metric defined on the mapping (Spherical components with respect to the mapping of the black hole ).
double * p_mass_irr
 Conformal metric $\tilde \gamma_{ij}$.
double * p_mass_adm
 Irreducible mass of the black hole.
double * p_mass_kom
 ADM mass.
double * p_rad_ah
 Komar mass.
double * p_spin_am_bh
 Radius of the apparent horizon.
Tblp_angu_mom_bh
 Spin angular momentum.

Friends

class Bin_bhns
ostream & operator<< (ostream &, const Black_hole &)
 Display.

Detailed Description

Class for black holes in black hole-neutron star binaries.

()

Definition at line 60 of file hole_bhns.h.


Constructor & Destructor Documentation

Hole_bhns::Hole_bhns ( Map mp_i,
bool  kerrschild_i,
bool  bc_lapconf_nd,
bool  bc_lapconf_fs,
bool  irrotational,
double  massbh 
)
Hole_bhns::Hole_bhns ( const Hole_bhns hole  ) 

Copy constructor.

Definition at line 193 of file hole_bhns.C.

References set_der_0x0().

Hole_bhns::Hole_bhns ( Map mp_i,
FILE *  fich 
)
Hole_bhns::~Hole_bhns (  )  [virtual]

Destructor.

Definition at line 376 of file hole_bhns.C.

References del_deriv().


Member Function Documentation

const Tbl & Black_hole::angu_mom_bh (  )  const [inherited]

Total angular momentum.

Returns:
1-D { Tbl} of size 3, according to \ { angu()(0)} = $J^x$, \ { angu()(1)} = $J^y$, \ { angu()(2)} = $J^z$.

Definition at line 630 of file blackhole_global.C.

References Tensor::annule_domain(), Tbl::annule_hard(), Map::cosp, Map::cost, Scalar::dec_dzpuis(), Map::get_bvect_cart(), Map_af::integrale_surface(), Black_hole::mp, Black_hole::p_angu_mom_bh, Scalar::raccord(), Tbl::set(), Tensor::set(), Map::sinp, Map::sint, Scalar::std_spectral_base(), Black_hole::taij, Map::val_r(), Map::x, Map::y, and Map::z.

const Valeur Black_hole::bc_confo (  )  const [inherited]
const Valeur Hole_bhns::bc_confo ( double  ome_orb,
double  x_rot,
double  y_rot 
) const
const Valeur Black_hole::bc_lapconf ( bool  neumann,
bool  first 
) const [inherited]

Boundary condition on the apparent horizon of the black hole for the lapse function: 2-D Valeur.

Definition at line 67 of file blackhole_bc.C.

References Mg3d::get_angu(), Map::get_mg(), Mg3d::get_np(), Mg3d::get_nt(), Black_hole::kerrschild, Black_hole::lapconf, Black_hole::mp, Map::r, Valeur::set(), Valeur::std_base_scal(), Scalar::std_spectral_base(), and Scalar::val_grid_point().

const Valeur Hole_bhns::bc_lapconf (  )  const
const Valeur Black_hole::bc_shift_x ( double  omega_r  )  const [inherited]
const Valeur Hole_bhns::bc_shift_x ( double  ome_orb,
double  y_rot 
) const
const Valeur Black_hole::bc_shift_y ( double  omega_r  )  const [inherited]
const Valeur Hole_bhns::bc_shift_y ( double  ome_orb,
double  x_rot 
) const
const Valeur Hole_bhns::bc_shift_z (  )  const
void Hole_bhns::del_deriv (  )  const [protected, virtual]

Deletes all the derived quantities.

Reimplemented from Black_hole.

Definition at line 388 of file hole_bhns.C.

References p_spin_am_bhns, and set_der_0x0().

void 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.

Parameters:
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 65 of file hole_bhns_equilibrium.C.

References Tensor::annule_domain(), Black_hole::bc_confo(), bc_lapconf(), bc_lapconf_fs, bc_lapconf_nd, bc_shift_x(), bc_shift_y(), bc_shift_z(), confo_auto, confo_auto_bh, confo_auto_rs, confo_comp, confo_tot, contract(), Map::cosp, Map::cost, d_confo_comp, d_lapconf_comp, Scalar::deriv(), diffrel(), Scalar::filtre(), Mg3d::get_angu(), Map::get_bvect_cart(), Scalar::get_etat(), Map::get_mg(), Mg3d::get_nzone(), Scalar::inc_dzpuis(), Black_hole::kerrschild, lapconf_auto, lapconf_auto_bh, lapconf_auto_rs, lapconf_comp, lapconf_tot, Black_hole::mass_bh, Black_hole::mp, Scalar::poisson_dirichlet(), Scalar::poisson_neumann(), pow(), Map::r, Black_hole::r_coord(), Scalar::raccord(), Map::resize(), Cmp::set(), Vector::set(), Tensor::set(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::set_etat_qcq(), shift_auto, shift_auto_bh, shift_auto_rs, Map::sinp, Map::sint, sqrt(), Vector::std_spectral_base(), Scalar::std_spectral_base(), taij_auto_rs, taij_comp, taij_quad_auto, taij_quad_comp, taij_tot_rs, and Map::val_r().

void Black_hole::equilibrium_spher ( bool  neumann,
bool  first,
double  spin_omega,
double  precis = 1.e-14,
double  precis_shift = 1.e-8 
) [inherited]

Computes a spherical, static black-hole by giving boundary conditions on the apparent horizon.

Parameters:
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 66 of file blackhole_eq_spher.C.

References Tensor::annule_domain(), Black_hole::bc_confo(), Black_hole::bc_lapconf(), Black_hole::bc_shift_x(), Black_hole::bc_shift_y(), Black_hole::bc_shift_z(), Black_hole::confo, contract(), Map::cosp, Map::cost, Black_hole::del_deriv(), Scalar::deriv(), diffrel(), Black_hole::extr_curv_bh(), Mg3d::get_angu(), Map::get_bvect_cart(), Scalar::get_dzpuis(), Map::get_mg(), Mg3d::get_nzone(), Scalar::inc_dzpuis(), Black_hole::kerrschild, Black_hole::lapconf, Black_hole::lapconf_bh, Black_hole::lapconf_rs, Black_hole::lapse, Black_hole::mass_adm(), Black_hole::mass_bh, Black_hole::mass_irr(), Black_hole::mass_kom(), Black_hole::mp, Scalar::poisson_dirichlet(), Scalar::poisson_neumann(), pow(), Map::r, Black_hole::r_coord(), Scalar::raccord(), Black_hole::rad_ah(), Tbl::set(), Vector::set(), Tensor::set(), Scalar::set_dzpuis(), Scalar::set_etat_qcq(), Tensor::set_etat_zero(), Black_hole::shift, Black_hole::shift_bh, Black_hole::shift_rs, Map::sinp, Map::sint, sqrt(), Vector::std_spectral_base(), Scalar::std_spectral_base(), Black_hole::taij, and Black_hole::taij_quad.

void Black_hole::extr_curv_bh (  )  [inherited]
void Hole_bhns::extr_curv_bhns ( double  omega_orb,
double  x_rot,
double  y_rot 
)
const Scalar& Black_hole::get_confo (  )  const [inline, inherited]

Returns the conformal factor generated by the black hole.

Definition at line 237 of file blackhole.h.

References Black_hole::confo.

const Scalar& Hole_bhns::get_confo_auto (  )  const [inline]

Returns the part of the conformal factor generated by the black hole.

Definition at line 434 of file hole_bhns.h.

References confo_auto.

const Scalar& Hole_bhns::get_confo_auto_rs (  )  const [inline]

Returns the part of the conformal factor from numerical computation.

Definition at line 429 of file hole_bhns.h.

References confo_auto_rs.

const Scalar& Hole_bhns::get_confo_comp (  )  const [inline]

Returns the part of the conformal factor generated by the companion star.

Definition at line 439 of file hole_bhns.h.

References confo_comp.

const Scalar& Hole_bhns::get_confo_tot (  )  const [inline]

Returns the total conformal factor.

Definition at line 442 of file hole_bhns.h.

References confo_tot.

const Vector& Hole_bhns::get_d_confo_auto (  )  const [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.

const Vector& Hole_bhns::get_d_confo_auto_rs (  )  const [inline]

Returns the derivative of the conformal factor generated by the black hole.

Definition at line 447 of file hole_bhns.h.

References d_confo_auto_rs.

const Vector& Hole_bhns::get_d_confo_comp (  )  const [inline]

Returns the derivative of the conformal factor generated by the companion star.

Definition at line 457 of file hole_bhns.h.

References d_confo_comp.

const Vector& Hole_bhns::get_d_lapconf_auto (  )  const [inline]

Returns the derivative of the lapconf function generated by the black hole.

Definition at line 392 of file hole_bhns.h.

References d_lapconf_auto.

const Vector& Hole_bhns::get_d_lapconf_auto_rs (  )  const [inline]

Returns the derivative of the lapconf function generated by the black hole.

Definition at line 386 of file hole_bhns.h.

References d_lapconf_auto_rs.

const Vector& Hole_bhns::get_d_lapconf_comp (  )  const [inline]

Returns the derivative of the lapconf function generated by the companion star.

Definition at line 397 of file hole_bhns.h.

References d_lapconf_comp.

const Tensor& Hole_bhns::get_d_shift_auto (  )  const [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.

const Tensor& Hole_bhns::get_d_shift_auto_rs (  )  const [inline]

Returns the derivative of the shift vector generated by the black hole.

Definition at line 416 of file hole_bhns.h.

References d_shift_auto_rs.

const Tensor& Hole_bhns::get_d_shift_comp (  )  const [inline]

Returns the derivative of the shift vector generated by the companion star.

Definition at line 426 of file hole_bhns.h.

References d_shift_comp.

const Scalar& Black_hole::get_lapconf (  )  const [inline, inherited]

Returns lapconf generated by the black hole.

Definition at line 220 of file blackhole.h.

References Black_hole::lapconf.

const Scalar& Hole_bhns::get_lapconf_auto (  )  const [inline]

Returns the part of the lapconf function generated by the black hole.

Definition at line 365 of file hole_bhns.h.

References lapconf_auto.

const Scalar& Hole_bhns::get_lapconf_auto_rs (  )  const [inline]

Returns the part of the lapconf function from numerical computation.

Definition at line 360 of file hole_bhns.h.

References lapconf_auto_rs.

const Scalar& Hole_bhns::get_lapconf_comp (  )  const [inline]

Returns the part of the lapconf function generated by the companion star.

Definition at line 370 of file hole_bhns.h.

References lapconf_comp.

const Scalar& Black_hole::get_lapconf_rs (  )  const [inline, inherited]

Returns the part of lapconf from the numerical computation.

Definition at line 223 of file blackhole.h.

References Black_hole::lapconf_rs.

const Scalar& Hole_bhns::get_lapconf_tot (  )  const [inline]

Returns the total lapconf function.

Definition at line 373 of file hole_bhns.h.

References lapconf_tot.

const Scalar& Black_hole::get_lapse (  )  const [inline, inherited]

Returns the lapse function generated by the black hole.

Definition at line 226 of file blackhole.h.

References Black_hole::lapse.

const Scalar& Hole_bhns::get_lapse_auto (  )  const [inline]

Returns the part of the lapse function generated by the black hole.

Definition at line 378 of file hole_bhns.h.

References lapse_auto.

const Scalar& Hole_bhns::get_lapse_tot (  )  const [inline]

Returns the total lapse function.

Definition at line 381 of file hole_bhns.h.

References lapse_tot.

double Black_hole::get_mass_bh (  )  const [inline, inherited]

Returns the gravitational mass of BH [{ m}].

Definition at line 217 of file blackhole.h.

References Black_hole::mass_bh.

const Map& Black_hole::get_mp (  )  const [inline, inherited]

Returns the mapping.

Definition at line 209 of file blackhole.h.

References Black_hole::mp.

double Hole_bhns::get_omega_spin (  )  const [inline]

Returns the spin angular velocity of the black hole [{ f}].

Definition at line 357 of file hole_bhns.h.

References omega_spin.

const Vector& Black_hole::get_shift (  )  const [inline, inherited]

Returns the shift vector generated by the black hole.

Definition at line 229 of file blackhole.h.

References Black_hole::shift.

const Vector& Hole_bhns::get_shift_auto (  )  const [inline]

Returns the part of the shift vector generated by the black hole.

Definition at line 403 of file hole_bhns.h.

References shift_auto.

const Vector& Hole_bhns::get_shift_auto_rs (  )  const [inline]

Returns the part of the shift vector from numerical computation.

Definition at line 400 of file hole_bhns.h.

References shift_auto_rs.

const Vector& Hole_bhns::get_shift_comp (  )  const [inline]

Returns the part of the shift vector generated by the companion star.

Definition at line 408 of file hole_bhns.h.

References shift_comp.

const Vector& Black_hole::get_shift_rs (  )  const [inline, inherited]

Returns the part of the shift vector from the numerical computation.

Definition at line 234 of file blackhole.h.

References Black_hole::shift_rs.

const Vector& Hole_bhns::get_shift_tot (  )  const [inline]

Returns the total shift vector.

Definition at line 411 of file hole_bhns.h.

References shift_tot.

const Sym_tensor& Hole_bhns::get_taij_auto (  )  const [inline]

Returns the part of the extrinsic curvature tensor generated by the black hole.

Definition at line 473 of file hole_bhns.h.

References taij_auto.

const Sym_tensor& Hole_bhns::get_taij_auto_rs (  )  const [inline]

Returns the part of rs of the extrinsic curvature tensor generated by the black hole.

Definition at line 468 of file hole_bhns.h.

References taij_auto_rs.

const Sym_tensor& Hole_bhns::get_taij_comp (  )  const [inline]

Returns the part of the extrinsic curvature tensor generated by the companion star.

Definition at line 478 of file hole_bhns.h.

References taij_comp.

const Scalar& Hole_bhns::get_taij_quad_auto (  )  const [inline]

Returns the part of rs generated by the black hole.

Definition at line 489 of file hole_bhns.h.

References taij_quad_auto.

const Scalar& Hole_bhns::get_taij_quad_comp (  )  const [inline]

Returns the part of rs generated by the companion star.

Definition at line 492 of file hole_bhns.h.

References taij_quad_comp.

const Scalar& Hole_bhns::get_taij_quad_tot (  )  const [inline]

Returns the total scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$.

Definition at line 486 of file hole_bhns.h.

References taij_quad_tot.

const Scalar& Hole_bhns::get_taij_quad_tot_rot (  )  const [inline]

Returns the part of rot.

Definition at line 483 of file hole_bhns.h.

References taij_quad_tot_rot.

const Scalar& Hole_bhns::get_taij_quad_tot_rs (  )  const [inline]

Returns the part of rs.

Definition at line 481 of file hole_bhns.h.

References taij_quad_tot_rs.

const Sym_tensor& Hole_bhns::get_taij_tot (  )  const [inline]

Returns the total extrinsic curvature tensor.

Definition at line 463 of file hole_bhns.h.

References taij_tot.

const Sym_tensor& Hole_bhns::get_taij_tot_rs (  )  const [inline]

Returns the part of rs of the extrinsic curvature tensor.

Definition at line 460 of file hole_bhns.h.

References taij_tot_rs.

bool Hole_bhns::has_bc_lapconf_fs (  )  const [inline]

Returns true for the first type BC for the lapconf function, false for the second type BH.

Definition at line 349 of file hole_bhns.h.

References bc_lapconf_fs.

bool Hole_bhns::has_bc_lapconf_nd (  )  const [inline]

Returns true for the Neumann type BC for the lapconf function, false for the Dirichlet type BH.

Definition at line 344 of file hole_bhns.h.

References bc_lapconf_nd.

bool Hole_bhns::is_irrotational (  )  const [inline]

Returns true for an irrotational black hole, false for a corotating one.

Definition at line 354 of file hole_bhns.h.

References irrotational.

bool Black_hole::is_kerrschild (  )  const [inline, inherited]

Returns true for a Kerr-Schild background, false for a Conformally flat one.

Definition at line 214 of file blackhole.h.

References Black_hole::kerrschild.

Vector 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.

Parameters:
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 62 of file hole_bhns_killing.C.

References confo_tot, Scalar::dsdt(), Map::get_bvect_spher(), Tbl::get_dim(), Map::get_mg(), Tbl::get_ndim(), Mg3d::get_nr(), Black_hole::kerrschild, Black_hole::mp, pow(), Map::r, Black_hole::rad_ah(), runge_kutta_phi(), runge_kutta_theta(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::set_grid_point(), Map::sint, Scalar::std_spectral_base(), Scalar::stdsdp(), Scalar::val_grid_point(), and Scalar::val_point().

Vector Black_hole::killing_vect_bh ( const Tbl xi_i,
const double &  phi_i,
const double &  theta_i,
const int &  nrk_phi,
const int &  nrk_theta 
) const [inherited]

Compute the Killing vector of a black hole normalized so that its affine length is 2 M_PI.

Parameters:
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 62 of file blackhole_killing.C.

References Black_hole::confo, Map::get_bvect_spher(), Tbl::get_dim(), Map::get_mg(), Tbl::get_ndim(), Mg3d::get_nr(), Black_hole::kerrschild, Black_hole::mp, pow(), Map::r, Black_hole::rad_ah(), Black_hole::runge_kutta_phi_bh(), Black_hole::runge_kutta_theta_bh(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::set_grid_point(), Map::sint, Scalar::std_spectral_base(), Scalar::val_grid_point(), and Scalar::val_point().

double Black_hole::mass_adm (  )  const [virtual, inherited]
double Black_hole::mass_irr (  )  const [virtual, inherited]
double Hole_bhns::mass_irr_bhns (  )  const [virtual]
double Black_hole::mass_kom (  )  const [virtual, inherited]
void Hole_bhns::operator= ( const Hole_bhns hole  ) 
ostream & Hole_bhns::operator>> ( ostream &  ost  )  const [protected, virtual]

Operator >> (virtual function called by the operator <<).

Reimplemented from Black_hole.

Definition at line 616 of file hole_bhns.C.

References confo_tot, Map::get_mg(), Mg3d::get_nt(), lapse_tot, Black_hole::mass_bh, mass_irr_bhns(), Black_hole::mp, omega_spin, Black_hole::rad_ah(), shift_tot, and Scalar::val_grid_point().

const Scalar Black_hole::r_coord ( bool  neumann,
bool  first 
) const [inherited]

Expresses the areal radial coordinate by that in spatially isotropic coordinates.

Parameters:
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 62 of file blackhole_r_coord.C.

References Tensor::annule_domain(), Map::get_mg(), Mg3d::get_np(), Mg3d::get_nr(), Mg3d::get_nt(), Mg3d::get_nzone(), log(), Black_hole::mass_bh, Black_hole::mp, Map::r, Scalar::raccord(), Scalar::set_grid_point(), sqrt(), Scalar::std_spectral_base(), and Scalar::val_grid_point().

double Black_hole::rad_ah (  )  const [virtual, inherited]

Radius of the apparent horizon.

Definition at line 501 of file blackhole_global.C.

References Black_hole::mp, Black_hole::p_rad_ah, Map::r, Scalar::std_spectral_base(), and Scalar::val_grid_point().

double Black_hole::rah_iso ( bool  neumann,
bool  first 
) const [inherited]

Computes a radius of apparent horizon (excised surface) in isotropic coordinates.

Parameters:
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 65 of file blackhole_rah_iso.C.

References exp(), and sqrt().

void 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 .

Parameters:
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 655 of file hole_bhns.C.

References confo_auto_rs, del_deriv(), lapconf_auto_rs, and shift_auto_rs.

Tbl 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.

Parameters:
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 63 of file hole_bhns_rk_phi.C.

References confo_tot, Scalar::dsdt(), Map::get_mg(), Mg3d::get_np(), Black_hole::kerrschild, Scalar::lapang(), Black_hole::mp, Black_hole::rad_ah(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::std_spectral_base(), and Scalar::val_point().

Tbl Black_hole::runge_kutta_phi_bh ( const Tbl xi_i,
const double &  phi_i,
const int &  nrk 
) const [inherited]

Compute a forth-order Runge-Kutta integration to the phi direction for the solution of the Killing vectors on the equator.

Parameters:
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 63 of file blackhole_rk_phi.C.

References Black_hole::confo, Scalar::dsdt(), Map::get_mg(), Mg3d::get_np(), Black_hole::kerrschild, Scalar::lapang(), Black_hole::mp, Black_hole::rad_ah(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::std_spectral_base(), and Scalar::val_point().

Tbl 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.

Parameters:
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 63 of file hole_bhns_rk_theta.C.

References confo_tot, Map::get_mg(), Mg3d::get_nt(), Black_hole::kerrschild, Scalar::lapang(), Black_hole::mp, Black_hole::rad_ah(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::std_spectral_base(), Scalar::stdsdp(), and Scalar::val_point().

Tbl Black_hole::runge_kutta_theta_bh ( const Tbl xi_i,
const double &  theta_i,
const double &  phi,
const int &  nrk 
) const [inherited]

Compute a forth-order Runge-Kutta integration to the theta direction for the solution of the Killing vectors.

Parameters:
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 63 of file blackhole_rk_theta.C.

References Black_hole::confo, Map::get_mg(), Mg3d::get_nt(), Black_hole::kerrschild, Scalar::lapang(), Black_hole::mp, Black_hole::rad_ah(), Tbl::set(), Tbl::set_etat_qcq(), Scalar::std_spectral_base(), Scalar::stdsdp(), and Scalar::val_point().

void Hole_bhns::sauve ( FILE *  fich  )  const [virtual]

Save in a file.

Reimplemented from Black_hole.

Definition at line 599 of file hole_bhns.C.

References bc_lapconf_fs, bc_lapconf_nd, confo_auto_rs, irrotational, lapconf_auto_rs, omega_spin, Tensor::sauve(), Scalar::sauve(), and shift_auto_rs.

Scalar & Hole_bhns::set_confo_auto (  ) 

Read/write of the conformal factor generated by the black hole.

Definition at line 571 of file hole_bhns.C.

References confo_auto, and del_deriv().

Scalar & Hole_bhns::set_confo_auto_bh (  ) 

Read/write of the conformal factor generated by the black hole.

Definition at line 564 of file hole_bhns.C.

References confo_auto_bh, and del_deriv().

Scalar & Hole_bhns::set_confo_auto_rs (  ) 

Read/write of the conformal factor generated by the black hole.

Definition at line 557 of file hole_bhns.C.

References confo_auto_rs, and del_deriv().

Scalar & Hole_bhns::set_confo_comp (  ) 

Read/write of the conformal factor generated by the companion star.

Definition at line 578 of file hole_bhns.C.

References confo_comp, and del_deriv().

Scalar & Hole_bhns::set_confo_tot (  ) 

Read/write of the total conformal factor.

Definition at line 585 of file hole_bhns.C.

References confo_tot, and del_deriv().

void Hole_bhns::set_der_0x0 (  )  const [protected]

Sets to 0x0 all the pointers on derived quantities.

Reimplemented from Black_hole.

Definition at line 399 of file hole_bhns.C.

References p_spin_am_bhns.

Scalar & Hole_bhns::set_lapconf_auto (  ) 

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.

Scalar & Hole_bhns::set_lapconf_auto_bh (  ) 

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_bh.

Scalar & Hole_bhns::set_lapconf_auto_rs (  ) 

Read/write of the lapconf function generated by the black hole.

Definition at line 473 of file hole_bhns.C.

References del_deriv(), and lapconf_auto_rs.

Scalar & Hole_bhns::set_lapconf_comp (  ) 

Read/write of the lapconf function generated by the companion star.

Definition at line 494 of file hole_bhns.C.

References del_deriv(), and lapconf_comp.

Scalar & Hole_bhns::set_lapconf_tot (  ) 

Read/write of the total lapconf function.

Definition at line 501 of file hole_bhns.C.

References del_deriv(), and lapconf_tot.

Scalar & Hole_bhns::set_lapse_auto (  ) 

Read/write of the lapse function generated by the black hole.

Definition at line 508 of file hole_bhns.C.

References del_deriv(), and lapse_auto.

Scalar & Hole_bhns::set_lapse_tot (  ) 

Read/write of the total lapse function.

Definition at line 515 of file hole_bhns.C.

References del_deriv(), and lapse_tot.

double& Black_hole::set_mass_bh (  )  [inline, inherited]

Read/write of the gravitational mass of BH [{ m}].

Definition at line 203 of file blackhole.h.

References Black_hole::mass_bh.

Map& Black_hole::set_mp (  )  [inline, inherited]

Read/write of the mapping.

Definition at line 200 of file blackhole.h.

References Black_hole::mp.

double& Hole_bhns::set_omega_spin (  )  [inline]

Sets the spin angular velocity of the black hole [{ f}].

Definition at line 285 of file hole_bhns.h.

References omega_spin.

Vector & Hole_bhns::set_shift_auto (  ) 

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.

Vector & Hole_bhns::set_shift_auto_bh (  ) 

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_bh.

Vector & Hole_bhns::set_shift_auto_rs (  ) 

Read/write of the shift vector generated by the black hole.

Definition at line 522 of file hole_bhns.C.

References del_deriv(), and shift_auto_rs.

Vector & Hole_bhns::set_shift_comp (  ) 

Read/write of the shift vector generated by the companion star.

Definition at line 543 of file hole_bhns.C.

References del_deriv(), and shift_comp.

Vector & Hole_bhns::set_shift_tot (  ) 

Read/write of the total shift vector.

Definition at line 550 of file hole_bhns.C.

References del_deriv(), and shift_tot.

double Black_hole::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 [inherited]
double 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
void Black_hole::static_bh ( bool  neumann,
bool  first 
) [inherited]

Sets the metric quantities to a spherical, static blach-hole analytic solution.

Parameters:
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 56 of file blackhole_static.C.

References Tensor::annule_domain(), Black_hole::confo, Map::cosp, Map::cost, Map::get_bvect_cart(), Black_hole::kerrschild, Black_hole::lapconf, Black_hole::lapse, Black_hole::mass_bh, Black_hole::mp, pow(), Map::r, Black_hole::r_coord(), Scalar::raccord(), Vector::set(), Tensor::set(), Black_hole::shift, Map::sinp, Map::sint, sqrt(), Vector::std_spectral_base(), and Scalar::std_spectral_base().

void Hole_bhns::update_met_der_comp_bhns ( const Star_bhns star  ) 
void 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 ,

Parameters:
star companion neutron star
hole_prev previous value of the hole
relax relaxation parameter

Definition at line 57 of file hole_bhns_upmetr.C.

References Tensor::annule_domain(), bc_lapconf_fs, bc_lapconf_nd, Metric_flat::con(), confo_auto, confo_auto_bh, confo_auto_rs, confo_comp, confo_tot, Map::cosp, Map::cost, d_confo_auto, d_confo_auto_bh, d_confo_auto_rs, d_lapconf_auto, d_lapconf_auto_bh, d_lapconf_auto_rs, d_shift_auto, d_shift_auto_bh, d_shift_auto_rs, del_deriv(), Scalar::deriv(), Black_hole::flat, Map::get_bvect_cart(), Star_bhns::get_confo_auto(), Star_bhns::get_lapconf_auto(), Star::get_mp(), Star_bhns::get_shift_auto(), Tensor::get_triad(), Scalar::import(), Tensor::inc_dzpuis(), Black_hole::kerrschild, lapconf_auto, lapconf_auto_bh, lapconf_auto_rs, lapconf_comp, lapconf_tot, lapse_auto, lapse_tot, Black_hole::mass_bh, Black_hole::mp, pow(), Map::r, Black_hole::r_coord(), Scalar::raccord(), Tensor::set(), Vector::set(), Tensor::set_etat_qcq(), Scalar::set_etat_qcq(), Tensor::set_etat_zero(), Scalar::set_etat_zero(), Tensor::set_triad(), shift_auto, shift_auto_bh, shift_auto_rs, shift_comp, shift_tot, Map::sinp, Map::sint, sqrt(), Tensor::std_spectral_base(), Vector::std_spectral_base(), and Scalar::std_spectral_base().


Friends And Related Function Documentation

ostream& operator<< ( ostream &  ,
const Black_hole  
) [friend, inherited]

Display.


Member Data Documentation

bool Hole_bhns::bc_lapconf_fs [protected]

true for the first type BC for the lapconf function, false for the second type BH

Definition at line 73 of file hole_bhns.h.

bool Hole_bhns::bc_lapconf_nd [protected]

true for the Neumann type BC for the lapconf function, false for the Dirichlet type BH

Definition at line 68 of file hole_bhns.h.

Scalar Black_hole::confo [protected, inherited]

Conformal factor generated by the black hole.

Definition at line 114 of file blackhole.h.

Conformal factor generated by the black hole.

Definition at line 158 of file hole_bhns.h.

Part of the conformal factor from the analytic background.

Definition at line 155 of file hole_bhns.h.

Part of the conformal factor from the numerical computation.

Definition at line 152 of file hole_bhns.h.

Conformal factor generated by the companion star.

Definition at line 161 of file hole_bhns.h.

Total conformal factor.

Definition at line 164 of file hole_bhns.h.

Derivative of the conformal factor generated by the black hole.

Definition at line 177 of file hole_bhns.h.

Derivative of the part of the conformal factor from the analytic background.

Definition at line 174 of file hole_bhns.h.

Derivative of the part of the conformal factor from the numerical computation.

Definition at line 169 of file hole_bhns.h.

Derivative of the conformal factor generated by the companion star.

Definition at line 180 of file hole_bhns.h.

Derivative of the lapconf function generated by the black hole.

Definition at line 115 of file hole_bhns.h.

Derivative of the part of the lapconf function from the analytic background.

Definition at line 112 of file hole_bhns.h.

Derivative of the part of the lapconf function from the numerical computation.

Definition at line 107 of file hole_bhns.h.

Derivative of the lapconf function generated by the companion star.

Definition at line 118 of file hole_bhns.h.

Derivative of the shift vector generated by the black hole.

Definition at line 146 of file hole_bhns.h.

Derivative of the part of the shift vector from the analytic background.

Definition at line 143 of file hole_bhns.h.

Derivative of the part of the shift vector from the numerical computation.

Definition at line 138 of file hole_bhns.h.

Derivative of the shift vector generated by the companion star.

Definition at line 149 of file hole_bhns.h.

Metric_flat Black_hole::flat [protected, inherited]

Flat metric defined on the mapping (Spherical components with respect to the mapping of the black hole ).

Definition at line 139 of file blackhole.h.

bool Hole_bhns::irrotational [protected]

true for an irrotational black hole, false for a corotating one

Definition at line 78 of file hole_bhns.h.

bool Black_hole::kerrschild [protected, inherited]

true for a Kerr-Schild background, false for a conformally flat background

Definition at line 81 of file blackhole.h.

Scalar Black_hole::lapconf [protected, inherited]

A function (lapse function * conformal factor) lapconf generated by the black hole.

Definition at line 93 of file blackhole.h.

Lapconf function generated by the black hole.

Definition at line 90 of file hole_bhns.h.

Part of the lapconf function from the analytic background.

Definition at line 87 of file hole_bhns.h.

Part of the lapconf function from the numerical computation.

Definition at line 84 of file hole_bhns.h.

Scalar Black_hole::lapconf_bh [protected, inherited]

Part of lapconf from the analytic background.

Definition at line 99 of file blackhole.h.

Lapconf function generated by the companion star.

Definition at line 93 of file hole_bhns.h.

Scalar Black_hole::lapconf_rs [protected, inherited]

Part of lapconf from the numerical computation.

Definition at line 96 of file blackhole.h.

Total lapconf function.

Definition at line 96 of file hole_bhns.h.

Scalar Black_hole::lapse [protected, inherited]

Lapse function generated by the black hole.

Definition at line 102 of file blackhole.h.

Lapse function of the "black hole" part.

Definition at line 99 of file hole_bhns.h.

Total lapse function.

Definition at line 102 of file hole_bhns.h.

double Black_hole::mass_bh [protected, inherited]

Gravitational mass of BH.

Definition at line 84 of file blackhole.h.

Map& Black_hole::mp [protected, inherited]

Mapping associated with the black hole.

Definition at line 76 of file blackhole.h.

double Hole_bhns::omega_spin [protected]

Spin angular velocity of the black hole.

Definition at line 81 of file hole_bhns.h.

Tbl* Black_hole::p_angu_mom_bh [mutable, protected, inherited]

Spin angular momentum.

Total angular momentum of the black hole

Definition at line 158 of file blackhole.h.

double* Black_hole::p_mass_adm [mutable, protected, inherited]

Irreducible mass of the black hole.

Definition at line 149 of file blackhole.h.

double* Black_hole::p_mass_irr [mutable, protected, inherited]

Conformal metric $\tilde \gamma_{ij}$.

Definition at line 147 of file blackhole.h.

double* Black_hole::p_mass_kom [mutable, protected, inherited]

ADM mass.

Definition at line 151 of file blackhole.h.

double* Black_hole::p_rad_ah [mutable, protected, inherited]

Komar mass.

Definition at line 153 of file blackhole.h.

double* Black_hole::p_spin_am_bh [mutable, protected, inherited]

Radius of the apparent horizon.

Definition at line 155 of file blackhole.h.

double* Hole_bhns::p_spin_am_bhns [mutable, protected]

Irreducible mass of BH.

Quasilocal spin angular momentum of BH

Definition at line 243 of file hole_bhns.h.

Vector Black_hole::shift [protected, inherited]

Shift vector generated by the black hole.

Definition at line 105 of file blackhole.h.

Shift vector generated by the black hole.

Definition at line 127 of file hole_bhns.h.

Part of the shift vector from the analytic background.

Definition at line 124 of file hole_bhns.h.

Part of the shift vector from the numerical computation.

Definition at line 121 of file hole_bhns.h.

Vector Black_hole::shift_bh [protected, inherited]

Part of the shift vector from the analytic background.

Definition at line 111 of file blackhole.h.

Shift vector generated by the companion star.

Definition at line 130 of file hole_bhns.h.

Vector Black_hole::shift_rs [protected, inherited]

Part of the shift vector from the numerical computation.

Definition at line 108 of file blackhole.h.

Total shift vector ;.

Definition at line 133 of file hole_bhns.h.

Sym_tensor Black_hole::taij [protected, inherited]

Trace of the extrinsic curvature.

Extrinsic curvature tensor $\ A^{ij}$ generated by shift , lapse , and confo .

Definition at line 123 of file blackhole.h.

Part of the extrinsic curvature tensor generated by the black hole.

Definition at line 211 of file hole_bhns.h.

Part of the extrinsic curvature tensor numericalty computed for the black hole.

Definition at line 206 of file hole_bhns.h.

Part of the extrinsic curvature tensor generated by the companion star.

Definition at line 216 of file hole_bhns.h.

Scalar Black_hole::taij_quad [protected, inherited]

Part of the scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$ generated by $A_{ij}$.

Definition at line 131 of file blackhole.h.

Part of the scalar from the black hole.

Definition at line 233 of file hole_bhns.h.

Part of the scalar from the companion star.

Definition at line 236 of file hole_bhns.h.

Scalar Black_hole::taij_quad_rs [protected, inherited]

Part of the scalar.

Definition at line 134 of file blackhole.h.

Total scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$ generated by $A_{ij}^{\rm tot}$.

Definition at line 230 of file hole_bhns.h.

Part of the scalar from the analytic background.

Definition at line 225 of file hole_bhns.h.

Part of the scalar from the rotation shift vector.

Definition at line 222 of file hole_bhns.h.

Part of the scalar from the numerical computation.

Definition at line 219 of file hole_bhns.h.

Sym_tensor Black_hole::taij_rs [protected, inherited]

Part of the extrinsic curvature tensor.

Definition at line 126 of file blackhole.h.

Total extrinsic curvature tensor $\ A^{ij}$ generated by shift_tot , lapse_tot , and confo_tot .

Definition at line 201 of file hole_bhns.h.

Part of the extrinsic curvature tensor from the analytic background.

Definition at line 195 of file hole_bhns.h.

Part of the extrinsic curvature tensor from the rotation shift vector.

Definition at line 190 of file hole_bhns.h.

Part of the extrinsic curvature tensor from the numerical computation.

Definition at line 185 of file hole_bhns.h.


The documentation for this class was generated from the following files:

Generated on 7 Oct 2014 for LORENE by  doxygen 1.6.1