203 #include "utilitaires.h" 214 : mp(&map), valence(val), triad(&triad_i), type_indice(tipe),
215 n_comp(int(
pow(3., val))){
221 for (
int i=0 ; i<
valence ; i++)
222 assert ((tipe(i) == COV) || (tipe(i) == CON)) ;
226 for (
int i=0 ; i<
n_comp ; i++)
237 : mp(&map), valence(val), triad(triad_i), type_indice(tipe),
238 n_comp(int(
pow(3., val))){
244 for (
int i=0 ; i<
valence ; i++)
245 assert ((tipe(i) == COV) || (tipe(i) == CON)) ;
249 for (
int i=0 ; i<
n_comp ; i++)
262 : mp(&map), valence(val), triad(&triad_i), type_indice(val),
263 n_comp(int(
pow(3., val))){
267 assert ((tipe == COV) || (tipe == CON)) ;
273 for (
int i=0 ; i<
n_comp ; i++)
282 mp(source.mp), valence(source.valence), triad(source.triad),
283 type_indice(source.type_indice) {
288 for (
int i=0 ; i<
n_comp ; i++) {
306 : mp(&mapping), triad(&triad_i), type_indice(fd){
312 assert( *triad_fich == *
triad) ;
322 for (
int i=0 ; i<
n_comp ; i++)
333 type_indice(0), n_comp(1) {
346 mp(&map), valence(val), triad(&triad_i), type_indice(tipe), n_comp(compo)
354 for (
int i=0 ; i<
valence ; i++)
355 assert ((tipe(i) == COV) || (tipe(i) == CON)) ;
359 for (
int i=0 ; i<
n_comp ; i++)
371 mp(&map), valence(val), triad(&triad_i), type_indice(val), n_comp(compo)
377 assert ((tipe == COV) || (tipe == CON)) ;
383 for (
int i=0 ; i<
n_comp ; i++)
399 for (
int i=0 ; i<
n_comp ; i++) {
410 for (
int i=0; i<N_MET_MAX; i++)
419 for (
int i=0; i<N_MET_MAX; i++)
426 assert( (j>=0) && (j<N_MET_MAX) ) ;
429 for (
int i=0 ; i<N_TENSOR_DEPEND ; i++)
445 assert( (i>=0) && (i<N_MET_MAX) ) ;
455 for (
int i=0; i<N_MET_MAX; i++)
467 for (
int i=0; i<N_MET_MAX; i++) {
469 if ((!deja) && (
met_depend[i] != 0x0)) nmet++ ;
471 if (nmet == N_MET_MAX) {
472 cout <<
"Too many metrics in Tensor::set_dependances" << endl ;
477 while ((conte < N_TENSOR_DEPEND) && (met.
tensor_depend[conte] != 0x0))
480 if (conte == N_TENSOR_DEPEND) {
481 cout <<
"Too many dependancies in Tensor::set_dependances " << endl ;
494 for (
int i=0 ; i<
n_comp ; i++) {
502 for (
int i=0 ; i<
n_comp ; i++) {
510 for (
int i=0 ; i<
n_comp ; i++) {
521 for (
int i=0 ; i<
n_comp ; i++) {
540 for (
int i=0 ; i<
valence ; i++)
541 assert ((idx(i)>=1) && (idx(i)<=3)) ;
543 for (
int i=0 ; i<
valence ; i++)
544 res = 3*res+(idx(i)-1) ;
551 assert ((place >= 0) && (place <
n_comp)) ;
555 for (
int i=
valence-1 ; i>=0 ; i--) {
556 res.
set(i) = div(place, 3).rem ;
557 place = int((place-res(i))/3) ;
569 for (
int i=0 ; i<
valence ; i++)
572 for (
int i=0 ; i<
n_comp ; i++) {
574 *
cmp[i] = *t.
cmp[place_t] ;
585 for (
int i=0 ; i<
valence ; i++)
588 for (
int i=0 ; i<
n_comp ; i++) {
590 *
cmp[i] += *t.
cmp[place_t] ;
601 for (
int i=0 ; i<
valence ; i++)
604 for (
int i=0 ; i<
n_comp ; i++) {
606 *
cmp[i] -= *t.
cmp[place_t] ;
690 for (
int i=0 ; i<
n_comp ; i++) {
708 cout <<
"Tensor::annule_extern_cn : \n" 710 <<
"The number of coefficients in r is too low \n" 711 <<
"to do a clean matching..." << endl ;
714 double r_min =
mp->
val_r(lrac, -1., 0., 0.) ;
715 double r_max =
mp->
val_r(lrac, 1., 0., 0.) ;
718 Itbl binom(deg+1, deg+1) ;
721 for (
int n=1; n<=deg; n++) {
723 for (
int k=1; k<=n; k++)
724 binom.
set(n,k) = binom(n-1, k) + binom(n-1, k-1) ;
732 for (
int i=deg-1; i>=0; i--) {
734 coef.
set(i) = double(r_max*(i+1)*coef(i+1)
735 + sg*binom(deg,i)*(2*deg+1)*
pow(r_min,deg-i))
741 double aa = coef(deg) ;
742 for (
int i = deg-1; i>=0; i--)
743 aa = r_min*aa + coef(i) ;
744 aa *=
pow(r_min - r_max, deg+1) ;
752 for (
int i=deg-1; i>=0; i--)
753 poly = rr*poly + coef(i) ;
754 poly *= aa*
pow((rr-r_max), deg+1) ;
758 for (
int l=0; l<lrac; l++) rac.
set_domain(l) = 1 ;
763 for (
int ic=0; ic<
n_comp; ic++) *(
cmp[ic]) *= rac ;
775 idx.
set(0) = indice1 ;
776 idx.
set(1) = indice2 ;
786 idx.
set(0) = indice1 ;
787 idx.
set(1) = indice2 ;
788 idx.
set(2) = indice3 ;
799 idx.
set(0) = indice1 ;
800 idx.
set(1) = indice2 ;
801 idx.
set(2) = indice3 ;
802 idx.
set(3) = indice4 ;
820 for (
int i=0 ; i<
n_comp ; i++)
828 for (
int i=0 ; i<
n_comp ; i++)
836 ostream& operator<<(ostream& flux,
const Tensor &source ) {
839 flux <<
"Lorene class : " <<
typeid(source).name()
840 <<
" Valence : " << source.
valence <<
'\n' ;
843 flux <<
"Vectorial basis (triad) on which the components are defined :" 849 flux <<
"Type of the indices : " ;
850 for (
int i=0 ; i<source.
valence ; i++) {
851 flux <<
"index " << i <<
" : " ;
853 flux <<
" contravariant." <<
'\n' ;
855 flux <<
" covariant." <<
'\n' ;
856 if ( i < source.
valence-1 ) flux <<
" " ;
861 for (
int i=0 ; i<source.
n_comp ; i++) {
865 "===================== Scalar field ========================= \n" ;
868 flux <<
"================ Component " ;
869 Itbl num_indices = source.
indices(i) ;
870 for (
int j=0 ; j<source.
valence ; j++) {
871 flux <<
" " << num_indices(j) ;
873 flux <<
" ================ \n" ;
877 flux << *source.
cmp[i] <<
'\n' ;
885 double thres,
int precis, ostream& ost)
const {
887 if (comment != 0x0) {
888 ost << comment <<
" : " << endl ;
891 ost <<
"Lorene class : " <<
typeid(*this).name()
892 <<
" Valence : " <<
valence <<
'\n' ;
894 for (
int ic=0; ic<
n_comp; ic++) {
898 "===================== Scalar field ========================= \n" ;
901 ost <<
"================ Component " ;
903 for (
int j=0 ; j<
valence ; j++) {
904 ost <<
" " << num_indices(j) ;
906 ost <<
" ================ \n" ;
926 for (
int i=0 ; i<
n_comp ; i++)
947 "Tensor::std_spectral_base: should not be called on a Tensor" 948 <<
" of valence 1 but on a Vector !" << endl ;
965 for (
int i=0 ; i<
n_comp ; i++) {
968 (*bases[ind(1)-1]) ) ;
971 for (
int i=0 ; i<3 ; i++) {
982 cout <<
"Tensor::std_spectral_base: the case valence = " <<
valence 983 <<
" is not treated yet !" << endl ;
1003 cout <<
"Tensor::std_spectral_base_odd: the case valence = " <<
valence 1004 <<
" is not treated yet !" << endl ;
1016 assert ((j>=0) && (j<N_MET_MAX)) ;
1028 assert ((j>=0) && (j<N_MET_MAX)) ;
1069 assert ((j>=0) && (j<N_MET_MAX)) ;
1079 for (
int i=0; i<
n_comp; i++)
1082 cout <<
"Tensor::exponential_filter_r : " << endl ;
1083 cout <<
"Only Cartesian triad is implemented!" << endl ;
1084 cout <<
"Exiting..." << endl ;
1092 for (
int i=0; i<
n_comp; i++)
1095 cout <<
"Tensor::exponential_filter_ylm : " << endl ;
1096 cout <<
"Only Cartesian triad is implemented!" << endl ;
1097 cout <<
"Exiting..." << endl ;
1105 for (
int i=0; i<
n_comp; i++)
1108 cout <<
"Tensor::exponential_filter_ylm : " << endl ;
1109 cout <<
"Only Cartesian triad is implemented!" << endl ;
1110 cout <<
"Exiting..." << endl ;
1118 for (
int i=0; i<
n_comp; i++) {
1125 for (
int i=0; i<
n_comp; i++) {
void annule_domain(int l)
Sets the Tensor to zero in a given domain.
Base_val ** std_base_vect_cart() const
Returns the standard spectral bases for the Cartesian components of a vector.
Metric for tensor calculation.
virtual void set_etat_qcq()
Sets the logical state of all components to ETATQCQ (ordinary state).
virtual const Sym_tensor & con() const
Read-only access to the contravariant representation.
virtual void operator=(const Tensor &)
Assignment to a Tensor.
int & set(int i)
Read/write of a particular element (index i ) (1D case)
void copy_coefs_from_small_grid(const Scalar &scal_small_grid)
Copies the content of the argument Scalar to this defined on a larger grid, with similar mappings...
int n_comp
Number of stored components, depending on the symmetry.
virtual void set_etat_zero()
Sets the logical state to ETATZERO (zero).
virtual void annule(int l_min, int l_max)
Sets the Scalar to zero in several domains.
int sym_index1() const
Number of the first symmetric index (0<= id_sym1 < valence )
const Base_vect_spher & get_bvect_spher() const
Returns the orthonormal vectorial basis associated with the coordinates of the mapping.
int get_ndim() const
Gives the number of dimensions (ie dim.ndim )
virtual void del_derive_met(int) const
Logical destructor of the derivatives depending on the i-th element of met_depend ...
void set_dependance(const Metric &) const
To be used to describe the fact that the derivatives members have been calculated with met ...
const Mg3d * get_mg() const
Gives the Mg3d on which the mapping is defined.
void annule_hard()
Sets the Itbl to zero in a hard way.
double & set(int i)
Read/write of a particular element (index i) (1D case)
Tensor field of valence 0 (or component of a tensorial field).
virtual void set_etat_nondef()
Sets the logical state of all components to ETATNONDEF (undefined state).
virtual void sauve(FILE *) const
Save in a file.
Base class for coordinate mappings.
void copy_coefs_from_smaller_grid(const Tensor &tens_small_grid)
Copies the content of the argument Tensor to this defined on a larger grid, with similar mappings...
virtual Tensor * p_derive_cov(const Tensor &tens) const
Computes the covariant derivative of a tensor (with respect to the current connection).
int sym_index2() const
Number of the second symmetric index (id_sym1 < id_sym2 < valence )
Basic integer array class.
virtual void std_spectral_base()
Sets the spectral bases of the Valeur va to the standard ones for a scalar field. ...
const Base_vect * triad
Vectorial basis (triad) with respect to which the tensor components are defined.
virtual void sauve(FILE *) const
Save in a binary file.
virtual void std_spectral_base_odd()
Sets the standard odd spectal bases of decomposition for each component.
virtual void allocate_all()
Sets the logical state to ETATQCQ (ordinary state) and performs the memory allocation of all the elem...
virtual void set_etat_nondef()
Sets the logical state to ETATNONDEF (undefined).
virtual void set_etat_qcq()
Sets the logical state to ETATQCQ (ordinary state).
int get_place_met(const Metric &) const
Returns the position of the pointer on metre in the array met_depend .
Tensor field of valence 1.
Vectorial bases (triads) with respect to which the tensorial components are defined.
Tbl & set_domain(int l)
Read/write of the value in a given domain.
virtual void exponential_filter_ylm_phi(int lzmin, int lzmax, int p_r, int p_tet, int p_phi, double alpha=-16.)
Applies exponential filters to all components (see Scalar::exponential_filter_ylm_phi )...
void copy_coefs_from_larger_grid(const Tensor &tens_large_grid)
Copies the content of the argument Tensor to this defined on a smaller grid, with similar mappings...
static Base_vect * bvect_from_file(FILE *)
Construction of a vectorial basis from a file (see sauve(FILE* ) ).
Tensor * p_derive_cov[N_MET_MAX]
Array of pointers on the covariant derivatives of this with respect to various metrics.
virtual void dec_dzpuis(int dec=1)
Decreases by dec units the value of dzpuis and changes accordingly the values in the compactified ext...
void set_etat_qcq()
Sets the logical state to ETATQCQ (ordinary state).
virtual void exponential_filter_r(int lzmin, int lzmax, int p, double alpha=-16.)
Applies exponential filters to all components (see Scalar::exponential_filter_r ).
virtual double val_r(int l, double xi, double theta, double pphi) const =0
Returns the value of the radial coordinate r for a given in a given domain.
void operator-=(const Tensor &)
-= Tensor
Itbl type_indice
1D array of integers (class Itbl ) of size valence containing the type of each index: COV for a cova...
const Base_vect * get_triad() const
Returns the vectorial basis (triad) on which the components are defined.
virtual int position(const Itbl &ind) const
Returns the position in the array cmp of a component given by its indices.
int get_index_type(int i) const
Gives the type (covariant or contravariant) of the index number i .
virtual void allocate_all()
Performs the memory allocation of all the elements, down to the double arrays of the Tbl s...
virtual const Connection & connect() const
Returns the connection.
Scalar ** cmp
Array of size n_comp of pointers onto the components.
virtual void spectral_display(const char *comment=0x0, double threshold=1.e-7, int precision=4, ostream &ostr=cout) const
Displays the spectral coefficients and the associated basis functions.
void sauve(FILE *) const
Save in a file.
Base_val ** std_base_vect_spher() const
Returns the standard spectral bases for the spherical components of a vector.
int get_nzone() const
Returns the number of domains.
virtual int identify() const =0
Returns a number to identify the sub-classe of Base_vect the object belongs to.
virtual void std_spectral_base_odd()
Sets the spectral bases of the Valeur va to the standard odd ones for a scalar field.
int fwrite_be(const int *aa, int size, int nb, FILE *fich)
Writes integer(s) into a binary file according to the big endian convention.
Tensor * p_derive_con[N_MET_MAX]
Array of pointers on the contravariant derivatives of this with respect to various metrics...
Cmp pow(const Cmp &, int)
Power .
Tenseur contract(const Tenseur &, int id1, int id2)
Self contraction of two indices of a Tenseur .
const Tensor & derive_cov(const Metric &gam) const
Returns the covariant derivative of this with respect to some metric .
const Tensor & divergence(const Metric &gam) const
Computes the divergence of this with respect to some metric .
virtual void del_deriv() const
Deletes the derived quantities.
virtual void inc_dzpuis(int inc=1)
Increases by inc units the value of dzpuis and changes accordingly the values in the compactified ext...
virtual void spectral_display(const char *comment=0x0, double threshold=1.e-7, int precision=4, ostream &ostr=cout) const
Displays the spectral coefficients and the associated basis functions of each component.
void set_spectral_base(const Base_val &)
Sets the spectral bases of the Valeur va
int fread_be(int *aa, int size, int nb, FILE *fich)
Reads integer(s) from a binary file according to the big endian convention.
virtual ~Tensor()
Destructor.
void copy_coefs_from_large_grid(const Scalar &scal_large_grid)
Copies the content of the argument Scalar to this defined on a smaller grid, with similar mappings...
int valence
Valence of the tensor (0 = scalar, 1 = vector, etc...)
int get_nr(int l) const
Returns the number of points in the radial direction ( ) in domain no. l.
Tensor * p_divergence[N_MET_MAX]
Array of pointers on the divergence of this with respect to various metrics.
void operator+=(const Tensor &)
+= Tensor
const Tensor & derive_con(const Metric &gam) const
Returns the "contravariant" derivative of this with respect to some metric , by raising the last inde...
Bases of the spectral expansions.
virtual void exponential_filter_ylm(int lzmin, int lzmax, int p, double alpha=-16.)
Applies exponential filters to all components (see Scalar::exponential_filter_ylm )...
const Base_vect_cart & get_bvect_cart() const
Returns the Cartesian basis associated with the coordinates (x,y,z) of the mapping, i.e.
void set_der_met_0x0(int) const
Sets all the i-th components of met_depend , p_derive_cov , etc...
const Metric * met_depend[N_MET_MAX]
Array on the Metric 's which were used to compute derived quantities, like p_derive_cov ...
Scalar & set(const Itbl &ind)
Returns the value of a component (read/write version).
void annule_extern_cn(int l_0, int deg)
Performs a smooth (C^n) transition in a given domain to zero.
const Tensor * tensor_depend[N_TENSOR_DEPEND]
Pointer on the dependancies, that means the array contains pointers on all the Tensor whom derivative...
int get_dim(int i) const
Gives the i th dimension (ie {tt dim.dim[i] )
const Scalar & operator()(const Itbl &ind) const
Returns the value of a component (read-only version).
void set_triad(const Base_vect &new_triad)
Assigns a new vectorial basis (triad) of decomposition.
virtual void set_etat_zero()
Sets the logical state of all components to ETATZERO (zero state).
Symmetric tensors (with respect to two of their arguments).
void set_der_0x0() const
Sets the pointers on derived quantities to 0x0.
int get_type_r(int l) const
Returns the type of sampling in the radial direction in domain no.
const Map *const mp
Mapping on which the numerical values at the grid points are defined.
virtual void annule(int l_min, int l_max)
Sets the Tensor to zero in several domains.
virtual void std_spectral_base()
Sets the standard spectal bases of decomposition for each component.
virtual Itbl indices(int pos) const
Returns the indices of a component given by its position in the array cmp .
Coord r
r coordinate centered on the grid
Tensor(const Map &map, int val, const Itbl &tipe, const Base_vect &triad_i)
Standard constructor.
virtual Tensor * p_divergence(const Tensor &tens) const
Computes the divergence of a tensor (with respect to the current connection).