116 #include "utilitaires.h" 125 assert (
etat != ETATNONDEF) ;
126 assert (l_min <= l_max) ;
127 assert (l_min >= 0) ;
128 if (
etat == ETATZERO )
131 if (
etat == ETATUN) {
139 int l_q, m_q, base_r ;
141 if (m_coef(lz).
get_etat() != ETATZERO)
146 if ((l_min <= l_q) && (l_q<= l_max))
147 m_coef.
set(lz, k, j, i) = 0 ;
165 assert (
etat != ETATNONDEF) ;
166 if ( (
etat == ETATZERO) || (
etat == ETATUN) )
180 for (
int k=0 ; k<np+1 ; k++)
182 for (
int j=0 ; j<nt ; j++)
183 for (
int i=nr-1 ; i>nr-1-n ; i--)
193 assert (
etat != ETATNONDEF) ;
194 if ( (
etat == ETATZERO) || (
etat == ETATUN) )
202 int* nr =
new int[nz];
203 int* nt =
new int[nz];
204 int* np =
new int[nz];
205 for (
int l=0; l<=nz-1; l++) {
211 for (
int l=0; l<=nz-1; l++)
212 for (
int k=0 ; k<np[l]+1 ; k++)
214 for (
int j=0 ; j<nt[l] ; j++)
215 for (
int i=nr[l]-1; i>nr[l]-1-nn[l] ; i--)
231 assert (
etat != ETATNONDEF) ;
232 if ( (
etat == ETATZERO) || (
etat == ETATUN) )
243 for (
int k=0 ; k<np+1 ; k++)
245 for (
int j=0 ; j<nt ; j++)
246 for (
int i=nr-1; i>nr-1-n ; i--)
262 assert (
etat != ETATNONDEF) ;
263 if ( (
etat == ETATZERO) || (
etat == ETATUN) )
274 for (
int k=np+1-n ; k<np+1 ; k++)
275 for (
int j=0 ; j<nt ; j++)
276 for (
int i=0 ; i<nr ; i++)
297 assert (
etat != ETATNONDEF) ;
298 if (
etat == ETATZERO) {
299 if (x0 ==
double(0)) return ;
303 if (
etat == ETATUN) {
304 if (x0 ==
double(1)) return ;
305 else etat = ETATQCQ ;
316 for (
int k=0 ; k<np ; k++)
317 for (
int j=0 ; j<nt ; j++)
318 va.
set(l0, k, j, 0) = x0 ;
329 assert (
etat != ETATNONDEF) ;
330 if (
etat == ETATZERO) {
331 if (x0 ==
double(0)) return ;
335 if (
etat == ETATUN) {
336 if (x0 ==
double(1)) return ;
337 else etat = ETATQCQ ;
349 for (
int k=0 ; k<np ; k++)
350 for (
int j=0 ; j<nt ; j++)
351 va.
set(l0, k, j, nrm1) = x0 ;
374 cout <<
"Le mapping doit etre affine" << endl ;
385 for (
int conte=0 ; conte<nbre ; conte++) {
392 double* coloc =
new double [nr] ;
393 int * deg =
new int[3] ;
398 for (
int i=0 ; i<nr ; i++)
399 coloc[i] =
pow(alpha,
double(conte))*
400 pow(-1-
cos(M_PI*i/(nr-1)),
double(conte)) ;
402 cfrcheb(deg, deg, coloc, deg, coloc) ;
404 for (
int k=0 ; k<np+1 ; k++)
406 for (
int j=0 ; j<nt ; j++) {
409 double* coef =
new double [nr] ;
410 double* auxi =
new double[1] ;
411 for (
int i=0 ; i<nr ; i++)
412 coef[i] = (*courant.
va.
c_cf)(nz-1, k, j, i) ;
415 som_r_chebu (coef, nr, 1, 1, 1, auxi) ;
418 som_r_pas_prevu (coef, nr, 1, 1, 1, auxi) ;
425 courant.
va.
c_cf->
set(nz-1, k, j, 0) -= *auxi ;
427 for (
int i=0 ; i<nr ; i++)
428 this->
va.
c_cf->
set(nz-1, k, j, i) -= *auxi * coloc[i] ;
444 if (output_ylm)
va.
ylm() ;
451 assert(
etat == ETATQCQ) ;
453 for (
int k=0; k<np+2; k++)
454 for (
int j=0; j<nt; j++)
463 if (output_ylm)
va.
ylm() ;
470 assert(
etat == ETATQCQ) ;
472 for (
int k=0; k<np+2; k++)
473 for (
int j=0; j<nt; j++)
481 if (output_ylm)
va.
ylm() ;
485 Base_val base = resu.get_spectral_base() ;
487 resu.set_spectral_base(base) ;
488 if (
etat == ETATZERO) resu.set_etat_zero() ;
490 assert(
etat == ETATQCQ) ;
494 for (
int k=0; k<np+2; k++)
495 for (
int j=0; j<nt; j++)
496 resu.set_spectral_va().c_cf->set(0, k, j, 0)
498 delete resu.set_spectral_va().c ;
499 resu.set_spectral_va().c = 0x0 ;
507 assert(&scal_small_grid !=
this) ;
518 assert(scal_small_grid.
etat != ETATNONDEF) ;
521 for (
int l=0; l<nz; l++) {
531 if (scal_small_grid.
get_etat() == ETATZERO) {
540 assert( c_s.
get_etat() == ETATQCQ ) ;
545 for (
int l=0; l<nz; l++) {
547 c_l.t[l]->set_etat_zero() ;
554 int npl = mgl.
get_np(l)+2 ;
555 int nps = mgs.
get_np(l)+2 ;
556 c_l.t[l]->set_etat_qcq() ;
557 double* p_out = c_l.t[l]->t ;
558 double* p_in = c_s.
t[l]->
t ;
559 for (
int k=0; k<nps; k++) {
560 for (
int j=0; j<nts; j++) {
561 for (
int i=0; i<nrs; i++) {
565 for (
int i=nrs; i<nrl; i++) {
566 *p_out = 0. ; p_out++ ;
569 for (
int j=nts; j<ntl; j++) {
570 for (
int i=0; i<nrl; i++) {
571 *p_out = 0. ; p_out++ ;
575 for (
int k=nps; k<npl; k++) {
576 for (
int j=0; j<ntl; j++) {
577 for (
int i=0; i<nrl; i++) {
578 *p_out = 0. ; p_out++ ;
584 if (scal_small_grid.
get_etat() == ETATUN)
etat = ETATUN ;
592 assert(&scal_large_grid !=
this) ;
604 assert(scal_large_grid.
etat != ETATNONDEF) ;
606 for (
int l=0; l<nz; l++) {
616 if (scal_large_grid.
get_etat() == ETATZERO) {
625 assert( c_l.
get_etat() == ETATQCQ ) ;
630 for (
int l=0; l<nz; l++) {
632 c_s.t[l]->set_etat_zero() ;
637 int nps = mgs.
get_np(l)+1 ;
639 int dif_r = nrl - nrs ;
640 int dif_t = mgl.
get_nt(l) - nts ;
641 c_s.t[l]->set_etat_qcq() ;
642 double* p_out = c_s.t[l]->t ;
643 double* p_in = c_l.
t[l]->
t ;
644 for (
int k=0; k<nps; k++) {
645 for (
int j=0; j<nts; j++) {
646 for (
int i=0; i<nrs; i++) {
655 for (
int j=0; j<nts; j++) {
656 for (
int i=0; i<nrs; i++) {
657 *p_out = 0. ; p_out++ ;
662 if (scal_large_grid.
get_etat() == ETATUN)
etat = ETATUN ;
int get_type_p() const
Returns the type of sampling in the direction: SYM : : symmetry with respect to the transformatio...
const Base_val & get_spectral_base() const
Returns the spectral bases of the Valeur va.
void annule_l(int l_min, int l_max, bool ylm_output=false)
Sets all the multipolar components between l_min and l_max to zero.
Mtbl_cf * c_cf
Coefficients of the spectral expansion of the function.
void filtre_r(int *nn)
Sets the n lasts coefficients in r to 0 in all domains.
const double * get_alpha() const
Returns the pointer on the array alpha.
virtual const Map_af & mp_angu(int) const =0
Returns the "angular" mapping for the outside of domain l_zone.
void ylm_i()
Inverse of ylm()
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 get_np(int l) const
Returns the number of points in the azimuthal direction ( ) in domain no. l.
void set_etat_cf_qcq()
Sets the logical state to ETATQCQ (ordinary state) for values in the configuration space (Mtbl_cf c_c...
void coef() const
Computes the coeffcients of *this.
virtual void set_etat_zero()
Sets the logical state to ETATZERO (zero).
void give_quant_numbers(int, int, int, int &, int &, int &) const
Computes the various quantum numbers and 1d radial base.
Tbl & set(int l)
Read/write of the Tbl containing the coefficients in a given domain.
int get_base_t(int l) const
Returns the expansion basis for functions in the domain of index l (e.g.
void ylm()
Computes the coefficients of *this.
const Mg3d * get_mg() const
Gives the Mg3d on which the mapping is defined.
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).
void coef_i() const
Computes the physical value of *this.
int get_type_t() const
Returns the type of sampling in the direction: SYM : : symmetry with respect to the equatorial pl...
virtual void std_spectral_base()
Sets the spectral bases of the Valeur va to the standard ones for a scalar field. ...
int get_etat() const
Gives the logical state.
Scalar scalar_out_bound(int n, bool leave_ylm=false)
Returns the Scalar containing the values of angular coefficients at the outer boundary.
int dzpuis
Power of r by which the quantity represented by this must be divided in the compactified external do...
int get_etat() const
Returns the logical state ETATNONDEF (undefined), ETATZERO (null) or ETATQCQ (ordinary).
virtual void set_etat_qcq()
Sets the logical state to ETATQCQ (ordinary state).
void set_base_t(int base_t)
Sets the expansion basis for functions in all domains.
Tbl tbl_in_bound(int n, bool leave_ylm=false)
Returns the Tbl containing the values of angular coefficients at the inner boundary.
int get_etat() const
Returns the logical state.
double val_out_bound_jk(int l, int j, int k) const
Computes the angular coefficient of index j,k of the field represented by *this at by means of the s...
void annule_hard()
Sets the Scalar to zero in a hard way.
int get_base_r(int l) const
Returns the expansion basis for r ( ) functions in the domain of index l (e.g.
void set_etat_qcq()
Sets the logical state to ETATQCQ (ordinary state).
friend Scalar pow(const Scalar &, int)
Power .
double val_in_bound_jk(int l, int j, int k) const
Computes the angular coefficient of index j,k of the field represented by *this at by means of the s...
friend Scalar cos(const Scalar &)
Cosine.
virtual void del_deriv() const
Logical destructor of the derivatives.
Base_val base
Bases on which the spectral expansion is performed.
int get_dzpuis() const
Returns dzpuis.
void set_outer_boundary(int l, double x)
Sets the value of the Scalar at the outer boundary of a given domain.
double * t
The array of double.
void filtre_tp(int nn, int nz1, int nz2)
Sets the n lasts coefficients in to 0 in the domain nz1 to nz2 when expressed in spherical harmonics...
void mult_r_ced()
Multiplication by r in the compactified external domain (CED), the dzpuis flag is not changed...
Mtbl * c
Values of the function at the points of the multi-grid.
int get_nzone() const
Returns the number of domains.
Valeur va
The numerical value of the Scalar.
void set_etat_qcq()
Sets the logical state to ETATQCQ (ordinary state).
void filtre(int n)
Sets the n lasts coefficients in r to 0 in the external domain.
void set_etat_zero()
Sets the logical state to ETATZERO (zero).
void set_inner_boundary(int l, double x)
Sets the value of the Scalar at the inner boundary of a given domain.
void filtre_tp(int nn, int nz1, int nz2)
Sets the n lasts coefficients in to 0 in the domain nz1 to nz2 when expressed in spherical harmonics...
void fixe_decroissance(int puis)
Substracts all the components behaving like in the external domain, with n strictly lower than puis ...
void set_spectral_base(const Base_val &)
Sets the spectral bases of the Valeur va
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 get_nr(int l) const
Returns the number of points in the radial direction ( ) in domain no. l.
Bases of the spectral expansions.
void filtre_phi(int n, int zone)
Sets the n lasts coefficients in to 0 in the domain zone .
int etat
The logical state ETATNONDEF (undefined), ETATZERO (null), ETATUN (one), or ETATQCQ (ordinary)...
Coefficients storage for the multi-domain spectral method.
void set_etat_c_qcq()
Sets the logical state to ETATQCQ (ordinary state) for values in the configuration space (Mtbl c )...
Tbl tbl_out_bound(int l_dom, bool leave_ylm=false)
Returns the Tbl containing the values of angular coefficients at the outer boundary.
int get_nt(int l) const
Returns the number of points in the co-latitude direction ( ) in domain no. l.
#define R_CHEBU
base de Chebychev ordinaire (fin), dev. en 1/r
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.
const Map & get_mp() const
Returns the mapping.
Tbl ** t
Array (size nzone ) of pointers on the Tbl 's which contain the spectral coefficients in each domain...
const Valeur & get_spectral_va() const
Returns va (read only version)
Tbl & set(int l)
Read/write of the value in a given domain (configuration space).