ESTER
Evolution STEllaire en Rotation
 All Classes Files Functions Variables Enumerations Enumerator Friends Macros Pages
Classes | Public Member Functions | Public Attributes | Protected Member Functions | List of all members
star2d Class Reference

#include <star.h>

Inheritance diagram for star2d:
Inheritance graph
[legend]
Collaboration diagram for star2d:
Collaboration graph
[legend]

Classes

struct  config_struct
 
struct  units_struct
 
struct  version_struct
 

Public Member Functions

void calc_units ()
 
 star2d ()
 
virtual ~star2d ()
 
 star2d (const star2d &)
 
star2doperator= (const star2d &)
 
virtual void opacity ()
 
virtual void nuclear ()
 
virtual void eq_state ()
 
virtual void atmosphere ()
 
virtual int init (const char *input_file, const char *param_file, int argc, char *argv[])
 
virtual int check_arg (char *arg, char *val, int *change_grid)
 
virtual int read (const char *input_file, int dim=2)
 
virtual int read_old (const char *input_file)
 
virtual void write (const char *output_file, char output_mode='b') const
 
virtual void interp (remapper *red)
 
virtual void dump_info ()
 
virtual void init_comp ()
 
virtual solverinit_solver (int nvar_add=0)
 
virtual double solve (solver *)
 Performs one step of the Newton algorithm to compute the star's internal structure. More...
 
virtual void register_variables (solver *op)
 
virtual void solve_poisson (solver *)
 Writes Poisson equation and interface conditions into the solver. More...
 
virtual void solve_mov (solver *)
 Writes movement and vorticity equations into the solver. More...
 
virtual void solve_temp (solver *)
 Writes temperature and luminosity equations and interface conditions into the solver. More...
 
virtual void solve_dim (solver *)
 Writes the equations for the dimensional quantities (T_c, rho_c, R, etc.) More...
 
virtual void solve_map (solver *)
 Part of the Jacobian associated with the mapping There are geometrical relations and physical relations placing the physical interfaces on surfaces zeta=cst. Option also to define the stellar surface as a tau=cst or P=cst. More...
 
virtual void solve_Omega (solver *)
 Equation setting the equatorial angular velocity. More...
 
virtual void solve_gsup (solver *)
 Equation giving the effective surface gravity gsup gsup=(- P)/rho. More...
 
virtual void solve_Teff (solver *)
 Equation setting the surface effective temperature Derived from sigma T_e^4 = -xi. More...
 
virtual void solve_definitions (solver *)
 insert the definitions depending on opacity and eos tables into the solver, and the definitions used by the mapping (eta,deta,Ri,dRi,...), and the entropy More...
 
virtual void solve_atm (solver *)
 Equation setting the 'simple' atmosphere model equations To be checked. More...
 
virtual void update_map (matrix dR)
 
virtual void calc_veloc ()
 
virtual matrix entropy () const
 
virtual double luminosity () const
 
virtual matrix Teff () const
 
virtual matrix N2 () const
 
virtual matrix gsup () const
 
virtual double virial_3P () const
 
virtual double virial_L () const
 
virtual double virial_W () const
 
virtual double virial_ps () const
 
virtual double virial () const
 
virtual double energy_test () const
 
virtual matrix stream () const
 
virtual double apparent_luminosity (double i) const
 
virtual double Lz () const
 
virtual double Mcore () const
 
virtual double Lzcore () const
 
virtual matrix Rcore () const
 
virtual void fill ()
 Initialize star's chemical composition, equation of state, opacity, nuclear reaction, mass definition, pi_c, Lambda, velocity, units, atmosphere, flatness, scaled keplerian angular velocity. More...
 
virtual void remap (int ndomains, int *npts, int nth, int nex)
 
virtual bool remap_domains (int ndom, remapper &red)
 
virtual matrix find_boundaries (const matrix &logTi) const
 
virtual std::vector< int > distribute_domains (int ndom, matrix &zif, bool check_only=false) const
 
virtual matrix distribute_domains (int ndomains, int &conv_new, double p_cc=0) const
 
virtual matrix find_boundaries_old (matrix pif) const
 
virtual void check_map ()
 
virtual int check_convec (double &p_cc, matrix &Rcc)
 
void draw (figure *, const matrix &, int parity=0) const
 
void drawi (figure *, const matrix &, int sr, int st, int parity=0) const
 
void drawc (figure *, const matrix &, int ncontours, int parity=0) const
 
void drawci (figure *, const matrix &, int sr, int st, int ncontours, int parity=0) const
 
void spectrum (figure *, const matrix &, int parity=0) const
 
matrix kconv () const
 
void add_kconv (solver *op, const char *eqn, const matrix &d)
 
void add_dkconv_dz (solver *op, const char *eqn, const matrix &d)
 
void kconv_common (matrix &kc, matrix &Ja, matrix &Jb, symbolic &S, sym &a_, sym &b_) const
 
virtual void check_jacobian (solver *op, const char *eqn)
 Routine to check the Jacobian matrix. More...
 
void hdf5_write (const char *filename) const
 
int hdf5_read (const char *input_file, int dim)
 

Public Attributes

mapping map
 
const int & nr
 
const int & nth
 
const int & nex
 
const int & ndomains
 
const matrixr
 
const matrixz
 
const matrixth
 
const matrixDt
 
const matrixDt2
 
const matrixzex
 
const matrixDex
 
const matrixrex
 
const matrix_block_diagD
 
matrix rho
 
matrix phi
 
matrix p
 
matrix T
 
matrix phiex
 
matrix vr
 
matrix vt
 
matrix G
 
matrix w
 
composition_map comp
 
double X0
 
double Y0
 
double Z0
 
double R
 
double M
 
double rhoc
 
double Tc
 
double pc
 
double Omega
 
double Omega_bk
 
double Omegac
 
double Ekman
 
opa_struct opa
 
nuc_struct nuc
 
eos_struct eos
 
atm_struct atm
 
matrix ps
 
matrix Ts
 
double m
 
double pi_c
 
double Lambda
 
double surff
 
int conv
 
double Xc
 
int core_convec
 
int env_convec
 
int stratified_comp
 
double min_core_size
 
std::vector< int > domain_type
 
struct star2d::version_struct version
 
struct star2d::units_struct units
 
struct star2d::config_struct config
 

Protected Member Functions

virtual void copy (const star2d &)
 
void init1d (const star1d &A, int npts_th, int npts_ex)
 
virtual bool check_tag (const char *tag) const
 
virtual void write_tag (OUTFILE *fp) const
 

Constructor & Destructor Documentation

star2d::star2d ( )
star2d::~star2d ( )
virtual
star2d::star2d ( const star2d A)

Here is the call graph for this function:

Member Function Documentation

void star2d::add_dkconv_dz ( solver op,
const char *  eqn,
const matrix d 
)
void star2d::add_kconv ( solver op,
const char *  eqn,
const matrix d 
)

Here is the call graph for this function:

double star2d::apparent_luminosity ( double  i) const
virtual

Here is the call graph for this function:

void star2d::atmosphere ( )
virtual

Here is the call graph for this function:

void star2d::calc_units ( )

Here is the call graph for this function:

void star2d::calc_veloc ( )
virtual

Here is the call graph for this function:

int star2d::check_arg ( char *  arg,
char *  val,
int *  change_grid 
)
virtual

Reimplemented in star1d.

Here is the call graph for this function:

int star2d::check_convec ( double &  p_cc,
matrix Rcc 
)
virtual

Here is the call graph for this function:

void star2d::check_jacobian ( solver op,
const char *  eqn 
)
virtual

Routine to check the Jacobian matrix.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::check_map ( )
virtual

Here is the call graph for this function:

bool star2d::check_tag ( const char *  tag) const
protectedvirtual

Reimplemented in star1d.

void star2d::copy ( const star2d A)
protectedvirtual
std::vector< int > star2d::distribute_domains ( int  ndom,
matrix zif,
bool  check_only = false 
) const
virtual

Here is the call graph for this function:

matrix star2d::distribute_domains ( int  ndomains,
int &  conv_new,
double  p_cc = 0 
) const
virtual

Here is the call graph for this function:

void star2d::draw ( figure pfig,
const matrix A,
int  parity = 0 
) const

Here is the call graph for this function:

void star2d::drawc ( figure pfig,
const matrix A,
int  ncontours,
int  parity = 0 
) const

Here is the call graph for this function:

void star2d::drawci ( figure pfig,
const matrix A,
int  sr,
int  st,
int  ncontours,
int  parity = 0 
) const

Here is the call graph for this function:

void star2d::drawi ( figure pfig,
const matrix A,
int  sr,
int  st,
int  parity = 0 
) const

Here is the call graph for this function:

void star2d::dump_info ( )
virtual

Reimplemented in star1d.

Here is the call graph for this function:

double star2d::energy_test ( ) const
virtual

Here is the call graph for this function:

matrix star2d::entropy ( ) const
virtual

Here is the call graph for this function:

void star2d::eq_state ( )
virtual

Here is the call graph for this function:

void star2d::fill ( )
virtual

Initialize star's chemical composition, equation of state, opacity, nuclear reaction, mass definition, pi_c, Lambda, velocity, units, atmosphere, flatness, scaled keplerian angular velocity.

Reimplemented in star_evol, and star1d.

Here is the call graph for this function:

matrix star2d::find_boundaries ( const matrix logTi) const
virtual

Here is the call graph for this function:

matrix star2d::find_boundaries_old ( matrix  pif) const
virtual

Here is the call graph for this function:

matrix star2d::gsup ( ) const
virtual

Reimplemented in star1d.

Here is the call graph for this function:

int star2d::hdf5_read ( const char *  input_file,
int  dim 
)

Here is the call graph for this function:

void star2d::hdf5_write ( const char *  filename) const

Here is the call graph for this function:

int star2d::init ( const char *  input_file,
const char *  param_file,
int  argc,
char *  argv[] 
)
virtual

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::init1d ( const star1d A,
int  npts_th,
int  npts_ex 
)
protected

Here is the call graph for this function:

void star2d::init_comp ( )
virtual

Here is the call graph for this function:

solver * star2d::init_solver ( int  nvar_add = 0)
virtual

Reimplemented in star_evol, and star1d.

Here is the call graph for this function:

void star2d::interp ( remapper red)
virtual

Here is the call graph for this function:

matrix star2d::kconv ( ) const

Here is the call graph for this function:

void star2d::kconv_common ( matrix kc,
matrix Ja,
matrix Jb,
symbolic S,
sym a_,
sym b_ 
) const
double star2d::luminosity ( ) const
virtual

Reimplemented in star1d.

double star2d::Lz ( ) const
virtual

Here is the call graph for this function:

double star2d::Lzcore ( ) const
virtual

Here is the call graph for this function:

double star2d::Mcore ( ) const
virtual

Here is the call graph for this function:

matrix star2d::N2 ( ) const
virtual

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::nuclear ( )
virtual

Here is the call graph for this function:

void star2d::opacity ( )
virtual

Here is the call graph for this function:

star2d & star2d::operator= ( const star2d A)

Here is the call graph for this function:

matrix star2d::Rcore ( ) const
virtual

Here is the call graph for this function:

int star2d::read ( const char *  input_file,
int  dim = 2 
)
virtual

Reimplemented in star_evol, and star1d.

Here is the call graph for this function:

int star2d::read_old ( const char *  input_file)
virtual

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::register_variables ( solver op)
virtual

Reimplemented in star_evol, and star1d.

Here is the call graph for this function:

void star2d::remap ( int  ndomains,
int *  npts,
int  nth,
int  nex 
)
virtual

Here is the call graph for this function:

bool star2d::remap_domains ( int  ndom,
remapper red 
)
virtual

Here is the call graph for this function:

double star2d::solve ( solver op)
virtual

Performs one step of the Newton algorithm to compute the star's internal structure.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_atm ( solver op)
virtual

Equation setting the 'simple' atmosphere model equations To be checked.

Here is the call graph for this function:

void star2d::solve_definitions ( solver op)
virtual

insert the definitions depending on opacity and eos tables into the solver, and the definitions used by the mapping (eta,deta,Ri,dRi,...), and the entropy

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_dim ( solver op)
virtual

Writes the equations for the dimensional quantities (T_c, rho_c, R, etc.)

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_gsup ( solver op)
virtual

Equation giving the effective surface gravity gsup gsup=(- P)/rho.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_map ( solver op)
virtual

Part of the Jacobian associated with the mapping There are geometrical relations and physical relations placing the physical interfaces on surfaces zeta=cst. Option also to define the stellar surface as a tau=cst or P=cst.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_mov ( solver op)
virtual

Writes movement and vorticity equations into the solver.

Here is the call graph for this function:

void star2d::solve_Omega ( solver op)
virtual

Equation setting the equatorial angular velocity.

Reimplemented in star_evol.

Here is the call graph for this function:

void star2d::solve_poisson ( solver op)
virtual

Writes Poisson equation and interface conditions into the solver.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_Teff ( solver op)
virtual

Equation setting the surface effective temperature Derived from sigma T_e^4 = -xi.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::solve_temp ( solver op)
virtual

Writes temperature and luminosity equations and interface conditions into the solver.

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::spectrum ( figure pfig,
const matrix y,
int  parity = 0 
) const

Here is the call graph for this function:

matrix star2d::stream ( ) const
virtual

Here is the call graph for this function:

matrix star2d::Teff ( ) const
virtual

Reimplemented in star1d.

Here is the call graph for this function:

void star2d::update_map ( matrix  dR)
virtual

Reimplemented in star1d.

Here is the call graph for this function:

double star2d::virial ( ) const
virtual

Here is the call graph for this function:

double star2d::virial_3P ( ) const
virtual
double star2d::virial_L ( ) const
virtual

Here is the call graph for this function:

double star2d::virial_ps ( ) const
virtual

Here is the call graph for this function:

double star2d::virial_W ( ) const
virtual
void star2d::write ( const char *  output_file,
char  output_mode = 'b' 
) const
virtual

Here is the call graph for this function:

void star2d::write_tag ( OUTFILE fp) const
protectedvirtual

Reimplemented in star1d.

Here is the call graph for this function:

Member Data Documentation

atm_struct star2d::atm
composition_map star2d::comp
struct star2d::config_struct star2d::config
int star2d::conv
int star2d::core_convec
const matrix_block_diag& star2d::D
const matrix & star2d::Dex
std::vector<int> star2d::domain_type
const matrix & star2d::Dt
const matrix & star2d::Dt2
double star2d::Ekman
int star2d::env_convec
eos_struct star2d::eos
matrix star2d::G
double star2d::Lambda
double star2d::M
double star2d::m
mapping star2d::map
double star2d::min_core_size
const int & star2d::ndomains
const int & star2d::nex
const int& star2d::nr
const int & star2d::nth
nuc_struct star2d::nuc
double star2d::Omega
double star2d::Omega_bk
double star2d::Omegac
opa_struct star2d::opa
matrix star2d::p
double star2d::pc
matrix star2d::phi
matrix star2d::phiex
double star2d::pi_c
matrix star2d::ps
const matrix& star2d::r
double star2d::R
const matrix & star2d::rex
matrix star2d::rho
double star2d::rhoc
int star2d::stratified_comp
double star2d::surff
matrix star2d::T
double star2d::Tc
const matrix & star2d::th
matrix star2d::Ts
struct star2d::units_struct star2d::units
struct star2d::version_struct star2d::version
matrix star2d::vr
matrix star2d::vt
matrix star2d::w
double star2d::X0
double star2d::Xc
double star2d::Y0
const matrix & star2d::z
double star2d::Z0
const matrix & star2d::zex

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