LORENE
Lorene::Hole_bhns Class Reference

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

#include <hole_bhns.h>

Inheritance diagram for Lorene::Hole_bhns:
Lorene::Black_hole

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...
 
Scalarset_lapconf_auto_rs ()
 Read/write of the lapconf function generated by the black hole. More...
 
Scalarset_lapconf_auto_bh ()
 Read/write of the lapconf function generated by the black hole. More...
 
Scalarset_lapconf_auto ()
 Read/write of the lapconf function generated by the black hole. More...
 
Scalarset_lapconf_comp ()
 Read/write of the lapconf function generated by the companion star. More...
 
Scalarset_lapconf_tot ()
 Read/write of the total lapconf function. More...
 
Scalarset_lapse_auto ()
 Read/write of the lapse function generated by the black hole. More...
 
Scalarset_lapse_tot ()
 Read/write of the total lapse function. More...
 
Vectorset_shift_auto_rs ()
 Read/write of the shift vector generated by the black hole. More...
 
Vectorset_shift_auto_bh ()
 Read/write of the shift vector generated by the black hole. More...
 
Vectorset_shift_auto ()
 Read/write of the shift vector generated by the black hole. More...
 
Vectorset_shift_comp ()
 Read/write of the shift vector generated by the companion star. More...
 
Vectorset_shift_tot ()
 Read/write of the total shift vector. More...
 
Scalarset_confo_auto_rs ()
 Read/write of the conformal factor generated by the black hole. More...
 
Scalarset_confo_auto_bh ()
 Read/write of the conformal factor generated by the black hole. More...
 
Scalarset_confo_auto ()
 Read/write of the conformal factor generated by the black hole. More...
 
Scalarset_confo_comp ()
 Read/write of the conformal factor generated by the companion star. More...
 
Scalarset_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 Scalarget_lapconf_auto_rs () const
 Returns the part of the lapconf function from numerical computation. More...
 
const Scalarget_lapconf_auto () const
 Returns the part of the lapconf function generated by the black hole. More...
 
const Scalarget_lapconf_comp () const
 Returns the part of the lapconf function generated by the companion star. More...
 
const Scalarget_lapconf_tot () const
 Returns the total lapconf function. More...
 
const Scalarget_lapse_auto () const
 Returns the part of the lapse function generated by the black hole. More...
 
const Scalarget_lapse_tot () const
 Returns the total lapse function. More...
 
const Vectorget_d_lapconf_auto_rs () const
 Returns the derivative of the lapconf function generated by the black hole. More...
 
const Vectorget_d_lapconf_auto () const
 Returns the derivative of the lapconf function generated by the black hole. More...
 
const Vectorget_d_lapconf_comp () const
 Returns the derivative of the lapconf function generated by the companion star. More...
 
const Vectorget_shift_auto_rs () const
 Returns the part of the shift vector from numerical computation. More...
 
const Vectorget_shift_auto () const
 Returns the part of the shift vector generated by the black hole. More...
 
const Vectorget_shift_comp () const
 Returns the part of the shift vector generated by the companion star. More...
 
const Vectorget_shift_tot () const
 Returns the total shift vector. More...
 
const Tensorget_d_shift_auto_rs () const
 Returns the derivative of the shift vector generated by the black hole. More...
 
const Tensorget_d_shift_auto () const
 Returns the derivative of the shift vector generated by the black hole. More...
 
const Tensorget_d_shift_comp () const
 Returns the derivative of the shift vector generated by the companion star. More...
 
const Scalarget_confo_auto_rs () const
 Returns the part of the conformal factor from numerical computation. More...
 
const Scalarget_confo_auto () const
 Returns the part of the conformal factor generated by the black hole. More...
 
const Scalarget_confo_comp () const
 Returns the part of the conformal factor generated by the companion star. More...
 
const Scalarget_confo_tot () const
 Returns the total conformal factor. More...
 
const Vectorget_d_confo_auto_rs () const
 Returns the derivative of the conformal factor generated by the black hole. More...
 
const Vectorget_d_confo_auto () const
 Returns the derivative of the conformal factor generated by the black hole. More...
 
const Vectorget_d_confo_comp () const
 Returns the derivative of the conformal factor generated by the companion star. More...
 
const Sym_tensorget_taij_tot_rs () const
 Returns the part of rs of the extrinsic curvature tensor. More...
 
const Sym_tensorget_taij_tot () const
 Returns the total extrinsic curvature tensor. More...
 
const Sym_tensorget_taij_auto_rs () const
 Returns the part of rs of the extrinsic curvature tensor generated by the black hole. More...
 
const Sym_tensorget_taij_auto () const
 Returns the part of the extrinsic curvature tensor generated by the black hole. More...
 
const Sym_tensorget_taij_comp () const
 Returns the part of the extrinsic curvature tensor generated by the companion star. More...
 
const Scalarget_taij_quad_tot_rs () const
 Returns the part of rs. More...
 
const Scalarget_taij_quad_tot_rot () const
 Returns the part of rot. More...
 
const Scalarget_taij_quad_tot () const
 Returns the total scalar $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$. More...
 
const Scalarget_taij_quad_auto () const
 Returns the part of rs generated by the black hole. More...
 
const Scalarget_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...
 
Mapset_mp ()
 Read/write of the mapping. More...
 
double & set_mass_bh ()
 Read/write of the gravitational mass of BH [{ m_unit}]. More...
 
const Mapget_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 Scalarget_lapconf () const
 Returns lapconf generated by the black hole. More...
 
const Scalarget_lapconf_rs () const
 Returns the part of lapconf from the numerical computation. More...
 
const Scalarget_lapse () const
 Returns the lapse function generated by the black hole. More...
 
const Vectorget_shift () const
 Returns the shift vector generated by the black hole. More...
 
const Vectorget_shift_rs () const
 Returns the part of the shift vector from the numerical computation. More...
 
const Scalarget_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 Tblangu_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 $\ A^{ij}$ 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 $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$ generated by $A_{ij}^{\rm tot}$. 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...
 
Mapmp
 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 $\eta_{ik} \eta_{jl} A^{ij} A^{kl}$ generated by $A_{ij}$. 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 $\tilde \gamma_{ij}$. 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...
 
Tblp_angu_mom_bh
 Spin angular momentum. More...
 

Friends

class Bin_bhns
 

Detailed Description

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

()

Definition at line 65 of file hole_bhns.h.

Constructor & Destructor Documentation

◆ Hole_bhns() [1/3]

◆ Hole_bhns() [2/3]

Lorene::Hole_bhns::Hole_bhns ( const Hole_bhns hole)

Copy constructor.

Definition at line 200 of file hole_bhns.C.

References set_der_0x0().

◆ Hole_bhns() [3/3]

◆ ~Hole_bhns()

Lorene::Hole_bhns::~Hole_bhns ( )
virtual

Destructor.

Definition at line 383 of file hole_bhns.C.

References del_deriv().

Member Function Documentation

◆ angu_mom_bh()

◆ bc_confo() [1/2]

◆ bc_confo() [2/2]

◆ bc_lapconf() [1/2]

const Valeur Lorene::Black_hole::bc_lapconf ( bool  neumann,
bool  first 
) const
inherited

◆ bc_lapconf() [2/2]

◆ bc_shift_x() [1/2]

◆ bc_shift_x() [2/2]

◆ bc_shift_y() [1/2]

◆ bc_shift_y() [2/2]

◆ bc_shift_z()

◆ del_deriv()

void Lorene::Hole_bhns::del_deriv ( ) const
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().

◆ equilibrium_bhns()

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.

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 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().

◆ equilibrium_spher()

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

◆ extr_curv_bh()

◆ extr_curv_bhns()

◆ get_confo()

const Scalar& Lorene::Black_hole::get_confo ( ) const
inlineinherited

Returns the conformal factor generated by the black hole.

Definition at line 241 of file blackhole.h.

References Lorene::Black_hole::confo.

◆ get_confo_auto()

const Scalar& Lorene::Hole_bhns::get_confo_auto ( ) const
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.

◆ get_confo_auto_rs()

const Scalar& Lorene::Hole_bhns::get_confo_auto_rs ( ) const
inline

Returns the part of the conformal factor from numerical computation.

Definition at line 434 of file hole_bhns.h.

References confo_auto_rs.

◆ get_confo_comp()

const Scalar& Lorene::Hole_bhns::get_confo_comp ( ) const
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.

◆ get_confo_tot()

const Scalar& Lorene::Hole_bhns::get_confo_tot ( ) const
inline

Returns the total conformal factor.

Definition at line 447 of file hole_bhns.h.

References confo_tot.

◆ get_d_confo_auto()

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

◆ get_d_confo_auto_rs()

const Vector& Lorene::Hole_bhns::get_d_confo_auto_rs ( ) 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_rs.

◆ get_d_confo_comp()

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

◆ get_d_lapconf_auto()

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

◆ get_d_lapconf_auto_rs()

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

◆ get_d_lapconf_comp()

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

◆ get_d_shift_auto()

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

◆ get_d_shift_auto_rs()

const Tensor& Lorene::Hole_bhns::get_d_shift_auto_rs ( ) 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_rs.

◆ get_d_shift_comp()

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

◆ get_lapconf()

const Scalar& Lorene::Black_hole::get_lapconf ( ) const
inlineinherited

Returns lapconf generated by the black hole.

Definition at line 224 of file blackhole.h.

References Lorene::Black_hole::lapconf.

◆ get_lapconf_auto()

const Scalar& Lorene::Hole_bhns::get_lapconf_auto ( ) const
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.

◆ get_lapconf_auto_rs()

const Scalar& Lorene::Hole_bhns::get_lapconf_auto_rs ( ) const
inline

Returns the part of the lapconf function from numerical computation.

Definition at line 365 of file hole_bhns.h.

References lapconf_auto_rs.

◆ get_lapconf_comp()

const Scalar& Lorene::Hole_bhns::get_lapconf_comp ( ) const
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.

◆ get_lapconf_rs()

const Scalar& Lorene::Black_hole::get_lapconf_rs ( ) const
inlineinherited

Returns the part of lapconf from the numerical computation.

Definition at line 227 of file blackhole.h.

References Lorene::Black_hole::lapconf_rs.

◆ get_lapconf_tot()

const Scalar& Lorene::Hole_bhns::get_lapconf_tot ( ) const
inline

Returns the total lapconf function.

Definition at line 378 of file hole_bhns.h.

References lapconf_tot.

◆ get_lapse()

const Scalar& Lorene::Black_hole::get_lapse ( ) const
inlineinherited

Returns the lapse function generated by the black hole.

Definition at line 230 of file blackhole.h.

References Lorene::Black_hole::lapse.

◆ get_lapse_auto()

const Scalar& Lorene::Hole_bhns::get_lapse_auto ( ) const
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.

◆ get_lapse_tot()

const Scalar& Lorene::Hole_bhns::get_lapse_tot ( ) const
inline

Returns the total lapse function.

Definition at line 386 of file hole_bhns.h.

References lapse_tot.

◆ get_mass_bh()

double Lorene::Black_hole::get_mass_bh ( ) const
inlineinherited

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

Definition at line 221 of file blackhole.h.

References Lorene::Black_hole::mass_bh.

◆ get_mp()

const Map& Lorene::Black_hole::get_mp ( ) const
inlineinherited

Returns the mapping.

Definition at line 213 of file blackhole.h.

References Lorene::Black_hole::mp.

◆ get_omega_spin()

double Lorene::Hole_bhns::get_omega_spin ( ) const
inline

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

Definition at line 362 of file hole_bhns.h.

References omega_spin.

◆ get_shift()

const Vector& Lorene::Black_hole::get_shift ( ) const
inlineinherited

Returns the shift vector generated by the black hole.

Definition at line 233 of file blackhole.h.

References Lorene::Black_hole::shift.

◆ get_shift_auto()

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

◆ get_shift_auto_rs()

const Vector& Lorene::Hole_bhns::get_shift_auto_rs ( ) const
inline

Returns the part of the shift vector from numerical computation.

Definition at line 405 of file hole_bhns.h.

References shift_auto_rs.

◆ get_shift_comp()

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

◆ get_shift_rs()

const Vector& Lorene::Black_hole::get_shift_rs ( ) const
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.

◆ get_shift_tot()

const Vector& Lorene::Hole_bhns::get_shift_tot ( ) const
inline

Returns the total shift vector.

Definition at line 416 of file hole_bhns.h.

References shift_tot.

◆ get_taij_auto()

const Sym_tensor& Lorene::Hole_bhns::get_taij_auto ( ) const
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.

◆ get_taij_auto_rs()

const Sym_tensor& Lorene::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 473 of file hole_bhns.h.

References taij_auto_rs.

◆ get_taij_comp()

const Sym_tensor& Lorene::Hole_bhns::get_taij_comp ( ) const
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.

◆ get_taij_quad_auto()

const Scalar& Lorene::Hole_bhns::get_taij_quad_auto ( ) const
inline

Returns the part of rs generated by the black hole.

Definition at line 494 of file hole_bhns.h.

References taij_quad_auto.

◆ get_taij_quad_comp()

const Scalar& Lorene::Hole_bhns::get_taij_quad_comp ( ) const
inline

Returns the part of rs generated by the companion star.

Definition at line 497 of file hole_bhns.h.

References taij_quad_comp.

◆ get_taij_quad_tot()

const Scalar& Lorene::Hole_bhns::get_taij_quad_tot ( ) const
inline

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

Definition at line 491 of file hole_bhns.h.

References taij_quad_tot.

◆ get_taij_quad_tot_rot()

const Scalar& Lorene::Hole_bhns::get_taij_quad_tot_rot ( ) const
inline

Returns the part of rot.

Definition at line 488 of file hole_bhns.h.

References taij_quad_tot_rot.

◆ get_taij_quad_tot_rs()

const Scalar& Lorene::Hole_bhns::get_taij_quad_tot_rs ( ) const
inline

Returns the part of rs.

Definition at line 486 of file hole_bhns.h.

References taij_quad_tot_rs.

◆ get_taij_tot()

const Sym_tensor& Lorene::Hole_bhns::get_taij_tot ( ) const
inline

Returns the total extrinsic curvature tensor.

Definition at line 468 of file hole_bhns.h.

References taij_tot.

◆ get_taij_tot_rs()

const Sym_tensor& Lorene::Hole_bhns::get_taij_tot_rs ( ) const
inline

Returns the part of rs of the extrinsic curvature tensor.

Definition at line 465 of file hole_bhns.h.

References taij_tot_rs.

◆ has_bc_lapconf_fs()

bool Lorene::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 354 of file hole_bhns.h.

References bc_lapconf_fs.

◆ has_bc_lapconf_nd()

bool Lorene::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 349 of file hole_bhns.h.

References bc_lapconf_nd.

◆ is_irrotational()

bool Lorene::Hole_bhns::is_irrotational ( ) const
inline

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

Definition at line 359 of file hole_bhns.h.

References irrotational.

◆ is_kerrschild()

bool Lorene::Black_hole::is_kerrschild ( ) const
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.

◆ killing_vect()

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.

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 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().

◆ killing_vect_bh()

Vector Lorene::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 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().

◆ mass_adm()

◆ mass_irr()

◆ mass_irr_bhns()

double Lorene::Hole_bhns::mass_irr_bhns ( ) const
virtual

◆ mass_kom()

◆ operator=()

◆ operator>>()

ostream & Lorene::Hole_bhns::operator>> ( ostream &  ost) const
protectedvirtual

◆ r_coord()

const Scalar Lorene::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 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().

◆ rad_ah()

double Lorene::Black_hole::rad_ah ( ) const
virtualinherited

◆ rah_iso()

double Lorene::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 72 of file blackhole_rah_iso.C.

References Lorene::exp(), and Lorene::sqrt().

◆ relax_bhns()

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 .

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 662 of file hole_bhns.C.

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

◆ runge_kutta_phi()

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.

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 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().

◆ runge_kutta_phi_bh()

Tbl Lorene::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 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().

◆ runge_kutta_theta()

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.

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 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().

◆ runge_kutta_theta_bh()

Tbl Lorene::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 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().

◆ sauve()

void Lorene::Hole_bhns::sauve ( FILE *  fich) const
virtual

◆ set_confo_auto()

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().

◆ set_confo_auto_bh()

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().

◆ set_confo_auto_rs()

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().

◆ set_confo_comp()

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().

◆ set_confo_tot()

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().

◆ set_der_0x0()

void Lorene::Hole_bhns::set_der_0x0 ( ) const
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().

◆ set_lapconf_auto()

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.

◆ set_lapconf_auto_bh()

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.

◆ set_lapconf_auto_rs()

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.

◆ set_lapconf_comp()

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.

◆ set_lapconf_tot()

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.

◆ set_lapse_auto()

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.

◆ set_lapse_tot()

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.

◆ set_mass_bh()

double& Lorene::Black_hole::set_mass_bh ( )
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.

◆ set_mp()

Map& Lorene::Black_hole::set_mp ( )
inlineinherited

Read/write of the mapping.

Definition at line 204 of file blackhole.h.

References Lorene::Black_hole::mp.

◆ set_omega_spin()

double& Lorene::Hole_bhns::set_omega_spin ( )
inline

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

Definition at line 290 of file hole_bhns.h.

References omega_spin.

◆ set_shift_auto()

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.

◆ set_shift_auto_bh()

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.

◆ set_shift_auto_rs()

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.

◆ set_shift_comp()

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.

◆ set_shift_tot()

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.

◆ spin_am_bh()

◆ spin_am_bhns()

◆ static_bh()

void Lorene::Black_hole::static_bh ( bool  neumann,
bool  first 
)
inherited

◆ update_met_der_comp_bhns()

void Lorene::Hole_bhns::update_met_der_comp_bhns ( const Star_bhns star)

Computes derivative of metric quantities from the companion neutron star.

Parameters
starcompanion neutron star

Definition at line 63 of file hole_bhns_upmetr_der.C.

References Lorene::Star_bhns::get_d_lapconf_auto().

◆ update_metric_bhns()

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 ,

Parameters
starcompanion neutron star
hole_prevprevious value of the hole
relaxrelaxation 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.

Member Data Documentation

◆ bc_lapconf_fs

bool Lorene::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 78 of file hole_bhns.h.

◆ bc_lapconf_nd

bool Lorene::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 73 of file hole_bhns.h.

◆ confo

Scalar Lorene::Black_hole::confo
protectedinherited

Conformal factor generated by the black hole.

Definition at line 118 of file blackhole.h.

◆ confo_auto

Scalar Lorene::Hole_bhns::confo_auto
protected

Conformal factor generated by the black hole.

Definition at line 163 of file hole_bhns.h.

◆ confo_auto_bh

Scalar Lorene::Hole_bhns::confo_auto_bh
protected

Part of the conformal factor from the analytic background.

Definition at line 160 of file hole_bhns.h.

◆ confo_auto_rs

Scalar Lorene::Hole_bhns::confo_auto_rs
protected

Part of the conformal factor from the numerical computation.

Definition at line 157 of file hole_bhns.h.

◆ confo_comp

Scalar Lorene::Hole_bhns::confo_comp
protected

Conformal factor generated by the companion star.

Definition at line 166 of file hole_bhns.h.

◆ confo_tot

Scalar Lorene::Hole_bhns::confo_tot
protected

Total conformal factor.

Definition at line 169 of file hole_bhns.h.

◆ d_confo_auto

Vector Lorene::Hole_bhns::d_confo_auto
protected

Derivative of the conformal factor generated by the black hole.

Definition at line 182 of file hole_bhns.h.

◆ d_confo_auto_bh

Vector Lorene::Hole_bhns::d_confo_auto_bh
protected

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

Definition at line 179 of file hole_bhns.h.

◆ d_confo_auto_rs

Vector Lorene::Hole_bhns::d_confo_auto_rs
protected

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

Definition at line 174 of file hole_bhns.h.

◆ d_confo_comp

Vector Lorene::Hole_bhns::d_confo_comp
protected

Derivative of the conformal factor generated by the companion star.

Definition at line 185 of file hole_bhns.h.

◆ d_lapconf_auto

Vector Lorene::Hole_bhns::d_lapconf_auto
protected

Derivative of the lapconf function generated by the black hole.

Definition at line 120 of file hole_bhns.h.

◆ d_lapconf_auto_bh

Vector Lorene::Hole_bhns::d_lapconf_auto_bh
protected

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

Definition at line 117 of file hole_bhns.h.

◆ d_lapconf_auto_rs

Vector Lorene::Hole_bhns::d_lapconf_auto_rs
protected

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

Definition at line 112 of file hole_bhns.h.

◆ d_lapconf_comp

Vector Lorene::Hole_bhns::d_lapconf_comp
protected

Derivative of the lapconf function generated by the companion star.

Definition at line 123 of file hole_bhns.h.

◆ d_shift_auto

Tensor Lorene::Hole_bhns::d_shift_auto
protected

Derivative of the shift vector generated by the black hole.

Definition at line 151 of file hole_bhns.h.

◆ d_shift_auto_bh

Tensor Lorene::Hole_bhns::d_shift_auto_bh
protected

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

Definition at line 148 of file hole_bhns.h.

◆ d_shift_auto_rs

Tensor Lorene::Hole_bhns::d_shift_auto_rs
protected

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

Definition at line 143 of file hole_bhns.h.

◆ d_shift_comp

Tensor Lorene::Hole_bhns::d_shift_comp
protected

Derivative of the shift vector generated by the companion star.

Definition at line 154 of file hole_bhns.h.

◆ flat

Metric_flat Lorene::Black_hole::flat
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.

◆ irrotational

bool Lorene::Hole_bhns::irrotational
protected

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

Definition at line 83 of file hole_bhns.h.

◆ kerrschild

bool Lorene::Black_hole::kerrschild
protectedinherited

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

Definition at line 85 of file blackhole.h.

◆ lapconf

Scalar Lorene::Black_hole::lapconf
protectedinherited

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

Definition at line 97 of file blackhole.h.

◆ lapconf_auto

Scalar Lorene::Hole_bhns::lapconf_auto
protected

Lapconf function generated by the black hole.

Definition at line 95 of file hole_bhns.h.

◆ lapconf_auto_bh

Scalar Lorene::Hole_bhns::lapconf_auto_bh
protected

Part of the lapconf function from the analytic background.

Definition at line 92 of file hole_bhns.h.

◆ lapconf_auto_rs

Scalar Lorene::Hole_bhns::lapconf_auto_rs
protected

Part of the lapconf function from the numerical computation.

Definition at line 89 of file hole_bhns.h.

◆ lapconf_bh

Scalar Lorene::Black_hole::lapconf_bh
protectedinherited

Part of lapconf from the analytic background.

Definition at line 103 of file blackhole.h.

◆ lapconf_comp

Scalar Lorene::Hole_bhns::lapconf_comp
protected

Lapconf function generated by the companion star.

Definition at line 98 of file hole_bhns.h.

◆ lapconf_rs

Scalar Lorene::Black_hole::lapconf_rs
protectedinherited

Part of lapconf from the numerical computation.

Definition at line 100 of file blackhole.h.

◆ lapconf_tot

Scalar Lorene::Hole_bhns::lapconf_tot
protected

Total lapconf function.

Definition at line 101 of file hole_bhns.h.

◆ lapse

Scalar Lorene::Black_hole::lapse
protectedinherited

Lapse function generated by the black hole.

Definition at line 106 of file blackhole.h.

◆ lapse_auto

Scalar Lorene::Hole_bhns::lapse_auto
protected

Lapse function of the "black hole" part.

Definition at line 104 of file hole_bhns.h.

◆ lapse_tot

Scalar Lorene::Hole_bhns::lapse_tot
protected

Total lapse function.

Definition at line 107 of file hole_bhns.h.

◆ mass_bh

double Lorene::Black_hole::mass_bh
protectedinherited

Gravitational mass of BH.

Definition at line 88 of file blackhole.h.

◆ mp

Map& Lorene::Black_hole::mp
protectedinherited

Mapping associated with the black hole.

Definition at line 80 of file blackhole.h.

◆ omega_spin

double Lorene::Hole_bhns::omega_spin
protected

Spin angular velocity of the black hole.

Definition at line 86 of file hole_bhns.h.

◆ p_angu_mom_bh

Tbl* Lorene::Black_hole::p_angu_mom_bh
mutableprotectedinherited

Spin angular momentum.

Total angular momentum of the black hole

Definition at line 162 of file blackhole.h.

◆ p_mass_adm

double* Lorene::Black_hole::p_mass_adm
mutableprotectedinherited

Irreducible mass of the black hole.

Definition at line 153 of file blackhole.h.

◆ p_mass_irr

double* Lorene::Black_hole::p_mass_irr
mutableprotectedinherited

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

Definition at line 151 of file blackhole.h.

◆ p_mass_kom

double* Lorene::Black_hole::p_mass_kom
mutableprotectedinherited

ADM mass.

Definition at line 155 of file blackhole.h.

◆ p_rad_ah

double* Lorene::Black_hole::p_rad_ah
mutableprotectedinherited

Komar mass.

Definition at line 157 of file blackhole.h.

◆ p_spin_am_bh

double* Lorene::Black_hole::p_spin_am_bh
mutableprotectedinherited

Radius of the apparent horizon.

Definition at line 159 of file blackhole.h.

◆ p_spin_am_bhns

double* Lorene::Hole_bhns::p_spin_am_bhns
mutableprotected

Irreducible mass of BH.

Quasilocal spin angular momentum of BH

Definition at line 248 of file hole_bhns.h.

◆ shift

Vector Lorene::Black_hole::shift
protectedinherited

Shift vector generated by the black hole.

Definition at line 109 of file blackhole.h.

◆ shift_auto

Vector Lorene::Hole_bhns::shift_auto
protected

Shift vector generated by the black hole.

Definition at line 132 of file hole_bhns.h.

◆ shift_auto_bh

Vector Lorene::Hole_bhns::shift_auto_bh
protected

Part of the shift vector from the analytic background.

Definition at line 129 of file hole_bhns.h.

◆ shift_auto_rs

Vector Lorene::Hole_bhns::shift_auto_rs
protected

Part of the shift vector from the numerical computation.

Definition at line 126 of file hole_bhns.h.

◆ shift_bh

Vector Lorene::Black_hole::shift_bh
protectedinherited

Part of the shift vector from the analytic background.

Definition at line 115 of file blackhole.h.

◆ shift_comp

Vector Lorene::Hole_bhns::shift_comp
protected

Shift vector generated by the companion star.

Definition at line 135 of file hole_bhns.h.

◆ shift_rs

Vector Lorene::Black_hole::shift_rs
protectedinherited

Part of the shift vector from the numerical computation.

Definition at line 112 of file blackhole.h.

◆ shift_tot

Vector Lorene::Hole_bhns::shift_tot
protected

Total shift vector ;.

Definition at line 138 of file hole_bhns.h.

◆ taij

Sym_tensor Lorene::Black_hole::taij
protectedinherited

Trace of the extrinsic curvature.

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

Definition at line 127 of file blackhole.h.

◆ taij_auto

Sym_tensor Lorene::Hole_bhns::taij_auto
protected

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

Definition at line 216 of file hole_bhns.h.

◆ taij_auto_rs

Sym_tensor Lorene::Hole_bhns::taij_auto_rs
protected

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

Definition at line 211 of file hole_bhns.h.

◆ taij_comp

Sym_tensor Lorene::Hole_bhns::taij_comp
protected

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

Definition at line 221 of file hole_bhns.h.

◆ taij_quad

Scalar Lorene::Black_hole::taij_quad
protectedinherited

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

Definition at line 135 of file blackhole.h.

◆ taij_quad_auto

Scalar Lorene::Hole_bhns::taij_quad_auto
protected

Part of the scalar from the black hole.

Definition at line 238 of file hole_bhns.h.

◆ taij_quad_comp

Scalar Lorene::Hole_bhns::taij_quad_comp
protected

Part of the scalar from the companion star.

Definition at line 241 of file hole_bhns.h.

◆ taij_quad_rs

Scalar Lorene::Black_hole::taij_quad_rs
protectedinherited

Part of the scalar.

Definition at line 138 of file blackhole.h.

◆ taij_quad_tot

Scalar Lorene::Hole_bhns::taij_quad_tot
protected

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

Definition at line 235 of file hole_bhns.h.

◆ taij_quad_tot_bh

Scalar Lorene::Hole_bhns::taij_quad_tot_bh
protected

Part of the scalar from the analytic background.

Definition at line 230 of file hole_bhns.h.

◆ taij_quad_tot_rot

Scalar Lorene::Hole_bhns::taij_quad_tot_rot
protected

Part of the scalar from the rotation shift vector.

Definition at line 227 of file hole_bhns.h.

◆ taij_quad_tot_rs

Scalar Lorene::Hole_bhns::taij_quad_tot_rs
protected

Part of the scalar from the numerical computation.

Definition at line 224 of file hole_bhns.h.

◆ taij_rs

Sym_tensor Lorene::Black_hole::taij_rs
protectedinherited

Part of the extrinsic curvature tensor.

Definition at line 130 of file blackhole.h.

◆ taij_tot

Sym_tensor Lorene::Hole_bhns::taij_tot
protected

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

Definition at line 206 of file hole_bhns.h.

◆ taij_tot_bh

Sym_tensor Lorene::Hole_bhns::taij_tot_bh
protected

Part of the extrinsic curvature tensor from the analytic background.

Definition at line 200 of file hole_bhns.h.

◆ taij_tot_rot

Sym_tensor Lorene::Hole_bhns::taij_tot_rot
protected

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

Definition at line 195 of file hole_bhns.h.

◆ taij_tot_rs

Sym_tensor Lorene::Hole_bhns::taij_tot_rs
protected

Part of the extrinsic curvature tensor from the numerical computation.

Definition at line 190 of file hole_bhns.h.


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