LORENE
|
Binary black holes system. More...
#include <isol_hor.h>
Public Member Functions | |
Single_hor (Map_af &mpi) | |
Standard constructor. | |
Single_hor (const Single_hor &) | |
Copy constructor. | |
Single_hor (Map_af &mp, FILE *fich) | |
Constructor from a binary file. | |
virtual | ~Single_hor () |
Destructor. | |
void | operator= (const Single_hor &) |
Assignment to another Single_hor. | |
const Map_af & | get_mp () const |
Returns the mapping (readonly). | |
Map_af & | set_mp () |
Read/write of the mapping. | |
double | get_radius () const |
Returns the radius of the horizon. | |
void | set_radius (double rad) |
Sets the radius of the horizon to rad . | |
double | get_omega () const |
Returns the angular velocity. | |
void | set_omega (double ome) |
Sets the angular velocity to ome . | |
const Scalar & | get_n_auto () const |
Lapse function ![]() | |
const Scalar & | get_n_comp () const |
Lapse function ![]() | |
const Scalar & | get_nn () const |
Lapse function ![]() | |
const Scalar & | get_psi_auto () const |
Conformal factor ![]() | |
const Scalar & | get_psi_comp () const |
Conformal factor ![]() | |
const Scalar & | get_psi () const |
Conformal factor ![]() | |
const Scalar & | get_psi4 () const |
Conformal factor ![]() | |
const Vector & | get_dn () const |
Covariant derivative of the lapse function ![]() | |
const Vector & | get_dpsi () const |
Covariant derivative with respect to the flat metric of the conformal factor ![]() | |
const Vector & | get_beta_auto () const |
Shift function ![]() | |
const Vector & | get_beta_comp () const |
Shift function ![]() | |
const Vector & | get_beta () const |
Shift function ![]() | |
const Sym_tensor & | get_aa_auto () const |
Conformal representation ![]() | |
const Sym_tensor & | get_aa_comp () const |
Conformal representation ![]() | |
const Sym_tensor & | get_aa () const |
Conformal representation ![]() | |
const Metric & | get_tgam () const |
Conformal metric ![]() | |
const Metric & | get_gam () const |
metric ![]() | |
const Sym_tensor & | get_k_dd () const |
k_dd | |
const Scalar | get_decouple () const |
Returns the function used to construct tkij_auto from tkij_tot . | |
void | n_comp_import (const Single_hor &comp) |
Imports the part of N due to the companion hole comp . | |
void | psi_comp_import (const Single_hor &comp) |
Imports the part of ![]() comp . | |
void | beta_comp_import (const Single_hor &comp) |
Imports the part of ![]() comp . | |
double | viriel_seul () const |
Computes the viriel error, that is the difference between the ADM and the Komar masses, calculated by the asymptotic behaviours of respectively ![]() | |
void | init_bhole () |
Sets the values of the fields to : | |
void | init_met_trK () |
Sets the 3-metric tilde to the flat metric and gamt_point, trK and trK_point to zero. | |
void | init_bhole_seul () |
Initiates for a single black hole. | |
void | set_psi_auto (const Scalar &psi_in) |
Sets the conformal factor ![]() ![]() ![]() | |
void | set_n_auto (const Scalar &nn_in) |
Sets the lapse. | |
void | set_beta_auto (const Scalar &shift_in) |
Sets the shift. | |
void | set_aa_auto (const Scalar &aa_auto_in) |
Sets aa_auto. | |
void | set_aa_comp (const Scalar &aa_comp_in) |
Sets aa_comp. | |
void | set_aa (const Scalar &aa_in) |
Sets aa. | |
const Scalar | b_tilde () const |
Radial component of the shift with respect to the conformal metric. | |
const Scalar | darea_hor () const |
Element of area of the horizon. | |
double | area_hor () const |
Area of the horizon. | |
double | radius_hor () const |
Radius of the horizon. | |
double | ang_mom_hor () const |
Angular momentum (modulo) | |
double | mass_hor () const |
Mass computed at the horizon | |
double | kappa_hor () const |
Surface gravity | |
double | omega_hor () const |
Orbital velocity | |
double | ang_mom_adm () const |
ADM angular Momentum | |
Scalar | expansion () const |
Expansion of the outgoing null normal ( ![]() | |
const Valeur | boundary_psi_app_hor () const |
Neumann boundary condition for. | |
Component x of boundary value of f$ beta f$ const Valeur | boundary_beta_x (double om_orb, double om_loc) const |
Component y of boundary value of f$ beta f$ const Valeur | boundary_beta_y (double om_orb, double om_loc) const |
Component z of boundary value of f$ beta f$ const Valeur | boundary_beta_z () const |
double | regularisation (const Vector &shift_auto, const Vector &shift_comp, double ang_vel) |
Corrects shift_auto in such a way that the total ![]() ![]() | |
double | regularise_one () |
Corrects the shift in the innermost shell, so that it remains ![]() ![]() | |
virtual void | sauve (FILE *fich) const |
Total or partial saves in a binary file. | |
Public Attributes | |
Dirichlet boundary condition for c N f$ partial_r N a | N |
Neumann boundary condition on nn f$ partial_r N a | N |
Protected Member Functions | |
void | del_deriv () const |
Deletes all the derived quantities. | |
void | set_der_0x0 () const |
Sets to 0x0 all the pointers on derived quantities. | |
Protected Attributes | |
Map_af & | mp |
Affine mapping. | |
int | nz |
Number of zones. | |
double | radius |
Radius of the horizon in LORENE's units. | |
double | omega |
Angular velocity in LORENE's units. | |
double | regul |
Intensity of the correction on the shift vector. | |
Scalar | n_auto |
Lapse function ![]() | |
Scalar | n_comp |
Lapse function ![]() | |
Scalar | nn |
Lapse function ![]() | |
Scalar | psi_auto |
Conformal factor ![]() | |
Scalar | psi_comp |
Conformal factor ![]() | |
Scalar | psi |
Conformal factor ![]() | |
Scalar * | p_psi4 |
Conformal factor ![]() | |
Vector | dn |
Covariant derivative of the lapse with respect to the flat metric ![]() | |
Vector | dpsi |
Covariant derivative of the conformal factor ![]() | |
Vector | beta_auto |
Shift function ![]() | |
Vector | beta_comp |
Shift function ![]() | |
Vector | beta |
Shift function ![]() | |
Metric * | p_gam |
Spatial metric ![]() | |
Sym_tensor | aa_auto |
Components ![]() | |
Sym_tensor | aa_comp |
Components ![]() | |
Sym_tensor | aa |
Components ![]() | |
Sym_tensor * | p_k_dd |
Components ![]() | |
Metric | tgam |
3 metric tilde | |
Metric_flat | ff |
3 metric flat | |
Sym_tensor | hh |
Deviation metric. | |
Sym_tensor | gamt_point |
Time derivative of the 3-metric tilde. | |
Scalar | trK |
Trace of the extrinsic curvature. | |
Scalar | trK_point |
Time derivative of the trace of the extrinsic curvature. | |
Scalar | decouple |
Function used to construct ![]() ![]() | |
Friends | |
class | Bin_hor |
Binary black holes system.
()
This class is intended for dealing with binary black holes configurations in the conformaly flat approximation.
Definition at line 894 of file isol_hor.h.
Lorene::Single_hor::Single_hor | ( | Map_af & | mpi | ) |
Standard constructor.
mpi | affine mapping |
Definition at line 70 of file single_hor.C.
References hh, set_der_0x0(), and Lorene::Tensor::set_etat_zero().
Lorene::Single_hor::Single_hor | ( | const Single_hor & | singlehor_in | ) |
Constructor from a binary file.
mpi | affine mapping |
fich | file containing the saved isol_hor |
partial_read | indicates whether the full object must be read in file or whether the final construction is devoted to a constructor of a derived class |
Definition at line 130 of file single_hor.C.
References Lorene::Metric::con(), Lorene::Metric_flat::con(), ff, Lorene::fread_be(), gamt_point, Lorene::Map::get_bvect_spher(), Lorene::Map::get_mg(), hh, mp, omega, set_der_0x0(), tgam, trK, and trK_point.
|
virtual |
double Lorene::Single_hor::ang_mom_adm | ( | ) | const |
ADM angular Momentum
Definition at line 174 of file single_param.C.
References Lorene::Metric::cov(), get_gam(), get_k_dd(), Lorene::Map_af::integrale_surface_infini(), mp, Lorene::Scalar::mult_rsint(), and trK.
double Lorene::Single_hor::ang_mom_hor | ( | ) | const |
Angular momentum (modulo)
Definition at line 107 of file single_param.C.
References Lorene::contract(), darea_hor(), ff, get_gam(), get_k_dd(), Lorene::Metric::get_mp(), Lorene::Metric_flat::get_triad(), Lorene::Map_af::integrale_surface(), mp, Lorene::Scalar::mult_rsint(), radius, Lorene::Vector::set(), and Lorene::Scalar::std_spectral_base().
double Lorene::Single_hor::area_hor | ( | ) | const |
Area of the horizon.
Definition at line 88 of file single_param.C.
References darea_hor(), Lorene::Map_af::integrale_surface(), mp, Lorene::Scalar::raccord(), and radius.
Radial component of the shift with respect to the conformal metric.
Definition at line 68 of file single_param.C.
References beta, Lorene::contract(), Lorene::Tensor::down(), Lorene::Metric::radial_vect(), and tgam.
void Lorene::Single_hor::beta_comp_import | ( | const Single_hor & | comp | ) |
Imports the part of comp
.
The total
Definition at line 465 of file single_hor.C.
References beta, beta_auto, beta_comp, Lorene::Vector::change_triad(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Tensor::get_triad(), Lorene::Scalar::import(), mp, Lorene::Vector::set(), and Lorene::Vector::std_spectral_base().
Definition at line 174 of file single_bound.C.
Definition at line 217 of file single_bound.C.
Definition at line 260 of file single_bound.C.
Neumann boundary condition for.
Definition at line 69 of file single_bound.C.
References Lorene::contract(), Lorene::Scalar::derive_cov(), Lorene::Vector::divergence(), ff, Lorene::Map::flat_met_spher(), Lorene::Mg3d::get_angu(), Lorene::Map::get_bvect_spher(), get_k_dd(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nt(), mp, psi, Lorene::Metric::radial_vect(), Lorene::Valeur::set(), Lorene::Vector::set(), Lorene::Valeur::std_base_scal(), Lorene::Vector::std_spectral_base(), tgam, trK, and Lorene::Scalar::val_grid_point().
Element of area of the horizon.
Definition at line 77 of file single_param.C.
References get_gam(), Lorene::sqrt(), and Lorene::Scalar::std_spectral_base().
|
protected |
Deletes all the derived quantities.
Definition at line 221 of file single_hor.C.
References p_gam, p_k_dd, p_psi4, and set_der_0x0().
Scalar Lorene::Single_hor::expansion | ( | ) | const |
Expansion of the outgoing null normal (
Definition at line 190 of file single_param.C.
References Lorene::contract(), get_gam(), get_k_dd(), and trK.
const Sym_tensor & Lorene::Single_hor::get_aa | ( | ) | const |
Conformal representation
Definition at line 334 of file single_hor.C.
References aa.
const Sym_tensor & Lorene::Single_hor::get_aa_auto | ( | ) | const |
Conformal representation
Definition at line 324 of file single_hor.C.
References aa_auto.
const Sym_tensor & Lorene::Single_hor::get_aa_comp | ( | ) | const |
Conformal representation
Definition at line 329 of file single_hor.C.
References aa_comp.
Returns the function used to construct tkij_auto
from tkij_tot
.
Definition at line 1146 of file isol_hor.h.
References decouple.
Covariant derivative of the lapse function
Definition at line 299 of file single_hor.C.
References dn.
Covariant derivative with respect to the flat metric of the conformal factor
Definition at line 304 of file single_hor.C.
References dpsi.
metric
Definition at line 339 of file single_hor.C.
References Lorene::Metric::cov(), get_psi4(), p_gam, and tgam.
const Sym_tensor & Lorene::Single_hor::get_k_dd | ( | ) | const |
k_dd
Definition at line 348 of file single_hor.C.
References aa, get_gam(), get_psi4(), p_k_dd, Lorene::Tensor::std_spectral_base(), trK, and Lorene::Tensor::up_down().
|
inline |
Conformal factor
Definition at line 288 of file single_hor.C.
References p_psi4, Lorene::pow(), psi, and Lorene::Scalar::std_spectral_base().
|
inline |
void Lorene::Single_hor::init_bhole | ( | ) |
Sets the values of the fields to :
n_auto
n_comp
psi_auto
psi_comp
a being the radius of the hole, the other fields being set to zero.
Definition at line 484 of file single_hor.C.
References Lorene::Scalar::annule(), beta, beta_auto, beta_comp, Lorene::Scalar::derive_cov(), dn, dpsi, ff, Lorene::Map::get_bvect_spher(), mp, n_auto, n_comp, nn, psi, psi_auto, psi_comp, Lorene::Map::r, Lorene::Scalar::raccord(), radius, Lorene::Vector::set(), Lorene::Scalar::set_dzpuis(), Lorene::Tensor::set_etat_zero(), Lorene::Scalar::std_spectral_base(), and Lorene::Vector::std_spectral_base().
void Lorene::Single_hor::init_bhole_seul | ( | ) |
Initiates for a single black hole.
WARNING It supposes that the boost is zero and should only be used for an isolated black hole..
Definition at line 548 of file single_hor.C.
References Lorene::Scalar::annule(), beta, beta_auto, beta_comp, Lorene::Scalar::derive_cov(), dn, dpsi, ff, Lorene::Map::get_bvect_spher(), Lorene::Map::get_mg(), mp, n_auto, n_comp, nn, psi, psi_auto, psi_comp, Lorene::Map::r, Lorene::Scalar::raccord(), radius, Lorene::Scalar::set_dzpuis(), Lorene::Scalar::set_etat_zero(), Lorene::Tensor::set_etat_zero(), Lorene::Scalar::set_outer_boundary(), and Lorene::Scalar::std_spectral_base().
void Lorene::Single_hor::init_met_trK | ( | ) |
Sets the 3-metric tilde to the flat metric and gamt_point, trK and trK_point to zero.
Definition at line 536 of file single_hor.C.
References Lorene::Map::flat_met_spher(), gamt_point, mp, Lorene::Scalar::set_etat_zero(), Lorene::Tensor::set_etat_zero(), tgam, trK, and trK_point.
double Lorene::Single_hor::kappa_hor | ( | ) | const |
Surface gravity
Definition at line 146 of file single_param.C.
References ang_mom_hor(), Lorene::pow(), radius_hor(), and Lorene::sqrt().
double Lorene::Single_hor::mass_hor | ( | ) | const |
Mass computed at the horizon
Definition at line 135 of file single_param.C.
References ang_mom_hor(), Lorene::pow(), radius_hor(), and Lorene::sqrt().
void Lorene::Single_hor::n_comp_import | ( | const Single_hor & | comp | ) |
Imports the part of N due to the companion hole comp
.
The total N is then calculated.
It also imports the covariant derivative of N and construct the total
Definition at line 390 of file single_hor.C.
References Lorene::Vector::change_triad(), Lorene::Tensor::dec_dzpuis(), Lorene::Scalar::derive_cov(), dn, ff, Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Tensor::get_mp(), Lorene::Tensor::get_triad(), Lorene::Scalar::import(), Lorene::Tensor::inc_dzpuis(), mp, n_auto, n_comp, nn, Lorene::Scalar::raccord(), Lorene::Vector::set(), Lorene::Valeur::set_base(), Lorene::Tensor::set_etat_qcq(), Lorene::Scalar::set_spectral_va(), and Lorene::Scalar::std_spectral_base().
double Lorene::Single_hor::omega_hor | ( | ) | const |
Orbital velocity
Definition at line 160 of file single_param.C.
References ang_mom_hor(), Lorene::pow(), radius_hor(), and Lorene::sqrt().
void Lorene::Single_hor::operator= | ( | const Single_hor & | singlehor_in | ) |
void Lorene::Single_hor::psi_comp_import | ( | const Single_hor & | comp | ) |
Imports the part of comp
.
The total
It also imports the covariant derivative of
Definition at line 424 of file single_hor.C.
References Lorene::Vector::change_triad(), Lorene::Tensor::dec_dzpuis(), Lorene::Scalar::derive_cov(), dpsi, ff, Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Tensor::get_mp(), Lorene::Tensor::get_triad(), Lorene::Scalar::import(), Lorene::Tensor::inc_dzpuis(), mp, psi, psi_auto, psi_comp, Lorene::Scalar::raccord(), Lorene::Vector::set(), Lorene::Valeur::set_base(), Lorene::Tensor::set_etat_qcq(), Lorene::Scalar::set_spectral_va(), and Lorene::Scalar::std_spectral_base().
double Lorene::Single_hor::radius_hor | ( | ) | const |
Radius of the horizon.
Definition at line 97 of file single_param.C.
References area_hor(), and Lorene::pow().
double Lorene::Single_hor::regularisation | ( | const Vector & | shift_auto, |
const Vector & | shift_comp, | ||
double | ang_vel | ||
) |
Corrects shift_auto
in such a way that the total
WARNING : this should only be used for a black hole in a binary system Bin_hor
.
comp | [input]: the part of ![]() |
Definition at line 59 of file single_regul.C.
References Lorene::Valeur::annule(), Lorene::Tensor::annule_domain(), Lorene::Valeur::annule_hard(), beta_auto, Lorene::Vector::change_triad(), Lorene::Valeur::coef_i(), Lorene::diffrelmax(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Map::get_mg(), Lorene::Tensor::get_mp(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Map::get_rot_phi(), Lorene::Tensor::get_triad(), Lorene::Scalar::import(), Lorene::norme(), nz, Lorene::pow(), Lorene::Map::r, Lorene::Valeur::set(), Lorene::Vector::set(), Lorene::Valeur::set_base(), Lorene::Valeur::set_etat_c_qcq(), Lorene::Scalar::set_spectral_va(), Lorene::Vector::std_spectral_base(), Lorene::Map::val_r(), Lorene::Map::xa, and Lorene::Map::ya.
double Lorene::Single_hor::regularise_one | ( | ) |
Corrects the shift in the innermost shell, so that it remains
return the relative difference between the shift before and after the regularisation.
WARNING this should only be used for an isolated black hole.
Definition at line 153 of file single_regul.C.
References Lorene::Valeur::annule(), Lorene::Tensor::annule_domain(), Lorene::Valeur::annule_hard(), Lorene::Valeur::base, beta, Lorene::Vector::change_triad(), Lorene::Valeur::coef_i(), Lorene::diffrelmax(), Lorene::Map::get_bvect_cart(), Lorene::Map::get_bvect_spher(), Lorene::Map::get_mg(), Lorene::Mg3d::get_np(), Lorene::Mg3d::get_nr(), Lorene::Mg3d::get_nt(), Lorene::Mg3d::get_nzone(), mp, Lorene::norme(), nz, omega, Lorene::pow(), Lorene::Map::r, Lorene::Valeur::set(), Lorene::Vector::set(), Lorene::Valeur::set_etat_c_qcq(), Lorene::Tensor::set_etat_qcq(), Lorene::Scalar::set_spectral_va(), Lorene::Vector::std_spectral_base(), Lorene::Map_af::val_r(), Lorene::Map::x, and Lorene::Map::y.
Total or partial saves in a binary file.
fich | binary file |
partial_save | indicates whether the whole object must be saved. |
Definition at line 244 of file single_hor.C.
References beta_auto, Lorene::Metric::con(), Lorene::fwrite_be(), gamt_point, n_auto, omega, psi_auto, Lorene::Scalar::sauve(), Lorene::Tensor::sauve(), Lorene::Tensor_sym::sauve(), tgam, trK, and trK_point.
|
protected |
Sets to 0x0
all the pointers on derived quantities.
Definition at line 231 of file single_hor.C.
|
inline |
Sets the conformal factor
Sets the value at the current time step (jtime
) and delete all quantities which depend on
Definition at line 362 of file single_hor.C.
References psi_auto.
Sets the radius of the horizon to rad
.
Definition at line 1051 of file isol_hor.h.
References radius.
double Lorene::Single_hor::viriel_seul | ( | ) | const |
Computes the viriel error, that is the difference between the ADM and the Komar masses, calculated by the asymptotic behaviours of respectively
WARNING this should only be used for an isolated black hole.
Definition at line 57 of file binhor_viriel.C.
References Lorene::Scalar::asymptot(), Lorene::Map::get_mg(), Lorene::Mg3d::get_nzone(), mp, n_auto, and psi_auto.
Definition at line 1333 of file isol_hor.h.
|
protected |
Components
Definition at line 971 of file isol_hor.h.
|
protected |
Components
Definition at line 959 of file isol_hor.h.
|
protected |
Components
Definition at line 965 of file isol_hor.h.
|
protected |
Shift function
Definition at line 950 of file isol_hor.h.
|
protected |
Shift function
Definition at line 944 of file isol_hor.h.
|
protected |
Shift function
Definition at line 947 of file isol_hor.h.
|
protected |
Function used to construct
Only used for a binary system.
Mainly this Scalar
is 1 around the hole and 0 around the companion and the sum of decouple
for the hole and his companion is 1 everywhere.
Definition at line 1002 of file isol_hor.h.
|
protected |
Covariant derivative of the lapse with respect to the flat metric
Definition at line 937 of file isol_hor.h.
|
protected |
Covariant derivative of the conformal factor
Definition at line 941 of file isol_hor.h.
|
protected |
3 metric flat
Definition at line 980 of file isol_hor.h.
|
protected |
Time derivative of the 3-metric tilde.
Definition at line 986 of file isol_hor.h.
|
protected |
Deviation metric.
Definition at line 983 of file isol_hor.h.
|
protected |
Affine mapping.
Definition at line 900 of file isol_hor.h.
Definition at line 1282 of file isol_hor.h.
Definition at line 1286 of file isol_hor.h.
|
protected |
Lapse function
Definition at line 915 of file isol_hor.h.
|
protected |
Lapse function
Definition at line 918 of file isol_hor.h.
|
protected |
Lapse function
Definition at line 921 of file isol_hor.h.
|
protected |
Number of zones.
Definition at line 903 of file isol_hor.h.
|
protected |
Angular velocity in LORENE's units.
Definition at line 909 of file isol_hor.h.
|
mutableprotected |
Spatial metric
Definition at line 953 of file isol_hor.h.
|
mutableprotected |
Components
Definition at line 974 of file isol_hor.h.
|
mutableprotected |
Conformal factor
Definition at line 933 of file isol_hor.h.
|
protected |
Conformal factor
Definition at line 930 of file isol_hor.h.
|
protected |
Conformal factor
Definition at line 924 of file isol_hor.h.
|
protected |
Conformal factor
Definition at line 927 of file isol_hor.h.
|
protected |
Radius of the horizon in LORENE's units.
Definition at line 906 of file isol_hor.h.
|
protected |
Intensity of the correction on the shift vector.
Definition at line 912 of file isol_hor.h.
|
protected |
3 metric tilde
Definition at line 977 of file isol_hor.h.
|
protected |
Trace of the extrinsic curvature.
Definition at line 989 of file isol_hor.h.
|
protected |
Time derivative of the trace of the extrinsic curvature.
Definition at line 992 of file isol_hor.h.