file
stringlengths 18
26
| data
stringlengths 3
1.04M
|
---|---|
the_stack_data/98575440.c | #include <stdio.h>
#include <stdlib.h>
#include <string.h>
int main(void)
{
char *c;
c = calloc(sizeof(char), 20);
strcpy(c, "Hello!");
printf("%s\n", c);
return 0;
}
|
the_stack_data/36074237.c | #include <math.h>
#include <stdlib.h>
#include <string.h>
#include <stdio.h>
#include <complex.h>
#ifdef complex
#undef complex
#endif
#ifdef I
#undef I
#endif
#if defined(_WIN64)
typedef long long BLASLONG;
typedef unsigned long long BLASULONG;
#else
typedef long BLASLONG;
typedef unsigned long BLASULONG;
#endif
#ifdef LAPACK_ILP64
typedef BLASLONG blasint;
#if defined(_WIN64)
#define blasabs(x) llabs(x)
#else
#define blasabs(x) labs(x)
#endif
#else
typedef int blasint;
#define blasabs(x) abs(x)
#endif
typedef blasint integer;
typedef unsigned int uinteger;
typedef char *address;
typedef short int shortint;
typedef float real;
typedef double doublereal;
typedef struct { real r, i; } complex;
typedef struct { doublereal r, i; } doublecomplex;
#ifdef _MSC_VER
static inline _Fcomplex Cf(complex *z) {_Fcomplex zz={z->r , z->i}; return zz;}
static inline _Dcomplex Cd(doublecomplex *z) {_Dcomplex zz={z->r , z->i};return zz;}
static inline _Fcomplex * _pCf(complex *z) {return (_Fcomplex*)z;}
static inline _Dcomplex * _pCd(doublecomplex *z) {return (_Dcomplex*)z;}
#else
static inline _Complex float Cf(complex *z) {return z->r + z->i*_Complex_I;}
static inline _Complex double Cd(doublecomplex *z) {return z->r + z->i*_Complex_I;}
static inline _Complex float * _pCf(complex *z) {return (_Complex float*)z;}
static inline _Complex double * _pCd(doublecomplex *z) {return (_Complex double*)z;}
#endif
#define pCf(z) (*_pCf(z))
#define pCd(z) (*_pCd(z))
typedef int logical;
typedef short int shortlogical;
typedef char logical1;
typedef char integer1;
#define TRUE_ (1)
#define FALSE_ (0)
/* Extern is for use with -E */
#ifndef Extern
#define Extern extern
#endif
/* I/O stuff */
typedef int flag;
typedef int ftnlen;
typedef int ftnint;
/*external read, write*/
typedef struct
{ flag cierr;
ftnint ciunit;
flag ciend;
char *cifmt;
ftnint cirec;
} cilist;
/*internal read, write*/
typedef struct
{ flag icierr;
char *iciunit;
flag iciend;
char *icifmt;
ftnint icirlen;
ftnint icirnum;
} icilist;
/*open*/
typedef struct
{ flag oerr;
ftnint ounit;
char *ofnm;
ftnlen ofnmlen;
char *osta;
char *oacc;
char *ofm;
ftnint orl;
char *oblnk;
} olist;
/*close*/
typedef struct
{ flag cerr;
ftnint cunit;
char *csta;
} cllist;
/*rewind, backspace, endfile*/
typedef struct
{ flag aerr;
ftnint aunit;
} alist;
/* inquire */
typedef struct
{ flag inerr;
ftnint inunit;
char *infile;
ftnlen infilen;
ftnint *inex; /*parameters in standard's order*/
ftnint *inopen;
ftnint *innum;
ftnint *innamed;
char *inname;
ftnlen innamlen;
char *inacc;
ftnlen inacclen;
char *inseq;
ftnlen inseqlen;
char *indir;
ftnlen indirlen;
char *infmt;
ftnlen infmtlen;
char *inform;
ftnint informlen;
char *inunf;
ftnlen inunflen;
ftnint *inrecl;
ftnint *innrec;
char *inblank;
ftnlen inblanklen;
} inlist;
#define VOID void
union Multitype { /* for multiple entry points */
integer1 g;
shortint h;
integer i;
/* longint j; */
real r;
doublereal d;
complex c;
doublecomplex z;
};
typedef union Multitype Multitype;
struct Vardesc { /* for Namelist */
char *name;
char *addr;
ftnlen *dims;
int type;
};
typedef struct Vardesc Vardesc;
struct Namelist {
char *name;
Vardesc **vars;
int nvars;
};
typedef struct Namelist Namelist;
#define abs(x) ((x) >= 0 ? (x) : -(x))
#define dabs(x) (fabs(x))
#define f2cmin(a,b) ((a) <= (b) ? (a) : (b))
#define f2cmax(a,b) ((a) >= (b) ? (a) : (b))
#define dmin(a,b) (f2cmin(a,b))
#define dmax(a,b) (f2cmax(a,b))
#define bit_test(a,b) ((a) >> (b) & 1)
#define bit_clear(a,b) ((a) & ~((uinteger)1 << (b)))
#define bit_set(a,b) ((a) | ((uinteger)1 << (b)))
#define abort_() { sig_die("Fortran abort routine called", 1); }
#define c_abs(z) (cabsf(Cf(z)))
#define c_cos(R,Z) { pCf(R)=ccos(Cf(Z)); }
#ifdef _MSC_VER
#define c_div(c, a, b) {Cf(c)._Val[0] = (Cf(a)._Val[0]/Cf(b)._Val[0]); Cf(c)._Val[1]=(Cf(a)._Val[1]/Cf(b)._Val[1]);}
#define z_div(c, a, b) {Cd(c)._Val[0] = (Cd(a)._Val[0]/Cd(b)._Val[0]); Cd(c)._Val[1]=(Cd(a)._Val[1]/Cd(b)._Val[1]);}
#else
#define c_div(c, a, b) {pCf(c) = Cf(a)/Cf(b);}
#define z_div(c, a, b) {pCd(c) = Cd(a)/Cd(b);}
#endif
#define c_exp(R, Z) {pCf(R) = cexpf(Cf(Z));}
#define c_log(R, Z) {pCf(R) = clogf(Cf(Z));}
#define c_sin(R, Z) {pCf(R) = csinf(Cf(Z));}
//#define c_sqrt(R, Z) {*(R) = csqrtf(Cf(Z));}
#define c_sqrt(R, Z) {pCf(R) = csqrtf(Cf(Z));}
#define d_abs(x) (fabs(*(x)))
#define d_acos(x) (acos(*(x)))
#define d_asin(x) (asin(*(x)))
#define d_atan(x) (atan(*(x)))
#define d_atn2(x, y) (atan2(*(x),*(y)))
#define d_cnjg(R, Z) { pCd(R) = conj(Cd(Z)); }
#define r_cnjg(R, Z) { pCf(R) = conjf(Cf(Z)); }
#define d_cos(x) (cos(*(x)))
#define d_cosh(x) (cosh(*(x)))
#define d_dim(__a, __b) ( *(__a) > *(__b) ? *(__a) - *(__b) : 0.0 )
#define d_exp(x) (exp(*(x)))
#define d_imag(z) (cimag(Cd(z)))
#define r_imag(z) (cimagf(Cf(z)))
#define d_int(__x) (*(__x)>0 ? floor(*(__x)) : -floor(- *(__x)))
#define r_int(__x) (*(__x)>0 ? floor(*(__x)) : -floor(- *(__x)))
#define d_lg10(x) ( 0.43429448190325182765 * log(*(x)) )
#define r_lg10(x) ( 0.43429448190325182765 * log(*(x)) )
#define d_log(x) (log(*(x)))
#define d_mod(x, y) (fmod(*(x), *(y)))
#define u_nint(__x) ((__x)>=0 ? floor((__x) + .5) : -floor(.5 - (__x)))
#define d_nint(x) u_nint(*(x))
#define u_sign(__a,__b) ((__b) >= 0 ? ((__a) >= 0 ? (__a) : -(__a)) : -((__a) >= 0 ? (__a) : -(__a)))
#define d_sign(a,b) u_sign(*(a),*(b))
#define r_sign(a,b) u_sign(*(a),*(b))
#define d_sin(x) (sin(*(x)))
#define d_sinh(x) (sinh(*(x)))
#define d_sqrt(x) (sqrt(*(x)))
#define d_tan(x) (tan(*(x)))
#define d_tanh(x) (tanh(*(x)))
#define i_abs(x) abs(*(x))
#define i_dnnt(x) ((integer)u_nint(*(x)))
#define i_len(s, n) (n)
#define i_nint(x) ((integer)u_nint(*(x)))
#define i_sign(a,b) ((integer)u_sign((integer)*(a),(integer)*(b)))
#define pow_dd(ap, bp) ( pow(*(ap), *(bp)))
#define pow_si(B,E) spow_ui(*(B),*(E))
#define pow_ri(B,E) spow_ui(*(B),*(E))
#define pow_di(B,E) dpow_ui(*(B),*(E))
#define pow_zi(p, a, b) {pCd(p) = zpow_ui(Cd(a), *(b));}
#define pow_ci(p, a, b) {pCf(p) = cpow_ui(Cf(a), *(b));}
#define pow_zz(R,A,B) {pCd(R) = cpow(Cd(A),*(B));}
#define s_cat(lpp, rpp, rnp, np, llp) { ftnlen i, nc, ll; char *f__rp, *lp; ll = (llp); lp = (lpp); for(i=0; i < (int)*(np); ++i) { nc = ll; if((rnp)[i] < nc) nc = (rnp)[i]; ll -= nc; f__rp = (rpp)[i]; while(--nc >= 0) *lp++ = *(f__rp)++; } while(--ll >= 0) *lp++ = ' '; }
#define s_cmp(a,b,c,d) ((integer)strncmp((a),(b),f2cmin((c),(d))))
#define s_copy(A,B,C,D) { int __i,__m; for (__i=0, __m=f2cmin((C),(D)); __i<__m && (B)[__i] != 0; ++__i) (A)[__i] = (B)[__i]; }
#define sig_die(s, kill) { exit(1); }
#define s_stop(s, n) {exit(0);}
static char junk[] = "\n@(#)LIBF77 VERSION 19990503\n";
#define z_abs(z) (cabs(Cd(z)))
#define z_exp(R, Z) {pCd(R) = cexp(Cd(Z));}
#define z_sqrt(R, Z) {pCd(R) = csqrt(Cd(Z));}
#define myexit_() break;
#define mycycle() continue;
#define myceiling(w) {ceil(w)}
#define myhuge(w) {HUGE_VAL}
//#define mymaxloc_(w,s,e,n) {if (sizeof(*(w)) == sizeof(double)) dmaxloc_((w),*(s),*(e),n); else dmaxloc_((w),*(s),*(e),n);}
#define mymaxloc(w,s,e,n) {dmaxloc_(w,*(s),*(e),n)}
/* procedure parameter types for -A and -C++ */
#define F2C_proc_par_types 1
#ifdef __cplusplus
typedef logical (*L_fp)(...);
#else
typedef logical (*L_fp)();
#endif
static float spow_ui(float x, integer n) {
float pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static double dpow_ui(double x, integer n) {
double pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
#ifdef _MSC_VER
static _Fcomplex cpow_ui(complex x, integer n) {
complex pow={1.0,0.0}; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x.r = 1/x.r, x.i=1/x.i;
for(u = n; ; ) {
if(u & 01) pow.r *= x.r, pow.i *= x.i;
if(u >>= 1) x.r *= x.r, x.i *= x.i;
else break;
}
}
_Fcomplex p={pow.r, pow.i};
return p;
}
#else
static _Complex float cpow_ui(_Complex float x, integer n) {
_Complex float pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
#endif
#ifdef _MSC_VER
static _Dcomplex zpow_ui(_Dcomplex x, integer n) {
_Dcomplex pow={1.0,0.0}; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x._Val[0] = 1/x._Val[0], x._Val[1] =1/x._Val[1];
for(u = n; ; ) {
if(u & 01) pow._Val[0] *= x._Val[0], pow._Val[1] *= x._Val[1];
if(u >>= 1) x._Val[0] *= x._Val[0], x._Val[1] *= x._Val[1];
else break;
}
}
_Dcomplex p = {pow._Val[0], pow._Val[1]};
return p;
}
#else
static _Complex double zpow_ui(_Complex double x, integer n) {
_Complex double pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
#endif
static integer pow_ii(integer x, integer n) {
integer pow; unsigned long int u;
if (n <= 0) {
if (n == 0 || x == 1) pow = 1;
else if (x != -1) pow = x == 0 ? 1/x : 0;
else n = -n;
}
if ((n > 0) || !(n == 0 || x == 1 || x != -1)) {
u = n;
for(pow = 1; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static integer dmaxloc_(double *w, integer s, integer e, integer *n)
{
double m; integer i, mi;
for(m=w[s-1], mi=s, i=s+1; i<=e; i++)
if (w[i-1]>m) mi=i ,m=w[i-1];
return mi-s+1;
}
static integer smaxloc_(float *w, integer s, integer e, integer *n)
{
float m; integer i, mi;
for(m=w[s-1], mi=s, i=s+1; i<=e; i++)
if (w[i-1]>m) mi=i ,m=w[i-1];
return mi-s+1;
}
static inline void cdotc_(complex *z, integer *n_, complex *x, integer *incx_, complex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
#ifdef _MSC_VER
_Fcomplex zdotc = {0.0, 0.0};
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += conjf(Cf(&x[i]))._Val[0] * Cf(&y[i])._Val[0];
zdotc._Val[1] += conjf(Cf(&x[i]))._Val[1] * Cf(&y[i])._Val[1];
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += conjf(Cf(&x[i*incx]))._Val[0] * Cf(&y[i*incy])._Val[0];
zdotc._Val[1] += conjf(Cf(&x[i*incx]))._Val[1] * Cf(&y[i*incy])._Val[1];
}
}
pCf(z) = zdotc;
}
#else
_Complex float zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conjf(Cf(&x[i])) * Cf(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conjf(Cf(&x[i*incx])) * Cf(&y[i*incy]);
}
}
pCf(z) = zdotc;
}
#endif
static inline void zdotc_(doublecomplex *z, integer *n_, doublecomplex *x, integer *incx_, doublecomplex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
#ifdef _MSC_VER
_Dcomplex zdotc = {0.0, 0.0};
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += conj(Cd(&x[i]))._Val[0] * Cd(&y[i])._Val[0];
zdotc._Val[1] += conj(Cd(&x[i]))._Val[1] * Cd(&y[i])._Val[1];
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += conj(Cd(&x[i*incx]))._Val[0] * Cd(&y[i*incy])._Val[0];
zdotc._Val[1] += conj(Cd(&x[i*incx]))._Val[1] * Cd(&y[i*incy])._Val[1];
}
}
pCd(z) = zdotc;
}
#else
_Complex double zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conj(Cd(&x[i])) * Cd(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conj(Cd(&x[i*incx])) * Cd(&y[i*incy]);
}
}
pCd(z) = zdotc;
}
#endif
static inline void cdotu_(complex *z, integer *n_, complex *x, integer *incx_, complex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
#ifdef _MSC_VER
_Fcomplex zdotc = {0.0, 0.0};
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += Cf(&x[i])._Val[0] * Cf(&y[i])._Val[0];
zdotc._Val[1] += Cf(&x[i])._Val[1] * Cf(&y[i])._Val[1];
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += Cf(&x[i*incx])._Val[0] * Cf(&y[i*incy])._Val[0];
zdotc._Val[1] += Cf(&x[i*incx])._Val[1] * Cf(&y[i*incy])._Val[1];
}
}
pCf(z) = zdotc;
}
#else
_Complex float zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cf(&x[i]) * Cf(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cf(&x[i*incx]) * Cf(&y[i*incy]);
}
}
pCf(z) = zdotc;
}
#endif
static inline void zdotu_(doublecomplex *z, integer *n_, doublecomplex *x, integer *incx_, doublecomplex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
#ifdef _MSC_VER
_Dcomplex zdotc = {0.0, 0.0};
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += Cd(&x[i])._Val[0] * Cd(&y[i])._Val[0];
zdotc._Val[1] += Cd(&x[i])._Val[1] * Cd(&y[i])._Val[1];
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc._Val[0] += Cd(&x[i*incx])._Val[0] * Cd(&y[i*incy])._Val[0];
zdotc._Val[1] += Cd(&x[i*incx])._Val[1] * Cd(&y[i*incy])._Val[1];
}
}
pCd(z) = zdotc;
}
#else
_Complex double zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cd(&x[i]) * Cd(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cd(&x[i*incx]) * Cd(&y[i*incy]);
}
}
pCd(z) = zdotc;
}
#endif
/* -- translated by f2c (version 20000121).
You must link the resulting object file with the libraries:
-lf2c -lm (in that order)
*/
/* Table of constant values */
static integer c__1 = 1;
static doublereal c_b36 = .5;
/* > \brief \b ZLATPS solves a triangular system of equations with the matrix held in packed storage. */
/* =========== DOCUMENTATION =========== */
/* Online html documentation available at */
/* http://www.netlib.org/lapack/explore-html/ */
/* > \htmlonly */
/* > Download ZLATPS + dependencies */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/zlatps.
f"> */
/* > [TGZ]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/zlatps.
f"> */
/* > [ZIP]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/zlatps.
f"> */
/* > [TXT]</a> */
/* > \endhtmlonly */
/* Definition: */
/* =========== */
/* SUBROUTINE ZLATPS( UPLO, TRANS, DIAG, NORMIN, N, AP, X, SCALE, */
/* CNORM, INFO ) */
/* CHARACTER DIAG, NORMIN, TRANS, UPLO */
/* INTEGER INFO, N */
/* DOUBLE PRECISION SCALE */
/* DOUBLE PRECISION CNORM( * ) */
/* COMPLEX*16 AP( * ), X( * ) */
/* > \par Purpose: */
/* ============= */
/* > */
/* > \verbatim */
/* > */
/* > ZLATPS solves one of the triangular systems */
/* > */
/* > A * x = s*b, A**T * x = s*b, or A**H * x = s*b, */
/* > */
/* > with scaling to prevent overflow, where A is an upper or lower */
/* > triangular matrix stored in packed form. Here A**T denotes the */
/* > transpose of A, A**H denotes the conjugate transpose of A, x and b */
/* > are n-element vectors, and s is a scaling factor, usually less than */
/* > or equal to 1, chosen so that the components of x will be less than */
/* > the overflow threshold. If the unscaled problem will not cause */
/* > overflow, the Level 2 BLAS routine ZTPSV is called. If the matrix A */
/* > is singular (A(j,j) = 0 for some j), then s is set to 0 and a */
/* > non-trivial solution to A*x = 0 is returned. */
/* > \endverbatim */
/* Arguments: */
/* ========== */
/* > \param[in] UPLO */
/* > \verbatim */
/* > UPLO is CHARACTER*1 */
/* > Specifies whether the matrix A is upper or lower triangular. */
/* > = 'U': Upper triangular */
/* > = 'L': Lower triangular */
/* > \endverbatim */
/* > */
/* > \param[in] TRANS */
/* > \verbatim */
/* > TRANS is CHARACTER*1 */
/* > Specifies the operation applied to A. */
/* > = 'N': Solve A * x = s*b (No transpose) */
/* > = 'T': Solve A**T * x = s*b (Transpose) */
/* > = 'C': Solve A**H * x = s*b (Conjugate transpose) */
/* > \endverbatim */
/* > */
/* > \param[in] DIAG */
/* > \verbatim */
/* > DIAG is CHARACTER*1 */
/* > Specifies whether or not the matrix A is unit triangular. */
/* > = 'N': Non-unit triangular */
/* > = 'U': Unit triangular */
/* > \endverbatim */
/* > */
/* > \param[in] NORMIN */
/* > \verbatim */
/* > NORMIN is CHARACTER*1 */
/* > Specifies whether CNORM has been set or not. */
/* > = 'Y': CNORM contains the column norms on entry */
/* > = 'N': CNORM is not set on entry. On exit, the norms will */
/* > be computed and stored in CNORM. */
/* > \endverbatim */
/* > */
/* > \param[in] N */
/* > \verbatim */
/* > N is INTEGER */
/* > The order of the matrix A. N >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in] AP */
/* > \verbatim */
/* > AP is COMPLEX*16 array, dimension (N*(N+1)/2) */
/* > The upper or lower triangular matrix A, packed columnwise in */
/* > a linear array. The j-th column of A is stored in the array */
/* > AP as follows: */
/* > if UPLO = 'U', AP(i + (j-1)*j/2) = A(i,j) for 1<=i<=j; */
/* > if UPLO = 'L', AP(i + (j-1)*(2n-j)/2) = A(i,j) for j<=i<=n. */
/* > \endverbatim */
/* > */
/* > \param[in,out] X */
/* > \verbatim */
/* > X is COMPLEX*16 array, dimension (N) */
/* > On entry, the right hand side b of the triangular system. */
/* > On exit, X is overwritten by the solution vector x. */
/* > \endverbatim */
/* > */
/* > \param[out] SCALE */
/* > \verbatim */
/* > SCALE is DOUBLE PRECISION */
/* > The scaling factor s for the triangular system */
/* > A * x = s*b, A**T * x = s*b, or A**H * x = s*b. */
/* > If SCALE = 0, the matrix A is singular or badly scaled, and */
/* > the vector x is an exact or approximate solution to A*x = 0. */
/* > \endverbatim */
/* > */
/* > \param[in,out] CNORM */
/* > \verbatim */
/* > CNORM is DOUBLE PRECISION array, dimension (N) */
/* > */
/* > If NORMIN = 'Y', CNORM is an input argument and CNORM(j) */
/* > contains the norm of the off-diagonal part of the j-th column */
/* > of A. If TRANS = 'N', CNORM(j) must be greater than or equal */
/* > to the infinity-norm, and if TRANS = 'T' or 'C', CNORM(j) */
/* > must be greater than or equal to the 1-norm. */
/* > */
/* > If NORMIN = 'N', CNORM is an output argument and CNORM(j) */
/* > returns the 1-norm of the offdiagonal part of the j-th column */
/* > of A. */
/* > \endverbatim */
/* > */
/* > \param[out] INFO */
/* > \verbatim */
/* > INFO is INTEGER */
/* > = 0: successful exit */
/* > < 0: if INFO = -k, the k-th argument had an illegal value */
/* > \endverbatim */
/* Authors: */
/* ======== */
/* > \author Univ. of Tennessee */
/* > \author Univ. of California Berkeley */
/* > \author Univ. of Colorado Denver */
/* > \author NAG Ltd. */
/* > \date November 2017 */
/* > \ingroup complex16OTHERauxiliary */
/* > \par Further Details: */
/* ===================== */
/* > */
/* > \verbatim */
/* > */
/* > A rough bound on x is computed; if that is less than overflow, ZTPSV */
/* > is called, otherwise, specific code is used which checks for possible */
/* > overflow or divide-by-zero at every operation. */
/* > */
/* > A columnwise scheme is used for solving A*x = b. The basic algorithm */
/* > if A is lower triangular is */
/* > */
/* > x[1:n] := b[1:n] */
/* > for j = 1, ..., n */
/* > x(j) := x(j) / A(j,j) */
/* > x[j+1:n] := x[j+1:n] - x(j) * A[j+1:n,j] */
/* > end */
/* > */
/* > Define bounds on the components of x after j iterations of the loop: */
/* > M(j) = bound on x[1:j] */
/* > G(j) = bound on x[j+1:n] */
/* > Initially, let M(0) = 0 and G(0) = f2cmax{x(i), i=1,...,n}. */
/* > */
/* > Then for iteration j+1 we have */
/* > M(j+1) <= G(j) / | A(j+1,j+1) | */
/* > G(j+1) <= G(j) + M(j+1) * | A[j+2:n,j+1] | */
/* > <= G(j) ( 1 + CNORM(j+1) / | A(j+1,j+1) | ) */
/* > */
/* > where CNORM(j+1) is greater than or equal to the infinity-norm of */
/* > column j+1 of A, not counting the diagonal. Hence */
/* > */
/* > G(j) <= G(0) product ( 1 + CNORM(i) / | A(i,i) | ) */
/* > 1<=i<=j */
/* > and */
/* > */
/* > |x(j)| <= ( G(0) / |A(j,j)| ) product ( 1 + CNORM(i) / |A(i,i)| ) */
/* > 1<=i< j */
/* > */
/* > Since |x(j)| <= M(j), we use the Level 2 BLAS routine ZTPSV if the */
/* > reciprocal of the largest M(j), j=1,..,n, is larger than */
/* > f2cmax(underflow, 1/overflow). */
/* > */
/* > The bound on x(j) is also used to determine when a step in the */
/* > columnwise method can be performed without fear of overflow. If */
/* > the computed bound is greater than a large constant, x is scaled to */
/* > prevent overflow, but if the bound overflows, x is set to 0, x(j) to */
/* > 1, and scale to 0, and a non-trivial solution to A*x = 0 is found. */
/* > */
/* > Similarly, a row-wise scheme is used to solve A**T *x = b or */
/* > A**H *x = b. The basic algorithm for A upper triangular is */
/* > */
/* > for j = 1, ..., n */
/* > x(j) := ( b(j) - A[1:j-1,j]' * x[1:j-1] ) / A(j,j) */
/* > end */
/* > */
/* > We simultaneously compute two bounds */
/* > G(j) = bound on ( b(i) - A[1:i-1,i]' * x[1:i-1] ), 1<=i<=j */
/* > M(j) = bound on x(i), 1<=i<=j */
/* > */
/* > The initial values are G(0) = 0, M(0) = f2cmax{b(i), i=1,..,n}, and we */
/* > add the constraint G(j) >= G(j-1) and M(j) >= M(j-1) for j >= 1. */
/* > Then the bound on x(j) is */
/* > */
/* > M(j) <= M(j-1) * ( 1 + CNORM(j) ) / | A(j,j) | */
/* > */
/* > <= M(0) * product ( ( 1 + CNORM(i) ) / |A(i,i)| ) */
/* > 1<=i<=j */
/* > */
/* > and we can safely call ZTPSV if 1/M(n) and 1/G(n) are both greater */
/* > than f2cmax(underflow, 1/overflow). */
/* > \endverbatim */
/* > */
/* ===================================================================== */
/* Subroutine */ int zlatps_(char *uplo, char *trans, char *diag, char *
normin, integer *n, doublecomplex *ap, doublecomplex *x, doublereal *
scale, doublereal *cnorm, integer *info)
{
/* System generated locals */
integer i__1, i__2, i__3, i__4, i__5;
doublereal d__1, d__2, d__3, d__4;
doublecomplex z__1, z__2, z__3, z__4;
/* Local variables */
integer jinc, jlen;
doublereal xbnd;
integer imax;
doublereal tmax;
doublecomplex tjjs;
doublereal xmax, grow;
integer i__, j;
extern /* Subroutine */ int dscal_(integer *, doublereal *, doublereal *,
integer *);
extern logical lsame_(char *, char *);
doublereal tscal;
doublecomplex uscal;
integer jlast;
doublecomplex csumj;
extern /* Double Complex */ VOID zdotc_(doublecomplex *, integer *,
doublecomplex *, integer *, doublecomplex *, integer *);
logical upper;
extern /* Double Complex */ VOID zdotu_(doublecomplex *, integer *,
doublecomplex *, integer *, doublecomplex *, integer *);
extern /* Subroutine */ int zaxpy_(integer *, doublecomplex *,
doublecomplex *, integer *, doublecomplex *, integer *), ztpsv_(
char *, char *, char *, integer *, doublecomplex *, doublecomplex
*, integer *), dlabad_(doublereal *,
doublereal *);
extern doublereal dlamch_(char *);
integer ip;
doublereal xj;
extern integer idamax_(integer *, doublereal *, integer *);
extern /* Subroutine */ int xerbla_(char *, integer *, ftnlen), zdscal_(
integer *, doublereal *, doublecomplex *, integer *);
doublereal bignum;
extern integer izamax_(integer *, doublecomplex *, integer *);
extern /* Double Complex */ VOID zladiv_(doublecomplex *, doublecomplex *,
doublecomplex *);
logical notran;
integer jfirst;
extern doublereal dzasum_(integer *, doublecomplex *, integer *);
doublereal smlnum;
logical nounit;
doublereal rec, tjj;
/* -- LAPACK auxiliary routine (version 3.8.0) -- */
/* -- LAPACK is a software package provided by Univ. of Tennessee, -- */
/* -- Univ. of California Berkeley, Univ. of Colorado Denver and NAG Ltd..-- */
/* November 2017 */
/* ===================================================================== */
/* Parameter adjustments */
--cnorm;
--x;
--ap;
/* Function Body */
*info = 0;
upper = lsame_(uplo, "U");
notran = lsame_(trans, "N");
nounit = lsame_(diag, "N");
/* Test the input parameters. */
if (! upper && ! lsame_(uplo, "L")) {
*info = -1;
} else if (! notran && ! lsame_(trans, "T") && !
lsame_(trans, "C")) {
*info = -2;
} else if (! nounit && ! lsame_(diag, "U")) {
*info = -3;
} else if (! lsame_(normin, "Y") && ! lsame_(normin,
"N")) {
*info = -4;
} else if (*n < 0) {
*info = -5;
}
if (*info != 0) {
i__1 = -(*info);
xerbla_("ZLATPS", &i__1, (ftnlen)6);
return 0;
}
/* Quick return if possible */
if (*n == 0) {
return 0;
}
/* Determine machine dependent parameters to control overflow. */
smlnum = dlamch_("Safe minimum");
bignum = 1. / smlnum;
dlabad_(&smlnum, &bignum);
smlnum /= dlamch_("Precision");
bignum = 1. / smlnum;
*scale = 1.;
if (lsame_(normin, "N")) {
/* Compute the 1-norm of each column, not including the diagonal. */
if (upper) {
/* A is upper triangular. */
ip = 1;
i__1 = *n;
for (j = 1; j <= i__1; ++j) {
i__2 = j - 1;
cnorm[j] = dzasum_(&i__2, &ap[ip], &c__1);
ip += j;
/* L10: */
}
} else {
/* A is lower triangular. */
ip = 1;
i__1 = *n - 1;
for (j = 1; j <= i__1; ++j) {
i__2 = *n - j;
cnorm[j] = dzasum_(&i__2, &ap[ip + 1], &c__1);
ip = ip + *n - j + 1;
/* L20: */
}
cnorm[*n] = 0.;
}
}
/* Scale the column norms by TSCAL if the maximum element in CNORM is */
/* greater than BIGNUM/2. */
imax = idamax_(n, &cnorm[1], &c__1);
tmax = cnorm[imax];
if (tmax <= bignum * .5) {
tscal = 1.;
} else {
tscal = .5 / (smlnum * tmax);
dscal_(n, &tscal, &cnorm[1], &c__1);
}
/* Compute a bound on the computed solution vector to see if the */
/* Level 2 BLAS routine ZTPSV can be used. */
xmax = 0.;
i__1 = *n;
for (j = 1; j <= i__1; ++j) {
/* Computing MAX */
i__2 = j;
d__3 = xmax, d__4 = (d__1 = x[i__2].r / 2., abs(d__1)) + (d__2 =
d_imag(&x[j]) / 2., abs(d__2));
xmax = f2cmax(d__3,d__4);
/* L30: */
}
xbnd = xmax;
if (notran) {
/* Compute the growth in A * x = b. */
if (upper) {
jfirst = *n;
jlast = 1;
jinc = -1;
} else {
jfirst = 1;
jlast = *n;
jinc = 1;
}
if (tscal != 1.) {
grow = 0.;
goto L60;
}
if (nounit) {
/* A is non-unit triangular. */
/* Compute GROW = 1/G(j) and XBND = 1/M(j). */
/* Initially, G(0) = f2cmax{x(i), i=1,...,n}. */
grow = .5 / f2cmax(xbnd,smlnum);
xbnd = grow;
ip = jfirst * (jfirst + 1) / 2;
jlen = *n;
i__1 = jlast;
i__2 = jinc;
for (j = jfirst; i__2 < 0 ? j >= i__1 : j <= i__1; j += i__2) {
/* Exit the loop if the growth factor is too small. */
if (grow <= smlnum) {
goto L60;
}
i__3 = ip;
tjjs.r = ap[i__3].r, tjjs.i = ap[i__3].i;
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs), abs(
d__2));
if (tjj >= smlnum) {
/* M(j) = G(j-1) / abs(A(j,j)) */
/* Computing MIN */
d__1 = xbnd, d__2 = f2cmin(1.,tjj) * grow;
xbnd = f2cmin(d__1,d__2);
} else {
/* M(j) could overflow, set XBND to 0. */
xbnd = 0.;
}
if (tjj + cnorm[j] >= smlnum) {
/* G(j) = G(j-1)*( 1 + CNORM(j) / abs(A(j,j)) ) */
grow *= tjj / (tjj + cnorm[j]);
} else {
/* G(j) could overflow, set GROW to 0. */
grow = 0.;
}
ip += jinc * jlen;
--jlen;
/* L40: */
}
grow = xbnd;
} else {
/* A is unit triangular. */
/* Compute GROW = 1/G(j), where G(0) = f2cmax{x(i), i=1,...,n}. */
/* Computing MIN */
d__1 = 1., d__2 = .5 / f2cmax(xbnd,smlnum);
grow = f2cmin(d__1,d__2);
i__2 = jlast;
i__1 = jinc;
for (j = jfirst; i__1 < 0 ? j >= i__2 : j <= i__2; j += i__1) {
/* Exit the loop if the growth factor is too small. */
if (grow <= smlnum) {
goto L60;
}
/* G(j) = G(j-1)*( 1 + CNORM(j) ) */
grow *= 1. / (cnorm[j] + 1.);
/* L50: */
}
}
L60:
;
} else {
/* Compute the growth in A**T * x = b or A**H * x = b. */
if (upper) {
jfirst = 1;
jlast = *n;
jinc = 1;
} else {
jfirst = *n;
jlast = 1;
jinc = -1;
}
if (tscal != 1.) {
grow = 0.;
goto L90;
}
if (nounit) {
/* A is non-unit triangular. */
/* Compute GROW = 1/G(j) and XBND = 1/M(j). */
/* Initially, M(0) = f2cmax{x(i), i=1,...,n}. */
grow = .5 / f2cmax(xbnd,smlnum);
xbnd = grow;
ip = jfirst * (jfirst + 1) / 2;
jlen = 1;
i__1 = jlast;
i__2 = jinc;
for (j = jfirst; i__2 < 0 ? j >= i__1 : j <= i__1; j += i__2) {
/* Exit the loop if the growth factor is too small. */
if (grow <= smlnum) {
goto L90;
}
/* G(j) = f2cmax( G(j-1), M(j-1)*( 1 + CNORM(j) ) ) */
xj = cnorm[j] + 1.;
/* Computing MIN */
d__1 = grow, d__2 = xbnd / xj;
grow = f2cmin(d__1,d__2);
i__3 = ip;
tjjs.r = ap[i__3].r, tjjs.i = ap[i__3].i;
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs), abs(
d__2));
if (tjj >= smlnum) {
/* M(j) = M(j-1)*( 1 + CNORM(j) ) / abs(A(j,j)) */
if (xj > tjj) {
xbnd *= tjj / xj;
}
} else {
/* M(j) could overflow, set XBND to 0. */
xbnd = 0.;
}
++jlen;
ip += jinc * jlen;
/* L70: */
}
grow = f2cmin(grow,xbnd);
} else {
/* A is unit triangular. */
/* Compute GROW = 1/G(j), where G(0) = f2cmax{x(i), i=1,...,n}. */
/* Computing MIN */
d__1 = 1., d__2 = .5 / f2cmax(xbnd,smlnum);
grow = f2cmin(d__1,d__2);
i__2 = jlast;
i__1 = jinc;
for (j = jfirst; i__1 < 0 ? j >= i__2 : j <= i__2; j += i__1) {
/* Exit the loop if the growth factor is too small. */
if (grow <= smlnum) {
goto L90;
}
/* G(j) = ( 1 + CNORM(j) )*G(j-1) */
xj = cnorm[j] + 1.;
grow /= xj;
/* L80: */
}
}
L90:
;
}
if (grow * tscal > smlnum) {
/* Use the Level 2 BLAS solve if the reciprocal of the bound on */
/* elements of X is not too small. */
ztpsv_(uplo, trans, diag, n, &ap[1], &x[1], &c__1);
} else {
/* Use a Level 1 BLAS solve, scaling intermediate results. */
if (xmax > bignum * .5) {
/* Scale X so that its components are less than or equal to */
/* BIGNUM in absolute value. */
*scale = bignum * .5 / xmax;
zdscal_(n, scale, &x[1], &c__1);
xmax = bignum;
} else {
xmax *= 2.;
}
if (notran) {
/* Solve A * x = b */
ip = jfirst * (jfirst + 1) / 2;
i__1 = jlast;
i__2 = jinc;
for (j = jfirst; i__2 < 0 ? j >= i__1 : j <= i__1; j += i__2) {
/* Compute x(j) = b(j) / A(j,j), scaling x if necessary. */
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j]),
abs(d__2));
if (nounit) {
i__3 = ip;
z__1.r = tscal * ap[i__3].r, z__1.i = tscal * ap[i__3].i;
tjjs.r = z__1.r, tjjs.i = z__1.i;
} else {
tjjs.r = tscal, tjjs.i = 0.;
if (tscal == 1.) {
goto L110;
}
}
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs), abs(
d__2));
if (tjj > smlnum) {
/* abs(A(j,j)) > SMLNUM: */
if (tjj < 1.) {
if (xj > tjj * bignum) {
/* Scale x by 1/b(j). */
rec = 1. / xj;
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
}
i__3 = j;
zladiv_(&z__1, &x[j], &tjjs);
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j])
, abs(d__2));
} else if (tjj > 0.) {
/* 0 < abs(A(j,j)) <= SMLNUM: */
if (xj > tjj * bignum) {
/* Scale x by (1/abs(x(j)))*abs(A(j,j))*BIGNUM */
/* to avoid overflow when dividing by A(j,j). */
rec = tjj * bignum / xj;
if (cnorm[j] > 1.) {
/* Scale by 1/CNORM(j) to avoid overflow when */
/* multiplying x(j) times column j. */
rec /= cnorm[j];
}
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
i__3 = j;
zladiv_(&z__1, &x[j], &tjjs);
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j])
, abs(d__2));
} else {
/* A(j,j) = 0: Set x(1:n) = 0, x(j) = 1, and */
/* scale = 0, and compute a solution to A*x = 0. */
i__3 = *n;
for (i__ = 1; i__ <= i__3; ++i__) {
i__4 = i__;
x[i__4].r = 0., x[i__4].i = 0.;
/* L100: */
}
i__3 = j;
x[i__3].r = 1., x[i__3].i = 0.;
xj = 1.;
*scale = 0.;
xmax = 0.;
}
L110:
/* Scale x if necessary to avoid overflow when adding a */
/* multiple of column j of A. */
if (xj > 1.) {
rec = 1. / xj;
if (cnorm[j] > (bignum - xmax) * rec) {
/* Scale x by 1/(2*abs(x(j))). */
rec *= .5;
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
}
} else if (xj * cnorm[j] > bignum - xmax) {
/* Scale x by 1/2. */
zdscal_(n, &c_b36, &x[1], &c__1);
*scale *= .5;
}
if (upper) {
if (j > 1) {
/* Compute the update */
/* x(1:j-1) := x(1:j-1) - x(j) * A(1:j-1,j) */
i__3 = j - 1;
i__4 = j;
z__2.r = -x[i__4].r, z__2.i = -x[i__4].i;
z__1.r = tscal * z__2.r, z__1.i = tscal * z__2.i;
zaxpy_(&i__3, &z__1, &ap[ip - j + 1], &c__1, &x[1], &
c__1);
i__3 = j - 1;
i__ = izamax_(&i__3, &x[1], &c__1);
i__3 = i__;
xmax = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(
&x[i__]), abs(d__2));
}
ip -= j;
} else {
if (j < *n) {
/* Compute the update */
/* x(j+1:n) := x(j+1:n) - x(j) * A(j+1:n,j) */
i__3 = *n - j;
i__4 = j;
z__2.r = -x[i__4].r, z__2.i = -x[i__4].i;
z__1.r = tscal * z__2.r, z__1.i = tscal * z__2.i;
zaxpy_(&i__3, &z__1, &ap[ip + 1], &c__1, &x[j + 1], &
c__1);
i__3 = *n - j;
i__ = j + izamax_(&i__3, &x[j + 1], &c__1);
i__3 = i__;
xmax = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(
&x[i__]), abs(d__2));
}
ip = ip + *n - j + 1;
}
/* L120: */
}
} else if (lsame_(trans, "T")) {
/* Solve A**T * x = b */
ip = jfirst * (jfirst + 1) / 2;
jlen = 1;
i__2 = jlast;
i__1 = jinc;
for (j = jfirst; i__1 < 0 ? j >= i__2 : j <= i__2; j += i__1) {
/* Compute x(j) = b(j) - sum A(k,j)*x(k). */
/* k<>j */
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j]),
abs(d__2));
uscal.r = tscal, uscal.i = 0.;
rec = 1. / f2cmax(xmax,1.);
if (cnorm[j] > (bignum - xj) * rec) {
/* If x(j) could overflow, scale x by 1/(2*XMAX). */
rec *= .5;
if (nounit) {
i__3 = ip;
z__1.r = tscal * ap[i__3].r, z__1.i = tscal * ap[i__3]
.i;
tjjs.r = z__1.r, tjjs.i = z__1.i;
} else {
tjjs.r = tscal, tjjs.i = 0.;
}
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs),
abs(d__2));
if (tjj > 1.) {
/* Divide by A(j,j) when scaling x if A(j,j) > 1. */
/* Computing MIN */
d__1 = 1., d__2 = rec * tjj;
rec = f2cmin(d__1,d__2);
zladiv_(&z__1, &uscal, &tjjs);
uscal.r = z__1.r, uscal.i = z__1.i;
}
if (rec < 1.) {
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
}
csumj.r = 0., csumj.i = 0.;
if (uscal.r == 1. && uscal.i == 0.) {
/* If the scaling needed for A in the dot product is 1, */
/* call ZDOTU to perform the dot product. */
if (upper) {
i__3 = j - 1;
zdotu_(&z__1, &i__3, &ap[ip - j + 1], &c__1, &x[1], &
c__1);
csumj.r = z__1.r, csumj.i = z__1.i;
} else if (j < *n) {
i__3 = *n - j;
zdotu_(&z__1, &i__3, &ap[ip + 1], &c__1, &x[j + 1], &
c__1);
csumj.r = z__1.r, csumj.i = z__1.i;
}
} else {
/* Otherwise, use in-line code for the dot product. */
if (upper) {
i__3 = j - 1;
for (i__ = 1; i__ <= i__3; ++i__) {
i__4 = ip - j + i__;
z__3.r = ap[i__4].r * uscal.r - ap[i__4].i *
uscal.i, z__3.i = ap[i__4].r * uscal.i +
ap[i__4].i * uscal.r;
i__5 = i__;
z__2.r = z__3.r * x[i__5].r - z__3.i * x[i__5].i,
z__2.i = z__3.r * x[i__5].i + z__3.i * x[
i__5].r;
z__1.r = csumj.r + z__2.r, z__1.i = csumj.i +
z__2.i;
csumj.r = z__1.r, csumj.i = z__1.i;
/* L130: */
}
} else if (j < *n) {
i__3 = *n - j;
for (i__ = 1; i__ <= i__3; ++i__) {
i__4 = ip + i__;
z__3.r = ap[i__4].r * uscal.r - ap[i__4].i *
uscal.i, z__3.i = ap[i__4].r * uscal.i +
ap[i__4].i * uscal.r;
i__5 = j + i__;
z__2.r = z__3.r * x[i__5].r - z__3.i * x[i__5].i,
z__2.i = z__3.r * x[i__5].i + z__3.i * x[
i__5].r;
z__1.r = csumj.r + z__2.r, z__1.i = csumj.i +
z__2.i;
csumj.r = z__1.r, csumj.i = z__1.i;
/* L140: */
}
}
}
z__1.r = tscal, z__1.i = 0.;
if (uscal.r == z__1.r && uscal.i == z__1.i) {
/* Compute x(j) := ( x(j) - CSUMJ ) / A(j,j) if 1/A(j,j) */
/* was not used to scale the dotproduct. */
i__3 = j;
i__4 = j;
z__1.r = x[i__4].r - csumj.r, z__1.i = x[i__4].i -
csumj.i;
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j])
, abs(d__2));
if (nounit) {
/* Compute x(j) = x(j) / A(j,j), scaling if necessary. */
i__3 = ip;
z__1.r = tscal * ap[i__3].r, z__1.i = tscal * ap[i__3]
.i;
tjjs.r = z__1.r, tjjs.i = z__1.i;
} else {
tjjs.r = tscal, tjjs.i = 0.;
if (tscal == 1.) {
goto L160;
}
}
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs),
abs(d__2));
if (tjj > smlnum) {
/* abs(A(j,j)) > SMLNUM: */
if (tjj < 1.) {
if (xj > tjj * bignum) {
/* Scale X by 1/abs(x(j)). */
rec = 1. / xj;
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
}
i__3 = j;
zladiv_(&z__1, &x[j], &tjjs);
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
} else if (tjj > 0.) {
/* 0 < abs(A(j,j)) <= SMLNUM: */
if (xj > tjj * bignum) {
/* Scale x by (1/abs(x(j)))*abs(A(j,j))*BIGNUM. */
rec = tjj * bignum / xj;
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
i__3 = j;
zladiv_(&z__1, &x[j], &tjjs);
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
} else {
/* A(j,j) = 0: Set x(1:n) = 0, x(j) = 1, and */
/* scale = 0 and compute a solution to A**T *x = 0. */
i__3 = *n;
for (i__ = 1; i__ <= i__3; ++i__) {
i__4 = i__;
x[i__4].r = 0., x[i__4].i = 0.;
/* L150: */
}
i__3 = j;
x[i__3].r = 1., x[i__3].i = 0.;
*scale = 0.;
xmax = 0.;
}
L160:
;
} else {
/* Compute x(j) := x(j) / A(j,j) - CSUMJ if the dot */
/* product has already been divided by 1/A(j,j). */
i__3 = j;
zladiv_(&z__2, &x[j], &tjjs);
z__1.r = z__2.r - csumj.r, z__1.i = z__2.i - csumj.i;
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
}
/* Computing MAX */
i__3 = j;
d__3 = xmax, d__4 = (d__1 = x[i__3].r, abs(d__1)) + (d__2 =
d_imag(&x[j]), abs(d__2));
xmax = f2cmax(d__3,d__4);
++jlen;
ip += jinc * jlen;
/* L170: */
}
} else {
/* Solve A**H * x = b */
ip = jfirst * (jfirst + 1) / 2;
jlen = 1;
i__1 = jlast;
i__2 = jinc;
for (j = jfirst; i__2 < 0 ? j >= i__1 : j <= i__1; j += i__2) {
/* Compute x(j) = b(j) - sum A(k,j)*x(k). */
/* k<>j */
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j]),
abs(d__2));
uscal.r = tscal, uscal.i = 0.;
rec = 1. / f2cmax(xmax,1.);
if (cnorm[j] > (bignum - xj) * rec) {
/* If x(j) could overflow, scale x by 1/(2*XMAX). */
rec *= .5;
if (nounit) {
d_cnjg(&z__2, &ap[ip]);
z__1.r = tscal * z__2.r, z__1.i = tscal * z__2.i;
tjjs.r = z__1.r, tjjs.i = z__1.i;
} else {
tjjs.r = tscal, tjjs.i = 0.;
}
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs),
abs(d__2));
if (tjj > 1.) {
/* Divide by A(j,j) when scaling x if A(j,j) > 1. */
/* Computing MIN */
d__1 = 1., d__2 = rec * tjj;
rec = f2cmin(d__1,d__2);
zladiv_(&z__1, &uscal, &tjjs);
uscal.r = z__1.r, uscal.i = z__1.i;
}
if (rec < 1.) {
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
}
csumj.r = 0., csumj.i = 0.;
if (uscal.r == 1. && uscal.i == 0.) {
/* If the scaling needed for A in the dot product is 1, */
/* call ZDOTC to perform the dot product. */
if (upper) {
i__3 = j - 1;
zdotc_(&z__1, &i__3, &ap[ip - j + 1], &c__1, &x[1], &
c__1);
csumj.r = z__1.r, csumj.i = z__1.i;
} else if (j < *n) {
i__3 = *n - j;
zdotc_(&z__1, &i__3, &ap[ip + 1], &c__1, &x[j + 1], &
c__1);
csumj.r = z__1.r, csumj.i = z__1.i;
}
} else {
/* Otherwise, use in-line code for the dot product. */
if (upper) {
i__3 = j - 1;
for (i__ = 1; i__ <= i__3; ++i__) {
d_cnjg(&z__4, &ap[ip - j + i__]);
z__3.r = z__4.r * uscal.r - z__4.i * uscal.i,
z__3.i = z__4.r * uscal.i + z__4.i *
uscal.r;
i__4 = i__;
z__2.r = z__3.r * x[i__4].r - z__3.i * x[i__4].i,
z__2.i = z__3.r * x[i__4].i + z__3.i * x[
i__4].r;
z__1.r = csumj.r + z__2.r, z__1.i = csumj.i +
z__2.i;
csumj.r = z__1.r, csumj.i = z__1.i;
/* L180: */
}
} else if (j < *n) {
i__3 = *n - j;
for (i__ = 1; i__ <= i__3; ++i__) {
d_cnjg(&z__4, &ap[ip + i__]);
z__3.r = z__4.r * uscal.r - z__4.i * uscal.i,
z__3.i = z__4.r * uscal.i + z__4.i *
uscal.r;
i__4 = j + i__;
z__2.r = z__3.r * x[i__4].r - z__3.i * x[i__4].i,
z__2.i = z__3.r * x[i__4].i + z__3.i * x[
i__4].r;
z__1.r = csumj.r + z__2.r, z__1.i = csumj.i +
z__2.i;
csumj.r = z__1.r, csumj.i = z__1.i;
/* L190: */
}
}
}
z__1.r = tscal, z__1.i = 0.;
if (uscal.r == z__1.r && uscal.i == z__1.i) {
/* Compute x(j) := ( x(j) - CSUMJ ) / A(j,j) if 1/A(j,j) */
/* was not used to scale the dotproduct. */
i__3 = j;
i__4 = j;
z__1.r = x[i__4].r - csumj.r, z__1.i = x[i__4].i -
csumj.i;
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
i__3 = j;
xj = (d__1 = x[i__3].r, abs(d__1)) + (d__2 = d_imag(&x[j])
, abs(d__2));
if (nounit) {
/* Compute x(j) = x(j) / A(j,j), scaling if necessary. */
d_cnjg(&z__2, &ap[ip]);
z__1.r = tscal * z__2.r, z__1.i = tscal * z__2.i;
tjjs.r = z__1.r, tjjs.i = z__1.i;
} else {
tjjs.r = tscal, tjjs.i = 0.;
if (tscal == 1.) {
goto L210;
}
}
tjj = (d__1 = tjjs.r, abs(d__1)) + (d__2 = d_imag(&tjjs),
abs(d__2));
if (tjj > smlnum) {
/* abs(A(j,j)) > SMLNUM: */
if (tjj < 1.) {
if (xj > tjj * bignum) {
/* Scale X by 1/abs(x(j)). */
rec = 1. / xj;
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
}
i__3 = j;
zladiv_(&z__1, &x[j], &tjjs);
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
} else if (tjj > 0.) {
/* 0 < abs(A(j,j)) <= SMLNUM: */
if (xj > tjj * bignum) {
/* Scale x by (1/abs(x(j)))*abs(A(j,j))*BIGNUM. */
rec = tjj * bignum / xj;
zdscal_(n, &rec, &x[1], &c__1);
*scale *= rec;
xmax *= rec;
}
i__3 = j;
zladiv_(&z__1, &x[j], &tjjs);
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
} else {
/* A(j,j) = 0: Set x(1:n) = 0, x(j) = 1, and */
/* scale = 0 and compute a solution to A**H *x = 0. */
i__3 = *n;
for (i__ = 1; i__ <= i__3; ++i__) {
i__4 = i__;
x[i__4].r = 0., x[i__4].i = 0.;
/* L200: */
}
i__3 = j;
x[i__3].r = 1., x[i__3].i = 0.;
*scale = 0.;
xmax = 0.;
}
L210:
;
} else {
/* Compute x(j) := x(j) / A(j,j) - CSUMJ if the dot */
/* product has already been divided by 1/A(j,j). */
i__3 = j;
zladiv_(&z__2, &x[j], &tjjs);
z__1.r = z__2.r - csumj.r, z__1.i = z__2.i - csumj.i;
x[i__3].r = z__1.r, x[i__3].i = z__1.i;
}
/* Computing MAX */
i__3 = j;
d__3 = xmax, d__4 = (d__1 = x[i__3].r, abs(d__1)) + (d__2 =
d_imag(&x[j]), abs(d__2));
xmax = f2cmax(d__3,d__4);
++jlen;
ip += jinc * jlen;
/* L220: */
}
}
*scale /= tscal;
}
/* Scale the column norms by 1/TSCAL for return. */
if (tscal != 1.) {
d__1 = 1. / tscal;
dscal_(n, &d__1, &cnorm[1], &c__1);
}
return 0;
/* End of ZLATPS */
} /* zlatps_ */
|
the_stack_data/103264518.c | //
// ExtrudeMesh - extrudes 2d mesh on a constant number of levels and
// interpolates lower and upper surface from values
// given by a DEM
//
//
// Authors: thomas Zwinger, Thorsten Malm
// Email: [email protected]
// Address: CSC - IT Center for Science Ltd.
// Keilaranta 14
// 02101 Espoo, Finland
//
// This program is free software; you can redistribute it and/or
// modify it under the terms of the GNU General Public License
// as published by the Free Software Foundation; either version 2
// of the License, or (at your option) any later version.
//
// This program is distributed in the hope that it will be useful,
// but WITHOUT ANY WARRANTY; without even the implied warranty of
// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
// GNU General Public License for more details.
//
// You should have received a copy of the GNU General Public License
// along with this program; if not, write to the Free Software
// Foundation, Inc., 51 Franklin Street, Fifth Floor,
// Boston, MA 02110-1301, USA.
//
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <math.h>
#include <sys/file.h>
#include <sys/param.h>
#define PERMS 0666
#define BUF_LEN 100000
#ifdef WIN32
#include <direct.h>
#define MKDIR(x) _mkdir(x)
#else
#include <sys/stat.h>
#include <sys/types.h>
#define MKDIR(x) mkdir(x, S_IRWXU)
#endif
double f(double x,double GL, double dZ, double BL) {
return dZ - (BL+dZ)*pow(x,GL)+BL*pow(x,GL+1);
} /* f */
double f_prime(double x,double GL, double dZ, double BL) {
return -(BL+dZ)*GL*pow(x,GL-1)+BL*(GL+1)*pow(x,GL);
} /* f_prime */
double newton(double x_0, double tol, int max_iters,
int* iters_p, int* converged_p,double GL, double dZ, double BL) {
double x = x_0;
double x_prev;
int iter = 0;
do {
iter++;
x_prev = x;
x = x_prev - f(x_prev,GL,dZ,BL)/f_prime(x_prev,GL,dZ,BL);
} while ((fabs(x - x_prev) > tol && iter < max_iters));
if (fabs(x - x_prev) <= tol)
*converged_p = 1;
else{
*converged_p = 0;
printf("not converged, %d\n",converged_p[0]);
}
*iters_p = iter;
return x;
} /* newton algorithm */
// Compute layer cordinate Z for geometric refinement at BL and uniform:
//-----------------------------------------------------
double refinedHeightBL (double S, double B, int levels, int level, int GL, double p, double r)
{
int iters; /* Actual number of iterations */
int converged; /* Whether iteration converged */
double z;
int n = GL -1;
if(GL < 1){
double dZ = (S - B)/((double) levels -1);
z = B + level*dZ;
}else{
double BL = (S - B)*fabs(p);
double dZ = (S - B - BL)/((double) levels - GL -1);
if(r==0) r=newton(10,1e-3,1000,&iters,&converged,GL,dZ,BL);
//for r==0 r is calculated automatically, so that dZ=r*_last_boundary_layer_thickness_; but it's not always possible to find such an r > 1, pay attention to this!!!!
double a;
if(r>1) a = BL *(1-r)/(1-pow(r,n+1));
else{
a= BL/(GL-1);
printf("no good solution found, since r is equal or smaller as 1: r= %f \n",r);
printf("solution r %f dZ %f dZlast %f a %f\n",r,dZ,a*pow(r,GL-1),a);
printf("equation of the polynom for testing: poly konst %f GL %i c1 %f c2 %f \n",dZ,GL,-BL-dZ,BL);
}
int k = 0;
if(p>0){
z = B;
for(k = 0; k < level; ++k) {
if(k<GL){
z = z + a * pow(r, k);
}
else
z = z + dZ;
}
}else{
z = B;
for(k = 0; k < level; ++k) {
if(k<levels-GL-1){
z = z + dZ;
}
else
z = z + a * pow(r, levels-k-2);
}
}
}
return z;
}
int file_exists(const char * filename){
FILE * fileptr;
if (fileptr = fopen(filename, "r"))
{
fclose(fileptr);
return 1;
}
return 0;
}
int checkFileEntries(char *filename, char *argv[], int *entriesPerLine){
FILE *fileptr;
char dummys[BUF_LEN], *charptr;
int lines,entries;
fileptr = fopen(filename, "r");
if (fileptr==NULL){
printf("(%s) Error opening file %s\n",argv[0],filename);
return -1;
}
lines = 0;
entries = 0;
fgets(dummys, BUF_LEN,fileptr);
charptr = strtok(dummys, "\t ");
while(charptr != NULL) {
entries++;
charptr = strtok(NULL, "\t ");
}
while( fgets(dummys, BUF_LEN, fileptr) != NULL ){
lines++;
}
fclose(fileptr);
*entriesPerLine = entries;
return ++lines;
}
int readDEM(double *inputfield, int *isnoval, int pointsInDEM, char *filename, char *argv[]){
int i,validPointsInDEM;
double noval = atof(argv[13]);
FILE *fileptr;
fileptr = fopen(filename, "r");
if (fileptr==NULL){
printf("(%s) Error opening file %s\n",argv[0],filename);
return -1;
}
for (i=0,validPointsInDEM=0;i<pointsInDEM;++i){
fscanf(fileptr,"%lf %lf %lf",&inputfield[3*validPointsInDEM],&inputfield[3*validPointsInDEM+1],&inputfield[3*validPointsInDEM+2]);
if (inputfield[3*validPointsInDEM+2] == noval)
isnoval[validPointsInDEM] = 1;
// inputfield[3*validPointsInDEM] = inputfield[3*validPointsInDEM+1] = inputfield[3*validPointsInDEM+2] = 0.0;
else{
validPointsInDEM++;
isnoval[validPointsInDEM] = 0;
}
}
fclose(fileptr);
return validPointsInDEM;
}
int interpolatePoint(double X, double Y, double *B, double *S, double *bed, double *surf, double *thick, int *pointsInDEM, double minrad, double wexp, int interpolationScheme, char *argv[], int *isnoval0, int *isnoval1, int *isnoval2){
int i, j, k, rounds;
double weightsum, weight, radius, localthickness;
//printf("minrad=%e wexp=%e X=%e Y=%e \n",minrad,wexp, X, Y);
// do we need an interpolated thickness?
if (interpolationScheme > 11){
rounds = 0;
do{
localthickness = 0.0;
for (i=0,weightsum=0.0;i<pointsInDEM[2];++i){
radius = sqrt(pow((X-thick[3*i]),2.0) + pow((Y-thick[(3*i)+1]),2.0));
//printf("radius=%e, bed=%e,%e\n",radius,bed[3*i], bed[3*i+1]);
if (radius <= minrad*(1.0 + (double)(rounds+1)/100.0)){
if (isnoval2[i] == 1) {
weight = 0.0;
}else{
weight = 1.0/(pow(radius,wexp) + 1.0E-09);
}
weight = (weight > 1.0E05) ? 1.0E05 : weight;
weightsum += weight;
localthickness += weight * thick[(3*i)+2];
}
}
localthickness /= weightsum;
if (localthickness != localthickness){
rounds++;
}
}while ((rounds < 100) && (*B != *B));
if (rounds >= 99){
fprintf(stderr,"(%s) (thickness) no interpolation point within range of double the cut-off value %e\n", argv[0], minrad);
return EXIT_FAILURE;
}else if (rounds > 0){
fprintf(stderr,"(%s) (thickness) interpolation needed increasing cut-off value by %4e percent\n",argv[0], rounds*1.0);
}
}
// bedrock interpolation from DEM
if ((interpolationScheme == 11) || (interpolationScheme == 101)){
rounds = 0;
do{
*B = 0.0;
for (i=0,weightsum=0.0;i<pointsInDEM[0];++i){
radius = sqrt(pow((X-bed[3*i]),2.0) + pow((Y-bed[(3*i)+1]),2.0));
//printf("radius=%e, bed=%e,%e\n",radius,bed[3*i], bed[3*i+1]);
if (radius <= minrad*(1.0 + (double)(rounds+1)/100.0)){
if (isnoval0[i] == 1) {
weight = 0.0;
}else{
weight = 1.0/(pow(radius,wexp) + 1.0E-09);
}
weight = (weight > 1.0E05) ? 1.0E05 : weight;
weightsum += weight;
*B += weight * bed[(3*i)+2];
}
}
*B /= weightsum;
if (*B != *B){
rounds++;
}
}while ((rounds < 100) && (*B != *B));
if (rounds >= 99){
fprintf(stderr,"(%s) no interpolation point within range of double the cut-off value %e\n", argv[0], minrad);
return EXIT_FAILURE;
}else if (rounds > 0){
fprintf(stderr,"(%s) interpolation needed increasing cut-off value by %4e percent\n",argv[0], rounds*1.0);
}
}
//surface
if ((interpolationScheme == 11) || (interpolationScheme == 110)){
rounds = 0;
do{
*S=0.0;
for (i=0,weightsum=0.0;i<pointsInDEM[1];++i){
radius = sqrt(pow((X-surf[3*i]),2.0) + pow((Y-surf[(3*i)+1]),2.0));
if (radius <= minrad*(1.0 + (double)(rounds+1)/100.0)){
if (isnoval1[i] == 1) {
weight = 0.0;
}else{
weight = 1.0/(pow(radius,wexp) + 1.0E-09);
}
weightsum += weight;
*S += weight * surf[(3*i)+2];
}
}
if (weightsum <= 0.0){
rounds++;
}else *S /= weightsum;
}while ((rounds < 100) && (weightsum <= 0.0));
if (rounds >= 99){
fprintf(stderr,"(%s) (surface) no interpolation point within range of double the cut-off value %e\n", argv[0], minrad);
return EXIT_FAILURE;
}else if (rounds > 0){
fprintf(stderr,"(%s) (surface) interpolation needed increasing cut-off value by %4e percent\n",argv[0], rounds*1.0);
}
}
// get surface from bed and thickness
if (interpolationScheme == 101) *S = *B + localthickness;
// get bedrock from surface and thickness
if (interpolationScheme == 110) *B = *S - localthickness;
//-----
return EXIT_SUCCESS;
}
//----------------------------------------------------------------------------------------------
// extrudes every single partition
//---------------------------------------------------------------------------------------------------
int extrudepartition( char *argv[], char *inputfilename, char *outputfilename, int partition, int partitions, int levels, double depth, int pointsinlevel, int elementsinlevel, int belementsinlevel, int interpolationScheme, double *bed, double *surf, double *thick, int *pointsInDEM, double cutOffValue, double wexp, int *isnoval0, int *isnoval1, int *isnoval2)
{// extrudepartition
int i,j,k,l,level, dummyint, nodesinpartition, elementsinpartition, belementsinpartition, sharednodes, points, quads, lines, triangles, bricks, wedges, parent[2], elementtype, belementtype;
char instring[BUF_LEN],dummys[BUF_LEN], numberstring[BUF_LEN], dummyc, *charptr;
double dummydbl, dZ;
// arrays to be allocated
double *X,*Y,*S,*B;
int *nodeinfo, *elementinfo, *belementinfo, *sharednodeinfo;
char **inputfile, **outputfile;
FILE **outfids, **infids, *infofid;
// allocate and initiate needed arrays for input
//----------------------------------------------
infids = (FILE **) malloc(5 * sizeof(FILE *));
inputfile = (char **) malloc(5 * sizeof(char *));
for (i=0;i<5;++i)
inputfile[i] = (char *) malloc((MAXPATHLEN+1) * sizeof(char));
for (i=0;i<5;++i){
strcpy(inputfile[i],inputfilename);
}
strcat(inputfile[0],".header");//header
strcat(inputfile[1],".nodes");//elements
strcat(inputfile[2],".elements");//elements
strcat(inputfile[3],".boundary");//boundary
strcat(inputfile[4],".shared");//shared nodes
for (i=0;i<5;++i){
infids[i] = fopen(inputfile[i], "r");
if (infids[i] != NULL) continue;
printf("(%s) Could not open file %s\n",argv[0],inputfile[i]);
return EXIT_FAILURE;
}
// allocate and initiate needed arrays for output
//-----------------------------------------------
outfids = (FILE **) malloc(5 * sizeof(FILE *));
outputfile = (char **) malloc(5 * sizeof(char *));
for (i=0;i<5;++i)
outputfile[i] = (char *) malloc((MAXPATHLEN+1) * sizeof(char));
for (i=0;i<5;++i){
strcpy(outputfile[i],outputfilename);
}
strcat(outputfile[0],".header");//header
strcat(outputfile[1],".nodes");//elements
strcat(outputfile[2],".elements");//elements
strcat(outputfile[3],".boundary");//boundary
strcat(outputfile[4],".shared");//shared nodes
for (i=0;i<5;++i){
outfids[i] = fopen(outputfile[i], "w");
if (outfids[i] != NULL) continue;
printf("(%s) Could not open file %s\n",argv[0],outputfile[i]);
return EXIT_FAILURE;
}
for (i=0;i<5;++i){
printf("<-%s\n",inputfile[i]);
printf("->%s\n",outputfile[i]);
}
// read in header in order to
// inquire mesh sizes and open input files
//-----------------------------------------
fscanf(infids[0],"%i ",&nodesinpartition);
fscanf(infids[0],"%i ",&elementsinpartition);
fscanf(infids[0],"%i ",&belementsinpartition);
fscanf(infids[0],"%i ",&j);
points = lines = triangles = quads = 0;
for (i=0;i<j;++i){
fscanf(infids[0],"%i %i", &elementtype, &dummyint);
if (elementtype == 101) points = dummyint;
else if (elementtype == 202) lines = dummyint;
else if (elementtype == 303) triangles = dummyint;
else if (elementtype == 404) quads = dummyint;
else{
printf("(%s) element type %3i of input file %s not defined\n",argv[0],elementtype,inputfile[0]);
return EXIT_FAILURE;
}
}
fscanf(infids[0],"%i %i", &sharednodes, &dummyint);
printf("(%s) Partition %i of %i input: %i nodes, %i elements, %i boundary elements, %i shared nodes\n",argv[0], partition+1, partitions, nodesinpartition,elementsinpartition,belementsinpartition,sharednodes);
// now we also know the amount of wedges and bricks
wedges = triangles*(levels - 1); // extruded triangles
bricks = quads*(levels -1); // extruded quads
triangles *= 2; // double, as free surface and bottom
quads *= 2; // double, as free surface and bottom
quads += (levels -1)*lines; // plus the extruded lines
lines = (levels - 1)*points; // all extruded points
// write partition header
//printf("%i %i + %i %i\n",points, wedges, bricks, quads+triangles+lines);
fprintf(outfids[0],"%i %i %i\n",nodesinpartition*levels, wedges+bricks, quads+triangles+lines); // no. points, no- elements, no. boundary elements
fprintf(outfids[0],"%i\n",(quads > 0) + (triangles > 0) + (bricks > 0) + (wedges > 0) + (lines > 0) + (points > 0)); // no of different element types
if (lines > 0) fprintf(outfids[0],"202 %i\n", lines);
if (triangles > 0) fprintf(outfids[0],"303 %i\n", triangles);
if (quads > 0) fprintf(outfids[0],"404 %i\n", quads);
if (wedges > 0) fprintf(outfids[0],"706 %i\n", wedges);
if (bricks > 0) fprintf(outfids[0],"808 %i\n", bricks);
fprintf(outfids[0],"%i 0 \n",sharednodes*levels);
printf("(%s) Partition %i of %i output: %i nodes, %i elements, %i boundary elements, %i shared nodes\n\n",argv[0], partition+1, partitions, nodesinpartition*levels, wedges+bricks, quads+triangles+lines, sharednodes*levels);
X = (double *) malloc(nodesinpartition * sizeof(double));
Y = (double *) malloc(nodesinpartition * sizeof(double));
S = (double *) malloc(nodesinpartition * sizeof(double));
B = (double *) malloc(nodesinpartition * sizeof(double));
nodeinfo = (int *) malloc(nodesinpartition * sizeof(int));
elementinfo = (int *) malloc(elementsinpartition * 8 * sizeof(int));
belementinfo = (int *) malloc(belementsinpartition * 8 * sizeof(int));
sharednodeinfo = (int *) malloc((partitions + 2) * sizeof(int));
// load original mesh (footprint) nodes
// and compute lower as well as upper
// Z-coordinate
//-------------------------------------
for (i=0; i<nodesinpartition;++i){
fscanf(infids[1],"%i %i %le %le %le",&nodeinfo[i], &dummyint, &X[i], &Y[i], &B[i]);
if (interpolationScheme > 0){
if (interpolatePoint(X[i], Y[i], &B[i], &S[i], bed, surf, thick, pointsInDEM, cutOffValue, wexp, interpolationScheme, argv, isnoval0, isnoval1, isnoval2) == EXIT_FAILURE){
fprintf(stderr,"(%s) Failed interpolating values for point %i %e %e\n",argv[0],i,X[i],Y[i]);
return EXIT_FAILURE;
}else{
//printf("S,B= %e %e\n", B[i], S[i]);
S[i] = (S[i] <= B[i] - depth) ? (B[i] + depth) : S[i];
}
}else{
S[i] = B[i] + depth;
//printf("X(%i)= (%f, %f) Z=%f -> %f) \n ",nodeinfo[i],X[i],Y[i],B[i],S[i]);
}
}
/* for (i=0; i<nodesinpartition;++i){ */
/* fscanf(infids[1],"%i %i %le %le %le",&nodeinfo[i], &dummyint, &X[i], &Y[i], &B[i]); */
/* if (interpolateDEM==1){ */
/* printf("(%s) DEM interpolation yet not implemented\n",argv[0]); */
/* return EXIT_FAILURE; */
/* }else{ */
/* S[i] = B[i] + depth; */
/* printf("X(%i)= (%f, %f) Z=%f -> %f) \n ",nodeinfo[i],X[i],Y[i],B[i],S[i]); */
/* } */
/* } */
// load original mesh (footprint) elements
// elementinfo[8*k+0]/elementinfo[8*k+7] ... number/partition (if halo)
// elementinfo[8*k+1] ... body
// elementinfo[8*k+2] ... element type
// elementinfo[8*k+3..6] ... element nodes
// elementinfo[8*k+7] ... partition owing the element(see first line)
//---------------------------------------------------------------------
for (k=0,quads=0,triangles=0; k<elementsinpartition;++k){
fgets(instring, BUF_LEN-1,infids[2]);
//printf("%i: %s\n",k,instring);
sscanf(instring,"%s %i %i %i %i %i %i",&numberstring[0], &elementinfo[8*k+1],&elementinfo[8*k+2],
&elementinfo[8*k+3],&elementinfo[8*k+4],&elementinfo[8*k+5], &elementinfo[8*k+6]);
sscanf(numberstring,"%i%c%i",&elementinfo[8*k+0], &dummyc, &elementinfo[8*k+7]);
if (dummyc != '/') elementinfo[8*k+7] = 0;
if (elementinfo[8*k+2] == 404) quads++;
else if (elementinfo[8*k+2] == 303){
elementinfo[8*k+6] = -1;
triangles++;
} else {
printf("(%s): element type %i not recognised for entry %i in partition %i\n", argv[0], elementinfo[8*k+2],k,partition);
}
}
// load original mesh (footprint) boundary elements
// belementinfo[8*k+0]/elementinfo[8*k+7] ... num
// belementinfo[8*k+1] ... boundary
// belementinfo[8*k+2] ... parent 1
// belementinfo[8*k+3] ... parent 2
// belementinfo[8*k+4] ... element type
// belementinfo[8*k+5..6] ... element nodes
// belementinfo[8*k+7] ... partition owing the element(see first line)
//--------------------------------------------------------------------
for (k=0; k<belementsinpartition;++k){
/* fscanf(infids[3],"%s %i %i %i %i", &numberstring,&belementinfo[8*k+1],&belementinfo[8*k+2],&belementinfo[8*k+3],&belementinfo[8*k+4]); */
fgets(instring, BUF_LEN-1,infids[3]);
//printf("%i: %s\n",k,instring);
sscanf(instring,"%s %i %i %i %i %i %i",&numberstring[0], &belementinfo[8*k+1],&belementinfo[8*k+2],
&belementinfo[8*k+3],&belementinfo[8*k+4],&belementinfo[8*k+5], &belementinfo[8*k+6]);
sscanf(numberstring,"%i%c%i",&belementinfo[8*k+0], &dummyc, &belementinfo[8*k+7]);
//printf("%s: %i ,%c, %i\n",numberstring, belementinfo[8*k+0], dummyc, belementinfo[8*k+7]);
if (dummyc != '/') belementinfo[8*k+7] = 0;
if (belementinfo[8*k+4] == 202){
j=2;
}else if (belementinfo[8*k+4] == 101){
j=1;
belementinfo[8*k+6] = -1;
}else {
printf("(%s): boundary element type %i not recognised for entry %i in partition %i\n",
argv[0], belementinfo[8*k+4],k,partition);
}
/* printf("R %i/%i %i %i %i %i %i %i\n",belementinfo[8*k+0],belementinfo[8*k+7], */
/* belementinfo[8*k+1],belementinfo[8*k+2],belementinfo[8*k+3], */
/* belementinfo[8*k+4],belementinfo[8*k+5],belementinfo[8*k+6]); */
}
// read and write shared nodes file
//---------------------------------
k=0;
//printf("BUF_LEN = %i\n",BUF_LEN);
while(fgets(instring, BUF_LEN-1, infids[4]) != NULL) {
++k;
//printf("%i: %s\n", k, instring);
charptr = strtok(instring," ");
i=0;
while (charptr != NULL)
{
sharednodeinfo[i++] = atoi(charptr);
//printf("%s->%i ", charptr,sharednodeinfo[i-1]);
charptr = strtok(NULL," ");
}
//printf("\n");
for(level=0;level<levels;++level){
fprintf(outfids[4],"%i %i", pointsinlevel*level + sharednodeinfo[0],sharednodeinfo[1]);
for (j=2;j<i;++j){
fprintf(outfids[4]," %i", sharednodeinfo[j]);
}
fprintf(outfids[4],"\n");
}
}
// write extruded mesh
//--------------------
for (j=0,level=0;level<levels;++level){
for (k=0;k<nodesinpartition;++k){
l=100*k/pointsinlevel;
if (l>j){
j=l;
//printf("done: %3i percent\n", j);
}
dZ = (S[k] - B[k])/((double) levels - 1);
//printf("%i: S=%f, B=%f, dZ=%f\n",k,S[k],B[k],dZ);
fprintf(outfids[1],"%i -1 %e %e %e\n", pointsinlevel*level + nodeinfo[k], X[k], Y[k], B[k]+ ((double) level)*dZ ); //
}
}
// write elements
// elementinfo[8*k+0]/elementinfo[8*k+7] ... number/partition (if halo)
// elementinfo[8*k+1] ... body
// elementinfo[8*k+2] ... element type
// elementinfo[8*k+3..6] ... element nodes
// elementinfo[8*k+7] ... partition owing the element(see first line)
//--------------------------------------------------------------------
for (k=0;k<elementsinpartition;++k){
if (elementinfo[8*k+2] == 303) {elementtype = 706;l=3;}
else if (elementinfo[8*k+2] == 404) {elementtype = 808;l=4;}
for (level=0;level<levels-1;++level){
fprintf(outfids[2],"%i", elementsinlevel*level + elementinfo[8*k+0]); // number
if (elementinfo[8*k+7] > 0)
fprintf(outfids[2],"/%i ", elementinfo[8*k+7]); // if halo, then owner partition
fprintf(outfids[2]," %i %i", elementinfo[8*k+1], elementtype); // body, elementinfo[8*k+ 2]
for (j=0;j<l;++j) fprintf(outfids[2]," %i", pointsinlevel*level + elementinfo[8*k+ 3 + j]); //lower level points
for (j=0;j<l;++j) fprintf(outfids[2]," %i", pointsinlevel*(level + 1) + elementinfo[8*k+ 3 + j]);//upper level points
fprintf(outfids[2],"\n");
}
}
// write boundary elements
// belementinfo[8*k+0]/belementinfo[8*k+7] ... num
// belementinfo[8*k+1] ... boundary (off-setted by 2 for original ones)
// belementinfo[8*k+2] ... parent 1
// belementinfo[8*k+3] ... parent 2
// belementinfo[8*k+4] ... element type
// belementinfo[8*k+5..6] ... element nodes
// belementinfo[8*k+7] ... partition owing the element(see first line)
//--------------------------------------------------------------------
// bottom and surface (new, bcids=1,2)
parent[1]=0;
for (i=0,lines=0;i<2;++i){ // i==0 ... bottom, i==1 ... top
for (k=0;k<elementsinpartition;++k){
parent[0] = elementsinlevel*(levels-2)*i + elementinfo[8*k+0];
fprintf(outfids[3],"%i", i*elementsinpartition + k +1); // element number
if (elementinfo[8*k+7] > 0)
fprintf(outfids[3],"/%i", elementinfo[8*k+7]); // if halo, then owner partition
fprintf(outfids[3]," %1i %i %i %3i", i+1, parent[0], parent[1], elementinfo[8*k+2]); // bcid, parents, type
if (elementinfo[8*k+2] == 303) {l=3;}
else if (elementinfo[8*k+2] == 404) {l=4;}
for(j=0;j<l;++j){
fprintf(outfids[3]," %i", pointsinlevel*(levels-1)*i + elementinfo[8*k+ 3 + j]);
}
fprintf(outfids[3],"\n");
}
}
// already exsisting boundaries (extruded sides, bcids = original + 2)
for (k=0;k<belementsinpartition;++k){ //belementsinpartition
for (level=0;level<levels-1;++level){
for (i=0;i<2;++i)
parent[i] = (belementinfo[8*k+2+i] > 0) ? (level*elementsinlevel + belementinfo[8*k+2+i]) : 0;
if (belementinfo[8*k+4] == 202){
belementtype = 404;
++quads;
j=2;
}else if(belementinfo[8*k+4] == 101){
belementtype = 202;
++lines;
j=1;
}
else{
printf("(%s) boundary element type %3i of input file %s (line %i) not defined\n",argv[0],belementinfo[8*k+4],inputfile[3],k);
return EXIT_FAILURE;
}
/* printf("W %i/%i %i %i %i %i %i %i\n",belementinfo[8*k+0],belementinfo[8*k+7], */
/* belementinfo[8*k+1]+2,belementinfo[8*k+2],belementinfo[8*k+3], */
/* belementinfo[8*k+4],belementinfo[8*k+5],belementinfo[8*k+6]); */
fprintf(outfids[3],"%i", 2*elementsinpartition + belementsinpartition*level + belementinfo[8*k+0]); // number
if (belementinfo[8*k+7] > 0)
fprintf(outfids[3],"/%i",belementinfo[8*k+7]); //partition (if halo)
fprintf(outfids[3]," %i %i %i %3i",
belementinfo[8*k+1]+2, parent[0], parent[1], belementtype); // bcid, parents, type
for (l=0;l<2;++l){
if (l==0) {
for (i=0;i<j;++i){
fprintf(outfids[3]," %i", pointsinlevel*level + belementinfo[8*k+5+i]);
//printf("low: %i + %i\n", pointsinlevel*(level+l) , belementinfo[8*k+5+i]);
}
}else{
for (i=j-1;i>-1;--i){
fprintf(outfids[3]," %i", pointsinlevel*(level+1) + belementinfo[8*k+5+i]);
//printf(" %i + %i\n", pointsinlevel*(level+l) , belementinfo[8*k+5+i]);
}
}
}
fprintf(outfids[3],"\n");
}
}
// close files
//------------
for (i=0;i<5;++i){
fclose(infids[i]);
fclose(outfids[i]);
}
// free memory
//------------
free(X);
free(Y);
free(S);
free(B);
free(nodeinfo);
free(elementinfo);
free(belementinfo);
free(sharednodeinfo);
free(infids);
for (i=0;i<5;++i)
free(inputfile[i]);
free(inputfile);
free(outfids);
for (i=0;i<5;++i)
free(outputfile[i]);
free(outputfile);
return EXIT_SUCCESS;
}
//---------------------------------------------------------------------------------------------------
// extrudes serial mesh
//---------------------------------------------------------------------------------------------------
int extrudeserial( char *argv[], char *inputfilename, char *outputfilename, int levels, double depth, int pointsinlevel, int elementsinlevel, int belementsinlevel, int interpolationScheme, double *bed, double *surf, double *thick, int *pointsInDEM, double cutOffValue, double wexp, int GL, double percentage, double ratio, int baseline, int corrbed, int *isnoval0, int *isnoval1, int *isnoval2 )
{//extrudeserial
int i,j,k,l,level, dummyint, nodesinpartition, elementsinpartition, belementsinpartition, points, quads, lines, triangles, bricks, wedges, parent[2], elementtype, belementtype, bcoffset, maxorigBCno;
char instring[BUF_LEN],dummys[BUF_LEN], numberstring[BUF_LEN], *charptr;
double dummydbl, dZ;
// arrays to be allocated
double *X,*Y,*S,*B, Z;
int *nodeinfo, *elementinfo, *belementinfo;
char **inputfile, **outputfile;
FILE **outfids, **infids, *infofid;
// allocate and initiate needed arrays for input
//----------------------------------------------
infids = (FILE **) malloc(5 * sizeof(FILE *));
inputfile = (char **) malloc(5 * sizeof(char *));
for (i=0;i<5;++i)
inputfile[i] = (char *) malloc((MAXPATHLEN+1) * sizeof(char));
for (i=0;i<5;++i){
strcpy(inputfile[i],inputfilename);
}
strcat(inputfile[0],"/mesh.header");//header
strcat(inputfile[1],"/mesh.nodes");//elements
strcat(inputfile[2],"/mesh.elements");//elements
strcat(inputfile[3],"/mesh.boundary");//boundary
for (i=0;i<5;++i){
infids[i] = fopen(inputfile[i], "r");
if (infids[i] != NULL) continue;
printf("(%s) Could not open file %s\n",argv[0],inputfile[i]);
return EXIT_FAILURE;
}
// allocate and initiate needed arrays for output
//-----------------------------------------------
outfids = (FILE **) malloc(4 * sizeof(FILE *));
outputfile = (char **) malloc(4 * sizeof(char *));
for (i=0;i<4;++i)
outputfile[i] = (char *) malloc((MAXPATHLEN+1) * sizeof(char));
for (i=0;i<4;++i){
strcpy(outputfile[i],outputfilename);
}
strcat(outputfile[0],"/mesh.header");//header
strcat(outputfile[1],"/mesh.nodes");//elements
strcat(outputfile[2],"/mesh.elements");//elements
strcat(outputfile[3],"/mesh.boundary");//boundary
for (i=0;i<4;++i){
outfids[i] = fopen(outputfile[i], "w");
if (outfids[i] != NULL) continue;
printf("(%s) Could not open file %s\n",argv[0],outputfile[i]);
return EXIT_FAILURE;
}
for (i=0;i<4;++i){
printf("<-%s\n",inputfile[i]);
printf("->%s\n",outputfile[i]);
}
// read in header in order to
// inquire mesh sizes and open input files
//-----------------------------------------
fscanf(infids[0],"%i ",&nodesinpartition);
fscanf(infids[0],"%i ",&elementsinpartition);
fscanf(infids[0],"%i ",&belementsinpartition);
fscanf(infids[0],"%i ",&j);
points = lines = triangles = quads = 0;
for (i=0;i<j;++i){
fscanf(infids[0],"%i %i", &elementtype, &dummyint);
if (elementtype == 101) points = dummyint;
else if (elementtype == 202) lines = dummyint;
else if (elementtype == 303) triangles = dummyint;
else if (elementtype == 404) quads = dummyint;
else{
printf("(%s) element type %3i of input file %s not defined\n",argv[0],elementtype,inputfile[0]);
return EXIT_FAILURE;
}
}
printf("(%s) Serial mesh input: %i nodes, %i elements, %i boundary elements\n",argv[0], nodesinpartition,elementsinpartition,belementsinpartition);
// now we also know the amount of wedges and bricks
wedges = triangles*(levels - 1); // extruded triangles
bricks = quads*(levels -1); // extruded quads
triangles *= 2; // double, as free surface and bottom
quads *= 2; // double, as free surface and bottom
quads += (levels -1)*lines; // plus the extruded lines
lines = (levels - 1)*points + baseline*lines; // all extruded points and included baselines
// write partition header
//printf("%i %i + %i %i\n",points, wedges, bricks, quads+triangles+lines);
fprintf(outfids[0],"%i %i %i\n",nodesinpartition*levels, wedges+bricks, quads+triangles+lines); // no. points, no- elements, no. boundary elements
fprintf(outfids[0],"%i\n",(quads > 0) + (triangles > 0) + (bricks > 0) + (wedges > 0) + (lines > 0)); // no of different element types
if (lines > 0) fprintf(outfids[0],"202 %i\n", lines);
if (triangles > 0) fprintf(outfids[0],"303 %i\n", triangles);
if (quads > 0) fprintf(outfids[0],"404 %i\n", quads);
if (wedges > 0) fprintf(outfids[0],"706 %i\n", wedges);
if (bricks > 0) fprintf(outfids[0],"808 %i\n", bricks);
printf("(%s) Serial mesh output: %i nodes, %i elements, %i boundary elements\n\n",argv[0], nodesinpartition*levels, wedges+bricks, quads+triangles+lines);
X = (double *) malloc(nodesinpartition * sizeof(double));
Y = (double *) malloc(nodesinpartition * sizeof(double));
S = (double *) malloc(nodesinpartition * sizeof(double));
B = (double *) malloc(nodesinpartition * sizeof(double));
nodeinfo = (int *) malloc(nodesinpartition * sizeof(int));
elementinfo = (int *) malloc(elementsinpartition * 7 * sizeof(int));
belementinfo = (int *) malloc(belementsinpartition * 7 * sizeof(int));
// load original mesh (footprint) nodes
// and compute lower as well as upper
// Z-coordinate
//-------------------------------------
for (i=0; i<nodesinpartition;++i){
fscanf(infids[1],"%i %i %le %le %le",&nodeinfo[i], &dummyint, &X[i], &Y[i], &B[i]);
if (interpolationScheme > 0){
if (interpolatePoint(X[i], Y[i], &B[i], &S[i], bed, surf, thick, pointsInDEM, cutOffValue, wexp, interpolationScheme, argv, isnoval0, isnoval1, isnoval2) == EXIT_FAILURE){
fprintf(stderr,"(%s) Failed interpolating values for point %i %e %e\n",argv[0],i,X[i],Y[i]);
return EXIT_FAILURE;
}else{
//printf("S,B= %e %e\n", B[i], S[i]);
if (S[i] - B[i] < depth){
printf("corrected S[%i] %e %e %e\n", i, X[i], Y[i], S[i]);
if (corrbed == 1){
B[i] = S[i] - depth;
}else{
S[i] = B[i] + depth;
}
printf(" -> %e %e %e\n", X[i], Y[i], S[i]);
}
//S[i] = (S[i] <= B[i] - depth) ? (B[i] + depth) : S[i];
}
}else{ // constant extrusion offset
S[i] = B[i] + depth;
//printf("X(%i)= (%f, %f) Z=%f -> %f) \n ",nodeinfo[i],X[i],Y[i],B[i],S[i]);
}
}
// load original mesh (footprint) elements
// elementinfo[7*k+0] ... number
// elementinfo[7*k+1] ... body
// elementinfo[7*k+2] ... element type
// elementinfo[7*k+3..6] ... element nodes
//---------------------------------------------------------------------
for (k=0,quads=0,triangles=0; k<elementsinpartition;++k){
fgets(instring, BUF_LEN-1,infids[2]);
//printf("%i: %s\n",k,instring);
sscanf(instring,"%i %i %i %i %i %i %i",&elementinfo[7*k+0], &elementinfo[7*k+1],&elementinfo[7*k+2],
&elementinfo[7*k+3],&elementinfo[7*k+4],&elementinfo[7*k+5], &elementinfo[7*k+6]);
if (elementinfo[7*k+2] == 404) quads++;
else if (elementinfo[7*k+2] == 303){
elementinfo[7*k+6] = -1;
triangles++;
} else {
printf("(%s): element type %i not recognised for entry %i\n", argv[0], elementinfo[7*k+2],k);
}
}
// load original mesh (footprint) boundary elements
// belementinfo[7*k+0] ... number
// belementinfo[7*k+1] ... boundary
// belementinfo[7*k+2] ... parent 1
// belementinfo[7*k+3] ... parent 2
// belementinfo[7*k+4] ... element type
// belementinfo[7*k+5..6] ... element nodes
//--------------------------------------------------------------------
maxorigBCno = 0;
for (k=0; k<belementsinpartition;++k){
/* fscanf(infids[3],"%s %i %i %i %i", &numberstring,&belementinfo[7*k+1],&belementinfo[7*k+2],&belementinfo[7*k+3],&belementinfo[7*k+4]); */
fgets(instring, BUF_LEN-1,infids[3]);
//printf("%i: %s\n",k,instring);
sscanf(instring,"%i %i %i %i %i %i %i",&belementinfo[7*k+0], &belementinfo[7*k+1],&belementinfo[7*k+2],
&belementinfo[7*k+3],&belementinfo[7*k+4],&belementinfo[7*k+5], &belementinfo[7*k+6]);
if (belementinfo[7*k+4] == 202){
j=2;
}else if (belementinfo[7*k+4] == 101){
j=1;
belementinfo[7*k+6] = -1;
}else {
printf("(%s): boundary element type %i not recognised for entry %i\n",
argv[0], belementinfo[7*k+4],k);
}
/* printf("R %i/%i %i %i %i %i %i %i\n",belementinfo[7*k+0],belementinfo[7*k+7], */
/* belementinfo[7*k+1],belementinfo[7*k+2],belementinfo[7*k+3], */
/* belementinfo[7*k+4],belementinfo[7*k+5],belementinfo[7*k+6]); */
maxorigBCno = (belementinfo[7*k+1] > maxorigBCno) ? belementinfo[7*k+1]:maxorigBCno;
}
// write extruded mesh
//--------------------
for (j=0,level=0;level<levels;++level){
for (k=0;k<nodesinpartition;++k){
l=100*k/pointsinlevel;
//if (l>j){
//j=l;
//printf("done: %3i percent\n", j);
//}
// dZ = (S[k] - B[k])/((double) levels - 1);
Z = refinedHeightBL(S[k], B[k], levels, level, GL, percentage, ratio);
//if (percentage < 0) Z=S[k] + Z + B[k];
//printf("%i: S=%f, B=%f, dZ=%f\n",k,S[k],B[k],dZ);
fprintf(outfids[1],"%i -1 %e %e %e\n", pointsinlevel*level + nodeinfo[k], X[k], Y[k], Z ); //
// fprintf(outfids[1],"%i -1 %e %e %e\n", pointsinlevel*level + nodeinfo[k], X[k], Y[k], B[k]+ ((double) level)*dZ ); //
}
}
// write elements
// elementinfo[7*k+0] ... number
// elementinfo[7*k+1] ... body
// elementinfo[7*k+2] ... element type
// elementinfo[7*k+3..6] ... element nodes
//--------------------------------------------------------------------
for (k=0,bcoffset=1;k<elementsinpartition;++k){
if (elementinfo[7*k+2] == 303) {elementtype = 706;l=3;}
else if (elementinfo[7*k+2] == 404) {elementtype = 808;l=4;}
for (level=0;level<levels-1;++level){
fprintf(outfids[2],"%i", elementsinlevel*level + elementinfo[7*k+0]); // number
fprintf(outfids[2]," %i %i", elementinfo[7*k+1], elementtype); // body, elementinfo[7*k+ 2]
bcoffset = (bcoffset > elementinfo[7*k+1]) ? bcoffset : elementinfo[7*k+1];
for (j=0;j<l;++j) fprintf(outfids[2]," %i", pointsinlevel*level + elementinfo[7*k+ 3 + j]); //lower level points
for (j=0;j<l;++j) fprintf(outfids[2]," %i", pointsinlevel*(level + 1) + elementinfo[7*k+ 3 + j]);//upper level points
fprintf(outfids[2],"\n");
}
}
printf("bodies: %i\n", bcoffset);
// write boundary elements
// belementinfo[7*k+0] ... number
// belementinfo[7*k+1] ... boundary (off-setted by 2 for original ones)
// belementinfo[7*k+2] ... parent 1
// belementinfo[7*k+3] ... parent 2
// belementinfo[7*k+4] ... element type
// belementinfo[7*k+5..6] ... element nodes
//--------------------------------------------------------------------
// bottom and surface (new, bcids=1..bcoffset,bcoffset+1..2*bcoffset)
parent[1]=0;
for (i=0,lines=0;i<2;++i){ // i==0 ... bottom, i==1 ... top
for (k=0;k<elementsinpartition;++k){
parent[0] = elementsinlevel*(levels-2)*i + elementinfo[7*k+0];
fprintf(outfids[3],"%i", i*elementsinpartition + k +1); // element number
fprintf(outfids[3]," %i %i %i %3i", elementinfo[7*k+1]+i*bcoffset, parent[0], parent[1], elementinfo[7*k+2]); // bcid, parents, type
if (elementinfo[7*k+2] == 303) {l=3;}
else if (elementinfo[7*k+2] == 404) {l=4;}
for(j=0;j<l;++j){
fprintf(outfids[3]," %i", pointsinlevel*(levels-1)*i + elementinfo[7*k+ 3 + j]);
}
fprintf(outfids[3],"\n");
}
}
// already exsisting boundaries (extruded sides, bcids = original + 2)
for (k=0;k<belementsinpartition;++k){ //belementsinpartition
for (level=0;level<levels-1;++level){
for (i=0;i<2;++i)
parent[i] = (belementinfo[7*k+2+i] > 0) ? (level*elementsinlevel + belementinfo[7*k+2+i]) : 0;
if (belementinfo[7*k+4] == 202){
belementtype = 404;
++quads;
j=2;
}else if(belementinfo[7*k+4] == 101){
belementtype = 202;
++lines;
j=1;
}
else{
printf("(%s) boundary element type %3i of input file %s (line %i) not defined\n",argv[0],belementinfo[7*k+4],inputfile[3],k);
return EXIT_FAILURE;
}
fprintf(outfids[3],"%i", 2*elementsinpartition + belementsinpartition*level + belementinfo[7*k+0]); // number
fprintf(outfids[3]," %i %i %i %3i",
belementinfo[7*k+1]+2*bcoffset, parent[0], parent[1], belementtype); // bcid, parents, type
for (l=0;l<2;++l){
if (l==0) {
for (i=0;i<j;++i){
fprintf(outfids[3]," %i", pointsinlevel*level + belementinfo[7*k+5+i]);
//printf("low: %i + %i\n", pointsinlevel*(level+l) , belementinfo[7*k+5+i]);
}
}else{
for (i=j-1;i>-1;--i){
fprintf(outfids[3]," %i", pointsinlevel*(level+1) + belementinfo[7*k+5+i]);
//printf(" %i + %i\n", pointsinlevel*(level+l) , belementinfo[7*k+5+i]);
}
}
}
fprintf(outfids[3],"\n");
}
}
// include the frame of the 2d footprint (e.g., in order to place BC for DIM-1 problem)
if (baseline) {
for (k=0;k<belementsinpartition;++k){ //belementsinpartition
parent[0] = parent[1] = 0;
// for (i=0;i<2;++i)
// parent[i] = (belementinfo[7*k+2+i] > 0) ? (belementinfo[7*k+2+i]) : 0;
belementtype = belementinfo[7*k+4];
if (belementtype == 202) {++lines; j=2;}
else if (belementtype == 101) {++points; j=2;}
fprintf(outfids[3],"%i", 2*elementsinpartition + belementsinpartition*(levels-1) + belementinfo[7*k+0]); //number
fprintf(outfids[3]," %i %i %i %3i",
belementinfo[7*k+1] + (2*bcoffset) + maxorigBCno, parent[0], parent[1], belementtype); // bcid, parents, type
for (i=0;i<j;++i){
fprintf(outfids[3]," %i", belementinfo[7*k+5+i]);
}
fprintf(outfids[3],"\n");
}
}
// close files
//------------
for (i=0;i<4;++i){
fclose(infids[i]);
fclose(outfids[i]);
}
// free memory
//------------
free(X);
free(Y);
free(S);
free(B);
free(nodeinfo);
free(elementinfo);
free(belementinfo);
free(infids);
for (i=0;i<4;++i)
free(inputfile[i]);
free(inputfile);
free(outfids);
for (i=0;i<4;++i)
free(outputfile[i]);
free(outputfile);
return EXIT_SUCCESS;
}
int main(int argc, char *argv[])
{
int i,j,k,l,levels,partitions,partition,pointsinlevel, elementsinlevel, belementsinlevel, stat, interpolateDEM, fileExists[3], interpolationScheme, noelementtypes,triangles,quads,lines,points, pointsInDEM[3],dummyint,GL, baseline, *isnoval0, *isnoval1, *isnoval2, corrbed=0;
char inputdirectoryname[MAXPATHLEN+1],outputdirectoryname[MAXPATHLEN+1],directoryname[MAXPATHLEN+1], cpartition[11], inputfilename[MAXPATHLEN+1], outputfilename[MAXPATHLEN+1], filename[MAXPATHLEN+1], *charptr;
double depth, cutOffValue, *bed, *surf, *thick, wexp, noval, percentage, ratio;
FILE *infofid, *headerfid;
// failure/usage message
//----------------------
if((argc != 10) && ((argc != 14)) && (argc != 15)){
printf("%s usage:\a\n\n",argv[0]);
printf("%s inputdir outputdir levels extrudedepth N baseline GL percentage ratio DEM cutoff wexp noval\n\n",argv[0]);
printf(" inputdir ... directory containing the 2D footrpint to be extruded\n");
printf(" outputdir ... directory (will be created if not existing) containing\n");
printf(" the extruded mesh\n");
printf(" WARNING: Files in outputdir will be overwritten!\n");
printf(" levels ... levels in direction of extrushion (>2)\n");
printf(" extrudedepth ... depth in direction of extrushion in unit-length of\n");
printf(" input mesh\n");
printf(" N ... partitions\n");
printf(" inputdir should contain an already partitioned mesh)\n");
printf(" give N=1 for serial mesh\n");
printf(" baseline ... 1/0\n");
printf(" 1 if the existing side boundary for footprint (point/line in 2d/3d)\n");
printf(" shall be included, else excluded\n\n");
printf(" GL ... number of layers inside boundary layer\n");
printf(" has to be smaller than levels\n");
printf(" give 0, if no boundary layer wanted\n");
printf(" percentage ... percentage height of boundary layer\n");
printf(" with respect to the local height (as 0..1) \n");
printf(" if positive BL at bottom, if negative at the surface \n");
printf(" ratio ... ratio between two adjacent layers in boundary layer(>1) \n");
printf(" has to be >1, if it's 0 automatical calculation, but does not work always \n");
printf(" DEM ... (optional) directory of digital elevation model\n");
printf(" for interpolation of bed/surface (see below)\n");
printf(" cutoff ... (optional, but mandatory if previous was given)\n");
printf(" cutoff radius for interpolation\n");
printf(" wexp ... (optional, but mandatory if previous was given)\n");
printf(" exponent of weight for interpolation w=1/r^wexp\n");
printf(" noval ... (optional, but mandatory if previous was given)\n");
printf(" value indicating void/unvalid entry in DEM (e.g. -999.99)\n");
printf(" corrbed ... (optional) value: 1 or any other number\n");
printf(" corrections induced by minimum flowdpeth are by default applied\n");
printf(" correctiong the side of the free surface, only of value 1 is defined\n");
printf(" the surface is kept constant and the bedrock is adjusted\n");
printf("outputdir contains:\n");
printf(" mesh.{nodes,elements,boundary} ... mesh files (if N==1)\n");
printf(" partitioning.N/mesh.{nodes,elements,boundary} ... mesh files (if N>1)\n");
printf(" info.dat ... file containing information on the extruded mesh\n");
printf("DEM (if chosen) should provide (two of these three):\n");
printf(" DEM/bed.xyz (hard-coded name!)\n");
printf(" DEM/surf.xyz (hard-coded name!)\n");
printf(" DEM/thick.xyz (hard-coded name!)\n");
printf(" mind, that those filenames are hardcoded!\n");
printf(" the xyz-files can contain a set of irregullary distributed (x,y,z)\n");
printf(" coordinates, between those the mesh will be interpolated.\n");
printf(" In case of a DEM being provided, the earlier given\n");
printf(" parameter \"extrudedepth\" is taken as the minimum flow depth\n\n");
printf(" Boundary layer implemented only in serial\n\n");
return EXIT_FAILURE;
}
// inquire parameters
//-------------------
levels = atoi(argv[3]);
depth = atof(argv[4]);
partitions = atoi(argv[5]);
baseline = atoi(argv[6]);
if (baseline != 1) baseline = 0;
GL = atoi(argv[7]);
if (GL >= levels) {
fprintf(stderr, "GL = %i >= levels = %i !\n", GL, levels);
return EXIT_FAILURE;
}
percentage = atof(argv[8]);
if ((percentage < -0.99) || (percentage > 0.99)) {
fprintf(stderr, "0.01 < percentage = %f10.4 < 0.99 !\n", percentage);
return EXIT_FAILURE;
}
ratio = atof(argv[9]);
if (ratio < 1.0 && ratio != 0) {
fprintf(stderr, "ratio < 1.0 = %f10.4 < 1.0 or equal 0!\n", ratio);
return EXIT_FAILURE;
}
printf("(%s) executing with following inputs ...\n",argv[0]);
printf(" ... input directory: %s \n",argv[1]);
printf(" ... output directory: %s\n",argv[2]);
printf(" ... levels: %i\n",levels);
printf(" ... depth: %10.4f\n",depth);
printf(" ... partitions: %i\n",partitions);
printf(" ... include baseline(1=yes,0=no): %i\n",baseline);
printf(" ... GL: %i\n",GL);
printf(" ... percentage: %10.4f\n",percentage);
printf(" ... ratio: %10.4f\n",ratio);
if (partitions < 1){
printf("(%s) Wrong number of paritions %i\n",argv[0],partitions);
printf("(%s) Assuming serial mesh (N=1)\n",argv[0]);
partitions=1;
}
interpolateDEM = 0;
if ((argc == 14) || (argc == 15)){// we have a DEM to interpolate
for (i=0;i<argc;++i) {
printf("argv[%i] = %s\n",i, argv[i]);
}
cutOffValue = atof(argv[11]);
wexp = atof(argv[12]);
noval = atof(argv[13]);
printf(" ... DEM directory: %s\n", argv[10]);
printf(" ... cutoff radius: %e\n", cutOffValue);
printf(" ... exponent m of weight (1/r^m): %e\n", wexp);
printf(" ... noval: %10.4f\n",noval);
if (corrbed == 1){
printf(" ... depth corrections of bedrock\n");
}else{
printf(" ... depth corrections of surface (default)\n");
}
int entriesPerLine;
// the bedrock DEM
printf("(%s) Checking for input files of DEM in directory %s\n", argv[0], argv[7]);
strcpy(filename,argv[10]); strcat(filename,"/bed.xyz");
if (file_exists(filename)){
pointsInDEM[0] = checkFileEntries(filename, argv, &entriesPerLine);
if ((pointsInDEM[0] < 1) || (entriesPerLine < 3)){
fprintf(stderr,"(%s) Wrong file entries (%i,%i) found in file %s\n", argv[0], pointsInDEM[0], entriesPerLine, filename);
return EXIT_FAILURE;
}else{
printf("(%s) %i file entries found in file %s\n", argv[0], pointsInDEM[0], filename);
bed = (double *) malloc(pointsInDEM[0] * 3 * sizeof(double));
// for (i=0;i<pointsInDEM[0];++i){ bed[3*i]=(double) 3*i, bed[(3*i)+1]=2.0, bed[(3*i)+2]=3.0; printf("-> %f %f %f\n",bed[3*i], bed[(3*i)+1], bed[(3*i)+2]);}
isnoval0 = (int *) malloc( pointsInDEM[0] * sizeof(int));
dummyint = readDEM(bed, isnoval0, pointsInDEM[0], filename, argv);
if (dummyint > 1){
printf("(%s) %i out of %i valid points in DEM %s\n",argv[0],dummyint,pointsInDEM[0],filename);
pointsInDEM[0] = dummyint;
// for (i=0;i<pointsInDEM[0];++i) printf("->%i / %i %f %f %f\n",i, pointsInDEM[0], bed[3*i], bed[(3*i)+1], bed[(3*i)+2]);
} else {
fprintf(stderr,"(%s) Error reading file %s\n",argv[0],filename);
return EXIT_FAILURE;
}
interpolateDEM = 1;
interpolationScheme = 1;
}
}else{
interpolationScheme = 0;
printf("(%s) no file %s\n", argv[0], filename);
}
// the surface DEM
strcpy(filename,argv[10]); strcat(filename,"/surf.xyz");
if (file_exists(filename)){
pointsInDEM[1] = checkFileEntries(filename, argv, &entriesPerLine);
if ((pointsInDEM[1] < 1) || (entriesPerLine < 3)){
fprintf(stderr,"(%s) Wrong file entries (%i,%i) found in file %s\n", argv[0], pointsInDEM[1], entriesPerLine, filename);
return EXIT_FAILURE;
}else{
printf("(%s) %i file entries found in file %s\n", argv[0], pointsInDEM[1], filename);
surf = (double *) malloc(pointsInDEM[1] * 3 * sizeof(double));
for (i=0;i<pointsInDEM[1];++i){ surf[3*i]=0.0, surf[3*i+1]=0.0, surf[3*i+2]=0.0;}
isnoval1 = (int *) malloc( pointsInDEM[1] * sizeof(int));
dummyint = readDEM(surf, isnoval1, pointsInDEM[1], filename, argv);
if (dummyint > 1){
printf("(%s) %i out of %i valid points in DEM %s\n",argv[0],dummyint,pointsInDEM[1],filename);
pointsInDEM[1] = dummyint;
} else {
fprintf(stderr,"(%s) Error reading file %s\n",argv[0],filename);
return EXIT_FAILURE;
}
}
interpolateDEM = 1;
interpolationScheme += 10;
}else{
printf("(%s) no file %s\n", argv[0], filename);
if (interpolationScheme == 0) {
fprintf(stderr,"(%s) We either need a surface or a bedrock\n",argv[0]);
return EXIT_FAILURE;
}
}
if (interpolationScheme < 11){
// the thickness DEM
strcpy(filename,argv[10]); strcat(filename,"/thick.xyz");
if (file_exists(filename)){
pointsInDEM[2] = checkFileEntries(filename, argv, &entriesPerLine);
if ((pointsInDEM[2] < 1) || (entriesPerLine < 3)){
fprintf(stderr,"(%s) Wrong file entries (%i,%i) found in file %s\n", argv[0], pointsInDEM[2], entriesPerLine, filename);
return EXIT_FAILURE;
}else{
printf("(%s) %i file entries found in file %s\n", argv[0], pointsInDEM[2], filename);
thick = (double *) malloc(pointsInDEM[2] * 3 * sizeof(double));
for (i=0;i<pointsInDEM[2];++i){ thick[3*i]=0.0, thick[3*i+1]=0.0, thick[3*i+2]=0.0;}
isnoval2 = (int *) malloc( pointsInDEM[0] * sizeof(int));
dummyint = readDEM(thick, isnoval2, pointsInDEM[2], filename, argv);
if (dummyint > 1){
printf("(%s) %i out of %i valid points in DEM %s\n",argv[0],dummyint,pointsInDEM[2],filename);
pointsInDEM[2] = dummyint;
}else{
fprintf(stderr,"(%s) Error reading file %s\n",argv[0],filename);
return EXIT_FAILURE;
}
}
interpolateDEM = 1;
interpolationScheme += 100;
}else{
fprintf(stderr,"(%s) no file %s\n", argv[0], filename);
fprintf(stderr,"(%s) We either need a thickness file\n",argv[0]);
return EXIT_FAILURE;
}
}
}else{
interpolationScheme = 0;
}
strcpy(inputdirectoryname,argv[1]);
// read in global header file
//---------------------------
strcpy(filename,inputdirectoryname); strcat(filename,"/mesh.header");
headerfid = fopen(filename, "r");
if (headerfid==NULL){
printf("(%s) Error opening file %s\n",argv[0],filename);
return EXIT_FAILURE;
}
printf("(%s) reading global header file %s\n",argv[0],filename);
fscanf(headerfid,"%i %i %i",&pointsinlevel, &elementsinlevel,&belementsinlevel);
fscanf(headerfid,"%i",&noelementtypes);
points = lines = triangles = quads = 0;
for (i=0;i<noelementtypes;++i){
fscanf(headerfid,"%i %i",&l, &k);
if (l == 101) points = k;
else if (l == 202) lines = k;
else if ( l == 303) triangles = k;
else if (l == 404) quads = k;
else {
printf("(%s) element type %i in header file %s not recognised\n",argv[0],l,filename);
return EXIT_FAILURE;
}
}
//compose input and output directory name
//---------------------------------------
if (partitions > 1){// we have a parallel mesh
if (partitions < 10)
sprintf(cpartition,"%1i", partitions);
else if (partitions < 100)
sprintf(cpartition, "%2i", partitions);
else if (partitions < 1000)
sprintf(cpartition, "%3i", partitions);
else if (partitions < 10000)
sprintf(cpartition, "%4i", partitions);
else{
printf("(%s) More than 9999 partitions? Get real or (if you insist) change the source code of this executable!\n",argv[0]);
return EXIT_FAILURE;
}
strcat(inputdirectoryname,"/partitioning.");strcat(inputdirectoryname,cpartition);
printf("(%s) Reading from directory: %s\n",argv[0], inputdirectoryname);
strcpy(outputdirectoryname, argv[2]);
printf("(%s) creating output file directory %s\n", argv[0], outputdirectoryname);
MKDIR(outputdirectoryname);
strcat(outputdirectoryname,"/partitioning.");
strcat(outputdirectoryname,cpartition);
printf("(%s) creating output file partition directory %s\n", argv[0], outputdirectoryname);
MKDIR(outputdirectoryname);
}else{
printf("(%s) Reading from directory: %s\n",argv[0], inputdirectoryname);
strcpy(outputdirectoryname, argv[2]);
printf("(%s) creating output file directory %s\n", argv[0], outputdirectoryname);
MKDIR(outputdirectoryname);
}
strcpy(filename,outputdirectoryname); strcat(filename,"/info.dat");
infofid = fopen(filename, "w");
if (infofid==NULL){
printf("(%s) Error opening file %s\n",argv[0],filename);
return EXIT_FAILURE;
}
// write input to info file
//-------------------------
fprintf(infofid,"command line was: %s %s %s %i %8.2f %i %i %i %5.2f %4.2f %s %8.2f %3.2f %8.2f [%i]\n",argv[0], argv[1],argv[2],levels,depth, partitions,baseline,GL,percentage,ratio,argv[10],cutOffValue,wexp,noval,corrbed);
fprintf(infofid,"(%s) was invoked with following inputs ...\n",argv[0]);
fprintf(infofid," ... input directory: %s \n",argv[1]);
fprintf(infofid," ... output directory: %s\n",argv[2]);
fprintf(infofid," ... levels: %i\n",levels);
fprintf(infofid," ... depth: %10.4f\n\n",depth);
fprintf(infofid," ... partitions: %i\n",partitions);
fprintf(infofid," ... baseline: %i\n",baseline);
fprintf(infofid," ... GL: %i\n\n",GL);
fprintf(infofid," ... percentage: %10.4f\n\n",percentage);
fprintf(infofid," ... ratio: %10.4f\n\n",ratio);
if (interpolateDEM){
fprintf(infofid," ... DEM directory: %s\n",argv[10]);
fprintf(infofid," ... cutoff radius: %10.4f\n", cutOffValue);
fprintf(infofid," ... exponent m of weight (1/r^m): %10.4f\n",wexp);
fprintf(infofid," ... noval: %10.4f\n\n",noval);
fprintf(infofid," ... corrbed: %1i\n\n",corrbed);
}
fprintf(infofid," ... total poitns in 2d mesh: %i \n",pointsinlevel);
fprintf(infofid," ... total elements in 2d mesh: %i \n",elementsinlevel);
fprintf(infofid," ... total boundary elements in 2d mesh: %i \n",belementsinlevel);
fprintf(infofid," ... no of element type 101: %i \n",points);
fprintf(infofid," ... no of element type 202: %i \n",lines);
fprintf(infofid," ... no of element type 303: %i \n",triangles);
fprintf(infofid," ... no of element type 404: %i \n",quads);
printf(" ... total points in 2d mesh: %i \n",pointsinlevel);
printf(" ... total elements in 2d mesh: %i \n",elementsinlevel);
printf(" ... total boundary elements in 2d mesh: %i \n",belementsinlevel);
printf(" ... no of element type 101: %9i \n",points);
printf(" ... no of element type 202: %9i \n",lines);
printf(" ... no of element type 303: %9i \n",triangles);
printf(" ... no of element type 404: %9i \n",quads);
fclose(headerfid);
// write global header file
//-------------------------
strcpy(filename,outputdirectoryname); strcat(filename,"/mesh.header.global");
headerfid = fopen(filename, "w");
if (headerfid==NULL){
printf("(%s) Error opening file %s\n",argv[0],filename);
return EXIT_FAILURE;
}
fprintf(headerfid,"%9i %9i %9i\n",pointsinlevel*levels,elementsinlevel*(levels-1),elementsinlevel*2 + belementsinlevel*(levels-1));
// fprintf(headerfid,"%i\n",noelementtypes);
fprintf(headerfid,"%9i\n", (points > 0) + 2*(triangles > 0) + (quads > 0) +1);
if (points > 0) fprintf(headerfid,"202 %i\n",points * (levels-1)) + lines * baseline;
if ((lines > 0) || (quads > 0)) fprintf(headerfid,"404 %i\n",lines * (levels-1) + 2 * quads);
if (triangles > 0) fprintf(headerfid,"706 %i\n", triangles * (levels-1));
if (quads > 0) fprintf(headerfid,"808 %i\n", quads * (levels-1));
if (partitions > 1){
// extrude meshes for each partition
//----------------------------------
for (partition=0;partition<partitions;++partition){
if (partition < 10)
sprintf(cpartition,"/part.%1i", partition+1);
else if (partition < 100)
sprintf(cpartition, "/part.%2i", partition+1);
else if (partition < 1000)
sprintf(cpartition, "/part.%3i", partition+1);
else
sprintf(cpartition, "/part.%4i", partition+1);
strcpy(inputfilename,inputdirectoryname); strcat(inputfilename,cpartition);
printf("(%s) reading partition %i: base file name %s\n",argv[0],partition+1,inputfilename);
strcpy(outputfilename,outputdirectoryname); strcat(outputfilename,cpartition);
stat = extrudepartition(argv, inputfilename, outputfilename, partition, partitions, levels, depth, pointsinlevel, elementsinlevel, belementsinlevel, interpolationScheme, bed, surf, thick, pointsInDEM, cutOffValue, wexp, isnoval0, isnoval1, isnoval2);
//stat = extrudepartition(argv, inputfilename, outputfilename, partition, partitions, levels, depth, pointsinlevel, elementsinlevel, belementsinlevel, interpolateDEM=0, charptr);
} // end of loop over partitions
}else{
printf("(%s) Doing serial extrusion\n",argv[0]);
strcpy(inputfilename,inputdirectoryname);
strcpy(outputfilename,outputdirectoryname);
stat = extrudeserial(argv, inputfilename, outputfilename, levels, depth, pointsinlevel, elementsinlevel, belementsinlevel, interpolationScheme, bed, surf, thick, pointsInDEM, cutOffValue, wexp, GL, percentage, ratio, baseline, corrbed, isnoval0, isnoval1, isnoval2);
}
fclose(headerfid);
fclose(infofid);
if (interpolationScheme > 0){
free(bed);
free(surf);
}
return stat;
}
|
the_stack_data/71907.c | #include <math.h>
#include <time.h>
#include <stdio.h>
int main(){
clock_t start, end;
int y, z, i;
double t1, t2;
y = 0;
z= 0;
start = clock();
for(i=0; i<1000000;i++){
y+= pow(34,2);
}
end = clock();
t1 = ((double) (end-start))/CLOCKS_PER_SEC;
start = clock();
for(i=0; i<1000000; i++){
z+=34*34;
}
end = clock();
t2 = ((double)(end-start))/CLOCKS_PER_SEC;
printf("pow: %.8f sec\n", t1);
printf("mul: %.8f sec\n", t2);
printf("mul is faster %.2f times\n", t1/t2);
return 0;
}
|
the_stack_data/478763.c | /**
****************************************************************************
* @file adi_eda.c
* @author ADI
* @version V0.1
* @date 08-June-2021
* @brief EDA measurement on AD5940
****************************************************************************
* @attention
******************************************************************************
* Copyright (c) 2021 Analog Devices, Inc. All rights reserved.
*
* Redistribution and use in source and binary forms, with or without
* modification, are permitted provided that the following conditions are met:
* - Redistributions of source code must retain the above copyright notice, this
* list of conditions and the following disclaimer.
* - Redistributions in binary form must reproduce the above copyright notice,
* this list of conditions and the following disclaimer in the documentation
* and/or other materials provided with the distribution.
* - Modified versions of the software must be conspicuously marked as such.
* - This software is licensed solely and exclusively for use with
* processors/products manufactured by or for Analog Devices, Inc.
* - This software may not be combined or merged with other code in any manner
* that would cause the software to become subject to terms and conditions
* which differ from those listed here.
* - Neither the name of Analog Devices, Inc. nor the names of its contributors
* may be used to endorse or promote products derived from this software
* without specific prior written permission.
* - The use of this software may or may not infringe the patent rights of one
* or more patent holders. This license does not release you from the
* requirement that you obtain separate licenses from these patent holders to
* use this software.
*
* THIS SOFTWARE IS PROVIDED BY ANALOG DEVICES, INC. AND CONTRIBUTORS "AS IS"
* AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO,
* NONINFRINGEMENT, TITLE, MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE
* ARE DISCLAIMED. IN NO EVENT SHALL ANALOG DEVICES, INC. OR CONTRIBUTORS BE
* LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, PUNITIVE OR
* CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, DAMAGES ARISING OUT OF
* CLAIMS OF INTELLECTUAL PROPERTY RIGHTS INFRINGEMENT; PROCUREMENT OF
* SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS
* INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN
* CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE)
* ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE
* POSSIBILITY OF SUCH DAMAGE.
******************************************************************************/
/**
* @addtogroup AD5940_System_Examples
* @{
* @defgroup BioElec_Example
* @{
*/
#ifdef ENABLE_EDA_APP
#include "eda_application_task.h"
#include <adpd4000_dcfg.h>
#include <ecg_task.h>
#include <includes.h>
#include <limits.h>
#include <power_manager.h>
#include <stdint.h>
#include <string.h>
#include "us_tick.h"
#include "nrf_log_ctrl.h"
extern AppEDACfg_Type AppEDACfg;
extern volatile int16_t eda_user_applied_odr;
extern volatile int16_t eda_user_applied_dftnum;
extern volatile int16_t eda_user_applied_rtia_cal;
extern uint8_t rtia_cal_completed;
static float LFOSCFreq; /* Measured LFOSC frequency */
extern uint8_t measurement_cycle_completed;
extern uint8_t init_flag;
extern uint32_t ResistorForBaseline;
extern uint32_t AppBuff[APPBUFF_SIZE];
#ifdef EDA_DCFG_ENABLE
extern uint8_t eda_load_applied_dcfg;
#endif
#ifndef EXTERNAL_TRIGGER_EDA
uint32_t ad5940_port_Init(void);
#endif
/*!
****************************************************************************
*@brief This function is provided for upper controllers that want to
* change application parameters specially for user defined
* parameters
*@param pCfg: pointer to configuration structure
*@return AD5940Err
******************************************************************************/
AD5940Err AppEDAGetCfg(void *pCfg) {
if (pCfg) {
*(AppEDACfg_Type **)pCfg = &AppEDACfg;
return AD5940ERR_OK;
}
return AD5940ERR_PARA;
}
/*!
****************************************************************************
* @brief Control application like start, stop.
* @param EDACtrl The command for this applicaiton, select from below paramters
* - APPCTRL_START: start the measurment. Note: the ramp test need
* to call function AppRAMPInit() every time before start it.
* - APPCTRL_STOPNOW: Stop the measurment immediately.
* - APPCTRL_STOPSYNC: Stop the measuremnt when current measured data
* is read back.
* - APPCTRL_SHUTDOWN: Stop the measurment immediately and put AFE to
* shut down mode(turn off LP loop and enter hibernate).
* - EDACTRL_MEASVOLT: Measure voltage once current measurment
* is done(Interrupt occured).
* - EDACTRL_GETRTIAMAG: Get current RTIA value.
* @param pPara: pointer to return state
* @return AD5940Err.
*******************************************************************************/
AD5940Err AppEDACtrl(int32_t EDACtrl, void *pPara) {
switch (EDACtrl) {
case APPCTRL_START: {
#ifndef EXTERNAL_TRIGGER_EDA
WUPTCfg_Type wupt_cfg;
/* Wakeup AFE by read register, read 10 times at most */
if (AD5940_WakeUp(10) > 10)
return AD5940ERR_WAKEUP; /* Wakeup Failed */
if (AppEDACfg.EDAInited == bFALSE)
return AD5940ERR_APPERROR;
/* Start it */
wupt_cfg.WuptEn = bTRUE;
wupt_cfg.WuptEndSeq = WUPTENDSEQ_A;
wupt_cfg.WuptOrder[0] = SEQID_0;
wupt_cfg.SeqxSleepTime[SEQID_0] =
(uint32_t)(AppEDACfg.LfoscClkFreq / AppEDACfg.EDAODR) - 2 - 4;
/* The minimum value is 1. Do not set it to zero. Set it to 1 will spend 2
* 32kHz clock */
wupt_cfg.SeqxWakeupTime[SEQID_0] = 4;
AD5940_WUPTCfg(&wupt_cfg);
#endif
/* flags to indicate status of eda app and init fifo data count */
AppEDACfg.FifoDataCount = 0; /* restart */
AppEDACfg.bRunning = bTRUE;
break;
}
case APPCTRL_STOPNOW: {
/* Wakeup AFE by read register, read 10 times at most */
if (AD5940_WakeUp(10) > 10)
return AD5940ERR_WAKEUP; /* Wakeup Failed */
#ifndef EXTERNAL_TRIGGER_EDA
/* Start Wupt right now */
AD5940_WUPTCtrl(bFALSE);
/* There is chance this operation will fail because sequencer could put AFE
back to hibernate mode just after waking up. Use STOPSYNC is better. */
AD5940_WUPTCtrl(bFALSE);
#endif
AppEDACfg.bRunning = bFALSE;
break;
}
case APPCTRL_STOPSYNC: {
AppEDACfg.StopRequired = bTRUE;
break;
}
case APPCTRL_SHUTDOWN: {
/* Stop the measurement if it's running. */
AppEDACtrl(APPCTRL_STOPNOW, 0);
/* Turn off LPLoop related blocks which are not controlled
* automatically by hibernate operation */
AFERefCfg_Type aferef_cfg;
LPLoopCfg_Type lp_loop;
memset(&aferef_cfg, 0, sizeof(aferef_cfg));
AD5940_REFCfgS(&aferef_cfg);
memset(&lp_loop, 0, sizeof(lp_loop));
AD5940_LPLoopCfgS(&lp_loop);
AD5940_EnterSleepS(); /* Enter Hibernate */
} break;
case EDACTRL_MEASVOLT:
AppEDACfg.bMeasVoltReq = bTRUE;
break;
case EDACTRL_GETRTIAMAG:
if (pPara == NULL)
return AD5940ERR_NULLP; /* Null pointer */
*(float *)pPara = AD5940_ComplexMag(&AppEDACfg.RtiaCurrValue);
break;
case EDACTRL_RSTBASE:
AppEDACfg.ImpEDABase.Real = 0;
AppEDACfg.ImpEDABase.Image = 0;
AppEDACfg.ImpSum.Real = 0;
AppEDACfg.ImpSum.Image = 0;
AppEDACfg.ImpSumCount = 0;
break;
case EDACTRL_SETBASE: {
/* The impedance used to set base line */
fImpCar_Type *pImpBase = (fImpCar_Type *)pPara;
AppEDACfg.ImpEDABase = *pImpBase;
} break;
case EDACTRL_GETAVR:
if (pPara == NULL)
return AD5940ERR_NULLP;
{
fImpCar_Type *pImpAVR = (fImpCar_Type *)pPara;
pImpAVR->Real = AppEDACfg.ImpSum.Real / AppEDACfg.ImpSumCount;
pImpAVR->Image = AppEDACfg.ImpSum.Image / AppEDACfg.ImpSumCount;
break;
}
case APPCTRL_RUNNING:
case EDACTRL_STATUS:
if (pPara == NULL)
return AD5940ERR_NULLP; /* Null pointer */
*(BoolFlag *)pPara = AppEDACfg.bRunning;
break;
default:
break;
}
return AD5940ERR_OK;
}
/*!
****************************************************************************
*@brief Eda application sequencer configuration generate
*@param None
*@return AD5940Err
******************************************************************************/
AD5940Err AppEDASeqCfgGen(void) {
AD5940Err error = AD5940ERR_OK;
const uint32_t *pSeqCmd;
uint32_t SeqLen;
AFERefCfg_Type aferef_cfg;
/* Waveform Generator uses some parameter(DAC update rate)
* from HSDAC config registers */
HSDACCfg_Type hsdac_cfg;
LPLoopCfg_Type lp_loop;
WGCfg_Type wg_cfg;
DSPCfg_Type dsp_cfg;
SWMatrixCfg_Type sw_cfg;
AD5940_SEQGenCtrl(bTRUE);
#ifdef EDA_DCFG_ENABLE
write_ad5940_seqcfg();
#else
/* Sequence starts here */
AD5940_SEQGpioCtrlS(0);
AD5940_StructInit(&aferef_cfg, sizeof(aferef_cfg));
/* Turn off all references, only enable it when needed */
AD5940_REFCfgS(&aferef_cfg);
/* Disable everything, configure them during measurement */
AD5940_StructInit(&lp_loop, sizeof(lp_loop));
AD5940_LPLoopCfgS(&lp_loop);
AD5940_StructInit(&wg_cfg, sizeof(wg_cfg));
/* Maximum amplitude is 1100mV */
wg_cfg.SinCfg.SinAmplitudeWord =
(uint32_t)(AppEDACfg.SinAmplitude / 1100.0f * 2047);
wg_cfg.SinCfg.SinFreqWord = AD5940_WGFreqWordCal(AppEDACfg.SinFreq, AppEDACfg.LfoscClkFreq);
wg_cfg.SinCfg.SinPhaseWord = 0;
wg_cfg.WgType = WGTYPE_SIN;
AD5940_WGCfgS(&wg_cfg);
AD5940_AFECtrlS(AFECTRL_ALL, bFALSE);
/* Switch configuration for BioElec board */
sw_cfg.Dswitch = SWD_OPEN; /* Open all switch D */
sw_cfg.Pswitch = SWP_AIN2 | SWP_SE0;
sw_cfg.Nswitch = SWN_OPEN;
sw_cfg.Tswitch = SWT_AIN0 | SWT_AFE3LOAD;
AD5940_SWMatrixCfgS(&sw_cfg);
AD5940_StructInit(&dsp_cfg, sizeof(dsp_cfg));
dsp_cfg.ADCBaseCfg.ADCMuxN = ADCMUXN_VSET1P1;
dsp_cfg.ADCBaseCfg.ADCMuxP = ADCMUXP_AIN4;
dsp_cfg.ADCBaseCfg.ADCPga = ADCPGA_1;
dsp_cfg.ADCFilterCfg.ADCRate = ADCRATE_800KHZ;
/* Use averaged SINC3 output as DFT input source */
dsp_cfg.ADCFilterCfg.ADCAvgNum = ADCAVGNUM_4;
dsp_cfg.ADCFilterCfg.ADCSinc2Osr = ADCSINC2OSR_22;
dsp_cfg.ADCFilterCfg.ADCSinc3Osr = ADCSINC3OSR_5;
dsp_cfg.ADCFilterCfg.BpNotch = bTRUE;
dsp_cfg.ADCFilterCfg.BpSinc3 = bFALSE;
dsp_cfg.ADCFilterCfg.Sinc2NotchEnable = bFALSE;
dsp_cfg.DftCfg.DftNum = AppEDACfg.DftNum;
/* Use averaged SINC3 data */
dsp_cfg.DftCfg.DftSrc = DFTSRC_AVG;
dsp_cfg.DftCfg.HanWinEn = AppEDACfg.HanWinEn;
AD5940_DSPCfgS(&dsp_cfg);
/* (n+2)*osr + 1, n=4,osr=5 */
AD5940_ADCRepeatCfgS(5 * (4 + 2) + 1);
hsdac_cfg.ExcitBufGain = EXCITBUFGAIN_2;
hsdac_cfg.HsDacGain = HSDACGAIN_1;
/* Note: the DAC update rate is decided by register DACON.RATE */
hsdac_cfg.HsDacUpdateRate = AppEDACfg.DacUpdateRate;
AD5940_HSDacCfgS(&hsdac_cfg);
#endif //EDA_DCFG_ENABLE
/* GP6->endSeq, GP5 -> AD8233=OFF, GP1->RLD=OFF */
AD5940_SEQGpioCtrlS(0);
/* Sequence end. */
/* Add one extra command to disable sequencer for initialization
* sequence because it is needed only at run one time. */
AD5940_SEQGenInsert(SEQ_STOP());
/* Stop here */
/* Stop sequencer generator */
AD5940_SEQGenCtrl(bFALSE);
error = AD5940_SEQGenFetchSeq(&pSeqCmd, &SeqLen);
if (error == AD5940ERR_OK) {
AppEDACfg.InitSeqInfo.SeqId = SEQID_1;
AppEDACfg.InitSeqInfo.SeqRamAddr = AppEDACfg.SeqStartAddr;
AppEDACfg.InitSeqInfo.pSeqCmd = pSeqCmd;
AppEDACfg.InitSeqInfo.SeqLen = SeqLen;
AppEDACfg.InitSeqInfo.WriteSRAM = bTRUE;
/* Write command to SRAM */
AD5940_SEQInfoCfg(&AppEDACfg.InitSeqInfo);
} else {
return error; /* Error */
}
return AD5940ERR_OK;
}
/*!
****************************************************************************
* @brief Generate patch sequence according to current measurement
* type(Voltage or Current).
* @details The patch is used to adjust sequencer commands already
* stored in SRAM of AD5940 in order to perform different measurments.
* The reason is that the sequences need to be adjusted. Using the patch
* method will make things easiy and we won't need to modify
* sequences in register level.
* @param pPatch: pointer to patch information include the measurement
* type, Rtia selection and buffers.
* @return AD5940Err: error code.
******************************************************************************/
AD5940Err ApPEDASeqPatchGen(SeqPatchInfo_Type *pPatch) {
AD5940Err err;
const uint32_t *pSeqCmd;
uint32_t SeqLen;
LPAmpCfg_Type lpamp_cfg;
AD5940_SEQGenInit(pPatch->Buffer, pPatch->BuffLen);
AD5940_SEQGenCtrl(bTRUE);
lpamp_cfg.LpAmpSel = LPAMP0;
/* Use normal power mode is enough */
lpamp_cfg.LpAmpPwrMod = LPAMPPWR_NORM;
/* Enable Potential amplifier */
lpamp_cfg.LpPaPwrEn = bTRUE;
/* Enable TIA amplifier */
lpamp_cfg.LpTiaPwrEn = bTRUE;
/* Rf resistor controls cut off frequency. */
lpamp_cfg.LpTiaRf = LPF_RF;
/** @note Use 100Ohm Rload. */
lpamp_cfg.LpTiaRload = LPTIARLOAD_100R;
/* If autoscaling is enabled, use selected value. */
lpamp_cfg.LpTiaRtia = pPatch->RtiaSel;
/* Swtich settings for voltage measurement */
if (pPatch->Type == PATCHTYPE_VOLT)
lpamp_cfg.LpTiaSW = LPTIASW_VOLT;
/* Switch settings for current measurement */
else if (pPatch->Type == PATCHTYPE_CURR)
lpamp_cfg.LpTiaSW = LPTIASW_CURR;
AD5940_LPAMPCfgS(&lpamp_cfg);
AD5940_SEQGenCtrl(bFALSE);
err = AD5940_SEQGenFetchSeq(&pSeqCmd, &SeqLen);
if (err != AD5940ERR_OK)
return err;
pPatch->pSeqCmd = pSeqCmd;
pPatch->SeqLen = SeqLen;
return AD5940ERR_OK;
}
/*!
****************************************************************************
*@brief Eda application sequencer Measurement mode command generate
* and write to SRAM
*@param None
*@return AD5940Err
******************************************************************************/
AD5940Err AppEDASeqMeasureGen(void) {
AD5940Err error = AD5940ERR_OK;
const uint32_t *pSeqCmd;
uint32_t SeqLen;
uint32_t i;
uint32_t DFTNumber;
LPDACCfg_Type lpdac_cfg;
LPAmpCfg_Type lpamp_cfg;
/* Start sequence generator here */
AD5940_SEQGenCtrl(bTRUE);
#ifdef EDA_DCFG_ENABLE
write_ad5940_seqmeasurement();
#else
/* Stage I: Initialization */
#ifdef EXTERNAL_TRIGGER_EDA
/* GP6->endSeq, GP5 -> AD8233=OFF, GP1->RLD=OFF */
AD5940_SEQGpioCtrlS(AGPIO_Pin6);
#else
/* GP3-> enable electrode pin */
AD5940_SEQGpioCtrlS(AGPIO_Pin3);
#endif
/* LP loop configure: LPDAC and LPAMP */
lpdac_cfg.LpdacSel = LPDAC0;
lpdac_cfg.DataRst = bFALSE;
lpdac_cfg.LpDacSW =
LPDACSW_VBIAS2LPPA | LPDACSW_VZERO2LPTIA | LPDACSW_VZERO2PIN;
/* Use internal 2.5V reference */
lpdac_cfg.LpDacRef = LPDACREF_2P5;
/* Use data from waveform generator */
lpdac_cfg.LpDacSrc = LPDACSRC_WG;
lpdac_cfg.LpDacVbiasMux = LPDACVBIAS_12BIT;
/* Use 6bit LPDAC for Vzero */
lpdac_cfg.LpDacVzeroMux = LPDACVZERO_6BIT;
/* Enable LPDAC */
lpdac_cfg.PowerEn = bTRUE;
/* Don't care, 12bit DAC data is from WG */
lpdac_cfg.DacData12Bit = 0;
/* Set it to middle scale of LPDAC. Vzero is the
* bias voltage of LPTIA amplifier */
lpdac_cfg.DacData6Bit = 32;
AD5940_LPDACCfgS(&lpdac_cfg);
/* Voltage and current measurment need different switch settings,
* record the difference and only modify this part
* for different purpose */
/* Record the start address of below commands */
error = AD5940_SEQGenFetchSeq(NULL, &AppEDACfg.SeqPatchInfo.SRAMAddr);
if (error != AD5940ERR_OK)
return error;
lpamp_cfg.LpAmpSel = LPAMP0;
/* Use normal power mode is enough */
lpamp_cfg.LpAmpPwrMod = LPAMPPWR_NORM;
/* Enable Potential amplifier */
lpamp_cfg.LpPaPwrEn = bTRUE;
/* Enable TIA amplifier */
lpamp_cfg.LpTiaPwrEn = bTRUE;
/* Rf resistor controls cut off frequency. */
lpamp_cfg.LpTiaRf = LPF_RF;
/** @note Use 100Ohm Rload. */
lpamp_cfg.LpTiaRload = LPTIARLOAD_100R;
/* If autoscaling is enabled, then use selected value. */
lpamp_cfg.LpTiaRtia = AppEDACfg.LptiaRtiaSel;
/* Switch settings for voltage measurement */
lpamp_cfg.LpTiaSW = LPTIASW_VOLT;
AD5940_LPAMPCfgS(&lpamp_cfg);
/* Enable low power bandgap and 2.5V reference buffer */
AD5940_WriteReg(REG_AFE_LPREFBUFCON, 0);
/* Switch Off everything */
AD5940_AFECtrlS(AFECTRL_ALL, bFALSE);
/* Enter LP control mode. The registers are summarized to
* LPMODECON, so we can control some blocks conveniently */
AD5940_LPModeEnS(bTRUE);
/* Trigger switching system clock to 32kHz */
AD5940_LPModeClkS(LPMODECLK_LFOSC);
/* Disable all */
AD5940_LPModeCtrlS(LPMODECTRL_NONE);
/* Start waveform generator */
AD5940_AFECtrlS(AFECTRL_WG, bTRUE);
/* wait for stable state */
AD5940_SEQGenInsert(SEQ_WAIT(LPF_TIME * 32));
/* Enable DFT engine */
AD5940_AFECtrlS(AFECTRL_DFT, bTRUE);
/* Stage II: ADC Run to sample enough data(DFT number) */
DFTNumber = (1 << (AppEDACfg.DftNum + 2));
for (i = 0; i < DFTNumber; i++) {
#define EDA_LPMODCTRLSETS \
LPMODECTRL_GLBBIASZ | LPMODECTRL_GLBBIASP | LPMODECTRL_HPREFPWR | \
LPMODECTRL_BUFHP1P8V | LPMODECTRL_BUFHP1P1V | LPMODECTRL_HFOSCEN
/* Turn ON HPREF */
AD5940_LPModeCtrlS(EDA_LPMODCTRLSETS);
AD5940_SEQGenInsert(SEQ_WAIT(4));
/* Set RepeatEN will enable ADC power */
AD5940_LPModeCtrlS(EDA_LPMODCTRLSETS | LPMODECTRL_REPEATEN);
/* Wait 50us at least to allow ADC settiling. one NOP commands
* consumes two system clock(32kHz) before ADCCNV = 61.5us. */
AD5940_SEQGenInsert(SEQ_NOP());
/* Start ADC conversion. !!Clear REPEATEN bit */
AD5940_LPModeCtrlS(EDA_LPMODCTRLSETS | LPMODECTRL_ADCCNV);
AD5940_SEQGenInsert(SEQ_NOP());
/* One command need 31.25us because the system clock is 32kHz now. */
/* There is no need to wait such long time for last point, only
* enough clock for DFT calculation before disable it. */
if (i != DFTNumber - 1) {
/* Disable all */
AD5940_LPModeCtrlS(LPMODECTRL_NONE);
AD5940_SEQGenInsert(
SEQ_WAIT(AppEDACfg.LfoscClkFreq / AppEDACfg.SampleFreq - 12));
} else {
/* Disable all except 16MHz HFOSC */
AD5940_LPModeCtrlS(LPMODECTRL_HFOSCEN);
/* wait another 21 clocks. DFT need it to calculte last input data */
AD5940_SEQGenInsert(SEQ_WAIT(21));
}
}
/* Stage III: Turn off all we can */
/* Switching back to 16MHz */
AD5940_LPModeClkS(LPMODECLK_HFOSC);
/* Disable waveform generator */
AD5940_AFECtrlS(AFECTRL_ALL, bFALSE);
lpamp_cfg.LpAmpSel = LPAMP0;
lpamp_cfg.LpPaPwrEn = bFALSE;
lpamp_cfg.LpTiaPwrEn = bFALSE;
lpamp_cfg.LpTiaRf = LPTIARF_OPEN;
lpamp_cfg.LpTiaRtia = LPTIARTIA_OPEN;
lpamp_cfg.LpTiaSW = 0;
AD5940_LPAMPCfgS(&lpamp_cfg);
AD5940_WriteReg(REG_AFE_LPREFBUFCON,
BITM_AFE_LPREFBUFCON_LPBUF2P5DIS | BITM_AFE_LPREFBUFCON_LPREFDIS);
/* Disconnect all switch */
lpdac_cfg.LpDacSW = 0;
lpdac_cfg.PowerEn = bFALSE;
AD5940_LPDACCfgS(&lpdac_cfg);
/* GP6->endSeq, GP5 -> AD8233=OFF, GP1->RLD=OFF */
AD5940_SEQGpioCtrlS(0);
#ifndef EXTERNAL_TRIGGER_EDA
/* Go to hibernate */
AD5940_EnterSleepS(); /* we cannot enter ad5940 to sleep state while taking measurements */
/* Sequence end. */
#endif
#endif // EDA_DCFG_ENABLE
/* Stop sequencer generator */
AD5940_SEQGenCtrl(bFALSE);
error = AD5940_SEQGenFetchSeq(&pSeqCmd, &SeqLen);
if (error == AD5940ERR_OK) {
/* Buffer limited */
if (AppEDACfg.MaxSeqLen < (SeqLen + AppEDACfg.InitSeqInfo.SeqLen))
return AD5940ERR_BUFF;
AppEDACfg.MeasureSeqInfo.SeqId = SEQID_0;
AppEDACfg.MeasureSeqInfo.SeqRamAddr =
AppEDACfg.InitSeqInfo.SeqRamAddr + AppEDACfg.InitSeqInfo.SeqLen;
AppEDACfg.MeasureSeqInfo.pSeqCmd = pSeqCmd;
AppEDACfg.MeasureSeqInfo.SeqLen = SeqLen;
AppEDACfg.MeasureSeqInfo.WriteSRAM = bTRUE;
/* Write command to SRAM */
AD5940_SEQInfoCfg(&AppEDACfg.MeasureSeqInfo);
/* Record where the patch should be applied. */
/* The start address in AD5940 SRAM */
AppEDACfg.SeqPatchInfo.SRAMAddr += AppEDACfg.MeasureSeqInfo.SeqRamAddr;
} else {
return error; /* Error */
}
return AD5940ERR_OK;
}
fImpCar_Type RtiaCalValue; /* Calibration result - imaginary and real */
/*!
****************************************************************************
* @brief Calibrate LPTIA internal RTIA resistor(s).
* @details This function will do calibration using
* parameters stored in @ref AppEDACfg structure.
* @param None
* @return AD5940Err: return error code.
******************************************************************************/
AD5940Err AppEDARtiaCal(void) {
LPRTIACal_Type lprtia_cal;
AD5940_StructInit(&lprtia_cal, sizeof(lprtia_cal));
/* low power amplifier (LPTIA + potentiostat amplifier) */
lprtia_cal.LpAmpSel = LPAMP0;
/* Real + Image */
lprtia_cal.bPolarResult = bFALSE;
lprtia_cal.AdcClkFreq = AppEDACfg.AdcClkFreq;
lprtia_cal.SysClkFreq = AppEDACfg.SysClkFreq;
lprtia_cal.ADCSinc3Osr = ADCSINC3OSR_4;
lprtia_cal.ADCSinc2Osr = ADCSINC2OSR_22;
/* Maximum DFT number */
lprtia_cal.DftCfg.DftNum = DFTNUM_2048;
lprtia_cal.DftCfg.DftSrc = DFTSRC_SINC2NOTCH;
lprtia_cal.DftCfg.HanWinEn = bTRUE;
lprtia_cal.fFreq = AppEDACfg.SinFreq;
lprtia_cal.fRcal = AppEDACfg.RcalVal;
lprtia_cal.bWithCtia = bTRUE;
lprtia_cal.LpAmpPwrMod = LPAMPPWR_NORM;
lprtia_cal.bWithCtia = bTRUE;
lprtia_cal.LpTiaRtia = AppEDACfg.LptiaRtiaSel;
/* if autoscale enable */
if (AppEDACfg.RtiaAutoScaleEnable == bTRUE) {
int i = AppEDACfg.RtiaAutoScaleMin;
for (; i <= AppEDACfg.RtiaAutoScaleMax; i++) {
lprtia_cal.LpTiaRtia = i;
AD5940_LPRtiaCal(&lprtia_cal, &RtiaCalValue);
AppEDACfg.RtiaCalTable[i] = RtiaCalValue;
}
AppEDACfg.RtiaCurrValue = AppEDACfg.RtiaCalTable[AppEDACfg.RtiaIndexCurr];
rtia_cal_completed = 1;
} else {
AD5940_LPRtiaCal(&lprtia_cal, &RtiaCalValue);
AppEDACfg.RtiaCurrValue = RtiaCalValue;
rtia_cal_completed = 0;
}
return AD5940ERR_OK;
}
/*!
****************************************************************************
* @brief Initialize the EDA measurement.
* @details This function must be called before start measurement.
* It will initialize all needed hardwares and put AD5940 to ready state.
* The application parameters stored in @ref AppEDACfg can be changed.
* Call this function to re-initialize AD5940 with new parameters.
* @param pBuffer: the buffer for sequencer generator. Only need to
* provide it for the first time.
* @param BufferSize: The buffer size start from pBuffer.
* @return AD5940Err: return error code.
******************************************************************************/
AD5940Err AppEDAInit(uint32_t *pBuffer, uint32_t BufferSize) {
AD5940Err error = AD5940ERR_OK;
/* sequencer configuration */
SEQCfg_Type seq_cfg;
/* FIFO configuration */
FIFOCfg_Type fifo_cfg;
ADI_OSAL_PRIORITY default_priority;
/* State of EDA App, init/voltage mesaurement / current / RTIA Calibration */
AppEDACfg.EDAStateCurr = EDASTATE_INIT;
/* Wakeup AFE by read register, read 10 times at most */
if (AD5940_WakeUp(10) > 10)
return AD5940ERR_WAKEUP;
#ifndef EDA_DCFG_ENABLE
/*For now keeping the external trigger code as it is till it gets in working mode */
#ifdef EXTERNAL_TRIGGER_EDA
uint32_t tempreg;
tempreg = AD5940_ReadReg(REG_AGPIO_GP0OEN);
tempreg &= 0xFFE7;
tempreg |= 0x0018;
AD5940_AGPIOOen(tempreg);
/* pull up / pull down register */
tempreg = AD5940_ReadReg(REG_AGPIO_GP0PE);
tempreg &= 0xFFE7;
tempreg |= 0x0018;
AD5940_AGPIOPen(tempreg);
/* data set register */
tempreg = AD5940_ReadReg(REG_AGPIO_GP0SET);
tempreg &= 0xFFE7;
/* set only eda gpio pin as high */
tempreg |= 0x0008;
AD5940_AGPIOSet(tempreg);
#endif
/* Configure sequencer and stop it */
seq_cfg.SeqMemSize = SEQMEMSIZE_2KB;
seq_cfg.SeqBreakEn = bFALSE;
seq_cfg.SeqIgnoreEn = bFALSE;
seq_cfg.SeqCntCRCClr = bTRUE;
seq_cfg.SeqEnable = bFALSE;
seq_cfg.SeqWrTimer = 0;
AD5940_SEQCfg(&seq_cfg);
#endif //EDA_DCFG_ENABLE
#ifdef PROFILE_TIME_ENABLED
uint32_t eda_rtia_cal_start_time = get_micro_sec();
#endif
/* Do RTIA calibration */
/* Do calibration on the first initialization */
if ((AppEDACfg.ReDoRtiaCal == bTRUE) || AppEDACfg.EDAInited == bFALSE) {
AppEDACfg.EDAStateCurr = EDASTATE_RTIACAL;
adi_osal_ThreadGetPrio(NULL, &default_priority);
adi_osal_ThreadSetPrio(NULL, configMAX_PRIORITIES - 1);
AppEDARtiaCal();
adi_osal_ThreadSetPrio(NULL, default_priority);
AppEDACfg.ReDoRtiaCal = bFALSE;
}
#ifdef PROFILE_TIME_ENABLED
eda_rtia_cal_diff_time = get_micro_sec() - eda_rtia_cal_start_time;
#endif
/* Reconfigure FIFO */
AD5940_FIFOCtrlS(FIFOSRC_DFT, bFALSE);
fifo_cfg.FIFOEn = bTRUE;
fifo_cfg.FIFOMode = FIFOMODE_FIFO;
/* 4kB for FIFO, The reset 2kB for sequencer */
fifo_cfg.FIFOSize = FIFOSIZE_4KB;
fifo_cfg.FIFOSrc = FIFOSRC_DFT;
/* The first measurment is for excitation voltage. */
fifo_cfg.FIFOThresh = AppEDACfg.VoltCalPoints * 2;
AD5940_FIFOCfg(&fifo_cfg);
AD5940_INTCClrFlag(AFEINTSRC_ALLINT);
/* Start sequence generator */
/* Initialize sequencer generator */
if ((AppEDACfg.EDAInited == bFALSE) || (AppEDACfg.bParaChanged == bTRUE)) {
if (pBuffer == 0)
return AD5940ERR_PARA;
if (BufferSize == 0)
return AD5940ERR_PARA;
AD5940_SEQGenInit(pBuffer, BufferSize);
/* Generate initialize sequence */
/* Application initialization sequence using either MCU or sequencer */
error = AppEDASeqCfgGen();
if (error != AD5940ERR_OK)
return error;
/* Generate measurement sequence */
error = AppEDASeqMeasureGen();
if (error != AD5940ERR_OK)
return error;
AppEDACfg.bParaChanged = bFALSE; /* Clear this flag as we already
implemented the new configuration */
}
/* Initialization sequence */
/* Enable sequencer, run initialization sequence */
AD5940_SEQCtrlS(bTRUE);
AD5940_SEQMmrTrig(AppEDACfg.InitSeqInfo.SeqId);
while (AD5940_INTCTestFlag(AFEINTC_1, AFEINTSRC_ENDSEQ) == bFALSE)
;
/* Apply patch for voltage measurment */
/* After initialization, the first thing is to measure excitation voltage */
AppEDACfg.EDAStateCurr = EDASTATE_VOLT;
/* Init with a value */
AppEDACfg.RtiaIndexCurr = AppEDACfg.RtiaIndexNext = AppEDACfg.LptiaRtiaSel;
AppEDACfg.SeqPatchInfo.RtiaSel = LPTIARTIA_OPEN;
AppEDACfg.SeqPatchInfo.Type = PATCHTYPE_VOLT;
error = ApPEDASeqPatchGen(&AppEDACfg.SeqPatchInfo);
if (error != AD5940ERR_OK)
return error;
/* Apply the patch to SRAM */
AD5940_SEQCmdWrite(AppEDACfg.SeqPatchInfo.SRAMAddr,
AppEDACfg.SeqPatchInfo.pSeqCmd, AppEDACfg.SeqPatchInfo.SeqLen);
/* Enable sequencer, and wait for trigger */
AD5940_SEQCtrlS(bTRUE);
/* Clear interrupt flag generated before */
AD5940_ClrMCUIntFlag();
AD5940_AFEPwrBW(AFEPWR_LP, AFEBW_250KHZ);
/**@todo remove it? close switch SW1 */
AD5940_WriteReg(REG_AFE_SWMUX, 0x01);
if (AppEDACfg.RtiaAutoScaleMin > AppEDACfg.RtiaAutoScaleMax) {
uint32_t temp;
temp = AppEDACfg.RtiaAutoScaleMin;
AppEDACfg.RtiaAutoScaleMin = AppEDACfg.RtiaAutoScaleMax;
AppEDACfg.RtiaAutoScaleMax = temp;
}
/* EDA application has been initialized. */
AppEDACfg.EDAInited = bTRUE;
return AD5940ERR_OK;
}
/*!
****************************************************************************
*@brief AD5940 structure initialization
*@param None
*@return None
******************************************************************************/
void AD5940EDAStructInit(void) {
AppEDACfg_Type *pCfg;
AppEDAGetCfg(&pCfg);
pCfg->MaxSeqLen = 512;
/* Don't do LFOSC calibration now. We assume the default LFOSC is trimmed. */
pCfg->LfoscClkFreq = 32000;
/* We manually select resistor value */
if (!eda_user_applied_rtia_cal) {
pCfg->RtiaAutoScaleEnable = bTRUE;
pCfg->RtiaAutoScaleMax = LPTIARTIA_512K;
pCfg->RtiaAutoScaleMin = LPTIARTIA_100K;
pCfg->LptiaRtiaSel = LPTIARTIA_100K;
} else {
eda_user_applied_rtia_cal = 0;
}
#ifndef EDA_DCFG_ENABLE
if (!eda_user_applied_dftnum) {
/* DFNUM_16 = 2 */
AppEDACfg.DftNum = DFTNUM_16;
} else {
eda_user_applied_dftnum = 0;
}
/* if odr is > 16 use dft num = 8 */
if (eda_user_applied_odr) {
if (pCfg->EDAODR > 16) {
/* set dft num to 8 */
/* DFTNUM_8 = 1 */
AppEDACfg.DftNum = DFTNUM_8;
}
}
#endif
/* Set excitation voltage to 0.75 times of full range */
pCfg->SinAmplitude = 1100 * 3 / 4;
pCfg->SinFreq = 100.0f;
/* Do not change sample frequency unless you know how it works */
pCfg->SampleFreq = 400.0f;
if (!eda_user_applied_odr) {
/* ODR decides how freuquently to start the engine to measure impedance */
pCfg->EDAODR = 4.0f;
} else {
eda_user_applied_odr = 0;
}
/* The minimum threshold value is 4, and should always be 4*N, where N is
* 1,2,3... */
pCfg->FifoThresh = 4;
}
/*!
****************************************************************************
*@brief Initialize AD5940 basic blocks like clock. It will first reset
* AD5940 using reset pin
*@param None
*@return AD5940Err
******************************************************************************/
static AD5940Err AD5940PlatformCfg(void) {
CLKCfg_Type clk_cfg;
FIFOCfg_Type fifo_cfg;
SEQCfg_Type seq_cfg;
AGPIOCfg_Type gpio_cfg;
LFOSCMeasure_Type LfoscMeasure;
#ifdef EXTERNAL_TRIGGER_EDA
/* enable external trigger within ad5940 */
SeqGpioTrig_Cfg cfg;
#endif
#ifdef EDA_DCFG_ENABLE
/* load dcfg here for test */
write_ad5940_init();
#else
/* Step1. Configure clock */
clk_cfg.ADCClkDiv = ADCCLKDIV_1;
clk_cfg.ADCCLkSrc = ADCCLKSRC_HFOSC;
clk_cfg.SysClkDiv = SYSCLKDIV_1;
clk_cfg.SysClkSrc = SYSCLKSRC_HFOSC;
clk_cfg.HfOSC32MHzMode = bFALSE;
clk_cfg.HFOSCEn = bTRUE;
clk_cfg.HFXTALEn = bFALSE;
clk_cfg.LFOSCEn = bTRUE;
AD5940_CLKCfg(&clk_cfg);
/* Step2. Configure FIFO and Sequencer*/
fifo_cfg.FIFOEn = bFALSE;
fifo_cfg.FIFOMode = FIFOMODE_FIFO;
/* 4kB for FIFO, The reset 2kB for sequencer */
fifo_cfg.FIFOSize = FIFOSIZE_4KB;
fifo_cfg.FIFOSrc = FIFOSRC_DFT;
/* DFT result. One pair for RCAL, another for Rz. One DFT result have
* real part and imaginary part */
fifo_cfg.FIFOThresh = 2;
/* Disable to reset FIFO */
AD5940_FIFOCfg(&fifo_cfg);
fifo_cfg.FIFOEn = bTRUE;
AD5940_FIFOCfg(&fifo_cfg);
/* Enable FIFO here */
/* Configure sequencer and stop it */
seq_cfg.SeqMemSize = SEQMEMSIZE_2KB;
seq_cfg.SeqBreakEn = bFALSE;
seq_cfg.SeqIgnoreEn = bFALSE;
seq_cfg.SeqCntCRCClr = bTRUE;
seq_cfg.SeqEnable = bFALSE;
seq_cfg.SeqWrTimer = 0;
AD5940_SEQCfg(&seq_cfg);
/* Step3. Interrupt controller */
/* Enable all interrupt in Interrupt Controller 1, so we can check INTC flags
*/
AD5940_INTCCfg(AFEINTC_1, AFEINTSRC_ALLINT, bTRUE);
/* Interrupt Controller 0 will control GP0 to generate interrupt to MCU */
AD5940_INTCCfg(AFEINTC_0, AFEINTSRC_DATAFIFOTHRESH, bTRUE);
AD5940_INTCClrFlag(AFEINTSRC_ALLINT);
#ifdef EXTERNAL_TRIGGER_EDA
/* Step4: Reconfigure GPIO */
gpio_cfg.FuncSet = GP0_TRIG | GP6_SYNC | GP5_SYNC | GP4_SYNC | GP2_EXTCLK | GP1_SYNC ;
gpio_cfg.InputEnSet = AGPIO_Pin0;
gpio_cfg.OutputEnSet = AGPIO_Pin1 | AGPIO_Pin4 | AGPIO_Pin5 | AGPIO_Pin6;
gpio_cfg.OutVal = 0;
gpio_cfg.PullEnSet = AGPIO_Pin0;
AD5940_AGPIOCfg(&gpio_cfg);
cfg.bEnable = bTRUE;
cfg.PinSel = AGPIO_Pin0;
cfg.SeqPinTrigMode = SEQPINTRIGMODE_FALLING;
AD5940_SEQGpioTrigCfg(&cfg);
#else
/*Adding electrode switch on measurement sequence only using GPIO3*/
/* Step4: Configure GPIO */
/* GP3 is configured using sequencer */
gpio_cfg.FuncSet = GP3_SYNC | GP0_INT;
gpio_cfg.InputEnSet = 0;
gpio_cfg.OutputEnSet = AGPIO_Pin0 | AGPIO_Pin3;
gpio_cfg.OutVal = 0;
gpio_cfg.PullEnSet = 0;
AD5940_AGPIOCfg(&gpio_cfg);
#endif
/* Enable AFE to enter sleep mode. */
AD5940_SleepKeyCtrlS(SLPKEY_UNLOCK);
#endif //EDA_DCFG_ENABLE
/* Measure LFOSC frequency */
/**@note Calibrate LFOSC using system clock. The system clock accuracy
* decides measurment accuracy. Use XTAL to get better result. */
/* 1000ms used for calibration. */
LfoscMeasure.CalDuration = 1000.0;
/* Put sequence commands from start address of SRAM */
LfoscMeasure.CalSeqAddr = 0;
/* 16MHz in this firmware */
LfoscMeasure.SystemClkFreq = 16000000.0f;
AD5940_LFOSCMeasure(&LfoscMeasure, &LFOSCFreq);
return AD5940ERR_OK;
}
/*!
****************************************************************************
*@brief Eda application modify registers when AFE wakeup. It is called
in ISR when AFE has been wakeup and we can access registers
*@param pData: the buffer points to data read back from FIFO
*@param pDataCount: The data count in pData buffer
*@return AD5940Err
******************************************************************************/
AD5940Err AppEDARegModify(int32_t *const pData, uint32_t *pDataCount) {
AD5940Err error = AD5940ERR_OK;
if (AppEDACfg.EDAStateCurr == EDASTATE_VOLT) {
SWMatrixCfg_Type sw_cfg;
/* Next step is to measure current */
AppEDACfg.EDAStateNext = EDASTATE_CURR;
/* Need change some registers in order to measure current */
/* Stop it for now. */
AD5940_SEQCtrlS(bFALSE);
/* Disable FIFO firstly because we are going to change FIFO threshold */
AD5940_FIFOCtrlS(FIFOSRC_DFT, bFALSE);
AD5940_FIFOThrshSet(AppEDACfg.FifoThresh);
/* Enable FIFO */
AD5940_FIFOCtrlS(FIFOSRC_DFT, bTRUE);
/* Change Switch matrix settings to connect AIN2(body) to SE0 */
/* Open all switch D */
sw_cfg.Dswitch = SWD_OPEN;
sw_cfg.Pswitch = SWP_AIN2 | SWP_SE0;
sw_cfg.Nswitch = SWN_OPEN;
/* This switch is for ECG. */
sw_cfg.Tswitch = SWT_AIN0 | SWT_AFE3LOAD;
AD5940_SWMatrixCfgS(&sw_cfg);
/* Apply patch for current measurment */
AppEDACfg.SeqPatchInfo.Type = PATCHTYPE_CURR;
AppEDACfg.SeqPatchInfo.RtiaSel = AppEDACfg.RtiaIndexNext;
error = ApPEDASeqPatchGen(&AppEDACfg.SeqPatchInfo);
if (error != AD5940ERR_OK)
return error;
/* Apply the patch to SRAM */
AD5940_SEQCmdWrite(AppEDACfg.SeqPatchInfo.SRAMAddr,
AppEDACfg.SeqPatchInfo.pSeqCmd, AppEDACfg.SeqPatchInfo.SeqLen);
/* Enable sequencer. Sequencer will run when next valid trigger comes */
AD5940_SEQCtrlS(bTRUE);
} else if (AppEDACfg.EDAStateCurr == EDASTATE_CURR) {
if (AppEDACfg.bChangeRtia == bTRUE) {
AppEDACfg.bChangeRtia = bFALSE;
/* Apply patch for next RTIA selection */
AppEDACfg.SeqPatchInfo.Type = PATCHTYPE_CURR;
AppEDACfg.SeqPatchInfo.RtiaSel = AppEDACfg.RtiaIndexNext;
error = ApPEDASeqPatchGen(&AppEDACfg.SeqPatchInfo);
if (error != AD5940ERR_OK)
return error;
/* Apply the patch to SRAM */
AD5940_SEQCmdWrite(AppEDACfg.SeqPatchInfo.SRAMAddr,
AppEDACfg.SeqPatchInfo.pSeqCmd, AppEDACfg.SeqPatchInfo.SeqLen);
}
measurement_cycle_completed = 1;
}
if (AppEDACfg.bMeasVoltReq == bTRUE) {
SWMatrixCfg_Type sw_cfg;
/* Clear this request */
AppEDACfg.bMeasVoltReq = bFALSE;
/* Next step is to measure voltage */
AppEDACfg.EDAStateNext = EDASTATE_VOLT;
/* Change Switch matrix settings to connect AIN2(body) to SE0 */
/* Open all switch D */
sw_cfg.Dswitch = SWD_OPEN;
sw_cfg.Pswitch = SWP_OPEN;
sw_cfg.Nswitch = SWN_OPEN;
/* This switch is for ECG */
sw_cfg.Tswitch = SWT_AIN0 | SWT_AFE3LOAD;
AD5940_SWMatrixCfgS(&sw_cfg);
/* Need change some registers in order to measure current */
/* Stop it for now. */
AD5940_SEQCtrlS(bFALSE);
/* Disable FIFO first because we are going to change FIFO threshold */
AD5940_FIFOCtrlS(FIFOSRC_DFT, bFALSE);
AD5940_FIFOThrshSet(AppEDACfg.VoltCalPoints * 2);
/* Enable FIFO*/
AD5940_FIFOCtrlS(FIFOSRC_DFT, bTRUE);
/* Apply patch for current measurment */
AppEDACfg.SeqPatchInfo.Type = PATCHTYPE_VOLT;
AppEDACfg.SeqPatchInfo.RtiaSel = LPTIARTIA_OPEN;
error = ApPEDASeqPatchGen(&AppEDACfg.SeqPatchInfo);
if (error != AD5940ERR_OK)
return error;
/* Apply the patch to SRAM */
AD5940_SEQCmdWrite(AppEDACfg.SeqPatchInfo.SRAMAddr,
AppEDACfg.SeqPatchInfo.pSeqCmd, AppEDACfg.SeqPatchInfo.SeqLen);
/* Enable sequencer. Sequencer will run when next valid trigger comes */
AD5940_SEQCtrlS(bTRUE);
}
if (AppEDACfg.NumOfData > 0) {
AppEDACfg.FifoDataCount += *pDataCount / 4;
if (AppEDACfg.FifoDataCount >= AppEDACfg.NumOfData) {
AD5940_WUPTCtrl(bFALSE);
return AD5940ERR_OK;
}
}
if (AppEDACfg.StopRequired == bTRUE) {
AD5940_WUPTCtrl(bFALSE);
AppEDACfg.StopRequired = bFALSE;
AppEDACfg.bRunning = bFALSE;
return AD5940ERR_OK;
}
return AD5940ERR_OK;
}
/*!
****************************************************************************
* @brief Depending on the data type, do appropriate data pre-process
* before return back to controller
* @param pImpedance: the buffer points to pre-processed data.
* The impedance magnitude value is used to decide new RTIA settings.
* @param uiDataCount: The data count in pData buffer.
* @return uint32_t: return the next appropriate RTIA index value.
******************************************************************************/
uint32_t EDARtiaAutoScaling(
fImpCar_Type *const pImpedance, uint32_t uiDataCount) {
uint32_t OptRtiaIndex;
float MagMean = 0;
fImpCar_Type SumImp = {0, 0};
/* Get Averaged Magnitude Result */
for (int i = 0; i < uiDataCount; i++) {
SumImp.Real += pImpedance[i].Real;
SumImp.Image += pImpedance[i].Image;
}
if(uiDataCount != 0) {
SumImp.Real /= uiDataCount;
SumImp.Image /= uiDataCount;
}
/* Impedance under test is sum of changed value and baseline */
SumImp = AD5940_ComplexAddFloat(&SumImp, &AppEDACfg.ImpEDABase);
MagMean = AD5940_ComplexMag(&SumImp);
OptRtiaIndex = AppEDACfg.RtiaAutoScaleMin;
/* This is much easier because although the RTIA is not the best value,
* the results are still reliable. We can directly choose the RTIA matched */
for (; OptRtiaIndex < AppEDACfg.RtiaAutoScaleMax;) {
float mag;
mag = AD5940_ComplexMag(&AppEDACfg.RtiaCalTable[OptRtiaIndex + 1]);
if (MagMean < mag * 0.97f)
break;
OptRtiaIndex++;
}
return OptRtiaIndex;
}
int32_t SumReal = 0, SumImage = 0;
/*!
****************************************************************************
* @brief Data pre-process
* @details Depending on the data type, do appropriate data pre-process
* before return back to controller
* @param pData: the buffer points to data read back from FIFO.
* @param pDataCount: The data count in pData buffer.
* @return AD5940Err: return error code.
******************************************************************************/
AD5940Err AppEDADataProcess(int32_t *const pData, uint32_t *pDataCount) {
#ifdef PROFILE_TIME_ENABLED
delay_in_first_measurement =
abs(get_micro_sec() - eda_init_start_time) / 1000000;
#endif
uint32_t DataCount = *pDataCount;
*pDataCount = 0;
/* EDA results are DFT results */
for (uint32_t i = 0; i < DataCount; i++) {
pData[i] &= 0x3ffff;
/* Bit17 is sign bit */
/* Data is 18bit in two's complement, bit17 is the sign bit */
if (pData[i] & (1 << 17))
pData[i] |= 0xfffc0000;
}
if (AppEDACfg.EDAStateCurr == EDASTATE_VOLT) {
uint32_t DftResCnt;
iImpCar_Type *pDftRes = (iImpCar_Type *)pData;
SumReal = 0, SumImage = 0;
/* Get average excitation voltage */
if (DataCount != AppEDACfg.VoltCalPoints * 2)
return EDAERR_VOLTMEASURE;
DftResCnt = DataCount / 2;
/* Discard the first 4 results */
if (DftResCnt > 4) {
DftResCnt -= 4;
pDftRes += 4;
}
for (uint32_t i = 0; i < DftResCnt; i++) {
SumReal += pDftRes[i].Real;
SumImage += pDftRes[i].Image;
}
SumReal /= (int32_t)DftResCnt;
/* Get average result */
SumImage /= (int32_t)DftResCnt;
/* Fix sign of imaginary part of DFT result. */
SumImage = -SumImage;
AppEDACfg.ExcitVolt.Real = SumReal;
AppEDACfg.ExcitVolt.Image = SumImage;
/* Done */
/* Don't return voltage result */
*pDataCount = 0;
#ifdef PROFILE_TIME_ENABLED
voltage_measurement_diff_time =
abs(get_sensor_time_stamp() - gnAd5940TimeCurVal) / 1000;
voltage_cycles_diff_time =
abs(get_micro_sec() - gnAd5940TimeCurValInMicroSec);
#endif
/* The FIFO data is current result. We need to calculate impedance, Z=V/I */
} else if (AppEDACfg.EDAStateCurr == EDASTATE_CURR) {
iImpCar_Type *const pSrc = (iImpCar_Type *)pData;
fImpCar_Type *const pOut = (fImpCar_Type *)pData;
for (uint32_t i = 0; i < DataCount / 2; i++) {
fImpCar_Type DftCurr;
fImpCar_Type res;
DftCurr.Real = (float)pSrc[i].Real;
DftCurr.Image = (float)pSrc[i].Image;
DftCurr.Image = -DftCurr.Image;
DftCurr.Real = -DftCurr.Real;
DftCurr.Image = -DftCurr.Image;
/* I=Vrtia/Zrtia */
res = AD5940_ComplexDivFloat(&DftCurr, &AppEDACfg.RtiaCurrValue);
res = AD5940_ComplexDivFloat(&AppEDACfg.ExcitVolt, &res);
AppEDACfg.ImpSum = AD5940_ComplexAddFloat(&AppEDACfg.ImpSum, &res);
AppEDACfg.ImpSumCount++;
res = AD5940_ComplexSubFloat(&res, &AppEDACfg.ImpEDABase);
pOut[i] = res;
#ifdef PROFILE_TIME_ENABLED
current_measurement_diff_time =
abs(get_sensor_time_stamp() - gnAd5940TimeCurVal) / 1000;
current_cycles_diff_time =
abs(get_micro_sec() - gnAd5940TimeCurValInMicroSec);
#endif
}
/* Impedance result */
*pDataCount = DataCount / 2;
/* Process RTIA autoscaling calculation */
if (AppEDACfg.RtiaAutoScaleEnable) {
/* Init to invalid value */
static uint32_t rtia_pre = (uint32_t)-1;
uint32_t rtia_index;
AppEDACfg.RtiaIndexCurr = AppEDACfg.RtiaIndexNext;
AppEDACfg.RtiaCurrValue = AppEDACfg.RtiaCalTable[AppEDACfg.RtiaIndexCurr];
rtia_index = EDARtiaAutoScaling(pOut, *pDataCount);
if (rtia_index != rtia_pre) {
AppEDACfg.bChangeRtia = bTRUE;
rtia_pre = rtia_index;
AppEDACfg.RtiaIndexNext = rtia_index;
}
}
}
AppEDACfg.EDAStateCurr = AppEDACfg.EDAStateNext;
return AD5940ERR_OK;
}
#ifdef EDA_DCFG_ENABLE
extern uint64_t default_dcfg_eda[];
#endif
/*!
****************************************************************************
*@brief AD5940 EDA App initialization
*@param None
*@return None
******************************************************************************/
void ad5940_eda_start(void)
{
#ifndef EXTERNAL_TRIGGER_EDA
/* configure call back */
Ad5940DrvDataReadyCallback(Ad5940FifoCallBack);
#endif
/* switch off other switches */
/*
#ifdef ENABLE_ECG_APP
DG2502_SW_control_AD8233(false);
#endif
DG2502_SW_control_ADPD4000(false);
*/
#ifdef EDA_DCFG_ENABLE
if(eda_load_applied_dcfg == 1) {
/*Have to use it at properly,both rtia and eda calls this if we keep here*/
load_ad5940_default_config(&default_dcfg_eda[0]);
}
#endif//EDA_DCFG_ENABLE
if(init_flag == 1){
InitCfg();
}
ClearDataBufferAd5940();
AD5940PlatformCfg();
/* Configure your parameters in this function */
AD5940EDAStructInit();
AppEDAInit(AppBuff, APPBUFF_SIZE); /* Initialize EDA application. Provide a buffer, which is used to store sequencer commands */
#ifdef EXTERNAL_TRIGGER_EDA
enable_ad5940_ext_trigger(AppEDACfg.EDAODR);
#endif
}
#endif |
the_stack_data/100139878.c | #include <stdio.h>
#define NUMELE 100000
void main(){
int i, j, t, pos, a[NUMELE];
FILE *fptr;
for(i = 0; i < NUMELE; ++i)
scanf("%d", &a[i]);
for(i = 0; i < NUMELE - 1; i++){
pos = i;
for(j = i + 1; j < NUMELE; j++){
if(a[pos] > a[j]){
pos = j;
}
}
if(pos != i){
t = a[i];
a[i] = a[pos];
a[pos] = t;
}
}
fptr = fopen("ascending.txt", "w");
for(i = 0; i < NUMELE; i++)
fprintf(fptr, "%d\n", a[i]);
fclose(fptr);
fptr = fopen("descending.txt", "w");
for(i = NUMELE - 1; i > -1; i--)
fprintf(fptr, "%d\n", a[i]);
fclose(fptr);
}
|
the_stack_data/234519329.c | // possible deadlock in perf_swevent_init
// https://syzkaller.appspot.com/bug?id=06fa8ca9af98ef526aaad1b371cdb1671f016721
// status:open
// autogenerated by syzkaller (https://github.com/google/syzkaller)
#define _GNU_SOURCE
#include <endian.h>
#include <stdint.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <sys/syscall.h>
#include <sys/types.h>
#include <unistd.h>
#define BITMASK(bf_off, bf_len) (((1ull << (bf_len)) - 1) << (bf_off))
#define STORE_BY_BITMASK(type, htobe, addr, val, bf_off, bf_len) \
*(type*)(addr) = \
htobe((htobe(*(type*)(addr)) & ~BITMASK((bf_off), (bf_len))) | \
(((type)(val) << (bf_off)) & BITMASK((bf_off), (bf_len))))
uint64_t r[2] = {0xffffffffffffffff, 0xffffffffffffffff};
int main(void)
{
syscall(__NR_mmap, 0x20000000, 0x1000000, 3, 0x32, -1, 0);
long res = 0;
*(uint32_t*)0x20000280 = 2;
*(uint32_t*)0x20000284 = 0x70;
*(uint8_t*)0x20000288 = 0x6a;
*(uint8_t*)0x20000289 = 0;
*(uint8_t*)0x2000028a = 0;
*(uint8_t*)0x2000028b = 0;
*(uint32_t*)0x2000028c = 0;
*(uint64_t*)0x20000290 = 0;
*(uint64_t*)0x20000298 = 0;
*(uint64_t*)0x200002a0 = 0;
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 0, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 1, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 2, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 3, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 4, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 5, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 6, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 7, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 8, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 9, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 10, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 11, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 12, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 13, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 14, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 15, 2);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 17, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 18, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 19, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 20, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 21, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 22, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 23, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 24, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 25, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 26, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 27, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 28, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 29, 35);
*(uint32_t*)0x200002b0 = 0;
*(uint32_t*)0x200002b4 = 0;
*(uint64_t*)0x200002b8 = 0;
*(uint64_t*)0x200002c0 = 0;
*(uint64_t*)0x200002c8 = 0;
*(uint64_t*)0x200002d0 = 0;
*(uint32_t*)0x200002d8 = 0;
*(uint32_t*)0x200002dc = 0;
*(uint64_t*)0x200002e0 = 0;
*(uint32_t*)0x200002e8 = 0;
*(uint16_t*)0x200002ec = 0;
*(uint16_t*)0x200002ee = 0;
res = syscall(__NR_perf_event_open, 0x20000280, -1, 0, -1, 0);
if (res != -1)
r[0] = res;
*(uint32_t*)0x20000200 = 7;
*(uint32_t*)0x20000204 = 0x70;
*(uint8_t*)0x20000208 = 4;
*(uint8_t*)0x20000209 = 0;
*(uint8_t*)0x2000020a = 0;
*(uint8_t*)0x2000020b = 0;
*(uint32_t*)0x2000020c = 0;
*(uint64_t*)0x20000210 = 0;
*(uint64_t*)0x20000218 = 0;
*(uint64_t*)0x20000220 = 0;
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 0, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 1, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 2, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 3, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 4, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 5, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 6, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 7, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 8, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 9, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 10, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 11, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 12, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 13, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 14, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 15, 2);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 17, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 18, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 19, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 20, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 21, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 22, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 23, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 24, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 25, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 26, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 27, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 28, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 29, 35);
*(uint32_t*)0x20000230 = 0;
*(uint32_t*)0x20000234 = 0;
*(uint64_t*)0x20000238 = 0;
*(uint64_t*)0x20000240 = 0;
*(uint64_t*)0x20000248 = 0;
*(uint64_t*)0x20000250 = 0;
*(uint32_t*)0x20000258 = 0;
*(uint32_t*)0x2000025c = 0;
*(uint64_t*)0x20000260 = 0;
*(uint32_t*)0x20000268 = 0;
*(uint16_t*)0x2000026c = 0;
*(uint16_t*)0x2000026e = 0;
syscall(__NR_perf_event_open, 0x20000200, -1, 0, r[0], 0);
syscall(__NR_socket, 0x10, 2, 8);
syscall(__NR_openat, 0xffffffffffffff9c, 0, 0, 0);
*(uint32_t*)0x20000280 = 2;
*(uint32_t*)0x20000284 = 0x4a;
*(uint8_t*)0x20000288 = 0x6a;
*(uint8_t*)0x20000289 = 0;
*(uint8_t*)0x2000028a = 0;
*(uint8_t*)0x2000028b = 0;
*(uint32_t*)0x2000028c = 0;
*(uint64_t*)0x20000290 = 0;
*(uint64_t*)0x20000298 = 0;
*(uint64_t*)0x200002a0 = 0;
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 0, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 1, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 2, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 3, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 4, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 5, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 6, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 7, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 8, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 9, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 10, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 11, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 12, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 13, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 14, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 15, 2);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 17, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 18, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 19, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 20, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 21, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 22, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 23, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 24, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 25, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0x7fe9, 26, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 27, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 28, 1);
STORE_BY_BITMASK(uint64_t, , 0x200002a8, 0, 29, 35);
*(uint32_t*)0x200002b0 = 0;
*(uint32_t*)0x200002b4 = 0;
*(uint64_t*)0x200002b8 = 0;
*(uint64_t*)0x200002c0 = 0;
*(uint64_t*)0x200002c8 = 0;
*(uint64_t*)0x200002d0 = 0;
*(uint32_t*)0x200002d8 = 0;
*(uint32_t*)0x200002dc = 0;
*(uint64_t*)0x200002e0 = 0;
*(uint32_t*)0x200002e8 = 0;
*(uint16_t*)0x200002ec = 0;
*(uint16_t*)0x200002ee = 0;
res = syscall(__NR_perf_event_open, 0x20000280, -1, 0, -1, 0);
if (res != -1)
r[1] = res;
*(uint32_t*)0x20000200 = 1;
*(uint32_t*)0x20000204 = 0x70;
*(uint8_t*)0x20000208 = 4;
*(uint8_t*)0x20000209 = 0;
*(uint8_t*)0x2000020a = 0;
*(uint8_t*)0x2000020b = 0;
*(uint32_t*)0x2000020c = 0;
*(uint64_t*)0x20000210 = 0;
*(uint64_t*)0x20000218 = 0;
*(uint64_t*)0x20000220 = 0;
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 0, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 1, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 2, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 3, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 4, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 5, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0xfffffffffffffffd, 6, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 7, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 8, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 9, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 10, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 11, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 12, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 13, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 14, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 15, 2);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 17, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 4, 18, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 19, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 20, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 21, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 22, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 23, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 24, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 25, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 26, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 27, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 28, 1);
STORE_BY_BITMASK(uint64_t, , 0x20000228, 0, 29, 35);
*(uint32_t*)0x20000230 = 0;
*(uint32_t*)0x20000234 = 0;
*(uint64_t*)0x20000238 = 0;
*(uint64_t*)0x20000240 = 0;
*(uint64_t*)0x20000248 = 0;
*(uint64_t*)0x20000250 = 0;
*(uint32_t*)0x20000258 = 0;
*(uint32_t*)0x2000025c = 0;
*(uint64_t*)0x20000260 = 0;
*(uint32_t*)0x20000268 = 0;
*(uint16_t*)0x2000026c = 0;
*(uint16_t*)0x2000026e = 0;
syscall(__NR_perf_event_open, 0x20000200, -1, 0, r[1], 0);
syscall(__NR_inotify_add_watch, -1, 0, 0x80000003);
return 0;
}
|
the_stack_data/548294.c | /*
* author: Mahmud Ahsan
* https://github.com/mahmudahsan
* blog: http://thinkdiff.net
* http://banglaprogramming.com
* License: MIT License
*/
/*
* Challenge 1
*/
#include <stdio.h>
int main(){
printf("I am Bangladeshi.\n");
printf("I love my country.\n");
printf("I am proud for my country.\n");
return 0;
} |
the_stack_data/148577429.c | // This file is part of CPAchecker,
// a tool for configurable software verification:
// https://cpachecker.sosy-lab.org
//
// SPDX-FileCopyrightText: 2007-2020 Dirk Beyer <https://www.sosy-lab.org>
// SPDX-FileCopyrightText: 2014-2017 Université Grenoble Alpes
//
// SPDX-License-Identifier: Apache-2.0
void assert(int cond) { if (!cond) { ERROR: return; } }
int main() {
int a = 1;
int *b = &a;
int **c = &b;
**c = 42;
assert(a == 42);
}
|
the_stack_data/151705680.c | /*
* POK header
*
* The following file is a part of the POK project. Any modification should
* be made according to the POK licence. You CANNOT use this file or a part
* of a file for your own project.
*
* For more information on the POK licence, please see our LICENCE FILE
*
* Please follow the coding guidelines described in doc/CODING_GUIDELINES
*
* Copyright (c) 2007-2020 POK team
*/
/* @(#)e_atan2.c 5.1 93/09/24 */
/*
* ====================================================
* Copyright (C) 1993 by Sun Microsystems, Inc. All rights reserved.
*
* Developed at SunPro, a Sun Microsystems, Inc. business.
* Permission to use, copy, modify, and distribute this
* software is freely granted, provided that this notice
* is preserved.
* ====================================================
*/
/* __ieee754_atan2(y,x)
* Method :
* 1. Reduce y to positive by atan2(y,x)=-atan2(-y,x).
* 2. Reduce x to positive by (if x and y are unexceptional):
* ARG (x+iy) = arctan(y/x) ... if x > 0,
* ARG (x+iy) = pi - arctan[y/(-x)] ... if x < 0,
*
* Special cases:
*
* ATAN2((anything), NaN ) is NaN;
* ATAN2(NAN , (anything) ) is NaN;
* ATAN2(+-0, +(anything but NaN)) is +-0 ;
* ATAN2(+-0, -(anything but NaN)) is +-pi ;
* ATAN2(+-(anything but 0 and NaN), 0) is +-pi/2;
* ATAN2(+-(anything but INF and NaN), +INF) is +-0 ;
* ATAN2(+-(anything but INF and NaN), -INF) is +-pi;
* ATAN2(+-INF,+INF ) is +-pi/4 ;
* ATAN2(+-INF,-INF ) is +-3pi/4;
* ATAN2(+-INF, (anything but,0,NaN, and INF)) is +-pi/2;
*
* Constants:
* The hexadecimal values are the intended ones for the following
* constants. The decimal values may be used, provided that the
* compiler will convert from decimal to binary accurately enough
* to produce the hexadecimal values shown.
*/
#ifdef POK_NEEDS_LIBMATH
#include "math_private.h"
#include <libm.h>
static const double tiny = 1.0e-300, zero = 0.0,
pi_o_4 =
7.8539816339744827900E-01, /* 0x3FE921FB, 0x54442D18 */
pi_o_2 = 1.5707963267948965580E+00, /* 0x3FF921FB, 0x54442D18 */
pi = 3.1415926535897931160E+00, /* 0x400921FB, 0x54442D18 */
pi_lo = 1.2246467991473531772E-16; /* 0x3CA1A626, 0x33145C07 */
double __ieee754_atan2(double y, double x) {
double z;
int32_t k, m, hx, hy, ix, iy;
uint32_t lx, ly;
EXTRACT_WORDS(hx, lx, x);
ix = hx & 0x7fffffff;
EXTRACT_WORDS(hy, ly, y);
iy = hy & 0x7fffffff;
if (((ix | ((lx | -lx) >> 31)) > 0x7ff00000) ||
((iy | ((ly | -ly) >> 31)) > 0x7ff00000)) /* x or y is NaN */
return x + y;
if (((hx - 0x3ff00000) | lx) == 0)
return atan(y); /* x=1.0 */
m = ((hy >> 31) & 1) | ((hx >> 30) & 2); /* 2*sign(x)+sign(y) */
/* when y = 0 */
if ((iy | ly) == 0) {
switch (m) {
case 0:
case 1:
return y; /* atan(+-0,+anything)=+-0 */
case 2:
return pi + tiny; /* atan(+0,-anything) = pi */
case 3:
return -pi - tiny; /* atan(-0,-anything) =-pi */
}
}
/* when x = 0 */
if ((ix | lx) == 0)
return (hy < 0) ? -pi_o_2 - tiny : pi_o_2 + tiny;
/* when x is INF */
if (ix == 0x7ff00000) {
if (iy == 0x7ff00000) {
switch (m) {
case 0:
return pi_o_4 + tiny; /* atan(+INF,+INF) */
case 1:
return -pi_o_4 - tiny; /* atan(-INF,+INF) */
case 2:
return 3.0 * pi_o_4 + tiny; /*atan(+INF,-INF)*/
case 3:
return -3.0 * pi_o_4 - tiny; /*atan(-INF,-INF)*/
}
} else {
switch (m) {
case 0:
return zero; /* atan(+...,+INF) */
case 1:
return -zero; /* atan(-...,+INF) */
case 2:
return pi + tiny; /* atan(+...,-INF) */
case 3:
return -pi - tiny; /* atan(-...,-INF) */
}
}
}
/* when y is INF */
if (iy == 0x7ff00000)
return (hy < 0) ? -pi_o_2 - tiny : pi_o_2 + tiny;
/* compute y/x */
k = (iy - ix) >> 20;
if (k > 60)
z = pi_o_2 + 0.5 * pi_lo; /* |y/x| > 2**60 */
else if (hx < 0 && k < -60)
z = 0.0; /* |y|/x < -2**60 */
else
z = atan(fabs(y / x)); /* safe to do y/x */
switch (m) {
case 0:
return z; /* atan(+,+) */
case 1: {
uint32_t zh;
GET_HIGH_WORD(zh, z);
SET_HIGH_WORD(z, zh ^ 0x80000000);
}
return z; /* atan(-,+) */
case 2:
return pi - (z - pi_lo); /* atan(+,-) */
default: /* case 3 */
return (z - pi_lo) - pi; /* atan(-,-) */
}
}
#endif
|
the_stack_data/140934.c | // This just a test file for my first program.
#include<stdio.h>
int main(void){
printf("Hello fuck face");
}
|
the_stack_data/125139497.c | #include <stdio.h>
#define N 40
#define SIZE ((int) (sizeof(fib_numbers) / sizeof(fib_numbers[0])))
int main(void) {
int fib_numbers[N] = { 1, 1 };
for (int i = 2; i < SIZE; ++i) {
fib_numbers[i] = fib_numbers[i - 2] + fib_numbers[i - 1];
}
for (int i = 0; i < SIZE; ++i) {
printf("%d%s", fib_numbers[i], " ");
}
return 0;
}
|
the_stack_data/128376.c | /* Copyright (c) 2021 Dennis Wölfing
*
* Permission to use, copy, modify, and/or distribute this software for any
* purpose with or without fee is hereby granted, provided that the above
* copyright notice and this permission notice appear in all copies.
*
* THE SOFTWARE IS PROVIDED "AS IS" AND THE AUTHOR DISCLAIMS ALL WARRANTIES
* WITH REGARD TO THIS SOFTWARE INCLUDING ALL IMPLIED WARRANTIES OF
* MERCHANTABILITY AND FITNESS. IN NO EVENT SHALL THE AUTHOR BE LIABLE FOR
* ANY SPECIAL, DIRECT, INDIRECT, OR CONSEQUENTIAL DAMAGES OR ANY DAMAGES
* WHATSOEVER RESULTING FROM LOSS OF USE, DATA OR PROFITS, WHETHER IN AN
* ACTION OF CONTRACT, NEGLIGENCE OR OTHER TORTIOUS ACTION, ARISING OUT OF
* OR IN CONNECTION WITH THE USE OR PERFORMANCE OF THIS SOFTWARE.
*/
/* libc/src/string/strtok_r.c
* Split a string into tokens.
*/
#include <string.h>
char* strtok_r(char* restrict str, const char* restrict separators,
char** restrict state) {
if (!str) {
str = *state;
if (!str) return NULL;
}
// Discard any leading separators.
str = str + strspn(str, separators);
if (!*str) return NULL;
size_t tokenEnd = strcspn(str, separators);
if (str[tokenEnd] == '\0') {
*state = NULL;
} else {
str[tokenEnd] = '\0';
*state = str + tokenEnd + 1;
}
return str;
}
|
the_stack_data/151704508.c | /* ヘッダファイルのインクルード */
#include <stdio.h> /* 標準入出力 */
#include <sys/types.h> /* 派生型 */
#include <pthread.h> /* POSIXスレッド */
/* start_routine関数の定義 */
void *start_routine(void *arg){
/* 変数の宣言 */
int i; /* ループ用変数i */
/* 1から5までを出力. */
for (i = 1; i <= 5; i++){ /* 1から5まで5回繰り返す. */
/* iを出力. */
printf("i = %d\n", i); /* printfでiの値を出力. */
sleep(1); /* 1秒休止 */
}
/* スレッドの終了 */
return NULL; /* NULLを返す. */
}
/* main関数の定義 */
int main(void){
/* 変数・配列の宣言 */
int i; /* ループ用変数i */
pthread_t thread[5]; /* pthread_t型の配列thread(要素数5) */
int result; /* pthread_createの結果を格納するint型変数result. */
/* スレッドの一斉開始 */
for (i = 0; i < 5; i++){ /* 5回繰り返す. */
/* スレッド開始 */
result = pthread_create(&thread[i], NULL, start_routine, NULL); /* pthread_createでスレッドを生成して開始.(新しいスレッドstart_routineを実行.) */
if (result != 0){ /* 0以外ならエラー. */
printf("pthread_create error!\n"); /* エラーメッセージ. */
}
}
/* 全てのスレッドの終了を待機. */
for (i = 0; i < 5; i++){ /* 5回繰り返す. */
/* スレッド待機 */
pthread_join(thread[i], NULL); /* pthread_joinでthreadのi番目を待機. */
}
/* プログラムの終了 */
return 0;
}
|
the_stack_data/104828557.c | /*Nama File : InsertionSort.c*/
/*Deskripsi : Mengurutkan anggota array dengan menempatkan
anggota yang belum disortir di tempat yang
sesuai di tiap iterasi */
/*Pembuat : 24060121120012 - Emerio Kevin Aryaputra*/
/*Tgl Pembuatan : 4 Mei 2022 - 22:26*/
#include <stdio.h> /*header file*/
#include <stdlib.h>
// algoritma insertion sort
void InsertionSort(int T[], int N) {
// kamus lokal
int i, cek, j;
// algoritma
for (i = 1; i < N; i++) {
cek = T[i];
j = i - 1;
/* Pindahkan elemen T[0..i-1] yang lebih
besar dari cek ke satu posisi di depan
posisinya sekarang*/
while (j >= 0 && T[j] > cek) {
T[j + 1] = T[j];
j = j - 1;
}
T[j + 1] = cek;
}
}
// output tabel
void PrintTabel(int T[], int N) {
// kamus lokal
int i;
// algoritma
for (i = 0; i < N; i++) {
printf("%d ", T[i]);
}
printf("\n");
}
/*Program Utama*/
int main()
{
/*Kamus*/
int i, N;
/*Algoritma*/
printf("Masukkan ukuran tabel = ");
scanf("%d", &N);
int T[N];
for (i = 0; i < N; i++) {
printf("Masukkan anggota tabel ke-%d = ", i);
scanf("%d", &T[i]);
}
InsertionSort(T, N);
printf("\nTabel setelah disortir\n");
PrintTabel(T, N);
return 0;
}
|
the_stack_data/142467.c | # include<stdio.h>
int main()
{
int i,tc,n,tot;
scanf("%d",&tc);
while(tc--)
{
tot=0;
scanf("%d",&n);
int a[n];
for(i=0;i<n;i++)
{
scanf("%d",&a[i]);
tot+=(a[i]/(i+1));
}
if(tot&1)
{
printf("ALICE\n");
}
else
printf("BOB\n");
}
return 0;
} |
the_stack_data/54681893.c | /* Copyright (C) 2000-2015 Free Software Foundation, Inc.
This file is part of GCC.
GCC is free software; you can redistribute it and/or modify it under
the terms of the GNU General Public License as published by the Free
Software Foundation; either version 3, or (at your option) any later
version.
GCC is distributed in the hope that it will be useful, but WITHOUT ANY
WARRANTY; without even the implied warranty of MERCHANTABILITY or
FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
for more details.
Under Section 7 of GPL version 3, you are granted additional
permissions described in the GCC Runtime Library Exception, version
3.1, as published by the Free Software Foundation.
You should have received a copy of the GNU General Public License and
a copy of the GCC Runtime Library Exception along with this program;
see the files COPYING3 and COPYING.RUNTIME respectively. If not, see
<http://www.gnu.org/licenses/>. */
long udivmodsi4 ();
long
__divsi3 (long a, long b)
{
int neg = 0;
long res;
if (a < 0)
{
a = -a;
neg = !neg;
}
if (b < 0)
{
b = -b;
neg = !neg;
}
res = udivmodsi4 (a, b, 0);
if (neg)
res = -res;
return res;
}
long
__modsi3 (long a, long b)
{
int neg = 0;
long res;
if (a < 0)
{
a = -a;
neg = 1;
}
if (b < 0)
b = -b;
res = udivmodsi4 (a, b, 1);
if (neg)
res = -res;
return res;
}
|
the_stack_data/225143351.c | #include <stdio.h>
/*
#define LOWER 0
#define UPPER 300
#define STEP 20
float CtoF(int fah); // function prototype
int main (){
int fah = LOWER;
double cel;
while(fah <= UPPER){
cel = CtoF(fah);
printf("%3d%9.2f\n",fah,cel);
fah+=STEP;
}
return 0;
}
float CtoF(int fah){
float cel = 5 * (fah-32) / 9;
return cel;
}
*/
int main(){
int fah = 0;
for(; fah <= 300; fah+=20)
printf("%3d%9.2f\n",fah, (5.0 / 9.0) * (fah-32));
return 0;
}
|
the_stack_data/11074053.c | #include <limits.h>
#include <stdbool.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <time.h>
#include <unistd.h>
void banner();
void authorization();
void mainMenu();
void userMenu();
void friendMenu();
void addFriendMenu();
void checkFriendMenu();
void ViewFriendShipNetwork();
void recommendFriendsMenu();
void searchUserMenu();
void editUserMenu();
void removeUserMenu();
void displayFriendsMenu();
void quit();
void importData();
void ViewFriendshipNetwork();
void recommendFriendsNewUser();
struct Heap {
int *arr;
int count;
int capacity;
};
struct Heap *createHeap(int capacity) {
struct Heap *h = (struct Heap *)malloc(sizeof(struct Heap));
h->count = 0;
h->capacity = capacity;
h->arr = (int *)malloc(capacity * sizeof(int));
return h;
}
void heapify_bottom_top(struct Heap *h, int index) {
int temp;
int parent_node = (index - 1) / 2;
if (h->arr[parent_node] > h->arr[index]) {
temp = h->arr[parent_node];
h->arr[parent_node] = h->arr[index];
h->arr[index] = temp;
heapify_bottom_top(h, parent_node);
}
}
void heapify_top_bottom(struct Heap *h, int parent_node) {
int left = parent_node * 2 + 1;
int right = parent_node * 2 + 2;
int min;
int temp;
if (left >= h->count || left < 0)
left = -1;
if (right >= h->count || right < 0)
right = -1;
if (left != -1 && h->arr[left] < h->arr[parent_node])
min = left;
else
min = parent_node;
if (right != -1 && h->arr[right] < h->arr[min])
min = right;
if (min != parent_node) {
temp = h->arr[min];
h->arr[min] = h->arr[parent_node];
h->arr[parent_node] = temp;
heapify_top_bottom(h, min);
}
}
void insertHeap(struct Heap *h, int key) {
if (h->count < h->capacity) {
h->arr[h->count] = key;
heapify_bottom_top(h, h->count);
h->count++;
}
}
int PopMin(struct Heap *h) {
int pop;
if (h->count == 0) {
printf("\nHeap is Empty\n");
return -1;
}
pop = h->arr[0];
h->arr[0] = h->arr[h->count - 1];
h->count--;
heapify_top_bottom(h, 0);
return pop;
}
int minUID = 1;
int findUID(struct Heap *h) {
if (h->count == 0 || minUID <= h->arr[0])
return (minUID)++;
else
return PopMin(h);
}
typedef char string[50];
#define gets(s) \
getchar(); \
scanf("%[^\n]s", s);
struct User {
int uid;
string
name,
age,
gender,
email,
job_title,
university,
city,
country;
struct Node *RootUser;
};
void printUser(struct User u) {
printf("[%03d] %20s | %2s | %1s | %30s | %20s | %20s | %20s | %s\n", u.uid,
u.name, u.age, u.gender, u.email, u.job_title, u.university, u.city,
u.country);
}
struct Node {
int UserID; // UserID
int color; // 1-RED, 0-BLACK
struct Node *parent; // parent
struct Node *right; // right-child
struct Node *left; // left child
};
struct User NULLUSER = {0, "", "", "", "", "", "", "", ""};
struct User vertex[1000000];
struct User reversevertex[1000000];
bool exist[1000000] = {false};
int BLACK = 0;
int RED = 1;
struct Node *FindUncle(struct Node *temp) {
// If no parent or grandparent, then no uncle
if ((temp->parent == NULL) || (temp->parent->parent == NULL)) {
return NULL;
}
if (temp->parent->left == temp) {
// uncle on right
return temp->parent->parent->right;
} else {
// uncle on left
return temp->parent->parent->left;
}
}
struct Node *FindSibling(struct Node *temp) {
// sibling null if no parent
if (temp->parent == NULL)
return NULL;
if (temp->parent->left == temp)
return temp->parent->right;
return temp->parent->left;
}
void MoveDown(struct Node *temp, struct Node *nParent) {
if (temp->parent != NULL) {
if (temp->parent->left == temp) {
temp->parent->left = nParent;
} else {
temp->parent->right = nParent;
}
}
nParent->parent = temp->parent;
temp->parent = nParent;
}
bool HasRedChild(struct Node *temp) {
return ((temp->left != NULL && temp->left->color == RED) || (temp->right != NULL && temp->right->color == RED));
}
struct Node *LeftRotate(struct Node *Head, struct Node *x) {
// new parent will be node's right child
struct Node *nParent = x->right;
// update root if current node is root
if (x == Head)
Head = nParent;
MoveDown(x, nParent);
// connect x with new parent's left element
x->right = nParent->left;
// connect new parent's left element with node
// if it is not null
if (nParent->left != NULL)
nParent->left->parent = x;
// connect new parent with x
nParent->left = x;
return Head;
}
struct Node *RightRotate(struct Node *Head, struct Node *x) {
// new parent will be node's left child
struct Node *nParent = x->left;
// update root if current node is root
if (x == Head)
Head = nParent;
MoveDown(x, nParent);
// connect x with new parent's right element
x->left = nParent->right;
// connect new parent's right element with node
// if it is not null
if (nParent->right != NULL)
nParent->right->parent = x;
// connect new parent with x
nParent->right = x;
return Head;
}
void SwapColors(struct Node *x1, struct Node *x2) {
int temp;
temp = x1->color;
x1->color = x2->color;
x2->color = temp;
}
void SwapValues(struct Node *u, struct Node *v) {
int temp;
temp = u->UserID;
u->UserID = v->UserID;
v->UserID = temp;
}
struct Node *Restructure(struct Node *Head, struct Node *pt) {
struct Node *parent_pt = NULL;
struct Node *grand_parent_pt = NULL;
while ((pt != Head) && (pt->color != 0) && (pt->parent->color == RED)) {
parent_pt = pt->parent;
grand_parent_pt = pt->parent->parent;
/*Case : A
Parent of pt is left child
of Grand-parent of pt
*/
if (parent_pt == grand_parent_pt->left) {
struct Node *uncle_pt = grand_parent_pt->right;
/*Case : 1
The uncle of pt is also RED
Only Recoloring required
*/
if (uncle_pt != NULL && uncle_pt->color == RED) {
grand_parent_pt->color = RED;
parent_pt->color = 0;
uncle_pt->color = 0;
pt = grand_parent_pt;
}
else {
/*Case : 2
pt is right child of its parent
Left-rotation required
*/
if (pt == parent_pt->right) {
Head = LeftRotate(Head, parent_pt);
pt = parent_pt;
parent_pt = pt->parent;
}
/*Case : 3
pt is left child of its parent
Right-rotation required
*/
Head = RightRotate(Head, grand_parent_pt);
int t = parent_pt->color;
parent_pt->color = grand_parent_pt->color;
grand_parent_pt->color = t;
pt = parent_pt;
}
}
/*Case : B
Parent of pt is right child of Grand-parent of pt
*/
else {
struct Node *uncle_pt = grand_parent_pt->left;
/*Case : 1
The uncle of pt is also RED
Only Recoloring required
*/
if ((uncle_pt != NULL) && (uncle_pt->color == 1)) {
grand_parent_pt->color = 1;
parent_pt->color = 0;
uncle_pt->color = 0;
pt = grand_parent_pt;
} else {
/*Case : 2
pt is left child of its parent
Right-rotation required
*/
if (pt == parent_pt->left) {
Head = RightRotate(Head, parent_pt);
pt = parent_pt;
parent_pt = pt->parent;
}
/*Case : 3
pt is right child of its parent
Left-rotation required
*/
Head = LeftRotate(Head, grand_parent_pt);
int t = parent_pt->color;
parent_pt->color = grand_parent_pt->color;
grand_parent_pt->color = t;
pt = parent_pt;
}
}
}
Head->color = 0;
return Head;
}
struct Node *FixRedRed(struct Node *Head, struct Node *x) {
// if x is root color it black and return
if (x == Head) {
x->color = 0;
return Head;
}
// initialize parent, grandparent, uncle
struct Node *parent1 = x->parent;
struct Node *grandparent = parent1->parent;
struct Node *uncle1 = FindUncle(x);
if (parent1->color != 0) {
if (uncle1 != NULL && uncle1->color == RED) {
// uncle red, perform recoloring and recurse
parent1->color = 0;
uncle1->color = 0;
grandparent->color = RED;
Head = FixRedRed(Head, grandparent);
} else {
// Else perform LR, LL, RL, RR
if (parent1->parent->left == parent1) {
if (x->parent->left == x) {
// for left right
SwapColors(parent1, grandparent);
} else {
Head = LeftRotate(Head, parent1);
SwapColors(x, grandparent);
}
// for left left and left right
Head = RightRotate(Head, grandparent);
} else {
if (x->parent->left == x) {
// for right left
Head = RightRotate(Head, parent1);
SwapColors(x, grandparent);
} else {
SwapColors(parent1, grandparent);
}
// for right right and right left
Head = LeftRotate(Head, grandparent);
}
}
}
return Head;
}
struct Node *Successor(struct Node *x) {
struct Node *temp = x;
while (temp->left != NULL)
temp = temp->left;
return temp;
}
struct Node *RBTreplace(struct Node *x) {
// when node have 2 children
if (x->left != NULL && x->right != NULL)
return Successor(x->right);
// when leaf
if (x->left == NULL && x->right == NULL)
return NULL;
// when single child
if (x->left != NULL)
return x->left;
else
return x->right;
}
struct Node *FixDoubleBlack(struct Node *Head, struct Node *x) {
if (x == Head)
// Reached root
return Head;
struct Node *sibling1 = FindSibling(x);
struct Node *parent1 = x->parent;
if (sibling1 == NULL) {
// No sibiling, double black pushed up
Head = FixDoubleBlack(Head, parent1);
} else {
if (sibling1->color == RED) {
// Sibling red
parent1->color = RED;
sibling1->color = 0;
if (sibling1->parent->left == sibling1) {
// left case
Head = RightRotate(Head, parent1);
} else {
// right case
Head = LeftRotate(Head, parent1);
}
Head = FixDoubleBlack(Head, x);
} else {
// Sibling black
if (HasRedChild(sibling1)) {
// at least 1 red children
if (sibling1->left != NULL && sibling1->left->color == RED) {
if (sibling1->parent->left == sibling1) {
// left left
sibling1->left->color = sibling1->color;
sibling1->color = parent1->color;
Head = RightRotate(Head, parent1);
} else {
// right left
sibling1->left->color = parent1->color;
Head = RightRotate(Head, sibling1);
Head = LeftRotate(Head, parent1);
}
} else {
if (sibling1->parent->left == sibling1) {
// left right
sibling1->right->color = parent1->color;
Head = LeftRotate(Head, sibling1);
Head = RightRotate(Head, parent1);
} else {
// right right
sibling1->right->color = sibling1->color;
sibling1->color = parent1->color;
Head = LeftRotate(Head, parent1);
}
}
parent1->color = 0;
} else {
// 2 black children
sibling1->color = RED;
if (parent1->color == 0)
Head = FixDoubleBlack(Head, parent1);
else
parent1->color = 0;
}
}
}
return Head;
}
struct Node *DeleteNode(struct Node *Head, struct Node *v) {
struct Node *u = RBTreplace(v);
// True when u and v are both black
bool uvBlack = ((u == NULL || u->color == 0) && (v->color == 0));
struct Node *parent1 = v->parent;
if (u == NULL) {
// u is NULL therefore v is leaf
if (v == Head) {
// v is root, making root null
Head = NULL;
} else {
if (uvBlack) {
// u and v both black
// v is leaf, fix double black at v
Head = FixDoubleBlack(Head, v);
} else {
// u or v is red
if (FindSibling(v) != NULL)
// sibling is not null, make it red"
FindSibling(v)->color = RED;
}
// delete v from the tree
if (v->parent->left == v) {
parent1->left = NULL;
} else {
parent1->right = NULL;
}
}
free(v);
return Head;
}
if (v->left == NULL || v->right == NULL) {
// v has 1 child
if (v == Head) {
// v is root, assign the value of u to v, and delete u
v->UserID = u->UserID;
v->left = v->right = NULL;
free(u);
} else {
// Detach v from tree and move u up
if (v->parent->left == v) {
parent1->left = u;
} else {
parent1->right = u;
}
free(v);
u->parent = parent1;
if (uvBlack) {
// u and v both black, fix double black at u
Head = FixDoubleBlack(Head, u);
} else {
// u or v red, color u black
u->color = 0;
}
}
return Head;
}
// v has 2 children, swap values with successor and recurse
SwapValues(u, v);
Head = DeleteNode(Head, u);
return Head;
}
struct Node *Search(struct Node *Head, int n) {
struct Node *temp = Head;
while (temp != NULL) {
if (n < temp->UserID) {
if (temp->left == NULL)
break;
else
temp = temp->left;
} else if (n == temp->UserID) {
break;
} else {
if (temp->right == NULL)
break;
else
temp = temp->right;
}
}
return temp;
}
struct Node *Insert(struct Node *Head, int n) {
//struct Node *newNode = new Node(n);
struct Node *newNode = (struct Node *)malloc(sizeof(struct Node));
newNode->right = NULL;
newNode->left = NULL;
newNode->parent = NULL;
newNode->UserID = n;
newNode->color = 1;
if (Head == NULL) {
// when root is null
// simply insert value at root
newNode->color = 0;
Head = newNode;
} else {
struct Node *temp = Search(Head, n);
if (temp->UserID == n) {
printf("BOTH Already FRIENDS\n\n");
return Head;
}
// if value is not found, search returns the node
// where the value is to be inserted
// connect new node to correct node
//if (temp == Head)
// printf("head is the only node");
newNode->parent = temp;
if (n < temp->UserID)
temp->left = newNode;
else
temp->right = newNode;
// fix red red voilaton if exists
//Head = fixRedRed(Head, newNode);
Head = Restructure(Head, newNode);
}
return Head;
}
struct Node *DeleteByVal(struct Node *Head, int n) {
if (Head == NULL)
// Tree is empty
return Head;
struct Node *v = Search(Head, n), *u;
if (v->UserID != n) {
//cout << "No node found to delete with value:" << n << endl;
return Head;
}
//if (Head == v)
// printf("this is ROOT");
Head = DeleteNode(Head, v);
return Head;
}
void DeleteRBTUser(int Value, struct Node *NodeToBeDeleted) {
if (NodeToBeDeleted == NULL)
return;
else {
DeleteRBTUser(Value, NodeToBeDeleted->left);
vertex[NodeToBeDeleted->UserID].RootUser = DeleteByVal(vertex[NodeToBeDeleted->UserID].RootUser, Value);
DeleteRBTUser(Value, NodeToBeDeleted->right);
free(NodeToBeDeleted);
}
}
void DeleteRBT_Reverse_User(int Value, struct Node *NodeToBeDeleted) {
if (NodeToBeDeleted == NULL)
return;
else {
DeleteRBT_Reverse_User(Value, NodeToBeDeleted->left);
reversevertex[NodeToBeDeleted->UserID].RootUser = DeleteByVal(reversevertex[NodeToBeDeleted->UserID].RootUser, Value);
DeleteRBT_Reverse_User(Value, NodeToBeDeleted->right);
free(NodeToBeDeleted);
}
}
void addUSER(struct User userTObeInserted) {
userTObeInserted.RootUser = NULL;
vertex[userTObeInserted.uid] = userTObeInserted;
userTObeInserted.RootUser = NULL;
reversevertex[userTObeInserted.uid] = userTObeInserted;
exist[userTObeInserted.uid] = true;
}
void DeleteUSER(int nodetobedeleted) {
//if (exist[nodetobedeleted] == false)
// printf("User doesn't exist");
DeleteRBTUser(nodetobedeleted, reversevertex[nodetobedeleted].RootUser);
DeleteRBT_Reverse_User(nodetobedeleted, vertex[nodetobedeleted].RootUser);
reversevertex[nodetobedeleted].RootUser = NULL;
vertex[nodetobedeleted].RootUser = NULL;
exist[nodetobedeleted] = false;
}
void addfriends(int UserIdOfUser, int UserIdOfFriend) {
if ((exist[UserIdOfUser] == false) || (exist[UserIdOfFriend] == false)) {
printf("Atleast one of the user dont exist");
return;
}
vertex[UserIdOfUser].RootUser = Insert(vertex[UserIdOfUser].RootUser, UserIdOfFriend);
reversevertex[UserIdOfFriend].RootUser = Insert(reversevertex[UserIdOfFriend].RootUser, UserIdOfUser);
}
void Deletefriends(int UserIdOfUser, int UserIdOfFriend) {
if ((exist[UserIdOfUser] == false) || (exist[UserIdOfFriend] == false)) {
printf("Atleast one of the user dont exist");
return;
}
vertex[UserIdOfUser].RootUser = DeleteByVal(vertex[UserIdOfUser].RootUser, UserIdOfFriend);
reversevertex[UserIdOfFriend].RootUser = DeleteByVal(reversevertex[UserIdOfFriend].RootUser, UserIdOfUser);
}
int Findfrienshipstatus(int User1, int User2) {
if ((exist[User1] == false) || (exist[User2] == false)) {
//printf("One of the users dont exist\n");
return 0;
}
struct Node *temp = Search(vertex[User1].RootUser, User2);
if (temp->UserID == User2) {
//printf("%d is friend of %d", User2, User1);
return 1;
} else {
//printf("%d is not friend of %d", User2, User1);
return 0;
}
}
int CompatiFriend(struct User u1, struct User u2) {
int score = 0; // max 105
score += 10 - abs(atoi(u2.age) - atoi(u1.age));
if (u1.gender != u2.gender)
score += 10;
else
score += 5;
if (!strcmp(u1.job_title, u2.job_title))
score += 40;
if (!strcmp(u1.university, u2.university))
score += 30;
if (!strcmp(u1.city, u2.city))
score += 10;
if (!strcmp(u1.country, u2.country))
score += 5;
return score;
}
int NoRecUsers = 0;
int CurIndex = 1;
int FinIndex = 1;
int visitedForRecommendation[1000000];
int FriendofUser[1000000];
int Queueforbfs[1000000];
int LevelForQueueforbfs[1000000];
struct FriendQuality {
int userid;
int similarityscore;
int level;
};
struct FriendQuality Recommendation[1000000];
struct FriendQuality temp1[2000005];
struct FriendQuality temp2[2000005];
struct FriendQuality NullFriendQuality = {0, 0, 0};
void merge(int left, int mid, int right) {
int size1 = mid - left + 1;
int size2 = right - mid;
for (int i = 0; i < size1; i++)
temp1[i] = Recommendation[left + i];
for (int i = 0; i < size2; i++)
temp2[i] = Recommendation[mid + 1 + i];
int i = 0;
int j = 0;
int pos = left;
while ((i < size1) && (j < size2)) {
if (temp1[i].level < temp2[j].level) {
Recommendation[pos] = temp1[i];
i++;
} else if (temp1[i].level > temp2[j].level) {
Recommendation[pos] = temp2[j];
j++;
} else {
if (temp1[i].similarityscore > temp2[j].similarityscore) {
Recommendation[pos] = temp1[i];
i++;
} else if (temp1[i].similarityscore < temp2[j].similarityscore) {
Recommendation[pos] = temp2[j];
j++;
} else {
if (temp1[i].userid <= temp2[j].userid) {
Recommendation[pos] = temp1[i];
i++;
} else if (temp1[i].userid > temp2[j].userid) {
Recommendation[pos] = temp2[j];
j++;
}
}
}
pos++;
}
while (i < size1) {
Recommendation[pos] = temp1[i];
i++;
pos++;
}
while (j < size2) {
Recommendation[pos] = temp2[j];
j++;
pos++;
}
}
void mergeSort(int left, int right) {
if (left < right) {
int mid = left + ((right - left) / 2);
mergeSort(left, mid);
mergeSort(mid + 1, right);
merge(left, mid, right);
}
}
//add friends to FriendsofUser
void IniFriendOfUser(struct Node *trav, int x) {
if (trav == NULL)
return;
IniFriendOfUser(trav->left, x);
FriendofUser[trav->UserID] = x;
IniFriendOfUser(trav->right, x);
}
void clearQueue(int j) {
for (int i = 0; i <= j; i++) {
visitedForRecommendation[Queueforbfs[i]] = 0;
Queueforbfs[i] = 0;
LevelForQueueforbfs[i] = 0;
}
}
void clearRecomd(int j) {
for (int i = 0; i <= j; i++) {
Recommendation[i] = NullFriendQuality;
temp1[i] = NullFriendQuality;
temp2[i] = NullFriendQuality;
}
}
//addtoQueueToBFS
void TraverseBFSNODE(struct Node *trav, int level) {
if (trav == NULL)
return;
TraverseBFSNODE(trav->left, level);
//printf("inside traverse %d\n", trav->UserID);
if (visitedForRecommendation[trav->UserID] == 0) {
Queueforbfs[FinIndex + 1] = trav->UserID;
LevelForQueueforbfs[FinIndex + 1] = level + 1;
FinIndex++;
//printf("inside traverse %d,finindex %d\n", trav->UserID, FinIndex);
if (FriendofUser[trav->UserID] == 0) {
struct FriendQuality temp;
temp.userid = trav->UserID;
temp.level = level + 1;
temp.similarityscore = 0;
Recommendation[NoRecUsers + 1] = temp;
NoRecUsers++;
}
//visitedForRecommendation[trav->UserID] = 1;
}
TraverseBFSNODE(trav->right, level);
}
void Recommendfriends(int Userid, int K, int maximumUserID) {
struct Node *Root = (struct Node *)malloc(sizeof(struct Node));
Root = vertex[Userid].RootUser;
IniFriendOfUser(Root, 1);
Queueforbfs[1] = Userid;
LevelForQueueforbfs[1] = 0;
//visitedForRecommendation[Userid] = 1;
NoRecUsers = 0;
while (CurIndex <= FinIndex) {
if (visitedForRecommendation[Queueforbfs[CurIndex]] == 1) {
CurIndex++;
} else {
TraverseBFSNODE(vertex[Queueforbfs[CurIndex]].RootUser, LevelForQueueforbfs[CurIndex]);
visitedForRecommendation[Queueforbfs[CurIndex]] = 1;
CurIndex++;
}
if (K <= NoRecUsers) {
break;
}
}
if (NoRecUsers < K) {
for (int i = 1; i <= maximumUserID; i++) {
if ((exist[i] == 1) && (visitedForRecommendation[i] == 0) && (FriendofUser[i] == 0)) {
struct FriendQuality temp;
temp.userid = i;
temp.level = INT_MAX;
temp.similarityscore = 0;
Recommendation[NoRecUsers + 1] = temp;
NoRecUsers++;
}
if (NoRecUsers > K)
break;
}
}
for (int i = 1; i <= NoRecUsers; i++) {
Recommendation[i].similarityscore = CompatiFriend(vertex[Recommendation[i].userid], vertex[Userid]);
}
mergeSort(1, NoRecUsers);
int NoRecUsersFinal = NoRecUsers;
if (K < NoRecUsers)
NoRecUsersFinal = K;
printf("\nNO OF RECOMMENDED USERS IS: %d\n", NoRecUsersFinal);
for (int i = 1; i <= NoRecUsersFinal; i++) {
printUser(vertex[Recommendation[i].userid]);
}
printf("\n");
IniFriendOfUser(Root, 0);
clearQueue(FinIndex);
clearRecomd(NoRecUsers);
K = 0;
CurIndex = 1;
FinIndex = 1;
NoRecUsers = 0;
}
int V = 1000000;
struct Heap *h;
void initialize() {
h = createHeap(V);
}
void addUser() {
struct User u;
u.uid = findUID(h);
printf("Enter the details of User [%03d]\n", u.uid);
printf("Name: ");
gets(u.name);
printf("Age: ");
gets(u.age);
printf("Gender: ");
gets(u.gender);
printf("Email: ");
gets(u.email);
printf("Job Title: ");
gets(u.job_title);
printf("University: ");
gets(u.university);
printf("City: ");
gets(u.city);
printf("Country: ");
gets(u.country);
addUSER(u);
printUser(vertex[u.uid]);
Recommendfriends(u.uid, 10, minUID - 1);
if (minUID > 2) {
int no_of_friends = 0;
printf("\n\n");
printf("Enter No of Friends to add:");
scanf("%d", &no_of_friends);
printf("\n\n");
for (int i = 1; i <= no_of_friends; i++) {
printf("\nEnter 0 to to end adding friends.\n");
printf("\nEnter the UserID of friend to add.\n\n");
int frid;
scanf("%d", &frid);
if (frid == 0)
break;
if (u.uid == frid) {
printf("\nCannot add user as user's Friend\n");
} else {
printUser(vertex[u.uid]);
printUser(vertex[frid]);
addfriends(u.uid, frid);
printf("Added %s as %s\'s Friend.\n",
vertex[frid].name, vertex[u.uid].name);
}
}
}
}
void searchUserUID() {
system("clear");
int userid;
printf("Enter the User ID: ");
scanf("%d", &userid);
if (exist[userid])
printUser(vertex[userid]);
else
printf("EROR 404: USER ID #%d NOT FOUND!\n", userid);
printf("\n");
}
void searchUserName() {
system("clear");
bool found = 0;
string username;
printf("Enter the Name: ");
gets(username);
for (int i = 1; i < minUID; ++i) {
if (exist[i] == 1) {
if (!strcmp(vertex[i].name, username)) {
printUser(vertex[i]);
found = 1;
break;
}
}
}
if (!found)
printf("ERROR 404: USER \"%s\" NOT FOUND.", username);
printf("\n");
}
// Edits User by UID
void editUserUID() {
system("clear");
int userid;
printf("Enter the User ID: ");
scanf("%d", &userid);
if (exist[userid]) {
printUser(vertex[userid]);
printf("\n");
printf("Enter the new details\n");
printf("Name: ");
gets(vertex[userid].name);
printf("Age: ");
gets(vertex[userid].age);
printf("Gender: ");
gets(vertex[userid].gender);
printf("Email: ");
gets(vertex[userid].email);
printf("Job Title: ");
gets(vertex[userid].job_title);
printf("University: ");
gets(vertex[userid].university);
printf("City: ");
gets(vertex[userid].city);
printf("Country: ");
gets(vertex[userid].country);
printf("Edited.\n");
printUser(vertex[userid]);
} else
printf("EROR 404: USER ID #%d NOT FOUND!\n", userid);
printf("\n");
}
// Edits User by Name
void editUserName() {
system("clear");
bool found = 0;
string username;
printf("Enter the Name: ");
gets(username);
for (int i = 0; i < minUID; ++i)
if (exist[i]) {
if (!strcmp(vertex[i].name, username)) {
printUser(vertex[i]);
printf("\n");
printf("Enter the new details\n");
printf("Name: ");
gets(vertex[i].name);
printf("Age: ");
gets(vertex[i].age);
printf("Gender: ");
gets(vertex[i].gender);
printf("Email: ");
gets(vertex[i].email);
printf("Job Title: ");
gets(vertex[i].job_title);
printf("University: ");
gets(vertex[i].university);
printf("City: ");
gets(vertex[i].city);
printf("Country: ");
gets(vertex[i].country);
printf("Edited.\n");
printUser(vertex[i]);
found = 1;
break;
}
}
if (!found)
printf("ERROR 404: USER \"%s\" NOT FOUND.", username);
printf("\n");
}
// Displays the User Database
void displayUserDatabase() {
system("clear");
bool found = 0;
printf("-------------------------------------------------------");
printf("-------------------------------------------------------");
printf("-------------------------------------------------------\n");
for (int i = 1; i < minUID; ++i)
if (exist[i]) {
if (!found)
found = 1;
printUser(vertex[i]);
}
if (!found)
printf("\tUser Database is Empty!\n");
printf("-------------------------------------------------------");
printf("-------------------------------------------------------");
printf("-------------------------------------------------------\n");
printf("\n");
getchar();
getchar();
}
void removeUserUID() {
system("clear");
int userid;
printf("Enter the User ID: ");
scanf("%d", &userid);
if (exist[userid]) {
printUser(vertex[userid]);
printf("Confirm Delete (y/n)? ");
char c, buff;
scanf("%c%c", &buff, &c);
if (c != 'n') {
printf("Deleted!\n");
DeleteUSER(userid);
insertHeap(h, userid);
} else {
printf("Skipped!\n");
}
} else
printf("EROR 404: USER ID #%d NOT FOUND!\n", userid);
printf("\n");
}
// Removes User by Name
void removeUserName() {
system("clear");
bool found = 0;
string username;
printf("Enter the Name: ");
gets(username);
for (int i = 0; i < minUID; ++i)
if (exist[i]) {
if (!strcmp(vertex[i].name, username)) {
printUser(vertex[i]);
printf("Confirm Delete (y/n)? ");
char c, buff;
scanf("%c%c", &buff, &c);
if (c != 'n') {
printf("Deleted!\n");
DeleteUSER(vertex[i].uid);
insertHeap(h, i);
found = 1;
} else {
printf("Skipped!\n");
}
break;
}
}
if (!found)
printf("ERROR 404: USER \"%s\" NOT FOUND.", username);
printf("\n");
}
void addFriendshipUID() {
system("clear");
int userid, friendid;
printf("Enter the User ID and the Friend ID: ");
scanf("%d %d", &userid, &friendid);
if (exist[userid] && exist[friendid]) {
if (userid == friendid) {
printf("Cannot add user as user's Friend\n");
} else {
printUser(vertex[userid]);
printUser(vertex[friendid]);
addfriends(userid, friendid);
printf("Added %s as %s\'s Friend.\n",
vertex[friendid].name, vertex[userid].name);
}
} else
printf("EROR 404: USER ID(s) NOT FOUND!\n");
printf("\n");
}
void addFriendshipName() {
system("clear");
bool founduser = 0, foundfriend = 0;
int userid = 0, friendid = 0;
string username, friendname;
printf("Enter the User Name: ");
gets(username);
for (int i = 0; i < minUID; ++i)
if (exist[i]) {
if (!strcmp(vertex[i].name, username)) {
userid = i;
founduser = 1;
printUser(vertex[i]);
break;
}
}
if (!founduser) {
printf("ERROR 404: USER \"%s\" NOT FOUND.\n", username);
return;
}
printf("Enter the Friend's Name: ");
gets(friendname);
for (int i = 0; i < minUID; ++i)
if (exist[i]) {
if (!strcmp(vertex[i].name, friendname)) {
friendid = i;
foundfriend = 1;
printUser(vertex[i]);
break;
}
}
if (!foundfriend) {
printf("ERROR 404: USER \"%s\" NOT FOUND.\n", friendname);
return;
}
if (userid == friendid) {
printf("Cannot add user as user's Friend\n");
} else {
addfriends(userid, friendid);
printf("Added %s as %s\'s Friend.\n",
vertex[friendid].name, vertex[userid].name);
}
printf("\n");
}
void recommendFriendsExistingUser() {
system("clear");
int userid;
printf("Enter the User ID: ");
scanf("%d", &userid);
if (exist[userid] == 0) {
printf("ERROR 404: USER #%d NOT FOUND.\n", userid);
return;
}
printf("------> ");
printUser(vertex[userid]);
int toAdd;
printf("Enter the number of friends you want to add: ");
scanf("%d", &toAdd);
if (toAdd == 0) {
printf("Skipping Recommending Friends...\n");
recommendFriendsMenu();
}
int no_of_friends = 0;
Recommendfriends(userid, toAdd, minUID - 1);
printf("\n\n");
printf("Enter No of Friends to add:");
scanf("%d", &no_of_friends);
printf("\n\n");
for (int i = 1; i <= no_of_friends; i++) {
printf("\nEnter 0 to to end adding friends.\n");
printf("\nEnter the UserID of friend to add.\n\n");
int frid;
scanf("%d", &frid);
if (frid == 0)
break;
if (userid == frid) {
printf("\nCannot add user as user's Friend\n");
} else {
printUser(vertex[userid]);
printUser(vertex[frid]);
addfriends(userid, frid);
printf("Added %s as %s\'s Friend.\n",
vertex[frid].name, vertex[userid].name);
}
}
}
void checkFriendshipUID() {
system("clear");
int userid, friendid;
printf("Enter the User ID: ");
scanf("%d", &userid);
if (exist[userid] == 0) {
printf("ERROR 404: USER #%03d NOT FOUND!\n", userid);
return;
}
printf("Enter the Friend ID: ");
scanf("%d", &friendid);
if (exist[friendid] == 0) {
printf("ERROR 404: USER #%03d NOT FOUND!\n", friendid);
return;
}
bool friend12 = Findfrienshipstatus(userid, friendid);
bool friend21 = Findfrienshipstatus(friendid, userid);
if (friend12 && friend21)
printf("%s and %s are Mutual Friends.\n", vertex[userid].name,
vertex[friendid].name);
else if (friend12)
printf("%s considers %s to be a friend.\n", vertex[userid].name,
vertex[friendid].name);
else if (friend21)
printf("%s considers %s to be a friend.\n", vertex[friendid].name,
vertex[userid].name);
else
printf("%s and %s are not Friends.\n", vertex[userid].name,
vertex[friendid].name);
printf("\n");
}
void checkFriendshipName() {
system("clear");
bool founduser = 0, foundfriend = 0;
int userid = 0, friendid = 0;
string username, friendname;
printf("Enter the User Name: ");
gets(username);
for (int i = 0; i < minUID; ++i)
if (exist[i]) {
if (!strcmp(vertex[i].name, username)) {
userid = i;
founduser = 1;
printUser(vertex[i]);
break;
}
}
if (!founduser) {
printf("ERROR 404: USER \"%s\" NOT FOUND.\n", username);
return;
}
printf("Enter the Friend's Name: ");
gets(friendname);
for (int i = 0; i < minUID; ++i)
if (exist[i]) {
if (!strcmp(vertex[i].name, friendname)) {
friendid = i;
foundfriend = 1;
printUser(vertex[i]);
break;
}
}
if (!foundfriend) {
printf("ERROR 404: USER \"%s\" NOT FOUND.\n", friendname);
return;
}
bool friend12 = Findfrienshipstatus(userid, friendid);
bool friend21 = Findfrienshipstatus(friendid, userid);
if (friend12 && friend21)
printf("%s and %s are Mutual Friends.\n", vertex[userid].name,
vertex[friendid].name);
else if (friend12)
printf("%s considers %s to be a friend.\n", vertex[userid].name,
vertex[friendid].name);
else if (friend21)
printf("%s considers %s to be a friend.\n", vertex[friendid].name,
vertex[userid].name);
else
printf("%s and %s are not Friends.\n", vertex[userid].name,
vertex[friendid].name);
printf("\n");
}
void printFriendlist(struct Node *root) {
if (root != NULL) {
printFriendlist(root->left);
printf("%s | ", vertex[root->UserID].name);
printFriendlist(root->right);
}
}
// Displays the Frienship Network
void displayFriendsAdjacencyList() {
system("clear");
bool found = 0;
printf("-------------------------------------------------------");
printf("-------------------------------------------------------");
printf("-------------------------------------------------------\n");
for (int i = 1; i < minUID; ++i) {
if (exist[i]) {
if (!found)
found = 1;
printf("Friends of [%03d] %25s: ", vertex[i].uid, vertex[i].name);
if (vertex[i].RootUser)
printFriendlist(vertex[i].RootUser);
else
printf("NULL");
printf("\n");
}
}
if (!found)
printf("\tUser Database is Empty!\n");
printf("-------------------------------------------------------");
printf("-------------------------------------------------------");
printf("-------------------------------------------------------\n");
printf("\n");
}
void banner();
void authorization();
void mainMenu();
void userMenu();
void friendMenu();
void addFriendMenu();
void checkFriendMenu();
void ViewFriendShipNetwork();
void recommendFriendsMenu();
void searchUserMenu();
void editUserMenu();
void removeUserMenu();
void displayFriendsMenu();
void quit();
void importData();
void banner() {
system("clear");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
}
void mainMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** Main Menu ** \n");
printf(" ** ** \n");
printf(" ** 1. User Management ** \n");
printf(" ** 2. Friend Management ** \n");
printf(" ** ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
userMenu();
break;
case 2:
friendMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
mainMenu();
}
} while (ch <= 100);
}
void userMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** User Management ** \n");
printf(" ** ** \n");
printf(" ** 1. Register User ** \n");
printf(" ** 2. Search User ** \n");
printf(" ** 3. Edit User ** \n");
printf(" ** 4. Display User ** \n");
printf(" ** 5. Unregister User ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the Main Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
addUser();
break;
case 2:
searchUserMenu();
break;
case 3:
editUserMenu();
break;
case 4:
displayUserDatabase();
break;
case 5:
removeUserMenu();
break;
case 7:
//importData();
break;
case 9:
mainMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
userMenu();
}
} while (ch <= 100);
}
void searchUserMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** User Management ** \n");
printf(" ** ** \n");
printf(" ** Search User ** \n");
printf(" ** ** \n");
printf(" ** 1. Search User by UID ** \n");
printf(" ** 2. Search User by Name ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the User Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
searchUserUID();
break;
case 2:
searchUserName();
break;
case 9:
userMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
searchUserMenu();
}
} while (ch <= 100);
}
void editUserMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** User Management ** \n");
printf(" ** ** \n");
printf(" ** Edit User ** \n");
printf(" ** ** \n");
printf(" ** 1. Edit User by UID ** \n");
printf(" ** 2. Edit User by Name ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the User Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
editUserUID();
break;
case 2:
editUserName();
break;
case 9:
userMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
editUserMenu();
}
} while (ch <= 100);
}
void removeUserMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** User Management ** \n");
printf(" ** ** \n");
printf(" ** Remove User ** \n");
printf(" ** ** \n");
printf(" ** 1. Remove User by UID ** \n");
printf(" ** 2. Remove User by Name ** \n");
printf(" ** ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the User Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
removeUserUID();
break;
case 2:
removeUserName();
break;
case 9:
userMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
searchUserMenu();
}
} while (ch <= 100);
}
void friendMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** Friend Management ** \n");
printf(" ** ** \n");
printf(" ** 1. Add Friendship ** \n");
printf(" ** 2. Recommend Friends ** \n");
printf(" ** 3. Check Friendship ** \n");
printf(" ** 4. Display Friendships ** \n");
//printf(" ** 5. Delete Friends ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the Main Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
addFriendMenu();
break;
case 2:
recommendFriendsMenu();
break;
case 3:
checkFriendMenu();
break;
case 4:
displayFriendsMenu();
break;
case 9:
mainMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
friendMenu();
}
} while (ch <= 100);
}
void addFriendMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** Friend Management ** \n");
printf(" ** ** \n");
printf(" ** Add Friendship ** \n");
printf(" ** ** \n");
printf(" ** 1. Add Friendship by UIDs ** \n");
printf(" ** 2. Add Friendship by Names ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the Friend Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
addFriendshipUID();
break;
case 2:
addFriendshipName();
break;
case 9:
friendMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
friendMenu();
}
} while (ch <= 100);
}
void recommendFriendsMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** Friend Management ** \n");
printf(" ** ** \n");
printf(" ** Recommend Friends ** \n");
printf(" ** ** \n");
//printf(" ** 1. To a New User ** \n");
printf(" ** 1. To a User ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the Friend Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
recommendFriendsExistingUser();
break;
case 9:
friendMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
friendMenu();
}
} while (ch <= 100);
}
void checkFriendMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** Friend Management ** \n");
printf(" ** ** \n");
printf(" ** Check Friendship ** \n");
printf(" ** ** \n");
printf(" ** 1. Check Friendship by UID ** \n");
printf(" ** 2. Check Friendship by Name ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the Friend Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
checkFriendshipUID();
break;
case 2:
checkFriendshipName();
break;
case 9:
friendMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
friendMenu();
}
} while (ch <= 100);
}
void displayFriendsMenu() {
system("clear");
int ch;
do {
printf(" ************************************** \n");
printf(" ************************************** \n");
printf(" ** ** \n");
printf(" ** Amigos ** \n");
printf(" ** ** \n");
printf(" ** Friend Management ** \n");
printf(" ** ** \n");
printf(" ** Display Friendships ** \n");
printf(" ** ** \n");
printf(" ** 1. Display Adjacency List ** \n");
printf(" ** ** \n");
printf(" ** ** \n");
printf(" ** 9. Back to the Friend Menu ** \n");
printf(" ** 0. Exit Amigos ** \n");
printf(" ** ** \n");
printf(" ************************************** \n");
printf(" ************************************** \n");
printf("\n");
printf("Enter your choice: ");
scanf("%d", &ch);
switch (ch) {
case 1:
displayFriendsAdjacencyList();
break;
case 9:
friendMenu();
break;
case 0:
quit();
default:
printf("Invalid Choice!\n");
friendMenu();
}
} while (ch <= 100);
}
void quit() {
system("clear");
printf("Thank You for visiting us at https://amigos.com/\n");
exit(0);
}
int main() {
banner();
// authorization();
initialize();
mainMenu();
}
|
the_stack_data/856733.c | /* Copyright 2014 Lorenz Hüdepohl
*
* This file is part of ftimings.
*
* ftimings is free software: you can redistribute it and/or modify
* it under the terms of the GNU Lesser General Public License as published by
* the Free Software Foundation, either version 3 of the License, or
* (at your option) any later version.
*
* ftimings is distributed in the hope that it will be useful,
* but WITHOUT ANY WARRANTY; without even the implied warranty of
* MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
* GNU Lesser General Public License for more details.
*
* You should have received a copy of the GNU Lesser General Public License
* along with ftimings. If not, see <http://www.gnu.org/licenses/>.
*/
#include <sys/time.h>
#include <stdio.h>
#include <unistd.h>
#include <stdint.h>
#include <stddef.h>
#include <stdlib.h>
/* Return number of microseconds since 1.1.1970, in a 64 bit integer.
* (with 2^64 us ~ 6 * 10^5 years, this should be sufficiently overflow safe)
*/
int64_t ftimings_microseconds_since_epoch(void) {
struct timeval tv;
if (gettimeofday(&tv, NULL) != 0) {
perror("gettimeofday");
exit(1);
}
return (int64_t) (tv.tv_sec) * ((int64_t) 1000000) + (int64_t)(tv.tv_usec);
}
|
the_stack_data/50138636.c | /* { dg-do run { target i?86-*-linux* x86_64-*-linux* ia64-*-linux* alpha*-*-linux* powerpc*-*-linux* s390*-*-linux* sparc*-*-linux* mips*-*-linux* } } */
/* { dg-options "-fexceptions" } */
/* Verify that cleanups work with exception handling. */
#include <unwind.h>
#include <stdlib.h>
static _Unwind_Reason_Code
force_unwind_stop (int version, _Unwind_Action actions,
_Unwind_Exception_Class exc_class,
struct _Unwind_Exception *exc_obj,
struct _Unwind_Context *context,
void *stop_parameter)
{
if (actions & _UA_END_OF_STACK)
abort ();
return _URC_NO_REASON;
}
static void force_unwind ()
{
struct _Unwind_Exception *exc = malloc (sizeof (*exc));
exc->exception_class = 0;
exc->exception_cleanup = 0;
#ifndef __USING_SJLJ_EXCEPTIONS__
_Unwind_ForcedUnwind (exc, force_unwind_stop, 0);
#else
_Unwind_SjLj_ForcedUnwind (exc, force_unwind_stop, 0);
#endif
abort ();
}
static void handler (void *p __attribute__((unused)))
{
exit (0);
}
static void doit ()
{
char dummy __attribute__((cleanup (handler)));
force_unwind ();
}
int main()
{
doit ();
abort ();
}
|
the_stack_data/783119.c | #include <stdio.h>
int main()
{
float A,B,C,D,N;
scanf("%f %f %f %f",&A,&B,&C,&D);
A = (A*2+B*3+C*4+D*1)/10;
printf("Media: %.1f\n",A);
if (A>=7.0){
printf("Aluno aprovado.\n");
}
else if (A<5.0){
printf("Aluno reprovado.\n");
}
else if ((A>=5.0) && (A<7.0)){
printf("Aluno em exame.\n");
scanf("%f",&N);
printf("Nota do exame: %.1f\n",N);
N = (A+N)/2;
if (N>=5.0){
printf("Aluno aprovado.\n");
printf("Media final: %.1f\n",N);
}
else{
printf("Aluno reprovado.\n");
printf("Media final: %.1f\n",N);
}
}
return 0;
}
|
the_stack_data/941582.c | #include <stdint.h>
#include <inttypes.h>
#include <stdio.h>
const uint64_t KEY = 0x0000000000000000;
//const uint64_t PLAINTEXT = 0x1234567890ABCDEF;
const uint64_t PLAINTEXT = 0xFFFFFFFFFFFFFFFF;
const int Nr = 12;
//const int Nr = 2;
// const int SBOX[] = {0x0, 0x1, 0x2, 0x3, 0x4, 0x5, 0x6, 0x7, 0x8, 0x9, 0xA, 0xB, 0xC, 0xD, 0xE, 0xF};
const uint8_t SBOX[] = {0x7, 0x4, 0xA, 0x9, 0x1, 0xF, 0xB, 0x0, 0xC, 0x3, 0x2, 0x6, 0x8, 0xE, 0xD, 0x5};
void printBin64(uint64_t n) {
int i;
for (i = 63; i >= 0; i--) {
printf("%d", (int) (n >> i) & 0x1);
if (i % 4 == 0) {
printf(" ");
}
}
printf("\n");
}
void printBin8(uint8_t n) {
int i;
for (i = 7; i >= 0; i--) {
printf("%d", (int) (n >> i) & 0x1);
if (i % 4 == 0) {
printf(" ");
}
}
printf("\n");
}
uint8_t galois_x4_1(uint8_t a) {
int i;
for (i = 7; i >= 0; i--) {
if (a >> i & 0x1) {
a ^= 0x11 << (i - 4); // shift n to the same bit as the current bit in 'a'
}
}
return a;
}
uint64_t addRoundKey(uint64_t state, uint64_t sk) {
return state ^ sk;
}
uint64_t subNibbles(uint64_t state) {
uint64_t result = 0;
int i;
for (i = 15; i >= 0; i--) {
result = result << 4;
result += SBOX[(state & ((uint64_t) 0xF << 4*i)) >> 4*i];
//printBin(result);
}
return result;
}
uint64_t rotateLeft(uint64_t n) {
return ((n >> 63) & 0x1) | (n << 1);
}
uint64_t rotateNibbles(uint64_t state) {
int i;
for(i = 0; i < 16;i++) {
state = rotateLeft(state);
}
return state;
}
uint64_t mixNibbles(uint64_t state) {
//This fits _exactly_ in the registers.
uint8_t c01_1 = galois_x4_1((uint8_t) (state >> 56) & 0xFF);
uint8_t c01_2 = c01_1 << 1;
uint8_t c01_3 = c01_1 ^ c01_2;
uint8_t c23_1 = galois_x4_1((uint8_t) (state >> 48) & 0xFF);
uint8_t c23_2 = c23_1 << 1;
uint8_t c23_3 = c23_1 ^ c23_2;
uint8_t c45_1 = galois_x4_1((uint8_t) (state >> 40) & 0xFF);
uint8_t c45_2 = c45_1 << 1;
uint8_t c45_3 = c45_1 ^ c45_2;
uint8_t c67_1 = galois_x4_1((uint8_t) (state >> 32) & 0xFF);
uint8_t c67_2 = c67_1 << 1;
uint8_t c67_3 = c67_1 ^ c67_2;
uint8_t c89_1 = galois_x4_1((uint8_t) (state >> 24) & 0xFF);
uint8_t c89_2 = c89_1 << 1;
uint8_t c89_3 = c89_1 ^ c89_2;
uint8_t cAB_1 = galois_x4_1((uint8_t) (state >> 16) & 0xFF);
uint8_t cAB_2 = cAB_1 << 1;
uint8_t cAB_3 = cAB_1 ^ cAB_2;
uint8_t cCD_1 = galois_x4_1((uint8_t) (state >> 8) & 0xFF);
uint8_t cCD_2 = cCD_1 << 1;
uint8_t cCD_3 = cCD_1 ^ cCD_2;
uint8_t cEF_1 = galois_x4_1((uint8_t) state & 0xFF);
uint8_t cEF_2 = cEF_1 << 1;
uint8_t cEF_3 = cEF_1 ^ cEF_2;
printf("c01_1: %"PRIX64 "\n",c01_1);
printf("c01_2: %"PRIX64 "\n",c01_2);
printf("c01_3: %"PRIX64 "\n",c01_3);
printf("\n");
printf("c23_1: %"PRIX64 "\n",c23_1);
printf("c23_2: %"PRIX64 "\n",c23_2);
printf("c23_3: %"PRIX64 "\n",c23_3);
printf("\n");
printf("c45_1: %"PRIX64 "\n",c45_1);
printf("c45_2: %"PRIX64 "\n",c45_2);
printf("c45_3: %"PRIX64 "\n",c45_3);
printf("\n");
printf("c67_1: %"PRIX64 "\n",c67_1);
printf("c67_2: %"PRIX64 "\n",c67_2);
printf("c67_3: %"PRIX64 "\n",c67_3);
printf("\n");
printf("c89_1: %"PRIX64 "\n",c89_1);
printf("c89_2: %"PRIX64 "\n",c89_2);
printf("c89_3: %"PRIX64 "\n",c89_3);
printf("\n");
printf("cAB_1: %"PRIX64 "\n",cAB_1);
printf("cAB_2: %"PRIX64 "\n",cAB_2);
printf("cAB_3: %"PRIX64 "\n",cAB_3);
printf("\n");
printf("cCD_1: %"PRIX64 "\n",cCD_1);
printf("cCD_2: %"PRIX64 "\n",cCD_2);
printf("cCD_3: %"PRIX64 "\n",cCD_3);
printf("\n");
printf("cEF_1: %"PRIX64 "\n",cEF_1);
printf("cEF_2: %"PRIX64 "\n",cEF_2);
printf("cEF_3: %"PRIX64 "\n",cEF_3);
printf("\n");
uint8_t s01 = galois_x4_1((uint8_t) c01_2 ^ c23_3 ^ c45_1 ^ c67_1);
uint8_t s23 = galois_x4_1((uint8_t) c01_1 ^ c23_2 ^ c45_3 ^ c67_1);
uint8_t s45 = galois_x4_1((uint8_t) c01_1 ^ c23_1 ^ c45_2 ^ c67_3);
uint8_t s67 = galois_x4_1((uint8_t) c01_3 ^ c23_1 ^ c45_1 ^ c67_2);
uint8_t s89 = galois_x4_1((uint8_t) c89_2 ^ cAB_3 ^ cCD_1 ^ cEF_1);
uint8_t sAB = galois_x4_1((uint8_t) c89_1 ^ cAB_2 ^ cCD_3 ^ cEF_1);
uint8_t sCD = galois_x4_1((uint8_t) c89_1 ^ cAB_1 ^ cCD_2 ^ cEF_3);
uint8_t sEF = galois_x4_1((uint8_t) c89_3 ^ cAB_1 ^ cCD_1 ^ cEF_2);
printf(" s01: %"PRIX64 "\n", s01);
printf(" s23: %"PRIX64 "\n", s23);
printf(" s45: %"PRIX64 "\n", s45);
printf(" s67: %"PRIX64 "\n", s67);
printf(" s89: %"PRIX64 "\n", s89);
printf(" sAB: %"PRIX64 "\n", sAB);
printf(" sCD: %"PRIX64 "\n", sCD);
printf(" sEF: %"PRIX64 "\n", sEF);
return (((uint64_t) s01) << 56) ^ (((uint64_t) s23) << 48) ^ (((uint64_t) s45) << 40) ^ (((uint64_t) s67) << 32) ^ (((uint64_t) s89) << 24) ^ (((uint64_t) sAB) << 16) ^ (((uint64_t) sCD) << 8) ^ (uint64_t) sEF;
}
uint64_t keySchedule(uint64_t sk, uint8_t i) {
uint8_t r0 = ((uint8_t) (sk >> 56) & 0xFF);
uint8_t r1 = ((uint8_t) (sk >> 48) & 0xFF);
uint8_t r2 = ((uint8_t) (sk >> 40) & 0xFF);
uint8_t r3 = ((uint8_t) (sk >> 32) & 0xFF);
uint8_t r4 = ((uint8_t) (sk >> 24) & 0xFF);
uint8_t r5 = ((uint8_t) (sk >> 16) & 0xFF);
uint8_t r6 = ((uint8_t) (sk >> 8) & 0xFF);
uint8_t r7 = ((uint8_t) sk & 0xFF);
// <implicit swap> now the order is 1230 5674
r1 ^= r5;
r2 ^= r6;
r3 ^= r7;
r0 ^= r4;
return (((uint64_t) r5) << 56) ^ (((uint64_t) r6) << 48) ^ (((uint64_t) (r7 ^ i)) << 40) ^ (((uint64_t) r4) << 32)
^ (((uint64_t) r1) << 24)
^ (((uint64_t) SBOX[(r2 >> 4) & 0xF]) << 20) ^ (((uint64_t) SBOX[r2 & 0xF]) << 16)
^ (((uint64_t) SBOX[(r3 >> 4) & 0xF]) << 12) ^ (((uint64_t) SBOX[r3 & 0xF]) << 8)
^ (uint64_t) r0;
}
uint64_t KLEIN(uint64_t key, uint64_t plaintext) {
uint64_t sk = key;
uint64_t state = plaintext;
uint8_t i;
for (i = 1; i <= Nr ; i++) {
state = addRoundKey(state, sk);
printf("na addround : %" PRIX64 "\n", state);
state = subNibbles(state);
printf("na subnibbles : %" PRIX64 "\n", state);
state = rotateNibbles(state);
printf("na rotbnibbles: %" PRIX64 "\n", state);
state = mixNibbles(state);
printf("na mixbnibbles: %" PRIX64 "\n", state);
sk = keySchedule(sk, i);
printf("roundkey : %" PRIX64 "\n", sk);
}
state = addRoundKey(state, sk);
return state;
}
int main() {
//printf("Nibbleding: %" PRIX64 "\n", mixNibbles(0x82247502273DCC5F));
//printf("Subnibbles: %" PRIX64 "\n", subNibbles(0x123456789ABCDEF));
printf("Key: %" PRIX64 "\n", KEY);
printf("Ciphertext: %" PRIX64 "\n", KLEIN(KEY, PLAINTEXT));
printf("Plaintext: %" PRIX64 "\n", PLAINTEXT);
printf("KEY: %" PRIX64 "\n", KEY);
return 0;
}
|
the_stack_data/93112.c | /*
* Copyright (c) 2012-2013 Vincent Hanquez <[email protected]>
*
* All rights reserved.
*
* Redistribution and use in source and binary forms, with or without
* modification, are permitted provided that the following conditions
* are met:
* 1. Redistributions of source code must retain the above copyright
* notice, this list of conditions and the following disclaimer.
* 2. Redistributions in binary form must reproduce the above copyright
* notice, this list of conditions and the following disclaimer in the
* documentation and/or other materials provided with the distribution.
* 3. Neither the name of the author nor the names of his contributors
* may be used to endorse or promote products derived from this software
* without specific prior written permission.
*
* THIS SOFTWARE IS PROVIDED BY THE REGENTS AND CONTRIBUTORS ``AS IS'' AND
* ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
* IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE
* ARE DISCLAIMED. IN NO EVENT SHALL THE AUTHORS OR CONTRIBUTORS BE LIABLE
* FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL
* DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS
* OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
* HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT
* LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY
* OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF
* SUCH DAMAGE.
*/
#ifdef WITH_AESNI
#include <wmmintrin.h>
#include <tmmintrin.h>
#include <string.h>
#include <cryptonite_aes.h>
#include <cryptonite_cpu.h>
#include <aes/gf.h>
#include <aes/x86ni.h>
#include <aes/block128.h>
#ifdef ARCH_X86
#define ALIGN_UP(addr, size) (((addr) + ((size) - 1)) & (~((size) - 1)))
#define ALIGNMENT(n) __attribute__((aligned(n)))
/* old GCC version doesn't cope with the shuffle parameters, that can take 2 values (0xff and 0xaa)
* in our case, passed as argument despite being a immediate 8 bits constant anyway.
* un-factorise aes_128_key_expansion into 2 version that have the shuffle parameter explicitly set */
TARGET_AESNI
static __m128i aes_128_key_expansion_ff(__m128i key, __m128i keygened)
{
keygened = _mm_shuffle_epi32(keygened, 0xff);
key = _mm_xor_si128(key, _mm_slli_si128(key, 4));
key = _mm_xor_si128(key, _mm_slli_si128(key, 4));
key = _mm_xor_si128(key, _mm_slli_si128(key, 4));
return _mm_xor_si128(key, keygened);
}
TARGET_AESNI
static __m128i aes_128_key_expansion_aa(__m128i key, __m128i keygened)
{
keygened = _mm_shuffle_epi32(keygened, 0xaa);
key = _mm_xor_si128(key, _mm_slli_si128(key, 4));
key = _mm_xor_si128(key, _mm_slli_si128(key, 4));
key = _mm_xor_si128(key, _mm_slli_si128(key, 4));
return _mm_xor_si128(key, keygened);
}
TARGET_AESNI
void cryptonite_aesni_init(aes_key *key, uint8_t *ikey, uint8_t size)
{
__m128i k[28];
uint64_t *out = (uint64_t *) key->data;
int i;
switch (size) {
case 16:
k[0] = _mm_loadu_si128((const __m128i*) ikey);
#define AES_128_key_exp(K, RCON) aes_128_key_expansion_ff(K, _mm_aeskeygenassist_si128(K, RCON))
k[1] = AES_128_key_exp(k[0], 0x01);
k[2] = AES_128_key_exp(k[1], 0x02);
k[3] = AES_128_key_exp(k[2], 0x04);
k[4] = AES_128_key_exp(k[3], 0x08);
k[5] = AES_128_key_exp(k[4], 0x10);
k[6] = AES_128_key_exp(k[5], 0x20);
k[7] = AES_128_key_exp(k[6], 0x40);
k[8] = AES_128_key_exp(k[7], 0x80);
k[9] = AES_128_key_exp(k[8], 0x1B);
k[10] = AES_128_key_exp(k[9], 0x36);
/* generate decryption keys in reverse order.
* k[10] is shared by last encryption and first decryption rounds
* k[20] is shared by first encryption round (and is the original user key) */
k[11] = _mm_aesimc_si128(k[9]);
k[12] = _mm_aesimc_si128(k[8]);
k[13] = _mm_aesimc_si128(k[7]);
k[14] = _mm_aesimc_si128(k[6]);
k[15] = _mm_aesimc_si128(k[5]);
k[16] = _mm_aesimc_si128(k[4]);
k[17] = _mm_aesimc_si128(k[3]);
k[18] = _mm_aesimc_si128(k[2]);
k[19] = _mm_aesimc_si128(k[1]);
for (i = 0; i < 20; i++)
_mm_storeu_si128(((__m128i *) out) + i, k[i]);
break;
case 32:
#define AES_256_key_exp_1(K1, K2, RCON) aes_128_key_expansion_ff(K1, _mm_aeskeygenassist_si128(K2, RCON))
#define AES_256_key_exp_2(K1, K2) aes_128_key_expansion_aa(K1, _mm_aeskeygenassist_si128(K2, 0x00))
k[0] = _mm_loadu_si128((const __m128i*) ikey);
k[1] = _mm_loadu_si128((const __m128i*) (ikey+16));
k[2] = AES_256_key_exp_1(k[0], k[1], 0x01);
k[3] = AES_256_key_exp_2(k[1], k[2]);
k[4] = AES_256_key_exp_1(k[2], k[3], 0x02);
k[5] = AES_256_key_exp_2(k[3], k[4]);
k[6] = AES_256_key_exp_1(k[4], k[5], 0x04);
k[7] = AES_256_key_exp_2(k[5], k[6]);
k[8] = AES_256_key_exp_1(k[6], k[7], 0x08);
k[9] = AES_256_key_exp_2(k[7], k[8]);
k[10] = AES_256_key_exp_1(k[8], k[9], 0x10);
k[11] = AES_256_key_exp_2(k[9], k[10]);
k[12] = AES_256_key_exp_1(k[10], k[11], 0x20);
k[13] = AES_256_key_exp_2(k[11], k[12]);
k[14] = AES_256_key_exp_1(k[12], k[13], 0x40);
k[15] = _mm_aesimc_si128(k[13]);
k[16] = _mm_aesimc_si128(k[12]);
k[17] = _mm_aesimc_si128(k[11]);
k[18] = _mm_aesimc_si128(k[10]);
k[19] = _mm_aesimc_si128(k[9]);
k[20] = _mm_aesimc_si128(k[8]);
k[21] = _mm_aesimc_si128(k[7]);
k[22] = _mm_aesimc_si128(k[6]);
k[23] = _mm_aesimc_si128(k[5]);
k[24] = _mm_aesimc_si128(k[4]);
k[25] = _mm_aesimc_si128(k[3]);
k[26] = _mm_aesimc_si128(k[2]);
k[27] = _mm_aesimc_si128(k[1]);
for (i = 0; i < 28; i++)
_mm_storeu_si128(((__m128i *) out) + i, k[i]);
break;
default:
break;
}
}
/* TO OPTIMISE: use pcmulqdq... or some faster code.
* this is the lamest way of doing it, but i'm out of time.
* this is basically a copy of gf_mulx in gf.c */
TARGET_AESNI
static __m128i gfmulx(__m128i v)
{
uint64_t v_[2] ALIGNMENT(16);
const uint64_t gf_mask = 0x8000000000000000;
_mm_store_si128((__m128i *) v_, v);
uint64_t r = ((v_[1] & gf_mask) ? 0x87 : 0);
v_[1] = (v_[1] << 1) | (v_[0] & gf_mask ? 1 : 0);
v_[0] = (v_[0] << 1) ^ r;
v = _mm_load_si128((__m128i *) v_);
return v;
}
TARGET_AESNI
static __m128i gfmul_generic(__m128i tag, const table_4bit htable)
{
aes_block _t;
_mm_store_si128((__m128i *) &_t, tag);
cryptonite_aes_generic_gf_mul(&_t, htable);
tag = _mm_load_si128((__m128i *) &_t);
return tag;
}
#ifdef WITH_PCLMUL
__m128i (*gfmul_branch_ptr)(__m128i a, const table_4bit t) = gfmul_generic;
#define gfmul(a,t) ((*gfmul_branch_ptr)(a,t))
/* See Intel carry-less-multiplication-instruction-in-gcm-mode-paper.pdf
*
* Adapted from figure 5, with additional byte swapping so that interface
* is simimar to cryptonite_aes_generic_gf_mul.
*/
TARGET_AESNI_PCLMUL
static __m128i gfmul_pclmuldq(__m128i a, const table_4bit htable)
{
__m128i b, tmp2, tmp3, tmp4, tmp5, tmp6, tmp7, tmp8, tmp9;
__m128i bswap_mask = _mm_set_epi8(0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15);
a = _mm_shuffle_epi8(a, bswap_mask);
b = _mm_loadu_si128((__m128i *) htable);
tmp3 = _mm_clmulepi64_si128(a, b, 0x00);
tmp4 = _mm_clmulepi64_si128(a, b, 0x10);
tmp5 = _mm_clmulepi64_si128(a, b, 0x01);
tmp6 = _mm_clmulepi64_si128(a, b, 0x11);
tmp4 = _mm_xor_si128(tmp4, tmp5);
tmp5 = _mm_slli_si128(tmp4, 8);
tmp4 = _mm_srli_si128(tmp4, 8);
tmp3 = _mm_xor_si128(tmp3, tmp5);
tmp6 = _mm_xor_si128(tmp6, tmp4);
tmp7 = _mm_srli_epi32(tmp3, 31);
tmp8 = _mm_srli_epi32(tmp6, 31);
tmp3 = _mm_slli_epi32(tmp3, 1);
tmp6 = _mm_slli_epi32(tmp6, 1);
tmp9 = _mm_srli_si128(tmp7, 12);
tmp8 = _mm_slli_si128(tmp8, 4);
tmp7 = _mm_slli_si128(tmp7, 4);
tmp3 = _mm_or_si128(tmp3, tmp7);
tmp6 = _mm_or_si128(tmp6, tmp8);
tmp6 = _mm_or_si128(tmp6, tmp9);
tmp7 = _mm_slli_epi32(tmp3, 31);
tmp8 = _mm_slli_epi32(tmp3, 30);
tmp9 = _mm_slli_epi32(tmp3, 25);
tmp7 = _mm_xor_si128(tmp7, tmp8);
tmp7 = _mm_xor_si128(tmp7, tmp9);
tmp8 = _mm_srli_si128(tmp7, 4);
tmp7 = _mm_slli_si128(tmp7, 12);
tmp3 = _mm_xor_si128(tmp3, tmp7);
tmp2 = _mm_srli_epi32(tmp3, 1);
tmp4 = _mm_srli_epi32(tmp3, 2);
tmp5 = _mm_srli_epi32(tmp3, 7);
tmp2 = _mm_xor_si128(tmp2, tmp4);
tmp2 = _mm_xor_si128(tmp2, tmp5);
tmp2 = _mm_xor_si128(tmp2, tmp8);
tmp3 = _mm_xor_si128(tmp3, tmp2);
tmp6 = _mm_xor_si128(tmp6, tmp3);
return _mm_shuffle_epi8(tmp6, bswap_mask);
}
void cryptonite_aesni_hinit_pclmul(table_4bit htable, const block128 *h)
{
/* When pclmul is active we don't need to fill the table. Instead we just
* store H at index 0. It is written in reverse order, so function
* gfmul_pclmuldq will not byte-swap this value.
*/
htable->q[0] = bitfn_swap64(h->q[1]);
htable->q[1] = bitfn_swap64(h->q[0]);
}
TARGET_AESNI_PCLMUL
void cryptonite_aesni_gf_mul_pclmul(block128 *a, const table_4bit htable)
{
__m128i _a, _b;
_a = _mm_loadu_si128((__m128i *) a);
_b = gfmul_pclmuldq(_a, htable);
_mm_storeu_si128((__m128i *) a, _b);
}
void cryptonite_aesni_init_pclmul(void)
{
gfmul_branch_ptr = gfmul_pclmuldq;
}
#else
#define gfmul(a,t) (gfmul_generic(a,t))
#endif
TARGET_AESNI
static inline __m128i ghash_add(__m128i tag, const table_4bit htable, __m128i m)
{
tag = _mm_xor_si128(tag, m);
return gfmul(tag, htable);
}
#define PRELOAD_ENC_KEYS128(k) \
__m128i K0 = _mm_loadu_si128(((__m128i *) k)+0); \
__m128i K1 = _mm_loadu_si128(((__m128i *) k)+1); \
__m128i K2 = _mm_loadu_si128(((__m128i *) k)+2); \
__m128i K3 = _mm_loadu_si128(((__m128i *) k)+3); \
__m128i K4 = _mm_loadu_si128(((__m128i *) k)+4); \
__m128i K5 = _mm_loadu_si128(((__m128i *) k)+5); \
__m128i K6 = _mm_loadu_si128(((__m128i *) k)+6); \
__m128i K7 = _mm_loadu_si128(((__m128i *) k)+7); \
__m128i K8 = _mm_loadu_si128(((__m128i *) k)+8); \
__m128i K9 = _mm_loadu_si128(((__m128i *) k)+9); \
__m128i K10 = _mm_loadu_si128(((__m128i *) k)+10);
#define PRELOAD_ENC_KEYS256(k) \
PRELOAD_ENC_KEYS128(k) \
__m128i K11 = _mm_loadu_si128(((__m128i *) k)+11); \
__m128i K12 = _mm_loadu_si128(((__m128i *) k)+12); \
__m128i K13 = _mm_loadu_si128(((__m128i *) k)+13); \
__m128i K14 = _mm_loadu_si128(((__m128i *) k)+14);
#define DO_ENC_BLOCK128(m) \
m = _mm_xor_si128(m, K0); \
m = _mm_aesenc_si128(m, K1); \
m = _mm_aesenc_si128(m, K2); \
m = _mm_aesenc_si128(m, K3); \
m = _mm_aesenc_si128(m, K4); \
m = _mm_aesenc_si128(m, K5); \
m = _mm_aesenc_si128(m, K6); \
m = _mm_aesenc_si128(m, K7); \
m = _mm_aesenc_si128(m, K8); \
m = _mm_aesenc_si128(m, K9); \
m = _mm_aesenclast_si128(m, K10);
#define DO_ENC_BLOCK256(m) \
m = _mm_xor_si128(m, K0); \
m = _mm_aesenc_si128(m, K1); \
m = _mm_aesenc_si128(m, K2); \
m = _mm_aesenc_si128(m, K3); \
m = _mm_aesenc_si128(m, K4); \
m = _mm_aesenc_si128(m, K5); \
m = _mm_aesenc_si128(m, K6); \
m = _mm_aesenc_si128(m, K7); \
m = _mm_aesenc_si128(m, K8); \
m = _mm_aesenc_si128(m, K9); \
m = _mm_aesenc_si128(m, K10); \
m = _mm_aesenc_si128(m, K11); \
m = _mm_aesenc_si128(m, K12); \
m = _mm_aesenc_si128(m, K13); \
m = _mm_aesenclast_si128(m, K14);
/* load K0 at K9 from index 'at' */
#define PRELOAD_DEC_KEYS_AT(k, at) \
__m128i K0 = _mm_loadu_si128(((__m128i *) k)+at+0); \
__m128i K1 = _mm_loadu_si128(((__m128i *) k)+at+1); \
__m128i K2 = _mm_loadu_si128(((__m128i *) k)+at+2); \
__m128i K3 = _mm_loadu_si128(((__m128i *) k)+at+3); \
__m128i K4 = _mm_loadu_si128(((__m128i *) k)+at+4); \
__m128i K5 = _mm_loadu_si128(((__m128i *) k)+at+5); \
__m128i K6 = _mm_loadu_si128(((__m128i *) k)+at+6); \
__m128i K7 = _mm_loadu_si128(((__m128i *) k)+at+7); \
__m128i K8 = _mm_loadu_si128(((__m128i *) k)+at+8); \
__m128i K9 = _mm_loadu_si128(((__m128i *) k)+at+9); \
#define PRELOAD_DEC_KEYS128(k) \
PRELOAD_DEC_KEYS_AT(k, 10) \
__m128i K10 = _mm_loadu_si128(((__m128i *) k)+0);
#define PRELOAD_DEC_KEYS256(k) \
PRELOAD_DEC_KEYS_AT(k, 14) \
__m128i K10 = _mm_loadu_si128(((__m128i *) k)+14+10); \
__m128i K11 = _mm_loadu_si128(((__m128i *) k)+14+11); \
__m128i K12 = _mm_loadu_si128(((__m128i *) k)+14+12); \
__m128i K13 = _mm_loadu_si128(((__m128i *) k)+14+13); \
__m128i K14 = _mm_loadu_si128(((__m128i *) k)+0);
#define DO_DEC_BLOCK128(m) \
m = _mm_xor_si128(m, K0); \
m = _mm_aesdec_si128(m, K1); \
m = _mm_aesdec_si128(m, K2); \
m = _mm_aesdec_si128(m, K3); \
m = _mm_aesdec_si128(m, K4); \
m = _mm_aesdec_si128(m, K5); \
m = _mm_aesdec_si128(m, K6); \
m = _mm_aesdec_si128(m, K7); \
m = _mm_aesdec_si128(m, K8); \
m = _mm_aesdec_si128(m, K9); \
m = _mm_aesdeclast_si128(m, K10);
#define DO_DEC_BLOCK256(m) \
m = _mm_xor_si128(m, K0); \
m = _mm_aesdec_si128(m, K1); \
m = _mm_aesdec_si128(m, K2); \
m = _mm_aesdec_si128(m, K3); \
m = _mm_aesdec_si128(m, K4); \
m = _mm_aesdec_si128(m, K5); \
m = _mm_aesdec_si128(m, K6); \
m = _mm_aesdec_si128(m, K7); \
m = _mm_aesdec_si128(m, K8); \
m = _mm_aesdec_si128(m, K9); \
m = _mm_aesdec_si128(m, K10); \
m = _mm_aesdec_si128(m, K11); \
m = _mm_aesdec_si128(m, K12); \
m = _mm_aesdec_si128(m, K13); \
m = _mm_aesdeclast_si128(m, K14);
#define SIZE 128
#define SIZED(m) m##128
#define PRELOAD_ENC PRELOAD_ENC_KEYS128
#define DO_ENC_BLOCK DO_ENC_BLOCK128
#define PRELOAD_DEC PRELOAD_DEC_KEYS128
#define DO_DEC_BLOCK DO_DEC_BLOCK128
#include <aes/x86ni_impl.c>
#undef SIZE
#undef SIZED
#undef PRELOAD_ENC
#undef PRELOAD_DEC
#undef DO_ENC_BLOCK
#undef DO_DEC_BLOCK
#define SIZED(m) m##256
#define SIZE 256
#define PRELOAD_ENC PRELOAD_ENC_KEYS256
#define DO_ENC_BLOCK DO_ENC_BLOCK256
#define PRELOAD_DEC PRELOAD_DEC_KEYS256
#define DO_DEC_BLOCK DO_DEC_BLOCK256
#include <aes/x86ni_impl.c>
#undef SIZE
#undef SIZED
#undef PRELOAD_ENC
#undef PRELOAD_DEC
#undef DO_ENC_BLOCK
#undef DO_DEC_BLOCK
#endif
#endif
|
the_stack_data/156394318.c | #include <stdio.h>
#include <stdlib.h>
#include <sys/wait.h>
#include <unistd.h>
int main(int argc, char *argv[]) {
printf("hello world (pid:%d)\n", (int)getpid());
int rc = fork();
if (rc < 0) {
// fork failed
fprintf(stderr, "fork failed\n");
exit(1);
}
else if (rc == 0) {
printf("hello, I am child (pid:%d)\n", (int)getpid());
}
else {
int rc_wait = wait(NULL);
printf("hello, I am parent of %d (rc_wait:%d) (pid:%d)\n", rc, rc_wait,
(int)getpid());
}
return 0;
}
|
the_stack_data/218892640.c | // RUN: test.sh -e -t %t %s silly
//
// TEST: argv-001
//
// Description:
// Test that array bounds checking works on argv strings
//
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
int
main (int argc, char ** argv) {
int index = 0;
for (index = 0; index < strlen (argv[1]) + 2; ++index) {
printf ("%c", argv[1][index]);
}
return 0;
}
|
the_stack_data/73454.c | /* This testcase is part of GDB, the GNU debugger.
Copyright 2010-2014 Free Software Foundation, Inc.
This program is free software; you can redistribute it and/or modify
it under the terms of the GNU General Public License as published by
the Free Software Foundation; either version 3 of the License, or
(at your option) any later version.
This program is distributed in the hope that it will be useful,
but WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
GNU General Public License for more details.
You should have received a copy of the GNU General Public License
along with this program. If not, see <http://www.gnu.org/licenses/>. */
#include <stdio.h>
#include <unistd.h>
#include <assert.h>
static void pie_execl_marker (void);
int
main (int argc, char **argv)
{
setbuf (stdout, NULL);
#if BIN == 1
if (argc == 2)
{
printf ("pie-execl: re-exec: %s\n", argv[1]);
execl (argv[1], argv[1], NULL);
assert (0);
}
#endif
pie_execl_marker ();
return 0;
}
/* pie_execl_marker must be on a different address than in `pie-execl2.c'. */
volatile int v;
static void
pie_execl_marker (void)
{
v = 1;
}
|
the_stack_data/54312.c |
/*
* in_cksum --
* Checksum routine for Internet Protocol family headers (C Version)
*
* borrowed from the ping program from the Linux NetKit.
* This is a standard C version of the
* IP header checksum calculation algorithm.
*/
#include <sys/types.h>
int in_cksum(u_short * addr, int len)
{
register int nleft = len;
register u_short *w = addr;
register int sum = 0;
u_short answer = 0;
/*
* Our algorithm is simple, using a 32 bit accumulator (sum), we add
* sequential 16 bit words to it, and at the end, fold back all the
* carry bits from the top 16 bits into the lower 16 bits.
*/
while (nleft > 1) {
sum += *w++;
nleft -= 2;
}
/* mop up an odd byte, if necessary */
if (nleft == 1) {
*(u_char *) (&answer) = *(u_char *) w;
sum += answer;
}
/* add back carry outs from top 16 bits to low 16 bits */
sum = (sum >> 16) + (sum & 0xffff); /* add hi 16 to low 16 */
sum += (sum >> 16); /* add carry */
answer = ~sum; /* truncate to 16 bits */
return (answer);
}
|
the_stack_data/28261924.c | //EXERCICIO 1
#include <stdio.h>
int main()
{
int vetor[10], maior = 0;
int cont, pos;
for (cont = 0; cont < 10; cont++)
{
printf("Digite o numero na pos %d: ", cont);
scanf("%d", &vetor[cont]);
}
for (cont = 0; cont < 10; cont++)
{
if (cont == 0)
{
maior = vetor[cont];
pos = cont;
}
else if (vetor[cont] > maior)
{
maior = vetor[cont];
pos = cont;
}
}
printf("Vetor:");
for (cont = 0; cont < 10; cont++)
{
printf(" %d -> ", vetor[cont]);
}
printf("FIM!");
printf("\nMaior numero: %d - Na Pos: %d", maior, pos);
return 0;
} |
the_stack_data/43889202.c | /*
** 2013-04-17
**
** The author disclaims copyright to this source code. In place of
** a legal notice, here is a blessing:
**
** May you do good and not evil.
** May you find forgiveness for yourself and forgive others.
** May you share freely, never taking more than you give.
**
******************************************************************************
**
** This SQLite extension implements functions for the exact display
** and input of IEEE754 Binary64 floating-point numbers.
**
** ieee754(X)
** ieee754(Y,Z)
**
** In the first form, the value X should be a floating-point number.
** The function will return a string of the form 'ieee754(Y,Z)' where
** Y and Z are integers such that X==Y*pow(2,Z).
**
** In the second form, Y and Z are integers which are the mantissa and
** base-2 exponent of a new floating point number. The function returns
** a floating-point value equal to Y*pow(2,Z).
**
** Examples:
**
** ieee754(2.0) -> 'ieee754(2,0)'
** ieee754(45.25) -> 'ieee754(181,-2)'
** ieee754(2, 0) -> 2.0
** ieee754(181, -2) -> 45.25
*/
#include "sqlite3ext.h"
SQLITE_EXTENSION_INIT1
#include <assert.h>
#include <string.h>
/*
** Implementation of the ieee754() function
*/
static void ieee754func(
sqlite3_context *context,
int argc,
sqlite3_value **argv
){
if( argc==1 ){
sqlite3_int64 m, a;
double r;
int e;
int isNeg;
char zResult[100];
assert( sizeof(m)==sizeof(r) );
if( sqlite3_value_type(argv[0])!=SQLITE_FLOAT ) return;
r = sqlite3_value_double(argv[0]);
if( r<0.0 ){
isNeg = 1;
r = -r;
}else{
isNeg = 0;
}
memcpy(&a,&r,sizeof(a));
if( a==0 ){
e = 0;
m = 0;
}else{
e = a>>52;
m = a & ((((sqlite3_int64)1)<<52)-1);
m |= ((sqlite3_int64)1)<<52;
while( e<1075 && m>0 && (m&1)==0 ){
m >>= 1;
e++;
}
if( isNeg ) m = -m;
}
sqlite3_snprintf(sizeof(zResult), zResult, "ieee754(%lld,%d)",
m, e-1075);
sqlite3_result_text(context, zResult, -1, SQLITE_TRANSIENT);
}else if( argc==2 ){
sqlite3_int64 m, e, a;
double r;
int isNeg = 0;
m = sqlite3_value_int64(argv[0]);
e = sqlite3_value_int64(argv[1]);
if( m<0 ){
isNeg = 1;
m = -m;
if( m<0 ) return;
}else if( m==0 && e>1000 && e<1000 ){
sqlite3_result_double(context, 0.0);
return;
}
while( (m>>32)&0xffe00000 ){
m >>= 1;
e++;
}
while( m!=0 && ((m>>32)&0xfff00000)==0 ){
m <<= 1;
e--;
}
e += 1075;
if( e<0 ) e = m = 0;
if( e>0x7ff ) e = 0x7ff;
a = m & ((((sqlite3_int64)1)<<52)-1);
a |= e<<52;
if( isNeg ) a |= ((sqlite3_uint64)1)<<63;
memcpy(&r, &a, sizeof(r));
sqlite3_result_double(context, r);
}
}
#ifdef _WIN32
__declspec(dllexport)
#endif
int sqlite3_ieee_init(
sqlite3 *db,
char **pzErrMsg,
const sqlite3_api_routines *pApi
){
int rc = SQLITE_OK;
SQLITE_EXTENSION_INIT2(pApi);
(void)pzErrMsg; /* Unused parameter */
rc = sqlite3_create_function(db, "ieee754", 1, SQLITE_UTF8, 0,
ieee754func, 0, 0);
if( rc==SQLITE_OK ){
rc = sqlite3_create_function(db, "ieee754", 2, SQLITE_UTF8, 0,
ieee754func, 0, 0);
}
return rc;
}
|
the_stack_data/1142909.c | #include <stdlib.h>
#include <stdio.h>
#include <ctype.h>
#include <unistd.h>
#ifndef __MINGW32__
#include <termios.h>
static struct termios term;
static void newtermio()
{
struct termios newterm;
tcgetattr(0, &term);
newterm=term;
newterm.c_lflag&=~(ECHO|ICANON);
newterm.c_cc[VMIN]=1;
newterm.c_cc[VTIME]=0;
tcsetattr(0, TCSANOW, &newterm);
}
static void restoretermio()
{
tcsetattr(0, TCSANOW, &term);
}
#endif
#ifdef __win__
#include <windows.h>
#endif
int main(int argc, char **argv)
{
int ch;
int endOfInput = 0;
#ifdef __win__
INPUT_RECORD inputRecord;
DWORD eventsRead;
HANDLE hwnd = GetStdHandle(STD_INPUT_HANDLE);
(void) SetConsoleMode(hwnd, ENABLE_ECHO_INPUT);
printf("Handle = %p\n", hwnd);
while (!endOfInput) {
fflush(stdout);
if (!ReadConsoleInput(hwnd, &inputRecord, 1, &eventsRead)) {
printf("ReadConsoleInput() failed!\n");
return 0;
}
if (inputRecord.EventType == KEY_EVENT && inputRecord.Event.KeyEvent.bKeyDown) {
if ((inputRecord.Event.KeyEvent.dwControlKeyState & ENHANCED_KEY) != 0)
printf("Enhanced: ");
ch = inputRecord.Event.KeyEvent.wVirtualKeyCode;
printf("%d %x '%c'\n", (int)ch, (int)ch, ch);
}
}
return 0;
#else
while ((ch = getchar()) != EOF)
printf("%d %x '%c'\n", (int)ch, (int)ch, ch);
#endif
}
|
the_stack_data/51699295.c |
#include <stdlib.h>
#include <math.h>
#if defined(_WIN32) || defined(__WIN32__)
#define EXPORTIT __declspec(dllexport)
#else
#define EXPORTIT
#endif
EXPORTIT double integral_fxixifxixi_12(double xi1, double xi2, int i, int j,
double x1t, double x1r, double x2t, double x2r,
double y1t, double y1r, double y2t, double y2r) {
switch(i) {
case 0:
switch(j) {
case 0:
return 0.75*x1t*y1t*(-pow(xi1, 3) + pow(xi2, 3));
case 1:
return -0.1875*x1t*y1r*(2.0*pow(xi1, 3) - pow(xi1, 2) - 2.0*pow(xi2, 3) + pow(xi2, 2));
case 2:
return 0.75*x1t*y2t*(pow(xi1, 3) - pow(xi2, 3));
case 3:
return -0.1875*x1t*y2r*(2.0*pow(xi1, 3) + pow(xi1, 2) - pow(xi2, 2)*(2.0*xi2 + 1.0));
case 4:
return -0.1875*x1t*(3.0*pow(xi1, 4) - 2.0*pow(xi1, 2) - 3.0*pow(xi2, 4) + 2.0*pow(xi2, 2));
case 5:
return -0.75*x1t*(pow(xi1, 5) - pow(xi1, 3) - pow(xi2, 5) + pow(xi2, 3));
case 6:
return 0.03125*x1t*(-35.0*pow(xi1, 6) + 45.0*pow(xi1, 4) - 9.0*pow(xi1, 2) + 35.0*pow(xi2, 6) - 45.0*pow(xi2, 4) + 9.0*pow(xi2, 2));
case 7:
return -0.1875*x1t*(9.0*pow(xi1, 7) - 14.0*pow(xi1, 5) + 5.0*pow(xi1, 3) - 9.0*pow(xi2, 7) + 14.0*pow(xi2, 5) - 5.0*pow(xi2, 3));
case 8:
return -0.01171875*x1t*(231.0*pow(xi1, 8) - 420.0*pow(xi1, 6) + 210.0*pow(xi1, 4) - 20.0*pow(xi1, 2) - 231.0*pow(xi2, 8) + 420.0*pow(xi2, 6) - 210.0*pow(xi2, 4) + 20.0*pow(xi2, 2));
case 9:
return 0.03125*x1t*(-143.0*pow(xi1, 9) + 297.0*pow(xi1, 7) - 189.0*pow(xi1, 5) + 35.0*pow(xi1, 3) + 143.0*pow(xi2, 9) - 297.0*pow(xi2, 7) + 189.0*pow(xi2, 5) - 35.0*pow(xi2, 3));
case 10:
return -0.005859375*x1t*(1287.0*pow(xi1, 10) - 3003.0*pow(xi1, 8) + 2310.0*pow(xi1, 6) - 630.0*pow(xi1, 4) + 35.0*pow(xi1, 2) + pow(xi2, 2)*(-1287.0*pow(xi2, 8) + 3003.0*pow(xi2, 6) - 2310.0*pow(xi2, 4) + 630.0*pow(xi2, 2) - 35.0));
case 11:
return -0.01171875*x1t*(1105.0*pow(xi1, 11) - 2860.0*pow(xi1, 9) + 2574.0*pow(xi1, 7) - 924.0*pow(xi1, 5) + 105.0*pow(xi1, 3) + pow(xi2, 3)*(-1105.0*pow(xi2, 8) + 2860.0*pow(xi2, 6) - 2574.0*pow(xi2, 4) + 924.0*pow(xi2, 2) - 105.0));
case 12:
return 0.00048828125*x1t*(-46189.0*pow(xi1, 12) + 131274.0*pow(xi1, 10) - 135135.0*pow(xi1, 8) + 60060.0*pow(xi1, 6) - 10395.0*pow(xi1, 4) + 378.0*pow(xi1, 2) + pow(xi2, 2)*(46189.0*pow(xi2, 10) - 131274.0*pow(xi2, 8) + 135135.0*pow(xi2, 6) - 60060.0*pow(xi2, 4) + 10395.0*pow(xi2, 2) - 378.0));
case 13:
return -0.005859375*x1t*(6783.0*pow(xi1, 13) - 20995.0*pow(xi1, 11) + 24310.0*pow(xi1, 9) - 12870.0*pow(xi1, 7) + 3003.0*pow(xi1, 5) - 231.0*pow(xi1, 3) + pow(xi2, 3)*(-6783.0*pow(xi2, 10) + 20995.0*pow(xi2, 8) - 24310.0*pow(xi2, 6) + 12870.0*pow(xi2, 4) - 3003.0*pow(xi2, 2) + 231.0));
case 14:
return -0.000732421875*x1t*(96577.0*pow(xi1, 14) - 323323.0*pow(xi1, 12) + 415701.0*pow(xi1, 10) - 255255.0*pow(xi1, 8) + 75075.0*pow(xi1, 6) - 9009.0*pow(xi1, 4) + 231.0*pow(xi1, 2) + pow(xi2, 2)*(-96577.0*pow(xi2, 12) + 323323.0*pow(xi2, 10) - 415701.0*pow(xi2, 8) + 255255.0*pow(xi2, 6) - 75075.0*pow(xi2, 4) + 9009.0*pow(xi2, 2) - 231.0));
case 15:
return 0.00048828125*x1t*(-260015.0*pow(xi1, 15) + 936054.0*pow(xi1, 13) - 1322685.0*pow(xi1, 11) + 923780.0*pow(xi1, 9) - 328185.0*pow(xi1, 7) + 54054.0*pow(xi1, 5) - 3003.0*pow(xi1, 3) + pow(xi2, 3)*(260015.0*pow(xi2, 12) - 936054.0*pow(xi2, 10) + 1322685.0*pow(xi2, 8) - 923780.0*pow(xi2, 6) + 328185.0*pow(xi2, 4) - 54054.0*pow(xi2, 2) + 3003.0));
case 16:
return -4.57763671875e-5*x1t*(5014575.0*pow(xi1, 16) - 19315400.0*pow(xi1, 14) + 29745716.0*pow(xi1, 12) - 23279256.0*pow(xi1, 10) + 9699690.0*pow(xi1, 8) - 2042040.0*pow(xi1, 6) + 180180.0*pow(xi1, 4) - 3432.0*pow(xi1, 2) + pow(xi2, 2)*(-5014575.0*pow(xi2, 14) + 19315400.0*pow(xi2, 12) - 29745716.0*pow(xi2, 10) + 23279256.0*pow(xi2, 8) - 9699690.0*pow(xi2, 6) + 2042040.0*pow(xi2, 4) - 180180.0*pow(xi2, 2) + 3432.0));
case 17:
return -0.000732421875*x1t*(570285.0*pow(xi1, 17) - 2340135.0*pow(xi1, 15) + 3900225.0*pow(xi1, 13) - 3380195.0*pow(xi1, 11) + 1616615.0*pow(xi1, 9) - 415701.0*pow(xi1, 7) + 51051.0*pow(xi1, 5) - 2145.0*pow(xi1, 3) + pow(xi2, 3)*(-570285.0*pow(xi2, 14) + 2340135.0*pow(xi2, 12) - 3900225.0*pow(xi2, 10) + 3380195.0*pow(xi2, 8) - 1616615.0*pow(xi2, 6) + 415701.0*pow(xi2, 4) - 51051.0*pow(xi2, 2) + 2145.0));
case 18:
return 7.62939453125e-6*x1t*(-100180065.0*pow(xi1, 18) + 436268025.0*pow(xi1, 16) - 782273700.0*pow(xi1, 14) + 743642900.0*pow(xi1, 12) - 401567166.0*pow(xi1, 10) + 122216094.0*pow(xi1, 8) - 19399380.0*pow(xi1, 6) + 1312740.0*pow(xi1, 4) - 19305.0*pow(xi1, 2) + pow(xi2, 2)*(100180065.0*pow(xi2, 16) - 436268025.0*pow(xi2, 14) + 782273700.0*pow(xi2, 12) - 743642900.0*pow(xi2, 10) + 401567166.0*pow(xi2, 8) - 122216094.0*pow(xi2, 6) + 19399380.0*pow(xi2, 4) - 1312740.0*pow(xi2, 2) + 19305.0));
case 19:
return -4.57763671875e-5*x1t*(30705345.0*pow(xi1, 19) - 141430680.0*pow(xi1, 17) + 271455660.0*pow(xi1, 15) - 280816200.0*pow(xi1, 13) + 169009750.0*pow(xi1, 11) - 59491432.0*pow(xi1, 9) + 11639628.0*pow(xi1, 7) - 1108536.0*pow(xi1, 5) + 36465.0*pow(xi1, 3) + pow(xi2, 3)*(-30705345.0*pow(xi2, 16) + 141430680.0*pow(xi2, 14) - 271455660.0*pow(xi2, 12) + 280816200.0*pow(xi2, 10) - 169009750.0*pow(xi2, 8) + 59491432.0*pow(xi2, 6) - 11639628.0*pow(xi2, 4) + 1108536.0*pow(xi2, 2) - 36465.0));
case 20:
return -5.7220458984375e-6*x1t*(453756765.0*pow(xi1, 20) - 2203961430.0*pow(xi1, 18) + 4508102925.0*pow(xi1, 16) - 5041319400.0*pow(xi1, 14) + 3346393050.0*pow(xi1, 12) - 1338557220.0*pow(xi1, 10) + 312330018.0*pow(xi1, 8) - 38798760.0*pow(xi1, 6) + 2078505.0*pow(xi1, 4) - 24310.0*pow(xi1, 2) + pow(xi2, 2)*(-453756765.0*pow(xi2, 18) + 2203961430.0*pow(xi2, 16) - 4508102925.0*pow(xi2, 14) + 5041319400.0*pow(xi2, 12) - 3346393050.0*pow(xi2, 10) + 1338557220.0*pow(xi2, 8) - 312330018.0*pow(xi2, 6) + 38798760.0*pow(xi2, 4) - 2078505.0*pow(xi2, 2) + 24310.0));
case 21:
return 7.62939453125e-6*x1t*(-631165425.0*pow(xi1, 21) + 3224061225.0*pow(xi1, 19) - 7000818660.0*pow(xi1, 17) + 8415125460.0*pow(xi1, 15) - 6107752350.0*pow(xi1, 13) + 2737957950.0*pow(xi1, 11) - 743642900.0*pow(xi1, 9) + 114733476.0*pow(xi1, 7) - 8729721.0*pow(xi1, 5) + 230945.0*pow(xi1, 3) + pow(xi2, 3)*(631165425.0*pow(xi2, 18) - 3224061225.0*pow(xi2, 16) + 7000818660.0*pow(xi2, 14) - 8415125460.0*pow(xi2, 12) + 6107752350.0*pow(xi2, 10) - 2737957950.0*pow(xi2, 8) + 743642900.0*pow(xi2, 6) - 114733476.0*pow(xi2, 4) + 8729721.0*pow(xi2, 2) - 230945.0));
case 22:
return -2.86102294921875e-6*x1t*(3132875655.0*pow(xi1, 22) - 16789000305.0*pow(xi1, 20) + 38569325025.0*pow(xi1, 18) - 49589132175.0*pow(xi1, 16) + 39070225350.0*pow(xi1, 14) - 19409079690.0*pow(xi1, 12) + 6023507490.0*pow(xi1, 10) - 1115464350.0*pow(xi1, 8) + 111546435.0*pow(xi1, 6) - 4849845.0*pow(xi1, 4) + 46189.0*pow(xi1, 2) + pow(xi2, 2)*(-3132875655.0*pow(xi2, 20) + 16789000305.0*pow(xi2, 18) - 38569325025.0*pow(xi2, 16) + 49589132175.0*pow(xi2, 14) - 39070225350.0*pow(xi2, 12) + 19409079690.0*pow(xi2, 10) - 6023507490.0*pow(xi2, 8) + 1115464350.0*pow(xi2, 6) - 111546435.0*pow(xi2, 4) + 4849845.0*pow(xi2, 2) - 46189.0));
case 23:
return -5.7220458984375e-6*x1t*(2925314535.0*pow(xi1, 23) - 16410301050.0*pow(xi1, 21) + 39763421775.0*pow(xi1, 19) - 54450811800.0*pow(xi1, 17) + 46283190030.0*pow(xi1, 15) - 25245376380.0*pow(xi1, 13) + 8822308950.0*pow(xi1, 11) - 1912224600.0*pow(xi1, 9) + 239028075.0*pow(xi1, 7) - 14872858.0*pow(xi1, 5) + 323323.0*pow(xi1, 3) + pow(xi2, 3)*(-2925314535.0*pow(xi2, 20) + 16410301050.0*pow(xi2, 18) - 39763421775.0*pow(xi2, 16) + 54450811800.0*pow(xi2, 14) - 46283190030.0*pow(xi2, 12) + 25245376380.0*pow(xi2, 10) - 8822308950.0*pow(xi2, 8) + 1912224600.0*pow(xi2, 6) - 239028075.0*pow(xi2, 4) + 14872858.0*pow(xi2, 2) - 323323.0));
case 24:
return 1.19209289550781e-7*x1t*(-263012370465.0*pow(xi1, 24) + 1541374822260.0*pow(xi1, 22) - 3928626071370.0*pow(xi1, 20) + 5708260103700.0*pow(xi1, 18) - 5206858878375.0*pow(xi1, 16) + 3094361847720.0*pow(xi1, 14) - 1203362940780.0*pow(xi1, 12) + 299454372360.0*pow(xi1, 10) - 45176306175.0*pow(xi1, 8) + 3718214500.0*pow(xi1, 6) - 133855722.0*pow(xi1, 4) + 1058148.0*pow(xi1, 2) + pow(xi2, 2)*(263012370465.0*pow(xi2, 22) - 1541374822260.0*pow(xi2, 20) + 3928626071370.0*pow(xi2, 18) - 5708260103700.0*pow(xi2, 16) + 5206858878375.0*pow(xi2, 14) - 3094361847720.0*pow(xi2, 12) + 1203362940780.0*pow(xi2, 10) - 299454372360.0*pow(xi2, 8) + 45176306175.0*pow(xi2, 6) - 3718214500.0*pow(xi2, 4) + 133855722.0*pow(xi2, 2) - 1058148.0));
case 25:
return -2.86102294921875e-6*x1t*(20583576819.0*pow(xi1, 25) - 125788525005.0*pow(xi1, 23) + 336411171525.0*pow(xi1, 21) - 516924483075.0*pow(xi1, 19) + 503670009150.0*pow(xi1, 17) - 323982330210.0*pow(xi1, 15) + 138849570090.0*pow(xi1, 13) - 39070225350.0*pow(xi1, 11) + 6931814175.0*pow(xi1, 9) - 717084225.0*pow(xi1, 7) + 37182145.0*pow(xi1, 5) - 676039.0*pow(xi1, 3) + pow(xi2, 3)*(-20583576819.0*pow(xi2, 22) + 125788525005.0*pow(xi2, 20) - 336411171525.0*pow(xi2, 18) + 516924483075.0*pow(xi2, 16) - 503670009150.0*pow(xi2, 14) + 323982330210.0*pow(xi2, 12) - 138849570090.0*pow(xi2, 10) + 39070225350.0*pow(xi2, 8) - 6931814175.0*pow(xi2, 6) + 717084225.0*pow(xi2, 4) - 37182145.0*pow(xi2, 2) + 676039.0));
case 26:
return -1.78813934326172e-7*x1t*(620146224675.0*pow(xi1, 26) - 3945185556975.0*pow(xi1, 24) + 11046519559530.0*pow(xi1, 22) - 17897074325130.0*pow(xi1, 20) + 18551845337025.0*pow(xi1, 18) - 12843585233325.0*pow(xi1, 16) + 6016814703900.0*pow(xi1, 14) - 1890998906940.0*pow(xi1, 12) + 386795230965.0*pow(xi1, 10) - 48522699225.0*pow(xi1, 8) + 3346393050.0*pow(xi1, 6) - 101405850.0*pow(xi1, 4) + 676039.0*pow(xi1, 2) + pow(xi2, 2)*(-620146224675.0*pow(xi2, 24) + 3945185556975.0*pow(xi2, 22) - 11046519559530.0*pow(xi2, 20) + 17897074325130.0*pow(xi2, 18) - 18551845337025.0*pow(xi2, 16) + 12843585233325.0*pow(xi2, 14) - 6016814703900.0*pow(xi2, 12) + 1890998906940.0*pow(xi2, 10) - 386795230965.0*pow(xi2, 8) + 48522699225.0*pow(xi2, 6) - 3346393050.0*pow(xi2, 4) + 101405850.0*pow(xi2, 2) - 676039.0));
case 27:
return 1.19209289550781e-7*x1t*(-1755702867191.0*pow(xi1, 27) + 11609137325916.0*pow(xi1, 25) - 33962901751350.0*pow(xi1, 23) + 57862721502300.0*pow(xi1, 21) - 63581711418225.0*pow(xi1, 19) + 47143512856440.0*pow(xi1, 17) - 23974692435540.0*pow(xi1, 15) + 8330974205400.0*pow(xi1, 13) - 1933976154825.0*pow(xi1, 11) + 286514985900.0*pow(xi1, 9) - 24954531030.0*pow(xi1, 7) + 1095183180.0*pow(xi1, 5) - 16900975.0*pow(xi1, 3) + pow(xi2, 3)*(1755702867191.0*pow(xi2, 24) - 11609137325916.0*pow(xi2, 22) + 33962901751350.0*pow(xi2, 20) - 57862721502300.0*pow(xi2, 18) + 63581711418225.0*pow(xi2, 16) - 47143512856440.0*pow(xi2, 14) + 23974692435540.0*pow(xi2, 12) - 8330974205400.0*pow(xi2, 10) + 1933976154825.0*pow(xi2, 8) - 286514985900.0*pow(xi2, 6) + 24954531030.0*pow(xi2, 4) - 1095183180.0*pow(xi2, 2) + 16900975.0));
case 28:
return -4.4703483581543e-8*x1t*(8855688088359.0*pow(xi1, 28) - 60774330018150.0*pow(xi1, 26) + 185423721177825.0*pow(xi1, 24) - 331395586785900.0*pow(xi1, 22) + 384787097990295.0*pow(xi1, 20) - 304250263527210.0*pow(xi1, 18) + 166966608033225.0*pow(xi1, 16) - 63606326869800.0*pow(xi1, 14) + 16546240435725.0*pow(xi1, 12) - 2836498360410.0*pow(xi1, 10) + 300840735195.0*pow(xi1, 8) - 17644617900.0*pow(xi1, 6) + 456326325.0*pow(xi1, 4) - 2600150.0*pow(xi1, 2) + pow(xi2, 2)*(-8855688088359.0*pow(xi2, 26) + 60774330018150.0*pow(xi2, 24) - 185423721177825.0*pow(xi2, 22) + 331395586785900.0*pow(xi2, 20) - 384787097990295.0*pow(xi2, 18) + 304250263527210.0*pow(xi2, 16) - 166966608033225.0*pow(xi2, 14) + 63606326869800.0*pow(xi2, 12) - 16546240435725.0*pow(xi2, 10) + 2836498360410.0*pow(xi2, 8) - 300840735195.0*pow(xi2, 6) + 17644617900.0*pow(xi2, 4) - 456326325.0*pow(xi2, 2) + 2600150.0));
case 29:
return -1.78813934326172e-7*x1t*(4195990141483.0*pow(xi1, 29) - 29846948742247.0*pow(xi1, 27) + 94807954828314.0*pow(xi1, 25) - 177361820257050.0*pow(xi1, 23) + 216985205633625.0*pow(xi1, 21) - 182267572732245.0*pow(xi1, 19) + 107382445950780.0*pow(xi1, 17) - 44524428808860.0*pow(xi1, 15) + 12843585233325.0*pow(xi1, 13) - 2507006126625.0*pow(xi1, 11) + 315166484490.0*pow(xi1, 9) - 23442135210.0*pow(xi1, 7) + 882230895.0*pow(xi1, 5) - 11700675.0*pow(xi1, 3) + pow(xi2, 3)*(-4195990141483.0*pow(xi2, 26) + 29846948742247.0*pow(xi2, 24) - 94807954828314.0*pow(xi2, 22) + 177361820257050.0*pow(xi2, 20) - 216985205633625.0*pow(xi2, 18) + 182267572732245.0*pow(xi2, 16) - 107382445950780.0*pow(xi2, 14) + 44524428808860.0*pow(xi2, 12) - 12843585233325.0*pow(xi2, 10) + 2507006126625.0*pow(xi2, 8) - 315166484490.0*pow(xi2, 6) + 23442135210.0*pow(xi2, 4) - 882230895.0*pow(xi2, 2) + 11700675.0));
default:
return 0.;
}
case 1:
switch(j) {
case 0:
return -0.1875*x1r*y1t*(2.0*pow(xi1, 3) - pow(xi1, 2) - 2.0*pow(xi2, 3) + pow(xi2, 2));
case 1:
return 0.0625*x1r*y1r*(-3.0*pow(xi1, 3) + 3.0*pow(xi1, 2) - xi1 + 3.0*pow(xi2, 3) - 3.0*pow(xi2, 2) + xi2);
case 2:
return 0.1875*x1r*y2t*(2.0*pow(xi1, 3) - pow(xi1, 2) - 2.0*pow(xi2, 3) + pow(xi2, 2));
case 3:
return 0.0625*x1r*y2r*(-3.0*pow(xi1, 3) + xi1 + 3.0*pow(xi2, 3) - xi2);
case 4:
return 0.03125*x1r*(-9.0*pow(xi1, 4) + 4.0*pow(xi1, 3) + 6.0*pow(xi1, 2) - 4.0*xi1 + xi2*(9.0*pow(xi2, 3) - 4.0*pow(xi2, 2) - 6.0*xi2 + 4.0));
case 5:
return 0.03125*x1r*(-12.0*pow(xi1, 5) + 5.0*pow(xi1, 4) + 12.0*pow(xi1, 3) - 6.0*pow(xi1, 2) + pow(xi2, 2)*(12.0*pow(xi2, 3) - 5.0*pow(xi2, 2) - 12.0*xi2 + 6.0));
case 6:
return 0.015625*x1r*(-35.0*pow(xi1, 6) + 14.0*pow(xi1, 5) + 45.0*pow(xi1, 4) - 20.0*pow(xi1, 3) - 9.0*pow(xi1, 2) + 6.0*xi1 + xi2*(35.0*pow(xi2, 5) - 14.0*pow(xi2, 4) - 45.0*pow(xi2, 3) + 20.0*pow(xi2, 2) + 9.0*xi2 - 6.0));
case 7:
return 0.015625*x1r*(-54.0*pow(xi1, 7) + 21.0*pow(xi1, 6) + 84.0*pow(xi1, 5) - 35.0*pow(xi1, 4) - 30.0*pow(xi1, 3) + 15.0*pow(xi1, 2) + pow(xi2, 2)*(54.0*pow(xi2, 5) - 21.0*pow(xi2, 4) - 84.0*pow(xi2, 3) + 35.0*pow(xi2, 2) + 30.0*xi2 - 15.0));
case 8:
return 0.001953125*x1r*(-693.0*pow(xi1, 8) + 264.0*pow(xi1, 7) + 1260.0*pow(xi1, 6) - 504.0*pow(xi1, 5) - 630.0*pow(xi1, 4) + 280.0*pow(xi1, 3) + 60.0*pow(xi1, 2) - 40.0*xi1 + xi2*(693.0*pow(xi2, 7) - 264.0*pow(xi2, 6) - 1260.0*pow(xi2, 5) + 504.0*pow(xi2, 4) + 630.0*pow(xi2, 3) - 280.0*pow(xi2, 2) - 60.0*xi2 + 40.0));
case 9:
return 0.001953125*x1r*(-1144.0*pow(xi1, 9) + 429.0*pow(xi1, 8) + 2376.0*pow(xi1, 7) - 924.0*pow(xi1, 6) - 1512.0*pow(xi1, 5) + 630.0*pow(xi1, 4) + 280.0*pow(xi1, 3) - 140.0*pow(xi1, 2) + pow(xi2, 2)*(1144.0*pow(xi2, 7) - 429.0*pow(xi2, 6) - 2376.0*pow(xi2, 5) + 924.0*pow(xi2, 4) + 1512.0*pow(xi2, 3) - 630.0*pow(xi2, 2) - 280.0*xi2 + 140.0));
case 10:
return 0.0009765625*x1r*(-3861.0*pow(xi1, 10) + 1430.0*pow(xi1, 9) + 9009.0*pow(xi1, 8) - 3432.0*pow(xi1, 7) - 6930.0*pow(xi1, 6) + 2772.0*pow(xi1, 5) + 1890.0*pow(xi1, 4) - 840.0*pow(xi1, 3) - 105.0*pow(xi1, 2) + 70.0*xi1 + xi2*(3861.0*pow(xi2, 9) - 1430.0*pow(xi2, 8) - 9009.0*pow(xi2, 7) + 3432.0*pow(xi2, 6) + 6930.0*pow(xi2, 5) - 2772.0*pow(xi2, 4) - 1890.0*pow(xi2, 3) + 840.0*pow(xi2, 2) + 105.0*xi2 - 70.0));
case 11:
return 0.0009765625*x1r*(-6630.0*pow(xi1, 11) + 2431.0*pow(xi1, 10) + 17160.0*pow(xi1, 9) - 6435.0*pow(xi1, 8) - 15444.0*pow(xi1, 7) + 6006.0*pow(xi1, 6) + 5544.0*pow(xi1, 5) - 2310.0*pow(xi1, 4) - 630.0*pow(xi1, 3) + 315.0*pow(xi1, 2) + pow(xi2, 2)*(6630.0*pow(xi2, 9) - 2431.0*pow(xi2, 8) - 17160.0*pow(xi2, 7) + 6435.0*pow(xi2, 6) + 15444.0*pow(xi2, 5) - 6006.0*pow(xi2, 4) - 5544.0*pow(xi2, 3) + 2310.0*pow(xi2, 2) + 630.0*xi2 - 315.0));
case 12:
return 0.000244140625*x1r*(xi1*(xi1*(xi1*(xi1*(-13.0*xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(11.0*xi1 - 4.0) - 594.0) + 220.0) + 10395.0) - 3960.0) - 4620.0) + 1848.0) - 10395.0) + 4620.0) + 378.0) - 252.0) + xi2*(xi2*(xi2*(xi2*(13.0*xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(11.0*xi2 - 4.0) - 594.0) + 220.0) + 10395.0) - 3960.0) - 4620.0) + 1848.0) + 10395.0) - 4620.0) - 378.0) + 252.0));
case 13:
return 0.000244140625*x1r*(pow(xi1, 2)*(xi1*(xi1*(xi1*(xi1*(xi1*(-17.0*xi1*(xi1*(19.0*xi1*(xi1*(7.0*xi1*(36.0*xi1 - 13.0) - 780.0) + 286.0) + 17160.0) - 6435.0) + 154440.0) - 60060.0) - 36036.0) + 15015.0) + 2772.0) - 1386.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(7.0*xi2*(36.0*xi2 - 13.0) - 780.0) + 286.0) + 17160.0) - 6435.0) - 154440.0) + 60060.0) + 36036.0) - 15015.0) - 2772.0) + 1386.0));
case 14:
return 0.0001220703125*x1r*(xi1*(xi1*(xi1*(xi1*(xi1*(xi1*(-17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(39.0*xi1 - 14.0) - 3003.0) + 1092.0) + 3861.0) - 1430.0) - 45045.0) + 17160.0) - 225225.0) + 90090.0) + 27027.0) - 12012.0) - 693.0) + 462.0) + xi2*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(39.0*xi2 - 14.0) - 3003.0) + 1092.0) + 3861.0) - 1430.0) - 45045.0) + 17160.0) + 225225.0) - 90090.0) - 27027.0) + 12012.0) + 693.0) - 462.0));
case 15:
return 0.0001220703125*x1r*(pow(xi1, 2)*(xi1*(xi1*(xi1*(-17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(xi1*(5.0*xi1*(14.0*xi1 - 5.0) - 252.0) + 91.0) + 8190.0) - 3003.0) - 5720.0) + 2145.0) + 38610.0) - 15015.0) + 108108.0) - 45045.0) - 6006.0) + 3003.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(xi2*(5.0*xi2*(14.0*xi2 - 5.0) - 252.0) + 91.0) + 8190.0) - 3003.0) - 5720.0) + 2145.0) + 38610.0) - 15015.0) - 108108.0) + 45045.0) + 6006.0) - 3003.0));
case 16:
return 7.62939453125e-6*x1r*(-15043725.0*pow(xi1, 16) + 5348880.0*pow(xi1, 15) + 57946200.0*pow(xi1, 14) - 20801200.0*pow(xi1, 13) - 89237148.0*pow(xi1, 12) + 32449872.0*pow(xi1, 11) + 69837768.0*pow(xi1, 10) - 25865840.0*pow(xi1, 9) - 29099070.0*pow(xi1, 8) + 11085360.0*pow(xi1, 7) + 6126120.0*pow(xi1, 6) - 2450448.0*pow(xi1, 5) - 540540.0*pow(xi1, 4) + 240240.0*pow(xi1, 3) + 10296.0*pow(xi1, 2) - 6864.0*xi1 + xi2*(15043725.0*pow(xi2, 15) - 5348880.0*pow(xi2, 14) - 57946200.0*pow(xi2, 13) + 20801200.0*pow(xi2, 12) + 89237148.0*pow(xi2, 11) - 32449872.0*pow(xi2, 10) - 69837768.0*pow(xi2, 9) + 25865840.0*pow(xi2, 8) + 29099070.0*pow(xi2, 7) - 11085360.0*pow(xi2, 6) - 6126120.0*pow(xi2, 5) + 2450448.0*pow(xi2, 4) + 540540.0*pow(xi2, 3) - 240240.0*pow(xi2, 2) - 10296.0*xi2 + 6864.0));
case 17:
return 7.62939453125e-6*x1r*(-27373680.0*pow(xi1, 17) + 9694845.0*pow(xi1, 16) + 112326480.0*pow(xi1, 15) - 40116600.0*pow(xi1, 14) - 187210800.0*pow(xi1, 13) + 67603900.0*pow(xi1, 12) + 162249360.0*pow(xi1, 11) - 59491432.0*pow(xi1, 10) - 77597520.0*pow(xi1, 9) + 29099070.0*pow(xi1, 8) + 19953648.0*pow(xi1, 7) - 7759752.0*pow(xi1, 6) - 2450448.0*pow(xi1, 5) + 1021020.0*pow(xi1, 4) + 102960.0*pow(xi1, 3) - 51480.0*pow(xi1, 2) + pow(xi2, 2)*(27373680.0*pow(xi2, 15) - 9694845.0*pow(xi2, 14) - 112326480.0*pow(xi2, 13) + 40116600.0*pow(xi2, 12) + 187210800.0*pow(xi2, 11) - 67603900.0*pow(xi2, 10) - 162249360.0*pow(xi2, 9) + 59491432.0*pow(xi2, 8) + 77597520.0*pow(xi2, 7) - 29099070.0*pow(xi2, 6) - 19953648.0*pow(xi2, 5) + 7759752.0*pow(xi2, 4) + 2450448.0*pow(xi2, 3) - 1021020.0*pow(xi2, 2) - 102960.0*xi2 + 51480.0));
case 18:
return 3.814697265625e-6*x1r*(-100180065.0*pow(xi1, 18) + 35357670.0*pow(xi1, 17) + 436268025.0*pow(xi1, 16) - 155117520.0*pow(xi1, 15) - 782273700.0*pow(xi1, 14) + 280816200.0*pow(xi1, 13) + 743642900.0*pow(xi1, 12) - 270415600.0*pow(xi1, 11) - 401567166.0*pow(xi1, 10) + 148728580.0*pow(xi1, 9) + 122216094.0*pow(xi1, 8) - 46558512.0*pow(xi1, 7) - 19399380.0*pow(xi1, 6) + 7759752.0*pow(xi1, 5) + 1312740.0*pow(xi1, 4) - 583440.0*pow(xi1, 3) - 19305.0*pow(xi1, 2) + 12870.0*xi1 + xi2*(100180065.0*pow(xi2, 17) - 35357670.0*pow(xi2, 16) - 436268025.0*pow(xi2, 15) + 155117520.0*pow(xi2, 14) + 782273700.0*pow(xi2, 13) - 280816200.0*pow(xi2, 12) - 743642900.0*pow(xi2, 11) + 270415600.0*pow(xi2, 10) + 401567166.0*pow(xi2, 9) - 148728580.0*pow(xi2, 8) - 122216094.0*pow(xi2, 7) + 46558512.0*pow(xi2, 6) + 19399380.0*pow(xi2, 5) - 7759752.0*pow(xi2, 4) - 1312740.0*pow(xi2, 3) + 583440.0*pow(xi2, 2) + 19305.0*xi2 - 12870.0));
case 19:
return 3.814697265625e-6*x1r*(-184232070.0*pow(xi1, 19) + 64822395.0*pow(xi1, 18) + 848584080.0*pow(xi1, 17) - 300540195.0*pow(xi1, 16) - 1628733960.0*pow(xi1, 15) + 581690700.0*pow(xi1, 14) + 1684897200.0*pow(xi1, 13) - 608435100.0*pow(xi1, 12) - 1014058500.0*pow(xi1, 11) + 371821450.0*pow(xi1, 10) + 356948592.0*pow(xi1, 9) - 133855722.0*pow(xi1, 8) - 69837768.0*pow(xi1, 7) + 27159132.0*pow(xi1, 6) + 6651216.0*pow(xi1, 5) - 2771340.0*pow(xi1, 4) - 218790.0*pow(xi1, 3) + 109395.0*pow(xi1, 2) + pow(xi2, 2)*(184232070.0*pow(xi2, 17) - 64822395.0*pow(xi2, 16) - 848584080.0*pow(xi2, 15) + 300540195.0*pow(xi2, 14) + 1628733960.0*pow(xi2, 13) - 581690700.0*pow(xi2, 12) - 1684897200.0*pow(xi2, 11) + 608435100.0*pow(xi2, 10) + 1014058500.0*pow(xi2, 9) - 371821450.0*pow(xi2, 8) - 356948592.0*pow(xi2, 7) + 133855722.0*pow(xi2, 6) + 69837768.0*pow(xi2, 5) - 27159132.0*pow(xi2, 4) - 6651216.0*pow(xi2, 3) + 2771340.0*pow(xi2, 2) + 218790.0*xi2 - 109395.0));
case 20:
return 9.5367431640625e-7*x1r*(-1361270295.0*pow(xi1, 20) + 477638700.0*pow(xi1, 19) + 6611884290.0*pow(xi1, 18) - 2333606220.0*pow(xi1, 17) - 13524308775.0*pow(xi1, 16) + 4808643120.0*pow(xi1, 15) + 15123958200.0*pow(xi1, 14) - 5429113200.0*pow(xi1, 13) - 10039179150.0*pow(xi1, 12) + 3650610600.0*pow(xi1, 11) + 4015671660.0*pow(xi1, 10) - 1487285800.0*pow(xi1, 9) - 936990054.0*pow(xi1, 8) + 356948592.0*pow(xi1, 7) + 116396280.0*pow(xi1, 6) - 46558512.0*pow(xi1, 5) - 6235515.0*pow(xi1, 4) + 2771340.0*pow(xi1, 3) + 72930.0*pow(xi1, 2) - 48620.0*xi1 + xi2*(1361270295.0*pow(xi2, 19) - 477638700.0*pow(xi2, 18) - 6611884290.0*pow(xi2, 17) + 2333606220.0*pow(xi2, 16) + 13524308775.0*pow(xi2, 15) - 4808643120.0*pow(xi2, 14) - 15123958200.0*pow(xi2, 13) + 5429113200.0*pow(xi2, 12) + 10039179150.0*pow(xi2, 11) - 3650610600.0*pow(xi2, 10) - 4015671660.0*pow(xi2, 9) + 1487285800.0*pow(xi2, 8) + 936990054.0*pow(xi2, 7) - 356948592.0*pow(xi2, 6) - 116396280.0*pow(xi2, 5) + 46558512.0*pow(xi2, 4) + 6235515.0*pow(xi2, 3) - 2771340.0*pow(xi2, 2) - 72930.0*xi2 + 48620.0));
case 21:
return 9.5367431640625e-7*x1r*(-2524661700.0*pow(xi1, 21) + 883631595.0*pow(xi1, 20) + 12896244900.0*pow(xi1, 19) - 4537567650.0*pow(xi1, 18) - 28003274640.0*pow(xi1, 17) + 9917826435.0*pow(xi1, 16) + 33660501840.0*pow(xi1, 15) - 12021607800.0*pow(xi1, 14) - 24431009400.0*pow(xi1, 13) + 8822308950.0*pow(xi1, 12) + 10951831800.0*pow(xi1, 11) - 4015671660.0*pow(xi1, 10) - 2974571600.0*pow(xi1, 9) + 1115464350.0*pow(xi1, 8) + 458933904.0*pow(xi1, 7) - 178474296.0*pow(xi1, 6) - 34918884.0*pow(xi1, 5) + 14549535.0*pow(xi1, 4) + 923780.0*pow(xi1, 3) - 461890.0*pow(xi1, 2) + pow(xi2, 2)*(2524661700.0*pow(xi2, 19) - 883631595.0*pow(xi2, 18) - 12896244900.0*pow(xi2, 17) + 4537567650.0*pow(xi2, 16) + 28003274640.0*pow(xi2, 15) - 9917826435.0*pow(xi2, 14) - 33660501840.0*pow(xi2, 13) + 12021607800.0*pow(xi2, 12) + 24431009400.0*pow(xi2, 11) - 8822308950.0*pow(xi2, 10) - 10951831800.0*pow(xi2, 9) + 4015671660.0*pow(xi2, 8) + 2974571600.0*pow(xi2, 7) - 1115464350.0*pow(xi2, 6) - 458933904.0*pow(xi2, 5) + 178474296.0*pow(xi2, 4) + 34918884.0*pow(xi2, 3) - 14549535.0*pow(xi2, 2) - 923780.0*xi2 + 461890.0));
case 22:
return 4.76837158203125e-7*x1r*(-9398626965.0*pow(xi1, 22) + 3282060210.0*pow(xi1, 21) + 50367000915.0*pow(xi1, 20) - 17672631900.0*pow(xi1, 19) - 115707975075.0*pow(xi1, 18) + 40838108850.0*pow(xi1, 17) + 148767396525.0*pow(xi1, 16) - 52895074320.0*pow(xi1, 15) - 117210676050.0*pow(xi1, 14) + 42075627300.0*pow(xi1, 13) + 58227239070.0*pow(xi1, 12) - 21173541480.0*pow(xi1, 11) - 18070522470.0*pow(xi1, 10) + 6692786100.0*pow(xi1, 9) + 3346393050.0*pow(xi1, 8) - 1274816400.0*pow(xi1, 7) - 334639305.0*pow(xi1, 6) + 133855722.0*pow(xi1, 5) + 14549535.0*pow(xi1, 4) - 6466460.0*pow(xi1, 3) - 138567.0*pow(xi1, 2) + 92378.0*xi1 + xi2*(9398626965.0*pow(xi2, 21) - 3282060210.0*pow(xi2, 20) - 50367000915.0*pow(xi2, 19) + 17672631900.0*pow(xi2, 18) + 115707975075.0*pow(xi2, 17) - 40838108850.0*pow(xi2, 16) - 148767396525.0*pow(xi2, 15) + 52895074320.0*pow(xi2, 14) + 117210676050.0*pow(xi2, 13) - 42075627300.0*pow(xi2, 12) - 58227239070.0*pow(xi2, 11) + 21173541480.0*pow(xi2, 10) + 18070522470.0*pow(xi2, 9) - 6692786100.0*pow(xi2, 8) - 3346393050.0*pow(xi2, 7) + 1274816400.0*pow(xi2, 6) + 334639305.0*pow(xi2, 5) - 133855722.0*pow(xi2, 4) - 14549535.0*pow(xi2, 3) + 6466460.0*pow(xi2, 2) + 138567.0*xi2 - 92378.0));
case 23:
return 4.76837158203125e-7*x1r*(-17551887210.0*pow(xi1, 23) + 6116566755.0*pow(xi1, 22) + 98461806300.0*pow(xi1, 21) - 34461632205.0*pow(xi1, 20) - 238580530650.0*pow(xi1, 19) + 83945001525.0*pow(xi1, 18) + 326704870800.0*pow(xi1, 17) - 115707975075.0*pow(xi1, 16) - 277699140180.0*pow(xi1, 15) + 99178264350.0*pow(xi1, 14) + 151472258280.0*pow(xi1, 13) - 54698315490.0*pow(xi1, 12) - 52933853700.0*pow(xi1, 11) + 19409079690.0*pow(xi1, 10) + 11473347600.0*pow(xi1, 9) - 4302505350.0*pow(xi1, 8) - 1434168450.0*pow(xi1, 7) + 557732175.0*pow(xi1, 6) + 89237148.0*pow(xi1, 5) - 37182145.0*pow(xi1, 4) - 1939938.0*pow(xi1, 3) + 969969.0*pow(xi1, 2) + pow(xi2, 2)*(17551887210.0*pow(xi2, 21) - 6116566755.0*pow(xi2, 20) - 98461806300.0*pow(xi2, 19) + 34461632205.0*pow(xi2, 18) + 238580530650.0*pow(xi2, 17) - 83945001525.0*pow(xi2, 16) - 326704870800.0*pow(xi2, 15) + 115707975075.0*pow(xi2, 14) + 277699140180.0*pow(xi2, 13) - 99178264350.0*pow(xi2, 12) - 151472258280.0*pow(xi2, 11) + 54698315490.0*pow(xi2, 10) + 52933853700.0*pow(xi2, 9) - 19409079690.0*pow(xi2, 8) - 11473347600.0*pow(xi2, 7) + 4302505350.0*pow(xi2, 6) + 1434168450.0*pow(xi2, 5) - 557732175.0*pow(xi2, 4) - 89237148.0*pow(xi2, 3) + 37182145.0*pow(xi2, 2) + 1939938.0*xi2 - 969969.0));
case 24:
return 5.96046447753906e-8*x1r*(-263012370465.0*pow(xi1, 24) + 91482563640.0*pow(xi1, 23) + 1541374822260.0*pow(xi1, 22) - 538257874440.0*pow(xi1, 21) - 3928626071370.0*pow(xi1, 20) + 1378465288200.0*pow(xi1, 19) + 5708260103700.0*pow(xi1, 18) - 2014680036600.0*pow(xi1, 17) - 5206858878375.0*pow(xi1, 16) + 1851327601200.0*pow(xi1, 15) + 3094361847720.0*pow(xi1, 14) - 1110796560720.0*pow(xi1, 13) - 1203362940780.0*pow(xi1, 12) + 437586523920.0*pow(xi1, 11) + 299454372360.0*pow(xi1, 10) - 110909026800.0*pow(xi1, 9) - 45176306175.0*pow(xi1, 8) + 17210021400.0*pow(xi1, 7) + 3718214500.0*pow(xi1, 6) - 1487285800.0*pow(xi1, 5) - 133855722.0*pow(xi1, 4) + 59491432.0*pow(xi1, 3) + 1058148.0*pow(xi1, 2) - 705432.0*xi1 + xi2*(263012370465.0*pow(xi2, 23) - 91482563640.0*pow(xi2, 22) - 1541374822260.0*pow(xi2, 21) + 538257874440.0*pow(xi2, 20) + 3928626071370.0*pow(xi2, 19) - 1378465288200.0*pow(xi2, 18) - 5708260103700.0*pow(xi2, 17) + 2014680036600.0*pow(xi2, 16) + 5206858878375.0*pow(xi2, 15) - 1851327601200.0*pow(xi2, 14) - 3094361847720.0*pow(xi2, 13) + 1110796560720.0*pow(xi2, 12) + 1203362940780.0*pow(xi2, 11) - 437586523920.0*pow(xi2, 10) - 299454372360.0*pow(xi2, 9) + 110909026800.0*pow(xi2, 8) + 45176306175.0*pow(xi2, 7) - 17210021400.0*pow(xi2, 6) - 3718214500.0*pow(xi2, 5) + 1487285800.0*pow(xi2, 4) + 133855722.0*pow(xi2, 3) - 59491432.0*pow(xi2, 2) - 1058148.0*xi2 + 705432.0));
case 25:
return 5.96046447753906e-8*x1r*(-494005843656.0*pow(xi1, 25) + 171529806825.0*pow(xi1, 24) + 3018924600120.0*pow(xi1, 23) - 1052049481860.0*pow(xi1, 22) - 8073868116600.0*pow(xi1, 21) + 2825853840810.0*pow(xi1, 20) + 12406187593800.0*pow(xi1, 19) - 4365140079300.0*pow(xi1, 18) - 12088080219600.0*pow(xi1, 17) + 4281195077775.0*pow(xi1, 16) + 7775575925040.0*pow(xi1, 15) - 2776991401800.0*pow(xi1, 14) - 3332389682160.0*pow(xi1, 13) + 1203362940780.0*pow(xi1, 12) + 937685408400.0*pow(xi1, 11) - 343817983080.0*pow(xi1, 10) - 166363540200.0*pow(xi1, 9) + 62386327575.0*pow(xi1, 8) + 17210021400.0*pow(xi1, 7) - 6692786100.0*pow(xi1, 6) - 892371480.0*pow(xi1, 5) + 371821450.0*pow(xi1, 4) + 16224936.0*pow(xi1, 3) - 8112468.0*pow(xi1, 2) + pow(xi2, 2)*(494005843656.0*pow(xi2, 23) - 171529806825.0*pow(xi2, 22) - 3018924600120.0*pow(xi2, 21) + 1052049481860.0*pow(xi2, 20) + 8073868116600.0*pow(xi2, 19) - 2825853840810.0*pow(xi2, 18) - 12406187593800.0*pow(xi2, 17) + 4365140079300.0*pow(xi2, 16) + 12088080219600.0*pow(xi2, 15) - 4281195077775.0*pow(xi2, 14) - 7775575925040.0*pow(xi2, 13) + 2776991401800.0*pow(xi2, 12) + 3332389682160.0*pow(xi2, 11) - 1203362940780.0*pow(xi2, 10) - 937685408400.0*pow(xi2, 9) + 343817983080.0*pow(xi2, 8) + 166363540200.0*pow(xi2, 7) - 62386327575.0*pow(xi2, 6) - 17210021400.0*pow(xi2, 5) + 6692786100.0*pow(xi2, 4) + 892371480.0*pow(xi2, 3) - 371821450.0*pow(xi2, 2) - 16224936.0*xi2 + 8112468.0));
case 26:
return 2.98023223876953e-8*x1r*(-1860438674025.0*pow(xi1, 26) + 644952073662.0*pow(xi1, 25) + 11835556670925.0*pow(xi1, 24) - 4116715363800.0*pow(xi1, 23) - 33139558678590.0*pow(xi1, 22) + 11572544300460.0*pow(xi1, 21) + 53691222975390.0*pow(xi1, 20) - 18839025605400.0*pow(xi1, 19) - 55655536011075.0*pow(xi1, 18) + 19643130356850.0*pow(xi1, 17) + 38530755699975.0*pow(xi1, 16) - 13699824248880.0*pow(xi1, 15) - 18050444111700.0*pow(xi1, 14) + 6479646604200.0*pow(xi1, 13) + 5672996720820.0*pow(xi1, 12) - 2062907898480.0*pow(xi1, 11) - 1160385692895.0*pow(xi1, 10) + 429772478850.0*pow(xi1, 9) + 145568097675.0*pow(xi1, 8) - 55454513400.0*pow(xi1, 7) - 10039179150.0*pow(xi1, 6) + 4015671660.0*pow(xi1, 5) + 304217550.0*pow(xi1, 4) - 135207800.0*pow(xi1, 3) - 2028117.0*pow(xi1, 2) + 1352078.0*xi1 + xi2*(1860438674025.0*pow(xi2, 25) - 644952073662.0*pow(xi2, 24) - 11835556670925.0*pow(xi2, 23) + 4116715363800.0*pow(xi2, 22) + 33139558678590.0*pow(xi2, 21) - 11572544300460.0*pow(xi2, 20) - 53691222975390.0*pow(xi2, 19) + 18839025605400.0*pow(xi2, 18) + 55655536011075.0*pow(xi2, 17) - 19643130356850.0*pow(xi2, 16) - 38530755699975.0*pow(xi2, 15) + 13699824248880.0*pow(xi2, 14) + 18050444111700.0*pow(xi2, 13) - 6479646604200.0*pow(xi2, 12) - 5672996720820.0*pow(xi2, 11) + 2062907898480.0*pow(xi2, 10) + 1160385692895.0*pow(xi2, 9) - 429772478850.0*pow(xi2, 8) - 145568097675.0*pow(xi2, 7) + 55454513400.0*pow(xi2, 6) + 10039179150.0*pow(xi2, 5) - 4015671660.0*pow(xi2, 4) - 304217550.0*pow(xi2, 3) + 135207800.0*pow(xi2, 2) + 2028117.0*xi2 - 1352078.0));
case 27:
return 2.98023223876953e-8*x1r*(-3511405734382.0*pow(xi1, 27) + 1215486600363.0*pow(xi1, 26) + 23218274651832.0*pow(xi1, 25) - 8061900920775.0*pow(xi1, 24) - 67925803502700.0*pow(xi1, 23) + 23671113341850.0*pow(xi1, 22) + 115725443004600.0*pow(xi1, 21) - 40503905051610.0*pow(xi1, 20) - 127163422836450.0*pow(xi1, 19) + 44742685812825.0*pow(xi1, 18) + 94287025712880.0*pow(xi1, 17) - 33393321606645.0*pow(xi1, 16) - 47949384871080.0*pow(xi1, 15) + 17124780311100.0*pow(xi1, 14) + 16661948410800.0*pow(xi1, 13) - 6016814703900.0*pow(xi1, 12) - 3867952309650.0*pow(xi1, 11) + 1418249180205.0*pow(xi1, 10) + 573029971800.0*pow(xi1, 9) - 214886239425.0*pow(xi1, 8) - 49909062060.0*pow(xi1, 7) + 19409079690.0*pow(xi1, 6) + 2190366360.0*pow(xi1, 5) - 912652650.0*pow(xi1, 4) - 33801950.0*pow(xi1, 3) + 16900975.0*pow(xi1, 2) + pow(xi2, 2)*(3511405734382.0*pow(xi2, 25) - 1215486600363.0*pow(xi2, 24) - 23218274651832.0*pow(xi2, 23) + 8061900920775.0*pow(xi2, 22) + 67925803502700.0*pow(xi2, 21) - 23671113341850.0*pow(xi2, 20) - 115725443004600.0*pow(xi2, 19) + 40503905051610.0*pow(xi2, 18) + 127163422836450.0*pow(xi2, 17) - 44742685812825.0*pow(xi2, 16) - 94287025712880.0*pow(xi2, 15) + 33393321606645.0*pow(xi2, 14) + 47949384871080.0*pow(xi2, 13) - 17124780311100.0*pow(xi2, 12) - 16661948410800.0*pow(xi2, 11) + 6016814703900.0*pow(xi2, 10) + 3867952309650.0*pow(xi2, 9) - 1418249180205.0*pow(xi2, 8) - 573029971800.0*pow(xi2, 7) + 214886239425.0*pow(xi2, 6) + 49909062060.0*pow(xi2, 5) - 19409079690.0*pow(xi2, 4) - 2190366360.0*pow(xi2, 3) + 912652650.0*pow(xi2, 2) + 33801950.0*xi2 - 16900975.0));
case 28:
return 7.45058059692383e-9*x1r*(-26567064265077.0*pow(xi1, 28) + 9183676536076.0*pow(xi1, 27) + 182322990054450.0*pow(xi1, 26) - 63205303218876.0*pow(xi1, 25) - 556271163533475.0*pow(xi1, 24) + 193485622098600.0*pow(xi1, 23) + 994186760357700.0*pow(xi1, 22) - 347176329013800.0*pow(xi1, 21) - 1.15436129397089e+15*pow(xi1, 20) + 405039050516100.0*pow(xi1, 19) + 912750790581630.0*pow(xi1, 18) - 322147337852340.0*pow(xi1, 17) - 500899824099675.0*pow(xi1, 16) + 178097715235440.0*pow(xi1, 15) + 190818980609400.0*pow(xi1, 14) - 68499121244400.0*pow(xi1, 13) - 49638721307175.0*pow(xi1, 12) + 18050444111700.0*pow(xi1, 11) + 8509495081230.0*pow(xi1, 10) - 3151664844900.0*pow(xi1, 9) - 902522205585.0*pow(xi1, 8) + 343817983080.0*pow(xi1, 7) + 52933853700.0*pow(xi1, 6) - 21173541480.0*pow(xi1, 5) - 1368978975.0*pow(xi1, 4) + 608435100.0*pow(xi1, 3) + 7800450.0*pow(xi1, 2) - 5200300.0*xi1 + xi2*(26567064265077.0*pow(xi2, 27) - 9183676536076.0*pow(xi2, 26) - 182322990054450.0*pow(xi2, 25) + 63205303218876.0*pow(xi2, 24) + 556271163533475.0*pow(xi2, 23) - 193485622098600.0*pow(xi2, 22) - 994186760357700.0*pow(xi2, 21) + 347176329013800.0*pow(xi2, 20) + 1.15436129397089e+15*pow(xi2, 19) - 405039050516100.0*pow(xi2, 18) - 912750790581630.0*pow(xi2, 17) + 322147337852340.0*pow(xi2, 16) + 500899824099675.0*pow(xi2, 15) - 178097715235440.0*pow(xi2, 14) - 190818980609400.0*pow(xi2, 13) + 68499121244400.0*pow(xi2, 12) + 49638721307175.0*pow(xi2, 11) - 18050444111700.0*pow(xi2, 10) - 8509495081230.0*pow(xi2, 9) + 3151664844900.0*pow(xi2, 8) + 902522205585.0*pow(xi2, 7) - 343817983080.0*pow(xi2, 6) - 52933853700.0*pow(xi2, 5) + 21173541480.0*pow(xi2, 4) + 1368978975.0*pow(xi2, 3) - 608435100.0*pow(xi2, 2) - 7800450.0*xi2 + 5200300.0));
case 29:
return 7.45058059692383e-9*x1r*(-50351881697796.0*pow(xi1, 29) + 17383387729001.0*pow(xi1, 28) + 358163384906964.0*pow(xi1, 27) - 123979633237026.0*pow(xi1, 26) - 1.13769545793977e+15*pow(xi1, 25) + 395033145117975.0*pow(xi1, 24) + 2.1283418430846e+15*pow(xi1, 23) - 741694884711300.0*pow(xi1, 22) - 2.6038224676035e+15*pow(xi1, 21) + 911337863661225.0*pow(xi1, 20) + 2.18721087278694e+15*pow(xi1, 19) - 769574195980590.0*pow(xi1, 18) - 1.28858935140936e+15*pow(xi1, 17) + 456375395290815.0*pow(xi1, 16) + 534293145706320.0*pow(xi1, 15) - 190818980609400.0*pow(xi1, 14) - 154123022799900.0*pow(xi1, 13) + 55655536011075.0*pow(xi1, 12) + 30084073519500.0*pow(xi1, 11) - 11030826957150.0*pow(xi1, 10) - 3781997813880.0*pow(xi1, 9) + 1418249180205.0*pow(xi1, 8) + 281305622520.0*pow(xi1, 7) - 109396630980.0*pow(xi1, 6) - 10586770740.0*pow(xi1, 5) + 4411154475.0*pow(xi1, 4) + 140408100.0*pow(xi1, 3) - 70204050.0*pow(xi1, 2) + pow(xi2, 2)*(50351881697796.0*pow(xi2, 27) - 17383387729001.0*pow(xi2, 26) - 358163384906964.0*pow(xi2, 25) + 123979633237026.0*pow(xi2, 24) + 1.13769545793977e+15*pow(xi2, 23) - 395033145117975.0*pow(xi2, 22) - 2.1283418430846e+15*pow(xi2, 21) + 741694884711300.0*pow(xi2, 20) + 2.6038224676035e+15*pow(xi2, 19) - 911337863661225.0*pow(xi2, 18) - 2.18721087278694e+15*pow(xi2, 17) + 769574195980590.0*pow(xi2, 16) + 1.28858935140936e+15*pow(xi2, 15) - 456375395290815.0*pow(xi2, 14) - 534293145706320.0*pow(xi2, 13) + 190818980609400.0*pow(xi2, 12) + 154123022799900.0*pow(xi2, 11) - 55655536011075.0*pow(xi2, 10) - 30084073519500.0*pow(xi2, 9) + 11030826957150.0*pow(xi2, 8) + 3781997813880.0*pow(xi2, 7) - 1418249180205.0*pow(xi2, 6) - 281305622520.0*pow(xi2, 5) + 109396630980.0*pow(xi2, 4) + 10586770740.0*pow(xi2, 3) - 4411154475.0*pow(xi2, 2) - 140408100.0*xi2 + 70204050.0));
default:
return 0.;
}
case 2:
switch(j) {
case 0:
return 0.75*x2t*y1t*(pow(xi1, 3) - pow(xi2, 3));
case 1:
return 0.1875*x2t*y1r*(2.0*pow(xi1, 3) - pow(xi1, 2) - 2.0*pow(xi2, 3) + pow(xi2, 2));
case 2:
return 0.75*x2t*y2t*(-pow(xi1, 3) + pow(xi2, 3));
case 3:
return 0.1875*x2t*y2r*(2.0*pow(xi1, 3) + pow(xi1, 2) - pow(xi2, 2)*(2.0*xi2 + 1.0));
case 4:
return 0.1875*x2t*(3.0*pow(xi1, 4) - 2.0*pow(xi1, 2) - 3.0*pow(xi2, 4) + 2.0*pow(xi2, 2));
case 5:
return 0.75*x2t*(pow(xi1, 5) - pow(xi1, 3) - pow(xi2, 5) + pow(xi2, 3));
case 6:
return 0.03125*x2t*(35.0*pow(xi1, 6) - 45.0*pow(xi1, 4) + 9.0*pow(xi1, 2) - 35.0*pow(xi2, 6) + 45.0*pow(xi2, 4) - 9.0*pow(xi2, 2));
case 7:
return 0.1875*x2t*(9.0*pow(xi1, 7) - 14.0*pow(xi1, 5) + 5.0*pow(xi1, 3) - 9.0*pow(xi2, 7) + 14.0*pow(xi2, 5) - 5.0*pow(xi2, 3));
case 8:
return 0.01171875*x2t*(231.0*pow(xi1, 8) - 420.0*pow(xi1, 6) + 210.0*pow(xi1, 4) - 20.0*pow(xi1, 2) - 231.0*pow(xi2, 8) + 420.0*pow(xi2, 6) - 210.0*pow(xi2, 4) + 20.0*pow(xi2, 2));
case 9:
return 0.03125*x2t*(143.0*pow(xi1, 9) - 297.0*pow(xi1, 7) + 189.0*pow(xi1, 5) - 35.0*pow(xi1, 3) - 143.0*pow(xi2, 9) + 297.0*pow(xi2, 7) - 189.0*pow(xi2, 5) + 35.0*pow(xi2, 3));
case 10:
return 0.005859375*x2t*(1287.0*pow(xi1, 10) - 3003.0*pow(xi1, 8) + 2310.0*pow(xi1, 6) - 630.0*pow(xi1, 4) + 35.0*pow(xi1, 2) + pow(xi2, 2)*(-1287.0*pow(xi2, 8) + 3003.0*pow(xi2, 6) - 2310.0*pow(xi2, 4) + 630.0*pow(xi2, 2) - 35.0));
case 11:
return 0.01171875*x2t*(1105.0*pow(xi1, 11) - 2860.0*pow(xi1, 9) + 2574.0*pow(xi1, 7) - 924.0*pow(xi1, 5) + 105.0*pow(xi1, 3) + pow(xi2, 3)*(-1105.0*pow(xi2, 8) + 2860.0*pow(xi2, 6) - 2574.0*pow(xi2, 4) + 924.0*pow(xi2, 2) - 105.0));
case 12:
return 0.00048828125*x2t*(46189.0*pow(xi1, 12) - 131274.0*pow(xi1, 10) + 135135.0*pow(xi1, 8) - 60060.0*pow(xi1, 6) + 10395.0*pow(xi1, 4) - 378.0*pow(xi1, 2) + pow(xi2, 2)*(-46189.0*pow(xi2, 10) + 131274.0*pow(xi2, 8) - 135135.0*pow(xi2, 6) + 60060.0*pow(xi2, 4) - 10395.0*pow(xi2, 2) + 378.0));
case 13:
return 0.005859375*x2t*(6783.0*pow(xi1, 13) - 20995.0*pow(xi1, 11) + 24310.0*pow(xi1, 9) - 12870.0*pow(xi1, 7) + 3003.0*pow(xi1, 5) - 231.0*pow(xi1, 3) + pow(xi2, 3)*(-6783.0*pow(xi2, 10) + 20995.0*pow(xi2, 8) - 24310.0*pow(xi2, 6) + 12870.0*pow(xi2, 4) - 3003.0*pow(xi2, 2) + 231.0));
case 14:
return 0.000732421875*x2t*(96577.0*pow(xi1, 14) - 323323.0*pow(xi1, 12) + 415701.0*pow(xi1, 10) - 255255.0*pow(xi1, 8) + 75075.0*pow(xi1, 6) - 9009.0*pow(xi1, 4) + 231.0*pow(xi1, 2) + pow(xi2, 2)*(-96577.0*pow(xi2, 12) + 323323.0*pow(xi2, 10) - 415701.0*pow(xi2, 8) + 255255.0*pow(xi2, 6) - 75075.0*pow(xi2, 4) + 9009.0*pow(xi2, 2) - 231.0));
case 15:
return 0.00048828125*x2t*(260015.0*pow(xi1, 15) - 936054.0*pow(xi1, 13) + 1322685.0*pow(xi1, 11) - 923780.0*pow(xi1, 9) + 328185.0*pow(xi1, 7) - 54054.0*pow(xi1, 5) + 3003.0*pow(xi1, 3) + pow(xi2, 3)*(-260015.0*pow(xi2, 12) + 936054.0*pow(xi2, 10) - 1322685.0*pow(xi2, 8) + 923780.0*pow(xi2, 6) - 328185.0*pow(xi2, 4) + 54054.0*pow(xi2, 2) - 3003.0));
case 16:
return 4.57763671875e-5*x2t*(5014575.0*pow(xi1, 16) - 19315400.0*pow(xi1, 14) + 29745716.0*pow(xi1, 12) - 23279256.0*pow(xi1, 10) + 9699690.0*pow(xi1, 8) - 2042040.0*pow(xi1, 6) + 180180.0*pow(xi1, 4) - 3432.0*pow(xi1, 2) + pow(xi2, 2)*(-5014575.0*pow(xi2, 14) + 19315400.0*pow(xi2, 12) - 29745716.0*pow(xi2, 10) + 23279256.0*pow(xi2, 8) - 9699690.0*pow(xi2, 6) + 2042040.0*pow(xi2, 4) - 180180.0*pow(xi2, 2) + 3432.0));
case 17:
return 0.000732421875*x2t*(570285.0*pow(xi1, 17) - 2340135.0*pow(xi1, 15) + 3900225.0*pow(xi1, 13) - 3380195.0*pow(xi1, 11) + 1616615.0*pow(xi1, 9) - 415701.0*pow(xi1, 7) + 51051.0*pow(xi1, 5) - 2145.0*pow(xi1, 3) + pow(xi2, 3)*(-570285.0*pow(xi2, 14) + 2340135.0*pow(xi2, 12) - 3900225.0*pow(xi2, 10) + 3380195.0*pow(xi2, 8) - 1616615.0*pow(xi2, 6) + 415701.0*pow(xi2, 4) - 51051.0*pow(xi2, 2) + 2145.0));
case 18:
return 7.62939453125e-6*x2t*(100180065.0*pow(xi1, 18) - 436268025.0*pow(xi1, 16) + 782273700.0*pow(xi1, 14) - 743642900.0*pow(xi1, 12) + 401567166.0*pow(xi1, 10) - 122216094.0*pow(xi1, 8) + 19399380.0*pow(xi1, 6) - 1312740.0*pow(xi1, 4) + 19305.0*pow(xi1, 2) + pow(xi2, 2)*(-100180065.0*pow(xi2, 16) + 436268025.0*pow(xi2, 14) - 782273700.0*pow(xi2, 12) + 743642900.0*pow(xi2, 10) - 401567166.0*pow(xi2, 8) + 122216094.0*pow(xi2, 6) - 19399380.0*pow(xi2, 4) + 1312740.0*pow(xi2, 2) - 19305.0));
case 19:
return 4.57763671875e-5*x2t*(30705345.0*pow(xi1, 19) - 141430680.0*pow(xi1, 17) + 271455660.0*pow(xi1, 15) - 280816200.0*pow(xi1, 13) + 169009750.0*pow(xi1, 11) - 59491432.0*pow(xi1, 9) + 11639628.0*pow(xi1, 7) - 1108536.0*pow(xi1, 5) + 36465.0*pow(xi1, 3) + pow(xi2, 3)*(-30705345.0*pow(xi2, 16) + 141430680.0*pow(xi2, 14) - 271455660.0*pow(xi2, 12) + 280816200.0*pow(xi2, 10) - 169009750.0*pow(xi2, 8) + 59491432.0*pow(xi2, 6) - 11639628.0*pow(xi2, 4) + 1108536.0*pow(xi2, 2) - 36465.0));
case 20:
return 5.7220458984375e-6*x2t*(453756765.0*pow(xi1, 20) - 2203961430.0*pow(xi1, 18) + 4508102925.0*pow(xi1, 16) - 5041319400.0*pow(xi1, 14) + 3346393050.0*pow(xi1, 12) - 1338557220.0*pow(xi1, 10) + 312330018.0*pow(xi1, 8) - 38798760.0*pow(xi1, 6) + 2078505.0*pow(xi1, 4) - 24310.0*pow(xi1, 2) + pow(xi2, 2)*(-453756765.0*pow(xi2, 18) + 2203961430.0*pow(xi2, 16) - 4508102925.0*pow(xi2, 14) + 5041319400.0*pow(xi2, 12) - 3346393050.0*pow(xi2, 10) + 1338557220.0*pow(xi2, 8) - 312330018.0*pow(xi2, 6) + 38798760.0*pow(xi2, 4) - 2078505.0*pow(xi2, 2) + 24310.0));
case 21:
return 7.62939453125e-6*x2t*(631165425.0*pow(xi1, 21) - 3224061225.0*pow(xi1, 19) + 7000818660.0*pow(xi1, 17) - 8415125460.0*pow(xi1, 15) + 6107752350.0*pow(xi1, 13) - 2737957950.0*pow(xi1, 11) + 743642900.0*pow(xi1, 9) - 114733476.0*pow(xi1, 7) + 8729721.0*pow(xi1, 5) - 230945.0*pow(xi1, 3) + pow(xi2, 3)*(-631165425.0*pow(xi2, 18) + 3224061225.0*pow(xi2, 16) - 7000818660.0*pow(xi2, 14) + 8415125460.0*pow(xi2, 12) - 6107752350.0*pow(xi2, 10) + 2737957950.0*pow(xi2, 8) - 743642900.0*pow(xi2, 6) + 114733476.0*pow(xi2, 4) - 8729721.0*pow(xi2, 2) + 230945.0));
case 22:
return 2.86102294921875e-6*x2t*(3132875655.0*pow(xi1, 22) - 16789000305.0*pow(xi1, 20) + 38569325025.0*pow(xi1, 18) - 49589132175.0*pow(xi1, 16) + 39070225350.0*pow(xi1, 14) - 19409079690.0*pow(xi1, 12) + 6023507490.0*pow(xi1, 10) - 1115464350.0*pow(xi1, 8) + 111546435.0*pow(xi1, 6) - 4849845.0*pow(xi1, 4) + 46189.0*pow(xi1, 2) + pow(xi2, 2)*(-3132875655.0*pow(xi2, 20) + 16789000305.0*pow(xi2, 18) - 38569325025.0*pow(xi2, 16) + 49589132175.0*pow(xi2, 14) - 39070225350.0*pow(xi2, 12) + 19409079690.0*pow(xi2, 10) - 6023507490.0*pow(xi2, 8) + 1115464350.0*pow(xi2, 6) - 111546435.0*pow(xi2, 4) + 4849845.0*pow(xi2, 2) - 46189.0));
case 23:
return 5.7220458984375e-6*x2t*(2925314535.0*pow(xi1, 23) - 16410301050.0*pow(xi1, 21) + 39763421775.0*pow(xi1, 19) - 54450811800.0*pow(xi1, 17) + 46283190030.0*pow(xi1, 15) - 25245376380.0*pow(xi1, 13) + 8822308950.0*pow(xi1, 11) - 1912224600.0*pow(xi1, 9) + 239028075.0*pow(xi1, 7) - 14872858.0*pow(xi1, 5) + 323323.0*pow(xi1, 3) + pow(xi2, 3)*(-2925314535.0*pow(xi2, 20) + 16410301050.0*pow(xi2, 18) - 39763421775.0*pow(xi2, 16) + 54450811800.0*pow(xi2, 14) - 46283190030.0*pow(xi2, 12) + 25245376380.0*pow(xi2, 10) - 8822308950.0*pow(xi2, 8) + 1912224600.0*pow(xi2, 6) - 239028075.0*pow(xi2, 4) + 14872858.0*pow(xi2, 2) - 323323.0));
case 24:
return 1.19209289550781e-7*x2t*(263012370465.0*pow(xi1, 24) - 1541374822260.0*pow(xi1, 22) + 3928626071370.0*pow(xi1, 20) - 5708260103700.0*pow(xi1, 18) + 5206858878375.0*pow(xi1, 16) - 3094361847720.0*pow(xi1, 14) + 1203362940780.0*pow(xi1, 12) - 299454372360.0*pow(xi1, 10) + 45176306175.0*pow(xi1, 8) - 3718214500.0*pow(xi1, 6) + 133855722.0*pow(xi1, 4) - 1058148.0*pow(xi1, 2) + pow(xi2, 2)*(-263012370465.0*pow(xi2, 22) + 1541374822260.0*pow(xi2, 20) - 3928626071370.0*pow(xi2, 18) + 5708260103700.0*pow(xi2, 16) - 5206858878375.0*pow(xi2, 14) + 3094361847720.0*pow(xi2, 12) - 1203362940780.0*pow(xi2, 10) + 299454372360.0*pow(xi2, 8) - 45176306175.0*pow(xi2, 6) + 3718214500.0*pow(xi2, 4) - 133855722.0*pow(xi2, 2) + 1058148.0));
case 25:
return 2.86102294921875e-6*x2t*(20583576819.0*pow(xi1, 25) - 125788525005.0*pow(xi1, 23) + 336411171525.0*pow(xi1, 21) - 516924483075.0*pow(xi1, 19) + 503670009150.0*pow(xi1, 17) - 323982330210.0*pow(xi1, 15) + 138849570090.0*pow(xi1, 13) - 39070225350.0*pow(xi1, 11) + 6931814175.0*pow(xi1, 9) - 717084225.0*pow(xi1, 7) + 37182145.0*pow(xi1, 5) - 676039.0*pow(xi1, 3) + pow(xi2, 3)*(-20583576819.0*pow(xi2, 22) + 125788525005.0*pow(xi2, 20) - 336411171525.0*pow(xi2, 18) + 516924483075.0*pow(xi2, 16) - 503670009150.0*pow(xi2, 14) + 323982330210.0*pow(xi2, 12) - 138849570090.0*pow(xi2, 10) + 39070225350.0*pow(xi2, 8) - 6931814175.0*pow(xi2, 6) + 717084225.0*pow(xi2, 4) - 37182145.0*pow(xi2, 2) + 676039.0));
case 26:
return 1.78813934326172e-7*x2t*(620146224675.0*pow(xi1, 26) - 3945185556975.0*pow(xi1, 24) + 11046519559530.0*pow(xi1, 22) - 17897074325130.0*pow(xi1, 20) + 18551845337025.0*pow(xi1, 18) - 12843585233325.0*pow(xi1, 16) + 6016814703900.0*pow(xi1, 14) - 1890998906940.0*pow(xi1, 12) + 386795230965.0*pow(xi1, 10) - 48522699225.0*pow(xi1, 8) + 3346393050.0*pow(xi1, 6) - 101405850.0*pow(xi1, 4) + 676039.0*pow(xi1, 2) + pow(xi2, 2)*(-620146224675.0*pow(xi2, 24) + 3945185556975.0*pow(xi2, 22) - 11046519559530.0*pow(xi2, 20) + 17897074325130.0*pow(xi2, 18) - 18551845337025.0*pow(xi2, 16) + 12843585233325.0*pow(xi2, 14) - 6016814703900.0*pow(xi2, 12) + 1890998906940.0*pow(xi2, 10) - 386795230965.0*pow(xi2, 8) + 48522699225.0*pow(xi2, 6) - 3346393050.0*pow(xi2, 4) + 101405850.0*pow(xi2, 2) - 676039.0));
case 27:
return 1.19209289550781e-7*x2t*(1755702867191.0*pow(xi1, 27) - 11609137325916.0*pow(xi1, 25) + 33962901751350.0*pow(xi1, 23) - 57862721502300.0*pow(xi1, 21) + 63581711418225.0*pow(xi1, 19) - 47143512856440.0*pow(xi1, 17) + 23974692435540.0*pow(xi1, 15) - 8330974205400.0*pow(xi1, 13) + 1933976154825.0*pow(xi1, 11) - 286514985900.0*pow(xi1, 9) + 24954531030.0*pow(xi1, 7) - 1095183180.0*pow(xi1, 5) + 16900975.0*pow(xi1, 3) + pow(xi2, 3)*(-1755702867191.0*pow(xi2, 24) + 11609137325916.0*pow(xi2, 22) - 33962901751350.0*pow(xi2, 20) + 57862721502300.0*pow(xi2, 18) - 63581711418225.0*pow(xi2, 16) + 47143512856440.0*pow(xi2, 14) - 23974692435540.0*pow(xi2, 12) + 8330974205400.0*pow(xi2, 10) - 1933976154825.0*pow(xi2, 8) + 286514985900.0*pow(xi2, 6) - 24954531030.0*pow(xi2, 4) + 1095183180.0*pow(xi2, 2) - 16900975.0));
case 28:
return 4.4703483581543e-8*x2t*(8855688088359.0*pow(xi1, 28) - 60774330018150.0*pow(xi1, 26) + 185423721177825.0*pow(xi1, 24) - 331395586785900.0*pow(xi1, 22) + 384787097990295.0*pow(xi1, 20) - 304250263527210.0*pow(xi1, 18) + 166966608033225.0*pow(xi1, 16) - 63606326869800.0*pow(xi1, 14) + 16546240435725.0*pow(xi1, 12) - 2836498360410.0*pow(xi1, 10) + 300840735195.0*pow(xi1, 8) - 17644617900.0*pow(xi1, 6) + 456326325.0*pow(xi1, 4) - 2600150.0*pow(xi1, 2) + pow(xi2, 2)*(-8855688088359.0*pow(xi2, 26) + 60774330018150.0*pow(xi2, 24) - 185423721177825.0*pow(xi2, 22) + 331395586785900.0*pow(xi2, 20) - 384787097990295.0*pow(xi2, 18) + 304250263527210.0*pow(xi2, 16) - 166966608033225.0*pow(xi2, 14) + 63606326869800.0*pow(xi2, 12) - 16546240435725.0*pow(xi2, 10) + 2836498360410.0*pow(xi2, 8) - 300840735195.0*pow(xi2, 6) + 17644617900.0*pow(xi2, 4) - 456326325.0*pow(xi2, 2) + 2600150.0));
case 29:
return 1.78813934326172e-7*x2t*(4195990141483.0*pow(xi1, 29) - 29846948742247.0*pow(xi1, 27) + 94807954828314.0*pow(xi1, 25) - 177361820257050.0*pow(xi1, 23) + 216985205633625.0*pow(xi1, 21) - 182267572732245.0*pow(xi1, 19) + 107382445950780.0*pow(xi1, 17) - 44524428808860.0*pow(xi1, 15) + 12843585233325.0*pow(xi1, 13) - 2507006126625.0*pow(xi1, 11) + 315166484490.0*pow(xi1, 9) - 23442135210.0*pow(xi1, 7) + 882230895.0*pow(xi1, 5) - 11700675.0*pow(xi1, 3) + pow(xi2, 3)*(-4195990141483.0*pow(xi2, 26) + 29846948742247.0*pow(xi2, 24) - 94807954828314.0*pow(xi2, 22) + 177361820257050.0*pow(xi2, 20) - 216985205633625.0*pow(xi2, 18) + 182267572732245.0*pow(xi2, 16) - 107382445950780.0*pow(xi2, 14) + 44524428808860.0*pow(xi2, 12) - 12843585233325.0*pow(xi2, 10) + 2507006126625.0*pow(xi2, 8) - 315166484490.0*pow(xi2, 6) + 23442135210.0*pow(xi2, 4) - 882230895.0*pow(xi2, 2) + 11700675.0));
default:
return 0.;
}
case 3:
switch(j) {
case 0:
return -0.1875*x2r*y1t*(2.0*pow(xi1, 3) + pow(xi1, 2) - pow(xi2, 2)*(2.0*xi2 + 1.0));
case 1:
return 0.0625*x2r*y1r*(-3.0*pow(xi1, 3) + xi1 + 3.0*pow(xi2, 3) - xi2);
case 2:
return 0.1875*x2r*y2t*(2.0*pow(xi1, 3) + pow(xi1, 2) - pow(xi2, 2)*(2.0*xi2 + 1.0));
case 3:
return -0.0625*x2r*y2r*(3.0*pow(xi1, 3) + 3.0*pow(xi1, 2) + xi1 - xi2*(3.0*pow(xi2, 2) + 3.0*xi2 + 1.0));
case 4:
return 0.03125*x2r*(-9.0*pow(xi1, 4) - 4.0*pow(xi1, 3) + 6.0*pow(xi1, 2) + 4.0*xi1 + xi2*(9.0*pow(xi2, 3) + 4.0*pow(xi2, 2) - 6.0*xi2 - 4.0));
case 5:
return 0.03125*x2r*(-12.0*pow(xi1, 5) - 5.0*pow(xi1, 4) + 12.0*pow(xi1, 3) + 6.0*pow(xi1, 2) + pow(xi2, 2)*(12.0*pow(xi2, 3) + 5.0*pow(xi2, 2) - 12.0*xi2 - 6.0));
case 6:
return 0.015625*x2r*(-35.0*pow(xi1, 6) - 14.0*pow(xi1, 5) + 45.0*pow(xi1, 4) + 20.0*pow(xi1, 3) - 9.0*pow(xi1, 2) - 6.0*xi1 + xi2*(35.0*pow(xi2, 5) + 14.0*pow(xi2, 4) - 45.0*pow(xi2, 3) - 20.0*pow(xi2, 2) + 9.0*xi2 + 6.0));
case 7:
return 0.015625*x2r*(-54.0*pow(xi1, 7) - 21.0*pow(xi1, 6) + 84.0*pow(xi1, 5) + 35.0*pow(xi1, 4) - 30.0*pow(xi1, 3) - 15.0*pow(xi1, 2) + pow(xi2, 2)*(54.0*pow(xi2, 5) + 21.0*pow(xi2, 4) - 84.0*pow(xi2, 3) - 35.0*pow(xi2, 2) + 30.0*xi2 + 15.0));
case 8:
return 0.001953125*x2r*(-693.0*pow(xi1, 8) - 264.0*pow(xi1, 7) + 1260.0*pow(xi1, 6) + 504.0*pow(xi1, 5) - 630.0*pow(xi1, 4) - 280.0*pow(xi1, 3) + 60.0*pow(xi1, 2) + 40.0*xi1 + xi2*(693.0*pow(xi2, 7) + 264.0*pow(xi2, 6) - 1260.0*pow(xi2, 5) - 504.0*pow(xi2, 4) + 630.0*pow(xi2, 3) + 280.0*pow(xi2, 2) - 60.0*xi2 - 40.0));
case 9:
return 0.001953125*x2r*(-1144.0*pow(xi1, 9) - 429.0*pow(xi1, 8) + 2376.0*pow(xi1, 7) + 924.0*pow(xi1, 6) - 1512.0*pow(xi1, 5) - 630.0*pow(xi1, 4) + 280.0*pow(xi1, 3) + 140.0*pow(xi1, 2) + pow(xi2, 2)*(1144.0*pow(xi2, 7) + 429.0*pow(xi2, 6) - 2376.0*pow(xi2, 5) - 924.0*pow(xi2, 4) + 1512.0*pow(xi2, 3) + 630.0*pow(xi2, 2) - 280.0*xi2 - 140.0));
case 10:
return 0.0009765625*x2r*(-3861.0*pow(xi1, 10) - 1430.0*pow(xi1, 9) + 9009.0*pow(xi1, 8) + 3432.0*pow(xi1, 7) - 6930.0*pow(xi1, 6) - 2772.0*pow(xi1, 5) + 1890.0*pow(xi1, 4) + 840.0*pow(xi1, 3) - 105.0*pow(xi1, 2) - 70.0*xi1 + xi2*(3861.0*pow(xi2, 9) + 1430.0*pow(xi2, 8) - 9009.0*pow(xi2, 7) - 3432.0*pow(xi2, 6) + 6930.0*pow(xi2, 5) + 2772.0*pow(xi2, 4) - 1890.0*pow(xi2, 3) - 840.0*pow(xi2, 2) + 105.0*xi2 + 70.0));
case 11:
return 0.0009765625*x2r*(-6630.0*pow(xi1, 11) - 2431.0*pow(xi1, 10) + 17160.0*pow(xi1, 9) + 6435.0*pow(xi1, 8) - 15444.0*pow(xi1, 7) - 6006.0*pow(xi1, 6) + 5544.0*pow(xi1, 5) + 2310.0*pow(xi1, 4) - 630.0*pow(xi1, 3) - 315.0*pow(xi1, 2) + pow(xi2, 2)*(6630.0*pow(xi2, 9) + 2431.0*pow(xi2, 8) - 17160.0*pow(xi2, 7) - 6435.0*pow(xi2, 6) + 15444.0*pow(xi2, 5) + 6006.0*pow(xi2, 4) - 5544.0*pow(xi2, 3) - 2310.0*pow(xi2, 2) + 630.0*xi2 + 315.0));
case 12:
return 0.000244140625*x2r*(xi1*(xi1*(-xi1*(xi1*(13.0*xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(11.0*xi1 + 4.0) - 594.0) - 220.0) + 10395.0) + 3960.0) - 4620.0) - 1848.0) + 10395.0) + 4620.0) + 378.0) + 252.0) + xi2*(xi2*(xi2*(xi2*(13.0*xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(11.0*xi2 + 4.0) - 594.0) - 220.0) + 10395.0) + 3960.0) - 4620.0) - 1848.0) + 10395.0) + 4620.0) - 378.0) - 252.0));
case 13:
return 0.000244140625*x2r*(pow(xi1, 2)*(xi1*(-xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(xi1*(7.0*xi1*(36.0*xi1 + 13.0) - 780.0) - 286.0) + 17160.0) + 6435.0) - 154440.0) - 60060.0) + 36036.0) + 15015.0) + 2772.0) + 1386.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(7.0*xi2*(36.0*xi2 + 13.0) - 780.0) - 286.0) + 17160.0) + 6435.0) - 154440.0) - 60060.0) + 36036.0) + 15015.0) - 2772.0) - 1386.0));
case 14:
return 0.0001220703125*x2r*(-xi1*(xi1*(xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(39.0*xi1 + 14.0) - 3003.0) - 1092.0) + 3861.0) + 1430.0) - 45045.0) - 17160.0) + 225225.0) + 90090.0) - 27027.0) - 12012.0) + 693.0) + 462.0) + xi2*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(39.0*xi2 + 14.0) - 3003.0) - 1092.0) + 3861.0) + 1430.0) - 45045.0) - 17160.0) + 225225.0) + 90090.0) - 27027.0) - 12012.0) + 693.0) + 462.0));
case 15:
return 0.0001220703125*x2r*(-pow(xi1, 2)*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(xi1*(5.0*xi1*(14.0*xi1 + 5.0) - 252.0) - 91.0) + 8190.0) + 3003.0) - 5720.0) - 2145.0) + 38610.0) + 15015.0) - 108108.0) - 45045.0) + 6006.0) + 3003.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(xi2*(5.0*xi2*(14.0*xi2 + 5.0) - 252.0) - 91.0) + 8190.0) + 3003.0) - 5720.0) - 2145.0) + 38610.0) + 15015.0) - 108108.0) - 45045.0) + 6006.0) + 3003.0));
case 16:
return 7.62939453125e-6*x2r*(-15043725.0*pow(xi1, 16) - 5348880.0*pow(xi1, 15) + 57946200.0*pow(xi1, 14) + 20801200.0*pow(xi1, 13) - 89237148.0*pow(xi1, 12) - 32449872.0*pow(xi1, 11) + 69837768.0*pow(xi1, 10) + 25865840.0*pow(xi1, 9) - 29099070.0*pow(xi1, 8) - 11085360.0*pow(xi1, 7) + 6126120.0*pow(xi1, 6) + 2450448.0*pow(xi1, 5) - 540540.0*pow(xi1, 4) - 240240.0*pow(xi1, 3) + 10296.0*pow(xi1, 2) + 6864.0*xi1 + xi2*(15043725.0*pow(xi2, 15) + 5348880.0*pow(xi2, 14) - 57946200.0*pow(xi2, 13) - 20801200.0*pow(xi2, 12) + 89237148.0*pow(xi2, 11) + 32449872.0*pow(xi2, 10) - 69837768.0*pow(xi2, 9) - 25865840.0*pow(xi2, 8) + 29099070.0*pow(xi2, 7) + 11085360.0*pow(xi2, 6) - 6126120.0*pow(xi2, 5) - 2450448.0*pow(xi2, 4) + 540540.0*pow(xi2, 3) + 240240.0*pow(xi2, 2) - 10296.0*xi2 - 6864.0));
case 17:
return 7.62939453125e-6*x2r*(-27373680.0*pow(xi1, 17) - 9694845.0*pow(xi1, 16) + 112326480.0*pow(xi1, 15) + 40116600.0*pow(xi1, 14) - 187210800.0*pow(xi1, 13) - 67603900.0*pow(xi1, 12) + 162249360.0*pow(xi1, 11) + 59491432.0*pow(xi1, 10) - 77597520.0*pow(xi1, 9) - 29099070.0*pow(xi1, 8) + 19953648.0*pow(xi1, 7) + 7759752.0*pow(xi1, 6) - 2450448.0*pow(xi1, 5) - 1021020.0*pow(xi1, 4) + 102960.0*pow(xi1, 3) + 51480.0*pow(xi1, 2) + pow(xi2, 2)*(27373680.0*pow(xi2, 15) + 9694845.0*pow(xi2, 14) - 112326480.0*pow(xi2, 13) - 40116600.0*pow(xi2, 12) + 187210800.0*pow(xi2, 11) + 67603900.0*pow(xi2, 10) - 162249360.0*pow(xi2, 9) - 59491432.0*pow(xi2, 8) + 77597520.0*pow(xi2, 7) + 29099070.0*pow(xi2, 6) - 19953648.0*pow(xi2, 5) - 7759752.0*pow(xi2, 4) + 2450448.0*pow(xi2, 3) + 1021020.0*pow(xi2, 2) - 102960.0*xi2 - 51480.0));
case 18:
return 3.814697265625e-6*x2r*(-100180065.0*pow(xi1, 18) - 35357670.0*pow(xi1, 17) + 436268025.0*pow(xi1, 16) + 155117520.0*pow(xi1, 15) - 782273700.0*pow(xi1, 14) - 280816200.0*pow(xi1, 13) + 743642900.0*pow(xi1, 12) + 270415600.0*pow(xi1, 11) - 401567166.0*pow(xi1, 10) - 148728580.0*pow(xi1, 9) + 122216094.0*pow(xi1, 8) + 46558512.0*pow(xi1, 7) - 19399380.0*pow(xi1, 6) - 7759752.0*pow(xi1, 5) + 1312740.0*pow(xi1, 4) + 583440.0*pow(xi1, 3) - 19305.0*pow(xi1, 2) - 12870.0*xi1 + xi2*(100180065.0*pow(xi2, 17) + 35357670.0*pow(xi2, 16) - 436268025.0*pow(xi2, 15) - 155117520.0*pow(xi2, 14) + 782273700.0*pow(xi2, 13) + 280816200.0*pow(xi2, 12) - 743642900.0*pow(xi2, 11) - 270415600.0*pow(xi2, 10) + 401567166.0*pow(xi2, 9) + 148728580.0*pow(xi2, 8) - 122216094.0*pow(xi2, 7) - 46558512.0*pow(xi2, 6) + 19399380.0*pow(xi2, 5) + 7759752.0*pow(xi2, 4) - 1312740.0*pow(xi2, 3) - 583440.0*pow(xi2, 2) + 19305.0*xi2 + 12870.0));
case 19:
return 3.814697265625e-6*x2r*(-184232070.0*pow(xi1, 19) - 64822395.0*pow(xi1, 18) + 848584080.0*pow(xi1, 17) + 300540195.0*pow(xi1, 16) - 1628733960.0*pow(xi1, 15) - 581690700.0*pow(xi1, 14) + 1684897200.0*pow(xi1, 13) + 608435100.0*pow(xi1, 12) - 1014058500.0*pow(xi1, 11) - 371821450.0*pow(xi1, 10) + 356948592.0*pow(xi1, 9) + 133855722.0*pow(xi1, 8) - 69837768.0*pow(xi1, 7) - 27159132.0*pow(xi1, 6) + 6651216.0*pow(xi1, 5) + 2771340.0*pow(xi1, 4) - 218790.0*pow(xi1, 3) - 109395.0*pow(xi1, 2) + pow(xi2, 2)*(184232070.0*pow(xi2, 17) + 64822395.0*pow(xi2, 16) - 848584080.0*pow(xi2, 15) - 300540195.0*pow(xi2, 14) + 1628733960.0*pow(xi2, 13) + 581690700.0*pow(xi2, 12) - 1684897200.0*pow(xi2, 11) - 608435100.0*pow(xi2, 10) + 1014058500.0*pow(xi2, 9) + 371821450.0*pow(xi2, 8) - 356948592.0*pow(xi2, 7) - 133855722.0*pow(xi2, 6) + 69837768.0*pow(xi2, 5) + 27159132.0*pow(xi2, 4) - 6651216.0*pow(xi2, 3) - 2771340.0*pow(xi2, 2) + 218790.0*xi2 + 109395.0));
case 20:
return 9.5367431640625e-7*x2r*(-1361270295.0*pow(xi1, 20) - 477638700.0*pow(xi1, 19) + 6611884290.0*pow(xi1, 18) + 2333606220.0*pow(xi1, 17) - 13524308775.0*pow(xi1, 16) - 4808643120.0*pow(xi1, 15) + 15123958200.0*pow(xi1, 14) + 5429113200.0*pow(xi1, 13) - 10039179150.0*pow(xi1, 12) - 3650610600.0*pow(xi1, 11) + 4015671660.0*pow(xi1, 10) + 1487285800.0*pow(xi1, 9) - 936990054.0*pow(xi1, 8) - 356948592.0*pow(xi1, 7) + 116396280.0*pow(xi1, 6) + 46558512.0*pow(xi1, 5) - 6235515.0*pow(xi1, 4) - 2771340.0*pow(xi1, 3) + 72930.0*pow(xi1, 2) + 48620.0*xi1 + xi2*(1361270295.0*pow(xi2, 19) + 477638700.0*pow(xi2, 18) - 6611884290.0*pow(xi2, 17) - 2333606220.0*pow(xi2, 16) + 13524308775.0*pow(xi2, 15) + 4808643120.0*pow(xi2, 14) - 15123958200.0*pow(xi2, 13) - 5429113200.0*pow(xi2, 12) + 10039179150.0*pow(xi2, 11) + 3650610600.0*pow(xi2, 10) - 4015671660.0*pow(xi2, 9) - 1487285800.0*pow(xi2, 8) + 936990054.0*pow(xi2, 7) + 356948592.0*pow(xi2, 6) - 116396280.0*pow(xi2, 5) - 46558512.0*pow(xi2, 4) + 6235515.0*pow(xi2, 3) + 2771340.0*pow(xi2, 2) - 72930.0*xi2 - 48620.0));
case 21:
return 9.5367431640625e-7*x2r*(-2524661700.0*pow(xi1, 21) - 883631595.0*pow(xi1, 20) + 12896244900.0*pow(xi1, 19) + 4537567650.0*pow(xi1, 18) - 28003274640.0*pow(xi1, 17) - 9917826435.0*pow(xi1, 16) + 33660501840.0*pow(xi1, 15) + 12021607800.0*pow(xi1, 14) - 24431009400.0*pow(xi1, 13) - 8822308950.0*pow(xi1, 12) + 10951831800.0*pow(xi1, 11) + 4015671660.0*pow(xi1, 10) - 2974571600.0*pow(xi1, 9) - 1115464350.0*pow(xi1, 8) + 458933904.0*pow(xi1, 7) + 178474296.0*pow(xi1, 6) - 34918884.0*pow(xi1, 5) - 14549535.0*pow(xi1, 4) + 923780.0*pow(xi1, 3) + 461890.0*pow(xi1, 2) + pow(xi2, 2)*(2524661700.0*pow(xi2, 19) + 883631595.0*pow(xi2, 18) - 12896244900.0*pow(xi2, 17) - 4537567650.0*pow(xi2, 16) + 28003274640.0*pow(xi2, 15) + 9917826435.0*pow(xi2, 14) - 33660501840.0*pow(xi2, 13) - 12021607800.0*pow(xi2, 12) + 24431009400.0*pow(xi2, 11) + 8822308950.0*pow(xi2, 10) - 10951831800.0*pow(xi2, 9) - 4015671660.0*pow(xi2, 8) + 2974571600.0*pow(xi2, 7) + 1115464350.0*pow(xi2, 6) - 458933904.0*pow(xi2, 5) - 178474296.0*pow(xi2, 4) + 34918884.0*pow(xi2, 3) + 14549535.0*pow(xi2, 2) - 923780.0*xi2 - 461890.0));
case 22:
return 4.76837158203125e-7*x2r*(-9398626965.0*pow(xi1, 22) - 3282060210.0*pow(xi1, 21) + 50367000915.0*pow(xi1, 20) + 17672631900.0*pow(xi1, 19) - 115707975075.0*pow(xi1, 18) - 40838108850.0*pow(xi1, 17) + 148767396525.0*pow(xi1, 16) + 52895074320.0*pow(xi1, 15) - 117210676050.0*pow(xi1, 14) - 42075627300.0*pow(xi1, 13) + 58227239070.0*pow(xi1, 12) + 21173541480.0*pow(xi1, 11) - 18070522470.0*pow(xi1, 10) - 6692786100.0*pow(xi1, 9) + 3346393050.0*pow(xi1, 8) + 1274816400.0*pow(xi1, 7) - 334639305.0*pow(xi1, 6) - 133855722.0*pow(xi1, 5) + 14549535.0*pow(xi1, 4) + 6466460.0*pow(xi1, 3) - 138567.0*pow(xi1, 2) - 92378.0*xi1 + xi2*(9398626965.0*pow(xi2, 21) + 3282060210.0*pow(xi2, 20) - 50367000915.0*pow(xi2, 19) - 17672631900.0*pow(xi2, 18) + 115707975075.0*pow(xi2, 17) + 40838108850.0*pow(xi2, 16) - 148767396525.0*pow(xi2, 15) - 52895074320.0*pow(xi2, 14) + 117210676050.0*pow(xi2, 13) + 42075627300.0*pow(xi2, 12) - 58227239070.0*pow(xi2, 11) - 21173541480.0*pow(xi2, 10) + 18070522470.0*pow(xi2, 9) + 6692786100.0*pow(xi2, 8) - 3346393050.0*pow(xi2, 7) - 1274816400.0*pow(xi2, 6) + 334639305.0*pow(xi2, 5) + 133855722.0*pow(xi2, 4) - 14549535.0*pow(xi2, 3) - 6466460.0*pow(xi2, 2) + 138567.0*xi2 + 92378.0));
case 23:
return 4.76837158203125e-7*x2r*(-17551887210.0*pow(xi1, 23) - 6116566755.0*pow(xi1, 22) + 98461806300.0*pow(xi1, 21) + 34461632205.0*pow(xi1, 20) - 238580530650.0*pow(xi1, 19) - 83945001525.0*pow(xi1, 18) + 326704870800.0*pow(xi1, 17) + 115707975075.0*pow(xi1, 16) - 277699140180.0*pow(xi1, 15) - 99178264350.0*pow(xi1, 14) + 151472258280.0*pow(xi1, 13) + 54698315490.0*pow(xi1, 12) - 52933853700.0*pow(xi1, 11) - 19409079690.0*pow(xi1, 10) + 11473347600.0*pow(xi1, 9) + 4302505350.0*pow(xi1, 8) - 1434168450.0*pow(xi1, 7) - 557732175.0*pow(xi1, 6) + 89237148.0*pow(xi1, 5) + 37182145.0*pow(xi1, 4) - 1939938.0*pow(xi1, 3) - 969969.0*pow(xi1, 2) + pow(xi2, 2)*(17551887210.0*pow(xi2, 21) + 6116566755.0*pow(xi2, 20) - 98461806300.0*pow(xi2, 19) - 34461632205.0*pow(xi2, 18) + 238580530650.0*pow(xi2, 17) + 83945001525.0*pow(xi2, 16) - 326704870800.0*pow(xi2, 15) - 115707975075.0*pow(xi2, 14) + 277699140180.0*pow(xi2, 13) + 99178264350.0*pow(xi2, 12) - 151472258280.0*pow(xi2, 11) - 54698315490.0*pow(xi2, 10) + 52933853700.0*pow(xi2, 9) + 19409079690.0*pow(xi2, 8) - 11473347600.0*pow(xi2, 7) - 4302505350.0*pow(xi2, 6) + 1434168450.0*pow(xi2, 5) + 557732175.0*pow(xi2, 4) - 89237148.0*pow(xi2, 3) - 37182145.0*pow(xi2, 2) + 1939938.0*xi2 + 969969.0));
case 24:
return 5.96046447753906e-8*x2r*(-263012370465.0*pow(xi1, 24) - 91482563640.0*pow(xi1, 23) + 1541374822260.0*pow(xi1, 22) + 538257874440.0*pow(xi1, 21) - 3928626071370.0*pow(xi1, 20) - 1378465288200.0*pow(xi1, 19) + 5708260103700.0*pow(xi1, 18) + 2014680036600.0*pow(xi1, 17) - 5206858878375.0*pow(xi1, 16) - 1851327601200.0*pow(xi1, 15) + 3094361847720.0*pow(xi1, 14) + 1110796560720.0*pow(xi1, 13) - 1203362940780.0*pow(xi1, 12) - 437586523920.0*pow(xi1, 11) + 299454372360.0*pow(xi1, 10) + 110909026800.0*pow(xi1, 9) - 45176306175.0*pow(xi1, 8) - 17210021400.0*pow(xi1, 7) + 3718214500.0*pow(xi1, 6) + 1487285800.0*pow(xi1, 5) - 133855722.0*pow(xi1, 4) - 59491432.0*pow(xi1, 3) + 1058148.0*pow(xi1, 2) + 705432.0*xi1 + xi2*(263012370465.0*pow(xi2, 23) + 91482563640.0*pow(xi2, 22) - 1541374822260.0*pow(xi2, 21) - 538257874440.0*pow(xi2, 20) + 3928626071370.0*pow(xi2, 19) + 1378465288200.0*pow(xi2, 18) - 5708260103700.0*pow(xi2, 17) - 2014680036600.0*pow(xi2, 16) + 5206858878375.0*pow(xi2, 15) + 1851327601200.0*pow(xi2, 14) - 3094361847720.0*pow(xi2, 13) - 1110796560720.0*pow(xi2, 12) + 1203362940780.0*pow(xi2, 11) + 437586523920.0*pow(xi2, 10) - 299454372360.0*pow(xi2, 9) - 110909026800.0*pow(xi2, 8) + 45176306175.0*pow(xi2, 7) + 17210021400.0*pow(xi2, 6) - 3718214500.0*pow(xi2, 5) - 1487285800.0*pow(xi2, 4) + 133855722.0*pow(xi2, 3) + 59491432.0*pow(xi2, 2) - 1058148.0*xi2 - 705432.0));
case 25:
return 5.96046447753906e-8*x2r*(-494005843656.0*pow(xi1, 25) - 171529806825.0*pow(xi1, 24) + 3018924600120.0*pow(xi1, 23) + 1052049481860.0*pow(xi1, 22) - 8073868116600.0*pow(xi1, 21) - 2825853840810.0*pow(xi1, 20) + 12406187593800.0*pow(xi1, 19) + 4365140079300.0*pow(xi1, 18) - 12088080219600.0*pow(xi1, 17) - 4281195077775.0*pow(xi1, 16) + 7775575925040.0*pow(xi1, 15) + 2776991401800.0*pow(xi1, 14) - 3332389682160.0*pow(xi1, 13) - 1203362940780.0*pow(xi1, 12) + 937685408400.0*pow(xi1, 11) + 343817983080.0*pow(xi1, 10) - 166363540200.0*pow(xi1, 9) - 62386327575.0*pow(xi1, 8) + 17210021400.0*pow(xi1, 7) + 6692786100.0*pow(xi1, 6) - 892371480.0*pow(xi1, 5) - 371821450.0*pow(xi1, 4) + 16224936.0*pow(xi1, 3) + 8112468.0*pow(xi1, 2) + pow(xi2, 2)*(494005843656.0*pow(xi2, 23) + 171529806825.0*pow(xi2, 22) - 3018924600120.0*pow(xi2, 21) - 1052049481860.0*pow(xi2, 20) + 8073868116600.0*pow(xi2, 19) + 2825853840810.0*pow(xi2, 18) - 12406187593800.0*pow(xi2, 17) - 4365140079300.0*pow(xi2, 16) + 12088080219600.0*pow(xi2, 15) + 4281195077775.0*pow(xi2, 14) - 7775575925040.0*pow(xi2, 13) - 2776991401800.0*pow(xi2, 12) + 3332389682160.0*pow(xi2, 11) + 1203362940780.0*pow(xi2, 10) - 937685408400.0*pow(xi2, 9) - 343817983080.0*pow(xi2, 8) + 166363540200.0*pow(xi2, 7) + 62386327575.0*pow(xi2, 6) - 17210021400.0*pow(xi2, 5) - 6692786100.0*pow(xi2, 4) + 892371480.0*pow(xi2, 3) + 371821450.0*pow(xi2, 2) - 16224936.0*xi2 - 8112468.0));
case 26:
return 2.98023223876953e-8*x2r*(-1860438674025.0*pow(xi1, 26) - 644952073662.0*pow(xi1, 25) + 11835556670925.0*pow(xi1, 24) + 4116715363800.0*pow(xi1, 23) - 33139558678590.0*pow(xi1, 22) - 11572544300460.0*pow(xi1, 21) + 53691222975390.0*pow(xi1, 20) + 18839025605400.0*pow(xi1, 19) - 55655536011075.0*pow(xi1, 18) - 19643130356850.0*pow(xi1, 17) + 38530755699975.0*pow(xi1, 16) + 13699824248880.0*pow(xi1, 15) - 18050444111700.0*pow(xi1, 14) - 6479646604200.0*pow(xi1, 13) + 5672996720820.0*pow(xi1, 12) + 2062907898480.0*pow(xi1, 11) - 1160385692895.0*pow(xi1, 10) - 429772478850.0*pow(xi1, 9) + 145568097675.0*pow(xi1, 8) + 55454513400.0*pow(xi1, 7) - 10039179150.0*pow(xi1, 6) - 4015671660.0*pow(xi1, 5) + 304217550.0*pow(xi1, 4) + 135207800.0*pow(xi1, 3) - 2028117.0*pow(xi1, 2) - 1352078.0*xi1 + xi2*(1860438674025.0*pow(xi2, 25) + 644952073662.0*pow(xi2, 24) - 11835556670925.0*pow(xi2, 23) - 4116715363800.0*pow(xi2, 22) + 33139558678590.0*pow(xi2, 21) + 11572544300460.0*pow(xi2, 20) - 53691222975390.0*pow(xi2, 19) - 18839025605400.0*pow(xi2, 18) + 55655536011075.0*pow(xi2, 17) + 19643130356850.0*pow(xi2, 16) - 38530755699975.0*pow(xi2, 15) - 13699824248880.0*pow(xi2, 14) + 18050444111700.0*pow(xi2, 13) + 6479646604200.0*pow(xi2, 12) - 5672996720820.0*pow(xi2, 11) - 2062907898480.0*pow(xi2, 10) + 1160385692895.0*pow(xi2, 9) + 429772478850.0*pow(xi2, 8) - 145568097675.0*pow(xi2, 7) - 55454513400.0*pow(xi2, 6) + 10039179150.0*pow(xi2, 5) + 4015671660.0*pow(xi2, 4) - 304217550.0*pow(xi2, 3) - 135207800.0*pow(xi2, 2) + 2028117.0*xi2 + 1352078.0));
case 27:
return 2.98023223876953e-8*x2r*(-3511405734382.0*pow(xi1, 27) - 1215486600363.0*pow(xi1, 26) + 23218274651832.0*pow(xi1, 25) + 8061900920775.0*pow(xi1, 24) - 67925803502700.0*pow(xi1, 23) - 23671113341850.0*pow(xi1, 22) + 115725443004600.0*pow(xi1, 21) + 40503905051610.0*pow(xi1, 20) - 127163422836450.0*pow(xi1, 19) - 44742685812825.0*pow(xi1, 18) + 94287025712880.0*pow(xi1, 17) + 33393321606645.0*pow(xi1, 16) - 47949384871080.0*pow(xi1, 15) - 17124780311100.0*pow(xi1, 14) + 16661948410800.0*pow(xi1, 13) + 6016814703900.0*pow(xi1, 12) - 3867952309650.0*pow(xi1, 11) - 1418249180205.0*pow(xi1, 10) + 573029971800.0*pow(xi1, 9) + 214886239425.0*pow(xi1, 8) - 49909062060.0*pow(xi1, 7) - 19409079690.0*pow(xi1, 6) + 2190366360.0*pow(xi1, 5) + 912652650.0*pow(xi1, 4) - 33801950.0*pow(xi1, 3) - 16900975.0*pow(xi1, 2) + pow(xi2, 2)*(3511405734382.0*pow(xi2, 25) + 1215486600363.0*pow(xi2, 24) - 23218274651832.0*pow(xi2, 23) - 8061900920775.0*pow(xi2, 22) + 67925803502700.0*pow(xi2, 21) + 23671113341850.0*pow(xi2, 20) - 115725443004600.0*pow(xi2, 19) - 40503905051610.0*pow(xi2, 18) + 127163422836450.0*pow(xi2, 17) + 44742685812825.0*pow(xi2, 16) - 94287025712880.0*pow(xi2, 15) - 33393321606645.0*pow(xi2, 14) + 47949384871080.0*pow(xi2, 13) + 17124780311100.0*pow(xi2, 12) - 16661948410800.0*pow(xi2, 11) - 6016814703900.0*pow(xi2, 10) + 3867952309650.0*pow(xi2, 9) + 1418249180205.0*pow(xi2, 8) - 573029971800.0*pow(xi2, 7) - 214886239425.0*pow(xi2, 6) + 49909062060.0*pow(xi2, 5) + 19409079690.0*pow(xi2, 4) - 2190366360.0*pow(xi2, 3) - 912652650.0*pow(xi2, 2) + 33801950.0*xi2 + 16900975.0));
case 28:
return 7.45058059692383e-9*x2r*(-26567064265077.0*pow(xi1, 28) - 9183676536076.0*pow(xi1, 27) + 182322990054450.0*pow(xi1, 26) + 63205303218876.0*pow(xi1, 25) - 556271163533475.0*pow(xi1, 24) - 193485622098600.0*pow(xi1, 23) + 994186760357700.0*pow(xi1, 22) + 347176329013800.0*pow(xi1, 21) - 1.15436129397089e+15*pow(xi1, 20) - 405039050516100.0*pow(xi1, 19) + 912750790581630.0*pow(xi1, 18) + 322147337852340.0*pow(xi1, 17) - 500899824099675.0*pow(xi1, 16) - 178097715235440.0*pow(xi1, 15) + 190818980609400.0*pow(xi1, 14) + 68499121244400.0*pow(xi1, 13) - 49638721307175.0*pow(xi1, 12) - 18050444111700.0*pow(xi1, 11) + 8509495081230.0*pow(xi1, 10) + 3151664844900.0*pow(xi1, 9) - 902522205585.0*pow(xi1, 8) - 343817983080.0*pow(xi1, 7) + 52933853700.0*pow(xi1, 6) + 21173541480.0*pow(xi1, 5) - 1368978975.0*pow(xi1, 4) - 608435100.0*pow(xi1, 3) + 7800450.0*pow(xi1, 2) + 5200300.0*xi1 + xi2*(26567064265077.0*pow(xi2, 27) + 9183676536076.0*pow(xi2, 26) - 182322990054450.0*pow(xi2, 25) - 63205303218876.0*pow(xi2, 24) + 556271163533475.0*pow(xi2, 23) + 193485622098600.0*pow(xi2, 22) - 994186760357700.0*pow(xi2, 21) - 347176329013800.0*pow(xi2, 20) + 1.15436129397089e+15*pow(xi2, 19) + 405039050516100.0*pow(xi2, 18) - 912750790581630.0*pow(xi2, 17) - 322147337852340.0*pow(xi2, 16) + 500899824099675.0*pow(xi2, 15) + 178097715235440.0*pow(xi2, 14) - 190818980609400.0*pow(xi2, 13) - 68499121244400.0*pow(xi2, 12) + 49638721307175.0*pow(xi2, 11) + 18050444111700.0*pow(xi2, 10) - 8509495081230.0*pow(xi2, 9) - 3151664844900.0*pow(xi2, 8) + 902522205585.0*pow(xi2, 7) + 343817983080.0*pow(xi2, 6) - 52933853700.0*pow(xi2, 5) - 21173541480.0*pow(xi2, 4) + 1368978975.0*pow(xi2, 3) + 608435100.0*pow(xi2, 2) - 7800450.0*xi2 - 5200300.0));
case 29:
return 7.45058059692383e-9*x2r*(-50351881697796.0*pow(xi1, 29) - 17383387729001.0*pow(xi1, 28) + 358163384906964.0*pow(xi1, 27) + 123979633237026.0*pow(xi1, 26) - 1.13769545793977e+15*pow(xi1, 25) - 395033145117975.0*pow(xi1, 24) + 2.1283418430846e+15*pow(xi1, 23) + 741694884711300.0*pow(xi1, 22) - 2.6038224676035e+15*pow(xi1, 21) - 911337863661225.0*pow(xi1, 20) + 2.18721087278694e+15*pow(xi1, 19) + 769574195980590.0*pow(xi1, 18) - 1.28858935140936e+15*pow(xi1, 17) - 456375395290815.0*pow(xi1, 16) + 534293145706320.0*pow(xi1, 15) + 190818980609400.0*pow(xi1, 14) - 154123022799900.0*pow(xi1, 13) - 55655536011075.0*pow(xi1, 12) + 30084073519500.0*pow(xi1, 11) + 11030826957150.0*pow(xi1, 10) - 3781997813880.0*pow(xi1, 9) - 1418249180205.0*pow(xi1, 8) + 281305622520.0*pow(xi1, 7) + 109396630980.0*pow(xi1, 6) - 10586770740.0*pow(xi1, 5) - 4411154475.0*pow(xi1, 4) + 140408100.0*pow(xi1, 3) + 70204050.0*pow(xi1, 2) + pow(xi2, 2)*(50351881697796.0*pow(xi2, 27) + 17383387729001.0*pow(xi2, 26) - 358163384906964.0*pow(xi2, 25) - 123979633237026.0*pow(xi2, 24) + 1.13769545793977e+15*pow(xi2, 23) + 395033145117975.0*pow(xi2, 22) - 2.1283418430846e+15*pow(xi2, 21) - 741694884711300.0*pow(xi2, 20) + 2.6038224676035e+15*pow(xi2, 19) + 911337863661225.0*pow(xi2, 18) - 2.18721087278694e+15*pow(xi2, 17) - 769574195980590.0*pow(xi2, 16) + 1.28858935140936e+15*pow(xi2, 15) + 456375395290815.0*pow(xi2, 14) - 534293145706320.0*pow(xi2, 13) - 190818980609400.0*pow(xi2, 12) + 154123022799900.0*pow(xi2, 11) + 55655536011075.0*pow(xi2, 10) - 30084073519500.0*pow(xi2, 9) - 11030826957150.0*pow(xi2, 8) + 3781997813880.0*pow(xi2, 7) + 1418249180205.0*pow(xi2, 6) - 281305622520.0*pow(xi2, 5) - 109396630980.0*pow(xi2, 4) + 10586770740.0*pow(xi2, 3) + 4411154475.0*pow(xi2, 2) - 140408100.0*xi2 - 70204050.0));
default:
return 0.;
}
case 4:
switch(j) {
case 0:
return 0.0625*y1t*(-9.0*pow(xi1, 4) + 6.0*pow(xi1, 2) + 9.0*pow(xi2, 4) - 6.0*pow(xi2, 2));
case 1:
return 0.03125*y1r*(-9.0*pow(xi1, 4) + 4.0*pow(xi1, 3) + 6.0*pow(xi1, 2) - 4.0*xi1 + xi2*(9.0*pow(xi2, 3) - 4.0*pow(xi2, 2) - 6.0*xi2 + 4.0));
case 2:
return 0.0625*y2t*(9.0*pow(xi1, 4) - 6.0*pow(xi1, 2) - 9.0*pow(xi2, 4) + 6.0*pow(xi2, 2));
case 3:
return 0.03125*y2r*(-9.0*pow(xi1, 4) - 4.0*pow(xi1, 3) + 6.0*pow(xi1, 2) + 4.0*xi1 + xi2*(9.0*pow(xi2, 3) + 4.0*pow(xi2, 2) - 6.0*xi2 - 4.0));
case 4:
return -0.45*pow(xi1, 5) + 0.5*pow(xi1, 3) - 0.25*xi1 + 0.45*pow(xi2, 5) - 0.5*pow(xi2, 3) + 0.25*xi2;
case 5:
return -0.625*pow(xi1, 6) + 0.875*pow(xi1, 4) - 0.375*pow(xi1, 2) + 0.625*pow(xi2, 6) - 0.875*pow(xi2, 4) + 0.375*pow(xi2, 2);
case 6:
return -0.9375*pow(xi1, 7) + 1.5625*pow(xi1, 5) - 0.8125*pow(xi1, 3) + 0.1875*xi1 + 0.9375*pow(xi2, 7) - 1.5625*pow(xi2, 5) + 0.8125*pow(xi2, 3) - 0.1875*xi2;
case 7:
return -1.4765625*pow(xi1, 8) + 2.84375*pow(xi1, 6) - 1.796875*pow(xi1, 4) + 0.46875*pow(xi1, 2) + 1.4765625*pow(xi2, 8) - 2.84375*pow(xi2, 6) + 1.796875*pow(xi2, 4) - 0.46875*pow(xi2, 2);
case 8:
return -2.40625*pow(xi1, 9) + 5.25*pow(xi1, 7) - 3.9375*pow(xi1, 5) + 1.25*pow(xi1, 3) - 0.15625*xi1 + 2.40625*pow(xi2, 9) - 5.25*pow(xi2, 7) + 3.9375*pow(xi2, 5) - 1.25*pow(xi2, 3) + 0.15625*xi2;
case 9:
return -4.021875*pow(xi1, 10) + 9.796875*pow(xi1, 8) - 8.53125*pow(xi1, 6) + 3.28125*pow(xi1, 4) - 0.546875*pow(xi1, 2) + 0.003125*pow(xi2, 2)*(1287.0*pow(xi2, 8) - 3135.0*pow(xi2, 6) + 2730.0*pow(xi2, 4) - 1050.0*pow(xi2, 2) + 175.0);
case 10:
return -6.85546875*pow(xi1, 11) + 18.43359375*pow(xi1, 9) - 18.3046875*pow(xi1, 7) + 8.3671875*pow(xi1, 5) - 1.77734375*pow(xi1, 3) + 0.13671875*xi1 + 6.85546875*pow(xi2, 11) - 18.43359375*pow(xi2, 9) + 18.3046875*pow(xi2, 7) - 8.3671875*pow(xi2, 5) + 1.77734375*pow(xi2, 3) - 0.13671875*xi2;
case 11:
return -11.8701171875*pow(xi1, 12) + 34.912109375*pow(xi1, 10) - 38.9619140625*pow(xi1, 8) + 20.75390625*pow(xi1, 6) - 5.4345703125*pow(xi1, 4) + 0.615234375*pow(xi1, 2) + 0.0009765625*pow(xi2, 2)*(12155.0*pow(xi2, 10) - 35750.0*pow(xi2, 8) + 39897.0*pow(xi2, 6) - 21252.0*pow(xi2, 4) + 5565.0*pow(xi2, 2) - 630.0);
case 12:
return -20.818359375*pow(xi1, 13) + 66.47265625*pow(xi1, 11) - 82.392578125*pow(xi1, 9) + 50.2734375*pow(xi1, 7) - 15.791015625*pow(xi1, 5) + 2.37890625*pow(xi1, 3) - 0.123046875*xi1 + 20.818359375*pow(xi2, 13) - 66.47265625*pow(xi2, 11) + 82.392578125*pow(xi2, 9) - 50.2734375*pow(xi2, 7) + 15.791015625*pow(xi2, 5) - 2.37890625*pow(xi2, 3) + 0.123046875*xi2;
case 13:
return -36.9052734375*pow(xi1, 14) + 127.1181640625*pow(xi1, 12) - 173.3037109375*pow(xi1, 10) + 119.3994140625*pow(xi1, 8) - 43.9892578125*pow(xi1, 6) + 8.3466796875*pow(xi1, 4) - 0.6767578125*pow(xi1, 2) + 0.0009765625*pow(xi2, 2)*(37791.0*pow(xi2, 12) - 130169.0*pow(xi2, 10) + 177463.0*pow(xi2, 8) - 122265.0*pow(xi2, 6) + 45045.0*pow(xi2, 4) - 8547.0*pow(xi2, 2) + 693.0);
case 14:
return -66.01943359375*pow(xi1, 15) + 243.98486328125*pow(xi1, 13) - 362.90185546875*pow(xi1, 11) + 278.94775390625*pow(xi1, 9) - 118.35205078125*pow(xi1, 7) + 27.27333984375*pow(xi1, 5) - 3.04541015625*pow(xi1, 3) + 0.11279296875*xi1 + 66.01943359375*pow(xi2, 15) - 243.98486328125*pow(xi2, 13) + 362.90185546875*pow(xi2, 11) - 278.94775390625*pow(xi2, 9) + 118.35205078125*pow(xi2, 7) - 27.27333984375*pow(xi2, 5) + 3.04541015625*pow(xi2, 3) - 0.11279296875*xi2;
case 15:
return -119.025421142578*pow(xi1, 16) + 469.753662109375*pow(xi1, 14) - 757.070678710938*pow(xi1, 12) + 642.766845703125*pow(xi1, 10) - 309.364929199219*pow(xi1, 8) + 84.312744140625*pow(xi1, 6) - 12.0970458984375*pow(xi1, 4) + 0.733154296875*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(3900225.0*pow(xi2, 14) - 15392888.0*pow(xi2, 12) + 24807692.0*pow(xi2, 10) - 21062184.0*pow(xi2, 8) + 10137270.0*pow(xi2, 6) - 2762760.0*pow(xi2, 4) + 396396.0*pow(xi2, 2) - 24024.0);
case 16:
return -216.046142578125*pow(xi1, 17) + 906.8603515625*pow(xi1, 15) - 1574.3095703125*pow(xi1, 13) + 1463.9091796875*pow(xi1, 11) - 789.36279296875*pow(xi1, 9) + 249.2724609375*pow(xi1, 7) - 43.9892578125*pow(xi1, 5) + 3.7705078125*pow(xi1, 3) - 0.104736328125*xi1 + 216.046142578125*pow(xi2, 17) - 906.8603515625*pow(xi2, 15) + 1574.3095703125*pow(xi2, 13) - 1463.9091796875*pow(xi2, 11) + 789.36279296875*pow(xi2, 9) - 249.2724609375*pow(xi2, 7) + 43.9892578125*pow(xi2, 5) - 3.7705078125*pow(xi2, 3) + 0.104736328125*xi2;
case 17:
return -394.484252929688*pow(xi1, 18) + 1754.77478027344*pow(xi1, 16) - 3264.697265625*pow(xi1, 14) + 3300.9716796875*pow(xi1, 12) - 1973.40698242188*pow(xi1, 10) + 710.426513671875*pow(xi1, 8) - 149.5634765625*pow(xi1, 6) + 16.7578125*pow(xi1, 4) - 0.7855224609375*pow(xi1, 2) + 0.0001220703125*pow(xi2, 2)*(3231615.0*pow(xi2, 16) - 14375115.0*pow(xi2, 14) + 26744400.0*pow(xi2, 12) - 27041560.0*pow(xi2, 10) + 16166150.0*pow(xi2, 8) - 5819814.0*pow(xi2, 6) + 1225224.0*pow(xi2, 4) - 137280.0*pow(xi2, 2) + 6435.0);
case 18:
return -724.086227416992*pow(xi1, 19) + 3402.42668151855*pow(xi1, 17) - 6753.84246826172*pow(xi1, 15) + 7379.57611083984*pow(xi1, 13) - 4848.30215454102*pow(xi1, 11) + 1963.53994750977*pow(xi1, 9) - 482.075134277344*pow(xi1, 7) + 67.2145385742188*pow(xi1, 5) - 4.54948425292969*pow(xi1, 3) + 0.0981903076171875*xi1 + 724.086227416992*pow(xi2, 19) - 3402.42668151855*pow(xi2, 17) + 6753.84246826172*pow(xi2, 15) - 7379.57611083984*pow(xi2, 13) + 4848.30215454102*pow(xi2, 11) - 1963.53994750977*pow(xi2, 9) + 482.075134277344*pow(xi2, 7) - 67.2145385742188*pow(xi2, 5) + 4.54948425292969*pow(xi2, 3) - 0.0981903076171875*xi2;
case 19:
return -1335.30018997192*pow(xi1, 20) + 6609.06154632568*pow(xi1, 18) - 13942.5528144836*pow(xi1, 16) + 16374.4972229004*pow(xi1, 14) - 11733.9227676392*pow(xi1, 12) + 5287.74400939941*pow(xi1, 10) - 1487.45551300049*pow(xi1, 8) + 249.495025634766*pow(xi1, 6) - 22.3955726623535*pow(xi1, 4) + 0.834617614746094*pow(xi1, 2) + 7.62939453125e-7*pow(xi2, 2)*(1750204665.0*pow(xi2, 18) - 8662629150.0*pow(xi2, 16) + 18274782825.0*pow(xi2, 14) - 21462381000.0*pow(xi2, 12) + 15379887250.0*pow(xi2, 10) - 6930751828.0*pow(xi2, 8) + 1949637690.0*pow(xi2, 6) - 327018120.0*pow(xi2, 4) + 29354325.0*pow(xi2, 2) - 1093950.0);
case 20:
return -2472.77812957764*pow(xi1, 21) + 12858.4462738037*pow(xi1, 19) - 28729.1859054565*pow(xi1, 17) + 36095.3091430664*pow(xi1, 15) - 28030.4866790771*pow(xi1, 13) + 13925.9742736816*pow(xi1, 11) - 4425.36515808105*pow(xi1, 9) + 871.118225097656*pow(xi1, 7) - 98.3179550170898*pow(xi1, 5) + 5.37864685058594*pow(xi1, 3) - 0.0927352905273438*xi1 + 2472.77812957764*pow(xi2, 21) - 12858.4462738037*pow(xi2, 19) + 28729.1859054565*pow(xi2, 17) - 36095.3091430664*pow(xi2, 15) + 28030.4866790771*pow(xi2, 13) - 13925.9742736816*pow(xi2, 11) + 4425.36515808105*pow(xi2, 9) - 871.118225097656*pow(xi2, 7) + 98.3179550170898*pow(xi2, 5) - 5.37864685058594*pow(xi2, 3) + 0.0927352905273438*xi2;
case 21:
return -4596.5277671814*pow(xi1, 22) + 25053.1468391418*pow(xi1, 20) - 59099.3972969055*pow(xi1, 18) + 79106.4203453064*pow(xi1, 16) - 66199.3886947632*pow(xi1, 14) + 35975.4335403442*pow(xi1, 12) - 12765.4764175415*pow(xi1, 10) + 2893.50798797607*pow(xi1, 8) - 395.914775848389*pow(xi1, 6) + 29.0725135803223*pow(xi1, 4) - 0.880985260009766*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(1204952175.0*pow(xi2, 20) - 6567532125.0*pow(xi2, 18) + 15492552405.0*pow(xi2, 16) - 20737273455.0*pow(xi2, 14) + 17353772550.0*pow(xi2, 12) - 9430744050.0*pow(xi2, 10) + 3346393050.0*pow(xi2, 8) - 758515758.0*pow(xi2, 6) + 103786683.0*pow(xi2, 4) - 7621185.0*pow(xi2, 2) + 230945.0);
case 22:
return -8573.52353096008*pow(xi1, 23) + 48876.4119243622*pow(xi1, 21) - 121393.88422966*pow(xi1, 19) + 172476.27453804*pow(xi1, 17) - 154773.431110382*pow(xi1, 15) + 91384.7427177429*pow(xi1, 13) - 35859.3837547302*pow(xi1, 11) + 9219.5107460022*pow(xi1, 9) - 1489.30558204651*pow(xi1, 7) + 138.755178451538*pow(xi1, 5) - 6.25499534606934*pow(xi1, 3) + 0.0880985260009766*xi1 + 8573.52353096008*pow(xi2, 23) - 48876.4119243622*pow(xi2, 21) + 121393.88422966*pow(xi2, 19) - 172476.27453804*pow(xi2, 17) + 154773.431110382*pow(xi2, 15) - 91384.7427177429*pow(xi2, 13) + 35859.3837547302*pow(xi2, 11) - 9219.5107460022*pow(xi2, 9) + 1489.30558204651*pow(xi2, 7) - 138.755178451538*pow(xi2, 5) + 6.25499534606934*pow(xi2, 3) - 0.0880985260009766*xi2;
case 23:
return -16041.3347017765*pow(xi1, 24) + 95465.5040788651*pow(xi1, 22) - 249016.891787052*pow(xi1, 20) + 374316.789364815*pow(xi1, 18) - 358630.103105307*pow(xi1, 16) + 228720.737085342*pow(xi1, 14) - 98439.2306470871*pow(xi1, 12) + 28357.5940418243*pow(xi1, 10) - 5299.95226264*pow(xi1, 8) + 602.814164161682*pow(xi1, 6) - 36.8472084999084*pow(xi1, 4) + 0.925034523010254*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(67282234305.0*pow(xi2, 22) - 400411345620.0*pow(xi2, 20) + 1044452545290.0*pow(xi2, 18) - 1569998406900.0*pow(xi2, 16) + 1504203675975.0*pow(xi2, 14) - 959324302440.0*pow(xi2, 12) + 412884058860.0*pow(xi2, 10) - 118940370120.0*pow(xi2, 8) + 22229610975.0*pow(xi2, 6) - 2528385860.0*pow(xi2, 4) + 154548394.0*pow(xi2, 2) - 3879876.0);
case 24:
return -30099.3771131516*pow(xi1, 25) + 186662.80380249*pow(xi1, 23) - 510192.693929672*pow(xi1, 21) + 808988.887023926*pow(xi1, 19) - 824362.408947945*pow(xi1, 17) + 564980.347045898*pow(xi1, 15) - 264834.537677765*pow(xi1, 13) + 84616.872253418*pow(xi1, 11) - 18008.4399461746*pow(xi1, 9) + 2431.51931762695*pow(xi1, 7) - 190.063759994507*pow(xi1, 5) + 7.176025390625*pow(xi1, 3) - 0.0840940475463867*xi1 + 30099.3771131516*pow(xi2, 25) - 186662.80380249*pow(xi2, 23) + 510192.693929672*pow(xi2, 21) - 808988.887023926*pow(xi2, 19) + 824362.408947945*pow(xi2, 17) - 564980.347045898*pow(xi2, 15) + 264834.537677765*pow(xi2, 13) - 84616.872253418*pow(xi2, 11) + 18008.4399461746*pow(xi2, 9) - 2431.51931762695*pow(xi2, 7) + 190.063759994507*pow(xi2, 5) - 7.176025390625*pow(xi2, 3) + 0.0840940475463867*xi2;
case 25:
return -56625.0823616982*pow(xi1, 26) + 365336.642496586*pow(xi1, 24) - 1044145.05877018*pow(xi1, 22) + 1741854.19737339*pow(xi1, 20) - 1881320.51070929*pow(xi1, 18) + 1379346.55040503*pow(xi1, 16) - 699919.84957695*pow(xi1, 14) + 245917.784986496*pow(xi1, 12) - 58835.1689887047*pow(xi1, 10) + 9232.17490911484*pow(xi1, 8) - 886.491417884827*pow(xi1, 6) + 45.7751932144165*pow(xi1, 4) - 0.967081546783447*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(118751404725.0*pow(xi2, 24) - 766166470485.0*pow(xi2, 22) + 2189730898290.0*pow(xi2, 20) - 3652933013730.0*pow(xi2, 18) + 3945415071675.0*pow(xi2, 16) - 2892699376875.0*pow(xi2, 14) + 1467838312380.0*pow(xi2, 12) - 515726974620.0*pow(xi2, 10) + 123386292315.0*pow(xi2, 8) - 19361274075.0*pow(xi2, 6) + 1859107250.0*pow(xi2, 4) - 95997538.0*pow(xi2, 2) + 2028117.0);
case 26:
return -106783.720132709*pow(xi1, 27) + 715678.124293685*pow(xi1, 25) - 2134765.60503602*pow(xi1, 23) + 3737630.98551393*pow(xi1, 21) - 4265625.64844191*pow(xi1, 19) + 3332338.98971379*pow(xi1, 17) - 1820737.44653463*pow(xi1, 15) + 698343.453519344*pow(xi1, 13) - 185835.598881841*pow(xi1, 11) + 33328.9112716913*pow(xi1, 9) - 3818.24517846107*pow(xi1, 7) + 253.858906030655*pow(xi1, 5) - 8.13960301876068*pow(xi1, 3) + 0.0805901288986206*xi1 + 106783.720132709*pow(xi2, 27) - 715678.124293685*pow(xi2, 25) + 2134765.60503602*pow(xi2, 23) - 3737630.98551393*pow(xi2, 21) + 4265625.64844191*pow(xi2, 19) - 3332338.98971379*pow(xi2, 17) + 1820737.44653463*pow(xi2, 15) - 698343.453519344*pow(xi2, 13) + 185835.598881841*pow(xi2, 11) - 33328.9112716913*pow(xi2, 9) + 3818.24517846107*pow(xi2, 7) - 253.858906030655*pow(xi2, 5) + 8.13960301876068*pow(xi2, 3) - 0.0805901288986206*xi2;
case 27:
return -201821.231050819*pow(xi1, 28) + 1403138.08254379*pow(xi1, 26) - 4360524.57158938*pow(xi1, 24) + 7995147.04568088*pow(xi1, 22) - 9614774.98687729*pow(xi1, 20) + 7974597.42012888*pow(xi1, 18) - 4669777.74639621*pow(xi1, 16) + 1942908.14099908*pow(xi1, 14) - 569965.699578077*pow(xi1, 12) + 115273.96171242*pow(xi1, 10) - 15411.178393811*pow(xi1, 8) + 1265.66797435284*pow(xi1, 6) - 55.909401923418*pow(xi1, 4) + 1.00737661123276*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(6771996773451.0*pow(xi2, 26) - 47081501377326.0*pow(xi2, 24) + 146314925221725.0*pow(xi2, 22) - 268272617874300.0*pow(xi2, 20) + 322618313492475.0*pow(xi2, 18) - 267583086861090.0*pow(xi2, 16) + 156691739846565.0*pow(xi2, 14) - 65193179099400.0*pow(xi2, 12) + 19124875308825.0*pow(xi2, 10) - 3867952309650.0*pow(xi2, 8) + 517113337455.0*pow(xi2, 6) - 42468769980.0*pow(xi2, 4) + 1876008225.0*pow(xi2, 2) - 33801950.0);
case 28:
return -382229.068886697*pow(xi1, 29) + 2753048.58766758*pow(xi1, 27) - 8899355.23585993*pow(xi1, 25) + 17053587.3045981*pow(xi1, 23) - 21555543.5055122*pow(xi1, 21) + 18920754.2807454*pow(xi1, 19) - 11825300.252687*pow(xi1, 17) + 5307725.52595854*pow(xi1, 15) - 1703492.98975021*pow(xi1, 13) + 384246.5390414*pow(xi1, 11) - 58917.8026530147*pow(xi1, 9) + 5799.38080430031*pow(xi1, 7) - 331.82985574007*pow(xi1, 5) + 9.14388000965118*pow(xi1, 3) - 0.077490508556366*xi1 + 382229.068886697*pow(xi2, 29) - 2753048.58766758*pow(xi2, 27) + 8899355.23585993*pow(xi2, 25) - 17053587.3045981*pow(xi2, 23) + 21555543.5055122*pow(xi2, 21) - 18920754.2807454*pow(xi2, 19) + 11825300.252687*pow(xi2, 17) - 5307725.52595854*pow(xi2, 15) + 1703492.98975021*pow(xi2, 13) - 384246.5390414*pow(xi2, 11) + 58917.8026530147*pow(xi2, 9) - 5799.38080430031*pow(xi2, 7) + 331.82985574007*pow(xi2, 5) - 9.14388000965118*pow(xi2, 3) + 0.077490508556366*xi2;
case 29:
return -725291.455405992*pow(xi1, 30) + 5405474.05444089*pow(xi1, 28) - 18148386.0844929*pow(xi1, 26) + 36279768.9150877*pow(xi1, 24) - 48088457.9659335*pow(xi1, 22) + 44542375.0997904*pow(xi1, 20) - 29602278.0252908*pow(xi1, 18) + 14264512.3510136*pow(xi1, 16) - 4975992.68058613*pow(xi1, 14) + 1240262.43990585*pow(xi1, 12) - 215092.673743397*pow(xi1, 10) + 24801.3675199449*pow(xi1, 8) - 1761.59948006272*pow(xi1, 6) + 67.3005066812038*pow(xi1, 4) - 1.04612186551094*pow(xi1, 2) + 5.96046447753906e-9*pow(xi2, 2)*(121683714103007.0*pow(xi2, 28) - 906888057937505.0*pow(xi2, 26) + 3.04479393390932e+15*pow(xi2, 24) - 6.08673519518513e+15*pow(xi2, 22) + 8.06790446401388e+15*pow(xi2, 20) - 7.47297048202205e+15*pow(xi2, 18) + 4.96643812522358e+15*pow(xi2, 16) - 2.39318804847623e+15*pow(xi2, 14) + 834833040166125.0*pow(xi2, 12) - 208081508509875.0*pow(xi2, 10) + 36086562474105.0*pow(xi2, 8) - 4160978999775.0*pow(xi2, 6) + 295547349825.0*pow(xi2, 4) - 11291151375.0*pow(xi2, 2) + 175510125.0);
default:
return 0.;
}
case 5:
switch(j) {
case 0:
return 0.25*y1t*(-3.0*pow(xi1, 5) + 3.0*pow(xi1, 3) + 3.0*pow(xi2, 5) - 3.0*pow(xi2, 3));
case 1:
return 0.03125*y1r*(-12.0*pow(xi1, 5) + 5.0*pow(xi1, 4) + 12.0*pow(xi1, 3) - 6.0*pow(xi1, 2) + pow(xi2, 2)*(12.0*pow(xi2, 3) - 5.0*pow(xi2, 2) - 12.0*xi2 + 6.0));
case 2:
return 0.25*y2t*(3.0*pow(xi1, 5) - 3.0*pow(xi1, 3) - 3.0*pow(xi2, 5) + 3.0*pow(xi2, 3));
case 3:
return 0.03125*y2r*(-12.0*pow(xi1, 5) - 5.0*pow(xi1, 4) + 12.0*pow(xi1, 3) + 6.0*pow(xi1, 2) + pow(xi2, 2)*(12.0*pow(xi2, 3) + 5.0*pow(xi2, 2) - 12.0*xi2 - 6.0));
case 4:
return -0.625*pow(xi1, 6) + 0.875*pow(xi1, 4) - 0.375*pow(xi1, 2) + 0.625*pow(xi2, 6) - 0.875*pow(xi2, 4) + 0.375*pow(xi2, 2);
case 5:
return -0.892857142857143*pow(xi1, 7) + 1.5*pow(xi1, 5) - 0.75*pow(xi1, 3) + 0.892857142857143*pow(xi2, 7) - 1.5*pow(xi2, 5) + 0.75*pow(xi2, 3);
case 6:
return -1.3671875*pow(xi1, 8) + 2.65625*pow(xi1, 6) - 1.640625*pow(xi1, 4) + 0.28125*pow(xi1, 2) + 1.3671875*pow(xi2, 8) - 2.65625*pow(xi2, 6) + 1.640625*pow(xi2, 4) - 0.28125*pow(xi2, 2);
case 7:
return -2.1875*pow(xi1, 9) + 4.8125*pow(xi1, 7) - 3.5625*pow(xi1, 5) + 0.9375*pow(xi1, 3) + 2.1875*pow(xi2, 9) - 4.8125*pow(xi2, 7) + 3.5625*pow(xi2, 5) - 0.9375*pow(xi2, 3);
case 8:
return -3.609375*pow(xi1, 10) + 8.859375*pow(xi1, 8) - 7.65625*pow(xi1, 6) + 2.65625*pow(xi1, 4) - 0.234375*pow(xi1, 2) + 0.015625*pow(xi2, 2)*(231.0*pow(xi2, 8) - 567.0*pow(xi2, 6) + 490.0*pow(xi2, 4) - 170.0*pow(xi2, 2) + 15.0);
case 9:
return -6.09375*pow(xi1, 11) + 16.5*pow(xi1, 9) - 16.3125*pow(xi1, 7) + 7.0*pow(xi1, 5) - 1.09375*pow(xi1, 3) + 0.03125*pow(xi2, 3)*(195.0*pow(xi2, 8) - 528.0*pow(xi2, 6) + 522.0*pow(xi2, 4) - 224.0*pow(xi2, 2) + 35.0);
case 10:
return -10.4736328125*pow(xi1, 12) + 31.001953125*pow(xi1, 10) - 34.5146484375*pow(xi1, 8) + 17.63671875*pow(xi1, 6) - 3.8623046875*pow(xi1, 4) + 0.205078125*pow(xi1, 2) + 0.0009765625*pow(xi2, 2)*(10725.0*pow(xi2, 10) - 31746.0*pow(xi2, 8) + 35343.0*pow(xi2, 6) - 18060.0*pow(xi2, 4) + 3955.0*pow(xi2, 2) - 210.0);
case 11:
return -18.26171875*pow(xi1, 13) + 58.65234375*pow(xi1, 11) - 72.6171875*pow(xi1, 9) + 43.0546875*pow(xi1, 7) - 12.05859375*pow(xi1, 5) + 1.23046875*pow(xi1, 3) + 0.00390625*pow(xi2, 3)*(4675.0*pow(xi2, 10) - 15015.0*pow(xi2, 8) + 18590.0*pow(xi2, 6) - 11022.0*pow(xi2, 4) + 3087.0*pow(xi2, 2) - 315.0);
case 12:
return -32.2188895089286*pow(xi1, 14) + 111.5791015625*pow(xi1, 12) - 152.0771484375*pow(xi1, 10) + 102.6416015625*pow(xi1, 8) - 34.9658203125*pow(xi1, 6) + 5.2294921875*pow(xi1, 4) - 0.1845703125*pow(xi1, 2) + 0.000139508928571429*pow(xi2, 2)*(230945.0*pow(xi2, 12) - 799799.0*pow(xi2, 10) + 1090089.0*pow(xi2, 8) - 735735.0*pow(xi2, 6) + 250635.0*pow(xi2, 4) - 37485.0*pow(xi2, 2) + 1323.0);
case 13:
return -57.408203125*pow(xi1, 15) + 213.23046875*pow(xi1, 13) - 317.255859375*pow(xi1, 11) + 240.1953125*pow(xi1, 9) - 96.357421875*pow(xi1, 7) + 18.94921875*pow(xi1, 5) - 1.353515625*pow(xi1, 3) + 0.001953125*pow(xi2, 3)*(29393.0*pow(xi2, 12) - 109174.0*pow(xi2, 10) + 162435.0*pow(xi2, 8) - 122980.0*pow(xi2, 6) + 49335.0*pow(xi2, 4) - 9702.0*pow(xi2, 2) + 693.0);
case 14:
return -103.155364990234*pow(xi1, 16) + 409.033447265625*pow(xi1, 14) - 659.681762695313*pow(xi1, 12) + 553.740966796875*pow(xi1, 10) - 255.687561035156*pow(xi1, 8) + 62.318115234375*pow(xi1, 6) - 6.7393798828125*pow(xi1, 4) + 0.169189453125*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(3380195.0*pow(xi2, 14) - 13403208.0*pow(xi2, 12) + 21616452.0*pow(xi2, 10) - 18144984.0*pow(xi2, 8) + 8378370.0*pow(xi2, 6) - 2042040.0*pow(xi2, 4) + 220836.0*pow(xi2, 2) - 5544.0);
case 15:
return -186.70654296875*pow(xi1, 17) + 787.15478515625*pow(xi1, 15) - 1367.86083984375*pow(xi1, 13) + 1260.93017578125*pow(xi1, 11) - 658.79150390625*pow(xi1, 9) + 191.66748046875*pow(xi1, 7) - 27.85986328125*pow(xi1, 5) + 1.46630859375*pow(xi1, 3) + 0.00048828125*pow(xi2, 3)*(382375.0*pow(xi2, 14) - 1612093.0*pow(xi2, 12) + 2801379.0*pow(xi2, 10) - 2582385.0*pow(xi2, 8) + 1349205.0*pow(xi2, 6) - 392535.0*pow(xi2, 4) + 57057.0*pow(xi2, 2) - 3003.0);
case 16:
return -340.072631835938*pow(xi1, 18) + 1518.99108886719*pow(xi1, 16) - 2829.404296875*pow(xi1, 14) + 2841.7060546875*pow(xi1, 12) - 1657.66186523438*pow(xi1, 10) + 560.863037109375*pow(xi1, 8) - 102.6416015625*pow(xi1, 6) + 8.37890625*pow(xi1, 4) - 0.1571044921875*pow(xi1, 2) + 0.0001220703125*pow(xi2, 2)*(2785875.0*pow(xi2, 16) - 12443575.0*pow(xi2, 14) + 23178480.0*pow(xi2, 12) - 23279256.0*pow(xi2, 10) + 13579566.0*pow(xi2, 8) - 4594590.0*pow(xi2, 6) + 840840.0*pow(xi2, 4) - 68640.0*pow(xi2, 2) + 1287.0);
case 17:
return -622.869873046875*pow(xi1, 19) + 2938.2275390625*pow(xi1, 17) - 5840.1806640625*pow(xi1, 15) + 6348.0224609375*pow(xi1, 13) - 4090.33447265625*pow(xi1, 11) + 1578.7255859375*pow(xi1, 9) - 348.9814453125*pow(xi1, 7) + 38.9619140625*pow(xi1, 5) - 1.571044921875*pow(xi1, 3) + 0.000244140625*pow(xi2, 3)*(2551275.0*pow(xi2, 16) - 12034980.0*pow(xi2, 14) + 23921380.0*pow(xi2, 12) - 26001500.0*pow(xi2, 10) + 16754010.0*pow(xi2, 8) - 6466460.0*pow(xi2, 6) + 1429428.0*pow(xi2, 4) - 159588.0*pow(xi2, 2) + 6435.0);
case 18:
return -1146.4698600769*pow(xi1, 20) + 5695.36640167236*pow(xi1, 18) - 12032.1948051453*pow(xi1, 16) + 14073.3390808105*pow(xi1, 14) - 9928.70388031006*pow(xi1, 12) + 4306.96073913574*pow(xi1, 10) - 1117.44170379639*pow(xi1, 8) + 159.133758544922*pow(xi1, 6) - 10.1381492614746*pow(xi1, 4) + 0.147285461425781*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(300540195.0*pow(xi2, 18) - 1493006130.0*pow(xi2, 16) + 3154167675.0*pow(xi2, 14) - 3689241400.0*pow(xi2, 12) + 2602750150.0*pow(xi2, 10) - 1129043916.0*pow(xi2, 8) + 292930638.0*pow(xi2, 6) - 41715960.0*pow(xi2, 4) + 2657655.0*pow(xi2, 2) - 38610.0);
case 19:
return -2119.52411106655*pow(xi1, 21) + 11060.0621795654*pow(xi1, 19) - 24748.0856323242*pow(xi1, 17) + 30994.2196655273*pow(xi1, 15) - 23765.4090881348*pow(xi1, 13) + 11450.245513916*pow(xi1, 11) - 3413.99407958984*pow(xi1, 9) + 593.230303083147*pow(xi1, 7) - 52.4139862060547*pow(xi1, 5) + 1.66923522949219*pow(xi1, 3) + 2.17982700892857e-6*pow(xi2, 3)*(972335925.0*pow(xi2, 18) - 5073825645.0*pow(xi2, 16) + 11353233780.0*pow(xi2, 14) - 14218660260.0*pow(xi2, 12) + 10902428950.0*pow(xi2, 10) - 5252823030.0*pow(xi2, 8) + 1566176612.0*pow(xi2, 6) - 272145588.0*pow(xi2, 4) + 24045021.0*pow(xi2, 2) - 765765.0);
case 20:
return -3933.96520614624*pow(xi1, 22) + 21513.1697273254*pow(xi1, 20) - 50826.8304634094*pow(xi1, 18) + 67863.6191368103*pow(xi1, 16) - 56201.2533187866*pow(xi1, 14) + 29786.1116409302*pow(xi1, 12) - 10042.1747817993*pow(xi1, 10) + 2064.67705535889*pow(xi1, 8) - 235.223064422607*pow(xi1, 6) + 12.009220123291*pow(xi1, 4) - 0.139102935791016*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(1031265375.0*pow(xi2, 20) - 5639548365.0*pow(xi2, 18) + 13323948645.0*pow(xi2, 16) - 17790040575.0*pow(xi2, 14) + 14732821350.0*pow(xi2, 12) - 7808250450.0*pow(xi2, 10) + 2632495866.0*pow(xi2, 8) - 541242702.0*pow(xi2, 6) + 61662315.0*pow(xi2, 4) - 3148145.0*pow(xi2, 2) + 36465.0);
case 21:
return -7327.79788970947*pow(xi1, 23) + 41907.0819854736*pow(xi1, 21) - 104247.120094299*pow(xi1, 19) + 147827.172546387*pow(xi1, 17) - 131511.187820435*pow(xi1, 15) + 76057.2441101074*pow(xi1, 13) - 28625.61378479*pow(xi1, 11) + 6808.25408935547*pow(xi1, 9) - 954.635627746582*pow(xi1, 7) + 68.3644561767578*pow(xi1, 5) - 1.76197052001953*pow(xi1, 3) + 7.62939453125e-6*pow(xi2, 3)*(960469125.0*pow(xi2, 20) - 5492845050.0*pow(xi2, 18) + 13663878525.0*pow(xi2, 16) - 19376003160.0*pow(xi2, 14) + 17237434410.0*pow(xi2, 12) - 9968975100.0*pow(xi2, 10) + 3752016450.0*pow(xi2, 8) - 892371480.0*pow(xi2, 6) + 125126001.0*pow(xi2, 4) - 8960666.0*pow(xi2, 2) + 230945.0);
case 22:
return -13693.8223063946*pow(xi1, 24) + 81741.5854597092*pow(xi1, 22) - 213555.301215649*pow(xi1, 20) + 320533.865046501*pow(xi1, 18) - 304889.328414202*pow(xi1, 16) + 191109.129095078*pow(xi1, 14) - 79465.0906991959*pow(xi1, 12) + 21488.5519695282*pow(xi1, 10) - 3590.29024243355*pow(xi1, 8) + 334.554152488708*pow(xi1, 6) - 13.985641002655*pow(xi1, 4) + 0.132147789001465*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(57436053675.0*pow(xi2, 22) - 342849058860.0*pow(xi2, 20) + 895715854110.0*pow(xi2, 18) - 1344416472300.0*pow(xi2, 16) + 1278798529725.0*pow(xi2, 14) - 801569784600.0*pow(xi2, 12) + 333300747780.0*pow(xi2, 10) - 90129519480.0*pow(xi2, 8) + 15058768725.0*pow(xi2, 6) - 1403221820.0*pow(xi2, 4) + 58660030.0*pow(xi2, 2) - 554268.0);
case 23:
return -25666.1355228424*pow(xi1, 25) + 159630.842885971*pow(xi1, 23) - 436998.461294174*pow(xi1, 21) + 692150.120401382*pow(xi1, 19) - 701032.59973526*pow(xi1, 17) + 473492.052211761*pow(xi1, 15) - 215647.282390594*pow(xi1, 13) + 65402.3434638977*pow(xi1, 11) - 12714.8197650909*pow(xi1, 9) + 1469.04292106628*pow(xi1, 7) - 86.9532451629639*pow(xi1, 5) + 1.85006904602051*pow(xi1, 3) + 1.9073486328125e-6*pow(xi2, 3)*(13456446861.0*pow(xi2, 22) - 83692535355.0*pow(xi2, 20) + 229113049275.0*pow(xi2, 18) - 362886002325.0*pow(xi2, 16) + 367542979650.0*pow(xi2, 14) - 248246201070.0*pow(xi2, 12) + 113061282390.0*pow(xi2, 10) - 34289663850.0*pow(xi2, 8) + 6666227425.0*pow(xi2, 6) - 770201575.0*pow(xi2, 4) + 45588543.0*pow(xi2, 2) - 969969.0);
case 24:
return -48236.1812710762*pow(xi1, 26) + 312076.875107288*pow(xi1, 24) - 893335.171551704*pow(xi1, 22) + 1489045.17017841*pow(xi1, 20) - 1600041.99846983*pow(xi1, 18) + 1158651.10234022*pow(xi1, 16) - 573808.164968491*pow(xi1, 14) + 193032.23982811*pow(xi1, 12) - 42878.3234667778*pow(xi1, 10) + 5939.49249982834*pow(xi1, 8) - 460.97553730011*pow(xi1, 6) + 16.0619630813599*pow(xi1, 4) - 0.12614107131958*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(101158604025.0*pow(xi2, 24) - 654472642785.0*pow(xi2, 22) + 1873459641690.0*pow(xi2, 20) - 3122754056730.0*pow(xi2, 18) + 3355531277175.0*pow(xi2, 16) - 2429867476575.0*pow(xi2, 14) + 1203362940780.0*pow(xi2, 12) - 404817947820.0*pow(xi2, 10) + 89922361815.0*pow(xi2, 8) - 12456018575.0*pow(xi2, 6) + 966735770.0*pow(xi2, 4) - 33684378.0*pow(xi2, 2) + 264537.0);
case 25:
return -90879.7618150711*pow(xi1, 27) + 610711.999397278*pow(xi1, 25) - 1824527.45999336*pow(xi1, 23) + 3192616.85771942*pow(xi1, 21) - 3627809.54024792*pow(xi1, 19) + 2804130.39894104*pow(xi1, 17) - 1500729.04684067*pow(xi1, 15) + 554891.412277222*pow(xi1, 13) - 138824.556040764*pow(xi1, 11) + 22491.5536880493*pow(xi1, 9) - 2178.23605537415*pow(xi1, 7) + 108.313133239746*pow(xi1, 5) - 1.93416309356689*pow(xi1, 3) + 9.5367431640625e-7*pow(xi2, 3)*(95294337125.0*pow(xi2, 24) - 640377945480.0*pow(xi2, 22) + 1913155705890.0*pow(xi2, 20) - 3347701414200.0*pow(xi2, 18) + 3804034016475.0*pow(xi2, 16) - 2940343837200.0*pow(xi2, 14) + 1573628461020.0*pow(xi2, 12) - 581845817520.0*pow(xi2, 10) + 145568097675.0*pow(xi2, 8) - 23584103400.0*pow(xi2, 6) + 2284046050.0*pow(xi2, 4) - 113574552.0*pow(xi2, 2) + 2028117.0);
case 26:
return -171616.693070424*pow(xi1, 28) + 1196204.86489087*pow(xi1, 26) - 3723230.24186119*pow(xi1, 24) + 6824129.6124512*pow(xi1, 22) - 8176238.95359054*pow(xi1, 20) + 6719716.61138982*pow(xi1, 18) - 3865618.70751008*pow(xi1, 16) + 1558943.10125368*pow(xi1, 14) - 434198.589116782*pow(xi1, 12) + 80733.090030849*pow(xi1, 10) - 9424.51188638806*pow(xi1, 8) + 618.529239296913*pow(xi1, 6) - 18.2335166633129*pow(xi1, 4) + 0.120885193347931*pow(xi1, 2) + 4.25747462681362e-9*pow(xi2, 2)*(40309504603875.0*pow(xi2, 26) - 280965823579350.0*pow(xi2, 24) + 874516131796125.0*pow(xi2, 22) - 1.60285855128126e+15*pow(xi2, 20) + 1.92044337788804e+15*pow(xi2, 18) - 1.57833391867305e+15*pow(xi2, 16) + 907960480413525.0*pow(xi2, 14) - 366166151980200.0*pow(xi2, 12) + 101985009231105.0*pow(xi2, 10) - 18962670857130.0*pow(xi2, 8) + 2213639002575.0*pow(xi2, 6) - 145280781100.0*pow(xi2, 4) + 4282707065.0*pow(xi2, 2) - 28393638.0);
case 27:
return -324769.797093272*pow(xi1, 29) + 2344970.49411428*pow(xi1, 27) - 7591913.54250741*pow(xi1, 25) + 14545305.8785021*pow(xi1, 23) - 18327224.8967797*pow(xi1, 21) + 15960149.8981029*pow(xi1, 19) - 9822894.75166082*pow(xi1, 17) + 4292526.46486044*pow(xi1, 15) - 1318261.2031728*pow(xi1, 13) + 277123.261490464*pow(xi1, 11) - 38011.4855825901*pow(xi1, 9) + 3130.23573517799*pow(xi1, 7) - 132.570762038231*pow(xi1, 5) + 2.01475322246552*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(2724366518055.0*pow(xi2, 26) - 19671038246691.0*pow(xi2, 24) + 63685586677986.0*pow(xi2, 22) - 122014869254850.0*pow(xi2, 20) + 153739905386925.0*pow(xi2, 18) - 133883441116425.0*pow(xi2, 16) + 82400413496940.0*pow(xi2, 14) - 36008321843340.0*pow(xi2, 12) + 11058376475025.0*pow(xi2, 10) - 2324678408325.0*pow(xi2, 8) + 318863452050.0*pow(xi2, 6) - 26258320530.0*pow(xi2, 4) + 1112084155.0*pow(xi2, 2) - 16900975.0);
case 28:
return -615813.499873012*pow(xi1, 30) + 4600489.08728662*pow(xi1, 28) - 15469264.6876864*pow(xi1, 26) + 30922406.9560893*pow(xi1, 24) - 40877148.8659076*pow(xi1, 22) + 37602893.7078018*pow(xi1, 20) - 24658808.1726824*pow(xi1, 18) + 11610649.5880343*pow(xi1, 16) - 3900102.37127021*pow(xi1, 14) + 915787.584715337*pow(xi1, 12) - 144732.863038927*pow(xi1, 10) + 14434.5987246931*pow(xi1, 8) - 811.441860347986*pow(xi1, 6) + 20.4962395131588*pow(xi1, 4) - 0.116235762834549*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(20663272206171.0*pow(xi2, 28) - 154366798246101.0*pow(xi2, 26) + 519062390052975.0*pow(xi2, 24) - 1.03758380148443e+15*pow(xi2, 22) + 1.37160951197498e+15*pow(xi2, 20) - 1.26174373992167e+15*pow(xi2, 18) + 827412302031315.0*pow(xi2, 16) - 389588752077525.0*pow(xi2, 14) + 130865719809825.0*pow(xi2, 12) - 30728732237775.0*pow(xi2, 10) + 4856429011005.0*pow(xi2, 8) - 484344761355.0*pow(xi2, 6) + 27227470725.0*pow(xi2, 4) - 687739675.0*pow(xi2, 2) + 3900225.0);
case 29:
return -1169824.92807418*pow(xi1, 31) + 9031931.33147085*pow(xi1, 29) - 31499061.7647464*pow(xi1, 27) + 65582289.5567043*pow(xi1, 25) - 90758210.1336434*pow(xi1, 23) + 87946617.5024897*pow(xi1, 21) - 61225764.2230055*pow(xi1, 19) + 30909695.7099938*pow(xi1, 17) - 11278916.7426619*pow(xi1, 15) + 2928812.50869334*pow(xi1, 13) - 525136.936689913*pow(xi1, 11) + 61789.9485003948*pow(xi1, 9) - 4379.58420842886*pow(xi1, 7) + 159.847421050072*pow(xi1, 5) - 2.09224373102188*pow(xi1, 3) + 5.96046447753906e-8*pow(xi2, 3)*(19626405500485.0*pow(xi2, 28) - 151530662845254.0*pow(xi2, 26) + 528466563024491.0*pow(xi2, 24) - 1.10028823766737e+15*pow(xi2, 22) + 1.52267009518553e+15*pow(xi2, 20) - 1.47549939830865e+15*pow(xi2, 18) + 1.02719787113444e+15*pow(xi2, 16) - 518578641420840.0*pow(xi2, 14) + 189228822437655.0*pow(xi2, 12) - 49137320081850.0*pow(xi2, 10) + 8810335816425.0*pow(xi2, 8) - 1036663312620.0*pow(xi2, 6) + 73477230255.0*pow(xi2, 4) - 2681794710.0*pow(xi2, 2) + 35102025.0);
default:
return 0.;
}
case 6:
switch(j) {
case 0:
return 0.03125*y1t*(-35.0*pow(xi1, 6) + 45.0*pow(xi1, 4) - 9.0*pow(xi1, 2) + 35.0*pow(xi2, 6) - 45.0*pow(xi2, 4) + 9.0*pow(xi2, 2));
case 1:
return 0.015625*y1r*(-35.0*pow(xi1, 6) + 14.0*pow(xi1, 5) + 45.0*pow(xi1, 4) - 20.0*pow(xi1, 3) - 9.0*pow(xi1, 2) + 6.0*xi1 + xi2*(35.0*pow(xi2, 5) - 14.0*pow(xi2, 4) - 45.0*pow(xi2, 3) + 20.0*pow(xi2, 2) + 9.0*xi2 - 6.0));
case 2:
return 0.03125*y2t*(35.0*pow(xi1, 6) - 45.0*pow(xi1, 4) + 9.0*pow(xi1, 2) - 35.0*pow(xi2, 6) + 45.0*pow(xi2, 4) - 9.0*pow(xi2, 2));
case 3:
return 0.015625*y2r*(-35.0*pow(xi1, 6) - 14.0*pow(xi1, 5) + 45.0*pow(xi1, 4) + 20.0*pow(xi1, 3) - 9.0*pow(xi1, 2) - 6.0*xi1 + xi2*(35.0*pow(xi2, 5) + 14.0*pow(xi2, 4) - 45.0*pow(xi2, 3) - 20.0*pow(xi2, 2) + 9.0*xi2 + 6.0));
case 4:
return -0.9375*pow(xi1, 7) + 1.5625*pow(xi1, 5) - 0.8125*pow(xi1, 3) + 0.1875*xi1 + 0.9375*pow(xi2, 7) - 1.5625*pow(xi2, 5) + 0.8125*pow(xi2, 3) - 0.1875*xi2;
case 5:
return -1.3671875*pow(xi1, 8) + 2.65625*pow(xi1, 6) - 1.640625*pow(xi1, 4) + 0.28125*pow(xi1, 2) + 1.3671875*pow(xi2, 8) - 2.65625*pow(xi2, 6) + 1.640625*pow(xi2, 4) - 0.28125*pow(xi2, 2);
case 6:
return -2.12673611111111*pow(xi1, 9) + 4.6875*pow(xi1, 7) - 3.46875*pow(xi1, 5) + 0.9375*pow(xi1, 3) - 0.140625*xi1 + 2.12673611111111*pow(xi2, 9) - 4.6875*pow(xi2, 7) + 3.46875*pow(xi2, 5) - 0.9375*pow(xi2, 3) + 0.140625*xi2;
case 7:
return -3.4453125*pow(xi1, 10) + 8.4765625*pow(xi1, 8) - 7.328125*pow(xi1, 6) + 2.578125*pow(xi1, 4) - 0.3515625*pow(xi1, 2) + 0.0078125*pow(xi2, 2)*(441.0*pow(xi2, 8) - 1085.0*pow(xi2, 6) + 938.0*pow(xi2, 4) - 330.0*pow(xi2, 2) + 45.0);
case 8:
return -5.7421875*pow(xi1, 11) + 15.5859375*pow(xi1, 9) - 15.421875*pow(xi1, 7) + 6.671875*pow(xi1, 5) - 1.2109375*pow(xi1, 3) + 0.1171875*xi1 + 5.7421875*pow(xi2, 11) - 15.5859375*pow(xi2, 9) + 15.421875*pow(xi2, 7) - 6.671875*pow(xi2, 5) + 1.2109375*pow(xi2, 3) - 0.1171875*xi2;
case 9:
return -9.775390625*pow(xi1, 12) + 29.00390625*pow(xi1, 10) - 32.326171875*pow(xi1, 8) + 16.6067708333333*pow(xi1, 6) - 3.896484375*pow(xi1, 4) + 0.41015625*pow(xi1, 2) + 0.000651041666666667*pow(xi2, 2)*(15015.0*pow(xi2, 10) - 44550.0*pow(xi2, 8) + 49653.0*pow(xi2, 6) - 25508.0*pow(xi2, 4) + 5985.0*pow(xi2, 2) - 630.0);
case 10:
return -16.9189453125*pow(xi1, 13) + 54.462890625*pow(xi1, 11) - 67.5146484375*pow(xi1, 9) + 40.18359375*pow(xi1, 7) - 11.6826171875*pow(xi1, 5) + 1.572265625*pow(xi1, 3) - 0.1025390625*xi1 + 16.9189453125*pow(xi2, 13) - 54.462890625*pow(xi2, 11) + 67.5146484375*pow(xi2, 9) - 40.18359375*pow(xi2, 7) + 11.6826171875*pow(xi2, 5) - 1.572265625*pow(xi2, 3) + 0.1025390625*xi2;
case 11:
return -29.67529296875*pow(xi1, 14) + 102.99072265625*pow(xi1, 12) - 140.55615234375*pow(xi1, 10) + 95.14892578125*pow(xi1, 8) - 33.15087890625*pow(xi1, 6) + 5.69091796875*pow(xi1, 4) - 0.46142578125*pow(xi1, 2) + 0.00048828125*pow(xi2, 2)*(60775.0*pow(xi2, 12) - 210925.0*pow(xi2, 10) + 287859.0*pow(xi2, 8) - 194865.0*pow(xi2, 6) + 67893.0*pow(xi2, 4) - 11655.0*pow(xi2, 2) + 945.0);
case 12:
return -52.6241861979167*pow(xi1, 15) + 195.85693359375*pow(xi1, 13) - 291.79541015625*pow(xi1, 11) + 221.459147135417*pow(xi1, 9) - 90.15380859375*pow(xi1, 7) + 19.16455078125*pow(xi1, 5) - 1.99951171875*pow(xi1, 3) + 0.09228515625*xi1 + 52.6241861979167*pow(xi2, 15) - 195.85693359375*pow(xi2, 13) + 291.79541015625*pow(xi2, 11) - 221.459147135417*pow(xi2, 9) + 90.15380859375*pow(xi2, 7) - 19.16455078125*pow(xi2, 5) + 1.99951171875*pow(xi2, 3) - 0.09228515625*xi2;
case 13:
return -94.1853332519531*pow(xi1, 16) + 374.178466796875*pow(xi1, 14) - 604.269897460938*pow(xi1, 12) + 508.285400390625*pow(xi1, 10) - 237.096862792969*pow(xi1, 8) + 60.626220703125*pow(xi1, 6) - 8.0364990234375*pow(xi1, 4) + 0.507568359375*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(3086265.0*pow(xi2, 14) - 12261080.0*pow(xi2, 12) + 19800716.0*pow(xi2, 10) - 16655496.0*pow(xi2, 8) + 7769190.0*pow(xi2, 6) - 1986600.0*pow(xi2, 4) + 263340.0*pow(xi2, 2) - 16632.0);
case 14:
return -169.902954101563*pow(xi1, 17) + 717.6025390625*pow(xi1, 15) - 1248.62841796875*pow(xi1, 13) + 1153.1279296875*pow(xi1, 11) - 606.947021484375*pow(xi1, 9) + 182.2412109375*pow(xi1, 7) - 29.89013671875*pow(xi1, 5) + 2.4814453125*pow(xi1, 3) - 0.0845947265625*xi1 + 169.902954101563*pow(xi2, 17) - 717.6025390625*pow(xi2, 15) + 1248.62841796875*pow(xi2, 13) - 1153.1279296875*pow(xi2, 11) + 606.947021484375*pow(xi2, 9) - 182.2412109375*pow(xi2, 7) + 29.89013671875*pow(xi2, 5) - 2.4814453125*pow(xi2, 3) + 0.0845947265625*xi2;
case 15:
return -308.584425184462*pow(xi1, 18) + 1380.69488525391*pow(xi1, 16) - 2575.08911132813*pow(xi1, 14) + 2590.54516601563*pow(xi1, 12) - 1519.67175292969*pow(xi1, 10) + 525.514526367188*pow(xi1, 8) - 103.863525390625*pow(xi1, 6) + 10.997314453125*pow(xi1, 4) - 0.54986572265625*pow(xi1, 2) + 6.78168402777778e-6*pow(xi2, 2)*(45502625.0*pow(xi2, 16) - 203591745.0*pow(xi2, 14) + 379712340.0*pow(xi2, 12) - 381991428.0*pow(xi2, 10) + 224084718.0*pow(xi2, 8) - 77490270.0*pow(xi2, 6) + 15315300.0*pow(xi2, 4) - 1621620.0*pow(xi2, 2) + 81081.0);
case 16:
return -563.804626464844*pow(xi1, 19) + 2663.90228271484*pow(xi1, 17) - 5301.50561523438*pow(xi1, 15) + 5771.18041992188*pow(xi1, 13) - 3735.12121582031*pow(xi1, 11) + 1464.47570800781*pow(xi1, 9) - 340.916748046875*pow(xi1, 7) + 44.722412109375*pow(xi1, 5) - 3.01116943359375*pow(xi1, 3) + 0.07855224609375*xi1 + 563.804626464844*pow(xi2, 19) - 2663.90228271484*pow(xi2, 17) + 5301.50561523438*pow(xi2, 15) - 5771.18041992188*pow(xi2, 13) + 3735.12121582031*pow(xi2, 11) - 1464.47570800781*pow(xi2, 9) + 340.916748046875*pow(xi2, 7) - 44.722412109375*pow(xi2, 5) + 3.01116943359375*pow(xi2, 3) - 0.07855224609375*xi2;
case 17:
return -1035.52116394043*pow(xi1, 20) + 5152.10037231445*pow(xi1, 18) - 10897.6274871826*pow(xi1, 16) + 12764.0594482422*pow(xi1, 14) - 9037.30697631836*pow(xi1, 12) + 3966.54803466797*pow(xi1, 10) - 1067.19772338867*pow(xi1, 8) + 168.992065429688*pow(xi1, 6) - 14.6303558349609*pow(xi1, 4) + 0.589141845703125*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(67863915.0*pow(xi2, 18) - 337648050.0*pow(xi2, 16) + 714186915.0*pow(xi2, 14) - 836505400.0*pow(xi2, 12) + 592268950.0*pow(xi2, 10) - 259951692.0*pow(xi2, 8) + 69939870.0*pow(xi2, 6) - 11075064.0*pow(xi2, 4) + 958815.0*pow(xi2, 2) - 38610.0);
case 18:
return -1910.78310012817*pow(xi1, 21) + 9985.38265228271*pow(xi1, 19) - 22369.5526313782*pow(xi1, 17) + 28051.8356831868*pow(xi1, 15) - 21573.3575820923*pow(xi1, 13) + 10488.2096099854*pow(xi1, 11) - 3210.89761098226*pow(xi1, 9) + 600.256988525391*pow(xi1, 7) - 64.6043128967285*pow(xi1, 5) + 3.58394622802734*pow(xi1, 3) - 0.0736427307128906*xi1 + 1910.78310012817*pow(xi2, 21) - 9985.38265228271*pow(xi2, 19) + 22369.5526313782*pow(xi2, 17) - 28051.8356831868*pow(xi2, 15) + 21573.3575820923*pow(xi2, 13) - 10488.2096099854*pow(xi2, 11) + 3210.89761098226*pow(xi2, 9) - 600.256988525391*pow(xi2, 7) + 64.6043128967285*pow(xi2, 5) - 3.58394622802734*pow(xi2, 3) + 0.0736427307128906*xi2;
case 19:
return -3540.56868553162*pow(xi1, 22) + 19388.8285160065*pow(xi1, 20) - 45859.8821353912*pow(xi1, 18) + 61306.8062496185*pow(xi1, 16) - 50899.6626853943*pow(xi1, 14) + 27168.544254303*pow(xi1, 12) - 9342.84868240356*pow(xi1, 10) + 2023.97553634644*pow(xi1, 8) - 263.558332443237*pow(xi1, 6) + 18.9875507354736*pow(xi1, 4) - 0.62596321105957*pow(xi1, 2) + 1.9073486328125e-6*pow(xi2, 2)*(1856277675.0*pow(xi2, 20) - 10165330125.0*pow(xi2, 18) + 24043785885.0*pow(xi2, 16) - 32142422835.0*pow(xi2, 14) + 26686082350.0*pow(xi2, 12) - 14244141730.0*pow(xi2, 10) + 4898343450.0*pow(xi2, 8) - 1061146086.0*pow(xi2, 6) + 138180471.0*pow(xi2, 4) - 9954945.0*pow(xi2, 2) + 328185.0);
case 20:
return -6585.11567115784*pow(xi1, 23) + 37709.866476059*pow(xi1, 21) - 93909.3694210052*pow(xi1, 19) + 133322.262125015*pow(xi1, 17) - 118866.862277985*pow(xi1, 15) + 69138.8915061951*pow(xi1, 13) - 26420.6678581238*pow(xi1, 11) + 6530.74373245239*pow(xi1, 9) - 1006.17326545715*pow(xi1, 7) + 90.5513744354248*pow(xi1, 5) - 4.1962718963623*pow(xi1, 3) + 0.0695514678955078*xi1 + 6585.11567115784*pow(xi2, 23) - 37709.866476059*pow(xi2, 21) + 93909.3694210052*pow(xi2, 19) - 133322.262125015*pow(xi2, 17) + 118866.862277985*pow(xi2, 15) - 69138.8915061951*pow(xi2, 13) + 26420.6678581238*pow(xi2, 11) - 6530.74373245239*pow(xi2, 9) + 1006.17326545715*pow(xi2, 7) - 90.5513744354248*pow(xi2, 5) + 4.1962718963623*pow(xi2, 3) - 0.0695514678955078*xi2;
case 21:
return -12289.3277108669*pow(xi1, 24) + 73451.2714147568*pow(xi1, 22) - 192100.697286129*pow(xi1, 20) + 288650.013709068*pow(xi1, 18) - 275090.35777688*pow(xi1, 16) + 173242.563199997*pow(xi1, 14) - 72901.8306016922*pow(xi1, 12) + 20297.107503891*pow(xi1, 10) - 3631.91679596901*pow(xi1, 8) + 396.634247144063*pow(xi1, 6) - 24.1169714927673*pow(xi1, 4) + 0.660738945007324*pow(xi1, 2) + 7.94728597005208e-8*pow(xi2, 2)*(154635529125.0*pow(xi2, 22) - 924230884500.0*pow(xi2, 20) + 2417186169090.0*pow(xi2, 18) - 3632057721300.0*pow(xi2, 16) + 3461437763955.0*pow(xi2, 14) - 2179895927400.0*pow(xi2, 12) + 917317319100.0*pow(xi2, 10) - 255396717576.0*pow(xi2, 8) + 45700089435.0*pow(xi2, 6) - 4990813828.0*pow(xi2, 4) + 303461730.0*pow(xi2, 2) - 8314020.0);
case 22:
return -23005.6214747429*pow(xi1, 25) + 143258.44874382*pow(xi1, 23) - 392582.810969353*pow(xi1, 21) + 622456.821012497*pow(xi1, 19) - 631527.864468098*pow(xi1, 17) + 428224.98418808*pow(xi1, 15) - 196905.242013931*pow(xi1, 13) + 61080.8704948425*pow(xi1, 11) - 12499.5289921761*pow(xi1, 9) + 1618.81041526794*pow(xi1, 7) - 123.646281242371*pow(xi1, 5) + 4.84541893005371*pow(xi1, 3) - 0.0660738945007324*xi1 + 23005.6214747429*pow(xi2, 25) - 143258.44874382*pow(xi2, 23) + 392582.810969353*pow(xi2, 21) - 622456.821012497*pow(xi2, 19) + 631527.864468098*pow(xi2, 17) - 428224.98418808*pow(xi2, 15) + 196905.242013931*pow(xi2, 13) - 61080.8704948425*pow(xi2, 11) + 12499.5289921761*pow(xi2, 9) - 1618.81041526794*pow(xi2, 7) + 123.646281242371*pow(xi2, 5) - 4.84541893005371*pow(xi2, 3) + 0.0660738945007324*xi2;
case 23:
return -43188.2088124752*pow(xi1, 26) + 279745.227116346*pow(xi1, 24) - 801585.194084644*pow(xi1, 22) + 1337462.24400759*pow(xi1, 20) - 1439388.69436383*pow(xi1, 18) + 1045795.4754889*pow(xi1, 16) - 521967.386698723*pow(xi1, 14) + 178745.682291985*pow(xi1, 12) - 41294.0366613865*pow(xi1, 10) + 6224.43616986275*pow(xi1, 8) - 578.917438983917*pow(xi1, 6) + 30.0636219978333*pow(xi1, 4) - 0.69377589225769*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(181144476975.0*pow(xi2, 24) - 1173336525075.0*pow(xi2, 22) + 3362091985890.0*pow(xi2, 20) - 5609723239890.0*pow(xi2, 18) + 6037233758325.0*pow(xi2, 16) - 4386384146025.0*pow(xi2, 14) + 2189289897900.0*pow(xi2, 12) - 749713730220.0*pow(xi2, 10) + 173199743145.0*pow(xi2, 8) - 26107177525.0*pow(xi2, 6) + 2428155730.0*pow(xi2, 4) - 126095970.0*pow(xi2, 2) + 2909907.0);
case 24:
return -81286.8980679247*pow(xi1, 27) + 546863.683015108*pow(xi1, 25) - 1635362.49871016*pow(xi1, 23) + 2864386.47074461*pow(xi1, 21) - 3259442.8732574*pow(xi1, 19) + 2526638.3282125*pow(xi1, 17) - 1360955.26306629*pow(xi1, 15) + 510447.213749886*pow(xi1, 13) - 131678.168796301*pow(xi1, 11) + 22745.5405149195*pow(xi1, 9) - 2515.10279417038*pow(xi1, 7) + 165.034568309784*pow(xi1, 5) - 5.52918362617493*pow(xi1, 3) + 0.06307053565979*xi1 + 81286.8980679247*pow(xi2, 27) - 546863.683015108*pow(xi2, 25) + 1635362.49871016*pow(xi2, 23) - 2864386.47074461*pow(xi2, 21) + 3259442.8732574*pow(xi2, 19) - 2526638.3282125*pow(xi2, 17) + 1360955.26306629*pow(xi2, 15) - 510447.213749886*pow(xi2, 13) + 131678.168796301*pow(xi2, 11) - 22745.5405149195*pow(xi2, 9) + 2515.10279417038*pow(xi2, 7) - 165.034568309784*pow(xi2, 5) + 5.52918362617493*pow(xi2, 3) - 0.06307053565979*xi2;
case 25:
return -153359.598062932*pow(xi1, 28) + 1070109.19537246*pow(xi1, 26) - 3333887.07623631*pow(xi1, 24) + 6116230.13594985*pow(xi1, 22) - 7337624.0086922*pow(xi1, 20) + 6045594.79239285*pow(xi1, 18) - 3496643.50527674*pow(xi1, 16) + 1426638.4321332*pow(xi1, 14) - 407136.064055264*pow(xi1, 12) + 79550.5738002062*pow(xi1, 10) - 10259.5551416278*pow(xi1, 8) + 822.825216054916*pow(xi1, 6) - 36.8699839711189*pow(xi1, 4) + 0.725311160087585*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2572947102375.0*pow(xi2, 26) - 17953453114350.0*pow(xi2, 24) + 55933343597625.0*pow(xi2, 22) - 102613314096540.0*pow(xi2, 20) + 123104902920615.0*pow(xi2, 18) - 101428249680450.0*pow(xi2, 16) + 58663943363025.0*pow(xi2, 14) - 23935021129800.0*pow(xi2, 12) + 6830609688045.0*pow(xi2, 10) - 1334637159570.0*pow(xi2, 8) + 172126772675.0*pow(xi2, 6) - 13804716380.0*pow(xi2, 4) + 618575685.0*pow(xi2, 2) - 12168702.0);
case 26:
return -289973.033118993*pow(xi1, 29) + 2095914.50686008*pow(xi1, 27) - 6791785.39954707*pow(xi1, 25) + 13024073.7724453*pow(xi1, 23) - 16430288.1617863*pow(xi1, 21) + 14339802.0394251*pow(xi1, 19) - 8866155.64289019*pow(xi1, 17) + 3911826.81694865*pow(xi1, 15) - 1225155.31102046*pow(xi1, 13) + 267815.70602864*pow(xi1, 11) - 39657.0352770388*pow(xi1, 9) + 3791.47774279118*pow(xi1, 7) - 215.921102851629*pow(xi1, 5) + 6.2457349896431*pow(xi1, 3) - 0.0604425966739655*xi1 + 289973.033118993*pow(xi2, 29) - 2095914.50686008*pow(xi2, 27) + 6791785.39954707*pow(xi2, 25) - 13024073.7724453*pow(xi2, 23) + 16430288.1617863*pow(xi2, 21) - 14339802.0394251*pow(xi2, 19) + 8866155.64289019*pow(xi2, 17) - 3911826.81694865*pow(xi2, 15) + 1225155.31102046*pow(xi2, 13) - 267815.70602864*pow(xi2, 11) + 39657.0352770388*pow(xi2, 9) - 3791.47774279118*pow(xi2, 7) + 215.921102851629*pow(xi2, 5) - 6.2457349896431*pow(xi2, 3) + 0.0604425966739655*xi2;
case 27:
return -549402.240082785*pow(xi1, 30) + 4108503.63210596*pow(xi1, 28) - 13827208.0805501*pow(xi1, 26) + 27664083.4957633*pow(xi1, 24) - 36611156.418654*pow(xi1, 22) + 33744830.445754*pow(xi1, 20) - 22216010.2240916*pow(xi1, 18) + 10544759.5412088*pow(xi1, 16) - 3599355.56090511*pow(xi1, 14) + 872026.17332451*pow(xi1, 12) - 146323.561076894*pow(xi1, 10) + 16351.5572648495*pow(xi1, 8) - 1142.58334207038*pow(xi1, 6) + 44.5764150470495*pow(xi1, 4) - 0.755532458424568*pow(xi1, 2) + 4.96705373128255e-9*pow(xi2, 2)*(110609280633033.0*pow(xi2, 28) - 827151034471515.0*pow(xi2, 26) + 2.78378467973202e+15*pow(xi2, 24) - 5.56951565100548e+15*pow(xi2, 22) + 7.37079935094653e+15*pow(xi2, 20) - 6.7937317112615e+15*pow(xi2, 18) + 4.47267362625353e+15*pow(xi2, 16) - 2.12294050189106e+15*pow(xi2, 14) + 724645988473275.0*pow(xi2, 12) - 175562057610225.0*pow(xi2, 10) + 29458823880915.0*pow(xi2, 8) - 3292003298025.0*pow(xi2, 6) + 230032410335.0*pow(xi2, 4) - 8974417725.0*pow(xi2, 2) + 152108775.0);
case 28:
return -1042909.95946236*pow(xi1, 31) + 8059911.98363207*pow(xi1, 29) - 28133362.1181482*pow(xi1, 27) + 58624160.113125*pow(xi1, 25) - 81214983.145294*pow(xi1, 23) + 78838147.1421372*pow(xi1, 21) - 55072273.9968482*pow(xi1, 19) + 27992398.0403953*pow(xi1, 17) - 10350961.3508769*pow(xi1, 15) + 2756968.91762204*pow(xi1, 13) - 518441.73184298*pow(xi1, 11) + 66642.1722281724*pow(xi1, 9) - 5566.69839374721*pow(xi1, 7) + 277.567127123475*pow(xi1, 5) - 6.99351839721203*pow(xi1, 3) + 0.0581178814172745*xi1 + 1042909.95946236*pow(xi2, 31) - 8059911.98363207*pow(xi2, 29) + 28133362.1181482*pow(xi2, 27) - 58624160.113125*pow(xi2, 25) + 81214983.145294*pow(xi2, 23) - 78838147.1421372*pow(xi2, 21) + 55072273.9968482*pow(xi2, 19) - 27992398.0403953*pow(xi2, 17) + 10350961.3508769*pow(xi2, 15) - 2756968.91762204*pow(xi2, 13) + 518441.73184298*pow(xi2, 11) - 66642.1722281724*pow(xi2, 9) + 5566.69839374721*pow(xi2, 7) - 277.567127123475*pow(xi2, 5) + 6.99351839721203*pow(xi2, 3) - 0.0581178814172745*xi2;
case 29:
return -1983218.82337576*pow(xi1, 32) + 15822985.760626*pow(xi1, 30) - 57208772.2688402*pow(xi1, 28) + 123966103.721286*pow(xi1, 26) - 179418908.264614*pow(xi1, 24) + 182977170.438836*pow(xi1, 22) - 135194614.345589*pow(xi1, 20) + 73288566.706319*pow(xi1, 18) - 29202857.0441898*pow(xi1, 16) + 8491314.83706627*pow(xi1, 14) - 1772603.99920279*pow(xi1, 12) + 258638.67419567*pow(xi1, 10) - 25307.2639591154*pow(xi1, 8) + 1554.31043241173*pow(xi1, 6) - 53.2214499078691*pow(xi1, 4) + 0.784591399133205*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(4.25892999360525e+15*pow(xi2, 30) - 3.39796031834812e+16*pow(xi2, 28) + 1.2285490296949e+17*pow(xi2, 26) - 2.66215180647733e+17*pow(xi2, 24) + 3.8529917164027e+17*pow(xi2, 22) - 3.9294048147471e+17*pow(xi2, 20) + 2.90328223604819e+17*pow(xi2, 18) - 1.57385998587177e+17*pow(xi2, 16) + 6.27126579772793e+16*pow(xi2, 14) - 1.82349597626196e+16*pow(xi2, 12) + 3.8066381026674e+15*pow(xi2, 10) - 555422323575600.0*pow(xi2, 8) + 54346935527820.0*pow(xi2, 6) - 3337856237520.0*pow(xi2, 4) + 114292193400.0*pow(xi2, 2) - 1684897200.0);
default:
return 0.;
}
case 7:
switch(j) {
case 0:
return 0.0625*y1t*(-27.0*pow(xi1, 7) + 42.0*pow(xi1, 5) - 15.0*pow(xi1, 3) + 27.0*pow(xi2, 7) - 42.0*pow(xi2, 5) + 15.0*pow(xi2, 3));
case 1:
return 0.015625*y1r*(-54.0*pow(xi1, 7) + 21.0*pow(xi1, 6) + 84.0*pow(xi1, 5) - 35.0*pow(xi1, 4) - 30.0*pow(xi1, 3) + 15.0*pow(xi1, 2) + pow(xi2, 2)*(54.0*pow(xi2, 5) - 21.0*pow(xi2, 4) - 84.0*pow(xi2, 3) + 35.0*pow(xi2, 2) + 30.0*xi2 - 15.0));
case 2:
return 0.0625*y2t*(27.0*pow(xi1, 7) - 42.0*pow(xi1, 5) + 15.0*pow(xi1, 3) - 27.0*pow(xi2, 7) + 42.0*pow(xi2, 5) - 15.0*pow(xi2, 3));
case 3:
return 0.015625*y2r*(-54.0*pow(xi1, 7) - 21.0*pow(xi1, 6) + 84.0*pow(xi1, 5) + 35.0*pow(xi1, 4) - 30.0*pow(xi1, 3) - 15.0*pow(xi1, 2) + pow(xi2, 2)*(54.0*pow(xi2, 5) + 21.0*pow(xi2, 4) - 84.0*pow(xi2, 3) - 35.0*pow(xi2, 2) + 30.0*xi2 + 15.0));
case 4:
return -1.4765625*pow(xi1, 8) + 2.84375*pow(xi1, 6) - 1.796875*pow(xi1, 4) + 0.46875*pow(xi1, 2) + 1.4765625*pow(xi2, 8) - 2.84375*pow(xi2, 6) + 1.796875*pow(xi2, 4) - 0.46875*pow(xi2, 2);
case 5:
return -2.1875*pow(xi1, 9) + 4.8125*pow(xi1, 7) - 3.5625*pow(xi1, 5) + 0.9375*pow(xi1, 3) + 2.1875*pow(xi2, 9) - 4.8125*pow(xi2, 7) + 3.5625*pow(xi2, 5) - 0.9375*pow(xi2, 3);
case 6:
return -3.4453125*pow(xi1, 10) + 8.4765625*pow(xi1, 8) - 7.328125*pow(xi1, 6) + 2.578125*pow(xi1, 4) - 0.3515625*pow(xi1, 2) + 0.0078125*pow(xi2, 2)*(441.0*pow(xi2, 8) - 1085.0*pow(xi2, 6) + 938.0*pow(xi2, 4) - 330.0*pow(xi2, 2) + 45.0);
case 7:
return -5.63778409090909*pow(xi1, 11) + 15.3125*pow(xi1, 9) - 15.15625*pow(xi1, 7) + 6.5625*pow(xi1, 5) - 1.171875*pow(xi1, 3) + 0.00142045454545455*pow(xi2, 3)*(3969.0*pow(xi2, 8) - 10780.0*pow(xi2, 6) + 10670.0*pow(xi2, 4) - 4620.0*pow(xi2, 2) + 825.0);
case 8:
return -9.474609375*pow(xi1, 12) + 28.13671875*pow(xi1, 10) - 31.376953125*pow(xi1, 8) + 16.1328125*pow(xi1, 6) - 3.759765625*pow(xi1, 4) + 0.29296875*pow(xi1, 2) + 0.001953125*pow(xi2, 2)*(4851.0*pow(xi2, 10) - 14406.0*pow(xi2, 8) + 16065.0*pow(xi2, 6) - 8260.0*pow(xi2, 4) + 1925.0*pow(xi2, 2) - 150.0);
case 9:
return -16.2421875*pow(xi1, 13) + 52.3359375*pow(xi1, 11) - 64.921875*pow(xi1, 9) + 38.671875*pow(xi1, 7) - 11.2109375*pow(xi1, 5) + 1.3671875*pow(xi1, 3) + 0.0078125*pow(xi2, 3)*(2079.0*pow(xi2, 10) - 6699.0*pow(xi2, 8) + 8310.0*pow(xi2, 6) - 4950.0*pow(xi2, 4) + 1435.0*pow(xi2, 2) - 175.0);
case 10:
return -28.27880859375*pow(xi1, 14) + 98.24267578125*pow(xi1, 12) - 134.17529296875*pow(xi1, 10) + 90.90087890625*pow(xi1, 8) - 31.63330078125*pow(xi1, 6) + 5.21240234375*pow(xi1, 4) - 0.25634765625*pow(xi1, 2) + 0.00048828125*pow(xi2, 2)*(57915.0*pow(xi2, 12) - 201201.0*pow(xi2, 10) + 274791.0*pow(xi2, 8) - 186165.0*pow(xi2, 6) + 64785.0*pow(xi2, 4) - 10675.0*pow(xi2, 2) + 525.0);
case 11:
return -49.8544921875*pow(xi1, 15) + 185.732421875*pow(xi1, 13) - 276.9228515625*pow(xi1, 11) + 210.33203125*pow(xi1, 9) - 85.5908203125*pow(xi1, 7) + 17.841796875*pow(xi1, 5) - 1.5380859375*pow(xi1, 3) + 0.0009765625*pow(xi2, 3)*(51051.0*pow(xi2, 12) - 190190.0*pow(xi2, 10) + 283569.0*pow(xi2, 8) - 215380.0*pow(xi2, 6) + 87645.0*pow(xi2, 4) - 18270.0*pow(xi2, 2) + 1575.0);
case 12:
return -88.8033142089844*pow(xi1, 16) + 353.135986328125*pow(xi1, 14) - 570.725708007813*pow(xi1, 12) + 480.425537109375*pow(xi1, 10) - 224.105529785156*pow(xi1, 8) + 56.719482421875*pow(xi1, 6) - 6.8829345703125*pow(xi1, 4) + 0.230712890625*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(2909907.0*pow(xi2, 14) - 11571560.0*pow(xi2, 12) + 18701540.0*pow(xi2, 10) - 15742584.0*pow(xi2, 8) + 7343490.0*pow(xi2, 6) - 1858584.0*pow(xi2, 4) + 225540.0*pow(xi2, 2) - 7560.0);
case 13:
return -159.56103515625*pow(xi1, 17) + 674.54638671875*pow(xi1, 15) - 1174.60205078125*pow(xi1, 13) + 1085.54443359375*pow(xi1, 11) - 571.51123046875*pow(xi1, 9) + 170.62353515625*pow(xi1, 7) - 26.73193359375*pow(xi1, 5) + 1.69189453125*pow(xi1, 3) + 0.00048828125*pow(xi2, 3)*(326781.0*pow(xi2, 14) - 1381471.0*pow(xi2, 12) + 2405585.0*pow(xi2, 10) - 2223195.0*pow(xi2, 8) + 1170455.0*pow(xi2, 6) - 349437.0*pow(xi2, 4) + 54747.0*pow(xi2, 2) - 3465.0);
case 14:
return -288.835021972656*pow(xi1, 18) + 1293.47857666016*pow(xi1, 16) - 2414.21997070313*pow(xi1, 14) + 2430.40649414063*pow(xi1, 12) - 1426.24694824219*pow(xi1, 10) + 491.579956054688*pow(xi1, 8) - 94.689697265625*pow(xi1, 6) + 8.741455078125*pow(xi1, 4) - 0.21148681640625*pow(xi1, 2) + 6.103515625e-5*pow(xi2, 2)*(4732273.0*pow(xi2, 16) - 21192353.0*pow(xi2, 14) + 39554580.0*pow(xi2, 12) - 39819780.0*pow(xi2, 10) + 23367630.0*pow(xi2, 8) - 8054046.0*pow(xi2, 6) + 1551396.0*pow(xi2, 4) - 143220.0*pow(xi2, 2) + 3465.0);
case 15:
return -526.217651367188*pow(xi1, 19) + 2488.4248046875*pow(xi1, 17) - 4955.87353515625*pow(xi1, 15) + 5398.5791015625*pow(xi1, 13) - 3495.47973632813*pow(xi1, 11) + 1367.8564453125*pow(xi1, 9) - 313.58056640625*pow(xi1, 7) + 38.1240234375*pow(xi1, 5) - 1.8328857421875*pow(xi1, 3) + 0.0001220703125*pow(xi2, 3)*(4310775.0*pow(xi2, 16) - 20385176.0*pow(xi2, 14) + 40598516.0*pow(xi2, 12) - 44225160.0*pow(xi2, 10) + 28634970.0*pow(xi2, 8) - 11205480.0*pow(xi2, 6) + 2568852.0*pow(xi2, 4) - 312312.0*pow(xi2, 2) + 15015.0);
case 16:
return -964.105911254883*pow(xi1, 20) + 4800.69198608398*pow(xi1, 18) - 10161.4835968018*pow(xi1, 16) + 11909.6392822266*pow(xi1, 14) - 8436.31484985352*pow(xi1, 12) + 3698.58013916016*pow(xi1, 10) - 985.634307861328*pow(xi1, 8) + 149.196899414063*pow(xi1, 6) - 10.7682037353516*pow(xi1, 4) + 0.196380615234375*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(63183645.0*pow(xi2, 18) - 314618150.0*pow(xi2, 16) + 665942989.0*pow(xi2, 14) - 780510120.0*pow(xi2, 12) + 552882330.0*pow(xi2, 10) - 242390148.0*pow(xi2, 8) + 64594530.0*pow(xi2, 6) - 9777768.0*pow(xi2, 4) + 705705.0*pow(xi2, 2) - 12870.0);
case 17:
return -1775.17913818359*pow(xi1, 21) + 9283.98284912109*pow(xi1, 19) - 20812.4450683594*pow(xi1, 17) + 26115.7644042969*pow(xi1, 15) - 20094.2510986328*pow(xi1, 13) + 9762.98254394531*pow(xi1, 11) - 2970.49682617188*pow(xi1, 9) + 539.915771484375*pow(xi1, 7) - 52.2372436523438*pow(xi1, 5) + 1.96380615234375*pow(xi1, 3) + 6.103515625e-5*pow(xi2, 3)*(29084535.0*pow(xi2, 18) - 152108775.0*pow(xi2, 16) + 340991100.0*pow(xi2, 14) - 427880684.0*pow(xi2, 12) + 329224210.0*pow(xi2, 10) - 159956706.0*pow(xi2, 8) + 48668620.0*pow(xi2, 6) - 8845980.0*pow(xi2, 4) + 855855.0*pow(xi2, 2) - 32175.0);
case 18:
return -3283.07278112932*pow(xi1, 22) + 17992.180223465*pow(xi1, 20) - 42584.5325946808*pow(xi1, 18) + 56963.228559494*pow(xi1, 16) - 47316.9975090027*pow(xi1, 14) + 25248.5089607239*pow(xi1, 12) - 8647.22272109985*pow(xi1, 10) + 1839.3581199646*pow(xi1, 8) - 224.21347618103*pow(xi1, 6) + 12.9488468170166*pow(xi1, 4) - 0.184106826782227*pow(xi1, 2) + 1.73395330255682e-7*pow(xi2, 2)*(18934032285.0*pow(xi2, 20) - 103763926035.0*pow(xi2, 18) + 245592153675.0*pow(xi2, 16) - 328516508925.0*pow(xi2, 14) + 272885073890.0*pow(xi2, 12) - 145612392926.0*pow(xi2, 10) + 49869986166.0*pow(xi2, 8) - 10607887290.0*pow(xi2, 6) + 1293076785.0*pow(xi2, 4) - 74678175.0*pow(xi2, 2) + 1061775.0);
case 19:
return -6095.93564987183*pow(xi1, 23) + 34933.6110305786*pow(xi1, 21) - 87051.21717453*pow(xi1, 19) + 123659.410858154*pow(xi1, 17) - 110306.809043884*pow(xi1, 15) + 64153.908493042*pow(xi1, 13) - 24448.4942550659*pow(xi1, 11) + 5969.55612182617*pow(xi1, 9) - 881.217098236084*pow(xi1, 7) + 69.2732620239258*pow(xi1, 5) - 2.08654403686523*pow(xi1, 3) + 3.814697265625e-6*pow(xi2, 3)*(1598012955.0*pow(xi2, 20) - 9157636530.0*pow(xi2, 18) + 22819954275.0*pow(xi2, 16) - 32416572600.0*pow(xi2, 14) + 28916268150.0*pow(xi2, 12) - 16817562188.0*pow(xi2, 10) + 6409026078.0*pow(xi2, 8) - 1564883320.0*pow(xi2, 6) + 231005775.0*pow(xi2, 4) - 18159570.0*pow(xi2, 2) + 546975.0);
case 20:
return -11359.3245327473*pow(xi1, 24) + 67939.5791101456*pow(xi1, 22) - 177795.557491779*pow(xi1, 20) + 267309.309983253*pow(xi1, 18) - 254878.725403547*pow(xi1, 16) + 160521.721315384*pow(xi1, 14) - 67422.9912786484*pow(xi1, 12) + 18613.5446720123*pow(xi1, 10) - 3236.46453738213*pow(xi1, 8) + 324.005513191223*pow(xi1, 6) - 15.2723431587219*pow(xi1, 4) + 0.17387866973877*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(47644460325.0*pow(xi2, 22) - 284959248420.0*pow(xi2, 20) + 745728617970.0*pow(xi2, 18) - 1121176508100.0*pow(xi2, 16) + 1069038857475.0*pow(xi2, 14) - 673276897800.0*pow(xi2, 12) + 282792522012.0*pow(xi2, 10) - 78070864872.0*pow(xi2, 8) + 13574716155.0*pow(xi2, 6) - 1358977620.0*pow(xi2, 4) + 64056850.0*pow(xi2, 2) - 729300.0);
case 21:
return -21235.9582843781*pow(xi1, 25) + 132326.16648674*pow(xi1, 23) - 362841.146650314*pow(xi1, 21) + 575621.929979324*pow(xi1, 19) - 584297.167682648*pow(xi1, 17) + 396256.456432343*pow(xi1, 15) - 181974.990749359*pow(xi1, 13) + 56113.9396705627*pow(xi1, 11) - 11257.6701450348*pow(xi1, 9) + 1375.65848350525*pow(xi1, 7) - 89.4200038909912*pow(xi1, 5) + 2.20246315002441*pow(xi1, 3) + 1.9073486328125e-6*pow(xi2, 3)*(11133758097.0*pow(xi2, 22) - 69377021175.0*pow(xi2, 20) + 190233259095.0*pow(xi2, 18) - 301791670425.0*pow(xi2, 16) + 306339993450.0*pow(xi2, 14) - 207752505030.0*pow(xi2, 12) + 95407303950.0*pow(xi2, 10) - 29419865202.0*pow(xi2, 8) + 5902261365.0*pow(xi2, 6) - 721241235.0*pow(xi2, 4) + 46881835.0*pow(xi2, 2) - 1154725.0);
case 22:
return -39817.4217832088*pow(xi1, 26) + 258075.881928205*pow(xi1, 24) - 739921.916306019*pow(xi1, 22) + 1235245.40490389*pow(xi1, 20) - 1330024.46163297*pow(xi1, 18) + 966541.123548746*pow(xi1, 16) - 482000.350642204*pow(xi1, 14) + 164355.508875847*pow(xi1, 12) - 37440.0785429478*pow(xi1, 10) + 5421.85859799385*pow(xi1, 8) - 453.112743854523*pow(xi1, 6) + 17.7298283576965*pow(xi1, 4) - 0.165184736251831*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(167006371455.0*pow(xi2, 24) - 1082448703875.0*pow(xi2, 22) + 3103457453250.0*pow(xi2, 20) - 5180994742770.0*pow(xi2, 18) + 5578526919525.0*pow(xi2, 16) - 4053967300665.0*pow(xi2, 14) + 2021655998700.0*pow(xi2, 12) - 689356968300.0*pow(xi2, 10) + 157035071193.0*pow(xi2, 8) - 22740923205.0*pow(xi2, 6) + 1900492594.0*pow(xi2, 4) - 74364290.0*pow(xi2, 2) + 692835.0);
case 23:
return -74859.5619416237*pow(xi1, 27) + 503932.66087532*pow(xi1, 25) - 1507825.26934147*pow(xi1, 23) + 2642391.18733406*pow(xi1, 21) - 3008256.60670996*pow(xi1, 19) + 2332526.65002823*pow(xi1, 17) - 1255698.85142326*pow(xi1, 15) + 469510.651874542*pow(xi1, 13) - 119893.934762478*pow(xi1, 11) + 20130.9536838531*pow(xi1, 9) - 2068.42124271393*pow(xi1, 7) + 112.854211807251*pow(xi1, 5) - 2.31258630752563*pow(xi1, 3) + 4.76837158203125e-7*pow(xi2, 3)*(156991880045.0*pow(xi2, 24) - 1056823387620.0*pow(xi2, 22) + 3162138779250.0*pow(xi2, 20) - 5541495963300.0*pow(xi2, 18) + 6308771359275.0*pow(xi2, 16) - 4891662929160.0*pow(xi2, 14) + 2633391357660.0*pow(xi2, 12) - 984635202600.0*pow(xi2, 10) + 251435805075.0*pow(xi2, 8) - 42217669780.0*pow(xi2, 6) + 4337793746.0*pow(xi2, 4) - 236672436.0*pow(xi2, 2) + 4849845.0);
case 24:
return -141090.830217898*pow(xi1, 28) + 985083.781004548*pow(xi1, 26) - 3070661.81036085*pow(xi1, 24) + 5636204.89152074*pow(xi1, 22) - 6764883.44941288*pow(xi1, 20) + 5575318.75673711*pow(xi1, 18) - 3223532.88829654*pow(xi1, 16) + 1312222.58924246*pow(xi1, 14) - 371694.770376384*pow(xi1, 12) + 71150.4344075918*pow(xi1, 10) - 8712.88090068102*pow(xi1, 8) + 616.332282304764*pow(xi1, 6) - 20.313968360424*pow(xi1, 4) + 0.157676339149475*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2367111334185.0*pow(xi2, 26) - 16526963372010.0*pow(xi2, 24) + 51517156455375.0*pow(xi2, 22) - 94559826885300.0*pow(xi2, 20) + 113495910845625.0*pow(xi2, 18) - 93538327050630.0*pow(xi2, 16) + 54081907550055.0*pow(xi2, 14) - 22015441819800.0*pow(xi2, 12) + 6236003448675.0*pow(xi2, 10) - 1193706206550.0*pow(xi2, 8) + 146177884853.0*pow(xi2, 6) - 10340339828.0*pow(xi2, 4) + 340811835.0*pow(xi2, 2) - 2645370.0);
case 25:
return -266528.404909372*pow(xi1, 29) + 1927559.74809766*pow(xi1, 27) - 6249526.46725416*pow(xi1, 25) + 11990174.723804*pow(xi1, 23) - 15132877.5010765*pow(xi1, 21) + 13211577.6992261*pow(xi1, 19) - 8167029.78691578*pow(xi1, 17) + 3597335.80345631*pow(xi1, 15) - 1120385.35932899*pow(xi1, 13) + 241233.31105113*pow(xi1, 11) - 34408.5311770439*pow(xi1, 9) + 3012.09060621262*pow(xi1, 7) - 139.743283510208*pow(xi1, 5) + 2.41770386695862*pow(xi1, 3) + 2.38418579101563e-7*pow(xi2, 3)*(1117901154825.0*pow(xi2, 26) - 8084771561685.0*pow(xi2, 24) + 26212413859710.0*pow(xi2, 22) - 50290437804750.0*pow(xi2, 20) + 63471888634275.0*pow(xi2, 18) - 55413373190175.0*pow(xi2, 16) + 34255005703380.0*pow(xi2, 14) - 15088319949780.0*pow(xi2, 12) + 4699236794175.0*pow(xi2, 10) - 1011805841475.0*pow(xi2, 8) + 144319839950.0*pow(xi2, 6) - 12633623678.0*pow(xi2, 4) + 586125813.0*pow(xi2, 2) - 10140585.0);
case 26:
return -504553.077627048*pow(xi1, 30) + 3775202.10564919*pow(xi1, 28) - 12711977.0834365*pow(xi1, 26) + 25445111.4509571*pow(xi1, 24) - 33689526.0770302*pow(xi1, 22) + 31062052.6502893*pow(xi1, 20) - 20448237.8820252*pow(xi1, 18) + 9693702.71960892*pow(xi1, 16) - 3294914.07228*pow(xi1, 14) + 789254.786240682*pow(xi1, 12) - 128830.869173482*pow(xi1, 10) + 13511.1869540066*pow(xi1, 8) - 818.705045714974*pow(xi1, 6) + 23.0185555666685*pow(xi1, 4) - 0.151106491684914*pow(xi1, 2) + 1.49011611938477e-8*pow(xi2, 2)*(33859983867255.0*pow(xi2, 28) - 253349524680525.0*pow(xi2, 26) + 853086341263455.0*pow(xi2, 24) - 1.70759252382713e+15*pow(xi2, 22) + 2.26086582372788e+15*pow(xi2, 20) - 2.08453906686911e+15*pow(xi2, 18) + 1.37225801506448e+15*pow(xi2, 16) - 650533377466665.0*pow(xi2, 14) + 221117940368325.0*pow(xi2, 12) - 52965992111175.0*pow(xi2, 10) + 8645693278365.0*pow(xi2, 8) - 906720407775.0*pow(xi2, 6) + 54942365569.0*pow(xi2, 4) - 1544749115.0*pow(xi2, 2) + 10140585.0);
case 27:
return -957023.256918401*pow(xi1, 31) + 7400111.8051967*pow(xi1, 29) - 25843137.068245*pow(xi1, 27) + 53877067.1146849*pow(xi1, 25) - 74671105.3192668*pow(xi1, 23) + 72510060.6815735*pow(xi1, 21) - 50652263.6690386*pow(xi1, 19) + 25722379.0240824*pow(xi1, 17) - 9480938.51420894*pow(xi1, 15) + 2503513.98898512*pow(xi1, 13) - 461137.163681835*pow(xi1, 11) + 56571.6800898314*pow(xi1, 9) - 4267.03145876527*pow(xi1, 7) + 170.246647298336*pow(xi1, 5) - 2.51844152808189*pow(xi1, 3) + 2.98023223876953e-8*pow(xi2, 3)*(32112371796687.0*pow(xi2, 28) - 248306548359870.0*pow(xi2, 26) + 867151785423105.0*pow(xi2, 24) - 1.80781438485913e+15*pow(xi2, 22) + 2.50554652580018e+15*pow(xi2, 20) - 2.43303390045573e+15*pow(xi2, 18) + 1.69960793692883e+15*pow(xi2, 16) - 863099817841800.0*pow(xi2, 14) + 318127506671205.0*pow(xi2, 12) - 84003989904450.0*pow(xi2, 10) + 15473195601435.0*pow(xi2, 8) - 1898230592700.0*pow(xi2, 6) + 143177816925.0*pow(xi2, 4) - 5712529550.0*pow(xi2, 2) + 84504875.0);
case 28:
return -1818574.24181249*pow(xi1, 32) + 14516897.6514182*pow(xi1, 30) - 52511869.8034722*pow(xi1, 28) + 113840304.253635*pow(xi1, 26) - 164833771.490504*pow(xi1, 24) + 168159990.091489*pow(xi1, 22) - 124255903.500852*pow(xi1, 20) + 67314123.2068179*pow(xi1, 18) - 26755766.9500322*pow(xi1, 16) + 7728158.51647016*pow(xi1, 14) - 1588058.92531319*pow(xi1, 12) + 223746.609440781*pow(xi1, 10) - 20315.2289499063*pow(xi1, 8) + 1065.5041789636*pow(xi1, 6) - 25.8382414467633*pow(xi1, 4) + 0.145294703543186*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.90535844696632e+15*pow(xi2, 30) - 3.11748003261102e+16*pow(xi2, 28) + 1.12768381728861e+17*pow(xi2, 26) - 2.44470191868025e+17*pow(xi2, 24) + 3.53977828914025e+17*pow(xi2, 22) - 3.61120828969315e+17*pow(xi2, 20) + 2.66837520935546e+17*pow(xi2, 18) - 1.44555978866099e+17*pow(xi2, 16) + 5.7457572014893e+16*pow(xi2, 14) - 1.65960940432716e+16*pow(xi2, 12) + 3.41033057417052e+15*pow(xi2, 10) - 480492185069520.0*pow(xi2, 8) + 43626621975300.0*pow(xi2, 6) - 2288152801200.0*pow(xi2, 4) + 55487201000.0*pow(xi2, 2) - 312018000.0);
case 29:
return -3461618.30989224*pow(xi1, 33) + 28498480.2996788*pow(xi1, 31) - 106650445.835851*pow(xi1, 29) + 240073829.195359*pow(xi1, 27) - 362501705.126616*pow(xi1, 25) + 387645522.427694*pow(xi1, 23) - 302119490.023002*pow(xi1, 21) + 173956904.077601*pow(xi1, 19) - 74200832.0310932*pow(xi1, 17) + 23288542.3204008*pow(xi1, 15) - 5288299.728707*pow(xi1, 13) + 843336.470763026*pow(xi1, 11) - 89923.5811349005*pow(xi1, 9) + 5901.7463196069*pow(xi1, 7) - 204.516824707389*pow(xi1, 5) + 2.61530466377735*pow(xi1, 3) + 1.35465101762251e-9*pow(xi2, 3)*(2.55535799616315e+15*pow(xi2, 30) - 2.10375070250161e+16*pow(xi2, 28) + 7.87290929165121e+16*pow(xi2, 26) - 1.77221901487736e+17*pow(xi2, 24) + 2.67597853920212e+17*pow(xi2, 22) - 2.861589570929e+17*pow(xi2, 20) + 2.23023853444733e+17*pow(xi2, 18) - 1.28414552393653e+17*pow(xi2, 16) + 5.47748690000762e+16*pow(xi2, 14) - 1.71915438127183e+16*pow(xi2, 12) + 3.90380966013539e+15*pow(xi2, 10) - 622548877749435.0*pow(xi2, 8) + 66381363144525.0*pow(xi2, 6) - 4356654402375.0*pow(xi2, 4) + 150973809525.0*pow(xi2, 2) - 1930611375.0);
default:
return 0.;
}
case 8:
switch(j) {
case 0:
return 0.00390625*y1t*(-693.0*pow(xi1, 8) + 1260.0*pow(xi1, 6) - 630.0*pow(xi1, 4) + 60.0*pow(xi1, 2) + 693.0*pow(xi2, 8) - 1260.0*pow(xi2, 6) + 630.0*pow(xi2, 4) - 60.0*pow(xi2, 2));
case 1:
return 0.001953125*y1r*(-693.0*pow(xi1, 8) + 264.0*pow(xi1, 7) + 1260.0*pow(xi1, 6) - 504.0*pow(xi1, 5) - 630.0*pow(xi1, 4) + 280.0*pow(xi1, 3) + 60.0*pow(xi1, 2) - 40.0*xi1 + xi2*(693.0*pow(xi2, 7) - 264.0*pow(xi2, 6) - 1260.0*pow(xi2, 5) + 504.0*pow(xi2, 4) + 630.0*pow(xi2, 3) - 280.0*pow(xi2, 2) - 60.0*xi2 + 40.0));
case 2:
return 0.00390625*y2t*(693.0*pow(xi1, 8) - 1260.0*pow(xi1, 6) + 630.0*pow(xi1, 4) - 60.0*pow(xi1, 2) - 693.0*pow(xi2, 8) + 1260.0*pow(xi2, 6) - 630.0*pow(xi2, 4) + 60.0*pow(xi2, 2));
case 3:
return 0.001953125*y2r*(-693.0*pow(xi1, 8) - 264.0*pow(xi1, 7) + 1260.0*pow(xi1, 6) + 504.0*pow(xi1, 5) - 630.0*pow(xi1, 4) - 280.0*pow(xi1, 3) + 60.0*pow(xi1, 2) + 40.0*xi1 + xi2*(693.0*pow(xi2, 7) + 264.0*pow(xi2, 6) - 1260.0*pow(xi2, 5) - 504.0*pow(xi2, 4) + 630.0*pow(xi2, 3) + 280.0*pow(xi2, 2) - 60.0*xi2 - 40.0));
case 4:
return -2.40625*pow(xi1, 9) + 5.25*pow(xi1, 7) - 3.9375*pow(xi1, 5) + 1.25*pow(xi1, 3) - 0.15625*xi1 + 2.40625*pow(xi2, 9) - 5.25*pow(xi2, 7) + 3.9375*pow(xi2, 5) - 1.25*pow(xi2, 3) + 0.15625*xi2;
case 5:
return -3.609375*pow(xi1, 10) + 8.859375*pow(xi1, 8) - 7.65625*pow(xi1, 6) + 2.65625*pow(xi1, 4) - 0.234375*pow(xi1, 2) + 0.015625*pow(xi2, 2)*(231.0*pow(xi2, 8) - 567.0*pow(xi2, 6) + 490.0*pow(xi2, 4) - 170.0*pow(xi2, 2) + 15.0);
case 6:
return -5.7421875*pow(xi1, 11) + 15.5859375*pow(xi1, 9) - 15.421875*pow(xi1, 7) + 6.671875*pow(xi1, 5) - 1.2109375*pow(xi1, 3) + 0.1171875*xi1 + 5.7421875*pow(xi2, 11) - 15.5859375*pow(xi2, 9) + 15.421875*pow(xi2, 7) - 6.671875*pow(xi2, 5) + 1.2109375*pow(xi2, 3) - 0.1171875*xi2;
case 7:
return -9.474609375*pow(xi1, 12) + 28.13671875*pow(xi1, 10) - 31.376953125*pow(xi1, 8) + 16.1328125*pow(xi1, 6) - 3.759765625*pow(xi1, 4) + 0.29296875*pow(xi1, 2) + 0.001953125*pow(xi2, 2)*(4851.0*pow(xi2, 10) - 14406.0*pow(xi2, 8) + 16065.0*pow(xi2, 6) - 8260.0*pow(xi2, 4) + 1925.0*pow(xi2, 2) - 150.0);
case 8:
return -16.0339543269231*pow(xi1, 13) + 51.6796875*pow(xi1, 11) - 64.12109375*pow(xi1, 9) + 38.203125*pow(xi1, 7) - 11.07421875*pow(xi1, 5) + 1.3671875*pow(xi1, 3) - 0.09765625*xi1 + 16.0339543269231*pow(xi2, 13) - 51.6796875*pow(xi2, 11) + 64.12109375*pow(xi2, 9) - 38.203125*pow(xi2, 7) + 11.07421875*pow(xi2, 5) - 1.3671875*pow(xi2, 3) + 0.09765625*xi2;
case 9:
return -27.650390625*pow(xi1, 14) + 96.099609375*pow(xi1, 12) - 131.291015625*pow(xi1, 10) + 88.974609375*pow(xi1, 8) - 30.966796875*pow(xi1, 6) + 5.126953125*pow(xi1, 4) - 0.341796875*pow(xi1, 2) + 0.001953125*pow(xi2, 2)*(14157.0*pow(xi2, 12) - 49203.0*pow(xi2, 10) + 67221.0*pow(xi2, 8) - 45555.0*pow(xi2, 6) + 15855.0*pow(xi2, 4) - 2625.0*pow(xi2, 2) + 175.0);
case 10:
return -48.38818359375*pow(xi1, 15) + 180.35595703125*pow(xi1, 13) - 269.01123046875*pow(xi1, 11) + 204.39697265625*pow(xi1, 9) - 83.19580078125*pow(xi1, 7) + 17.38037109375*pow(xi1, 5) - 1.62353515625*pow(xi1, 3) + 0.08544921875*xi1 + 48.38818359375*pow(xi2, 15) - 180.35595703125*pow(xi2, 13) + 269.01123046875*pow(xi2, 11) - 204.39697265625*pow(xi2, 9) + 83.19580078125*pow(xi2, 7) - 17.38037109375*pow(xi2, 5) + 1.62353515625*pow(xi2, 3) - 0.08544921875*xi2;
case 11:
return -85.6874084472656*pow(xi1, 16) + 340.916748046875*pow(xi1, 14) - 551.209838867188*pow(xi1, 12) + 464.177978515625*pow(xi1, 10) - 216.592712402344*pow(xi1, 8) + 54.884033203125*pow(xi1, 6) - 6.8572998046875*pow(xi1, 4) + 0.384521484375*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(2807805.0*pow(xi2, 14) - 11171160.0*pow(xi2, 12) + 18062044.0*pow(xi2, 10) - 15210184.0*pow(xi2, 8) + 7097310.0*pow(xi2, 6) - 1798440.0*pow(xi2, 4) + 224700.0*pow(xi2, 2) - 12600.0);
case 12:
return -153.229248046875*pow(xi1, 17) + 648.1083984375*pow(xi1, 15) - 1129.0576171875*pow(xi1, 13) + 1043.8720703125*pow(xi1, 11) - 549.75830078125*pow(xi1, 9) + 164.2587890625*pow(xi1, 7) - 26.0654296875*pow(xi1, 5) + 1.9482421875*pow(xi1, 3) - 0.076904296875*xi1 + 153.229248046875*pow(xi2, 17) - 648.1083984375*pow(xi2, 15) + 1129.0576171875*pow(xi2, 13) - 1043.8720703125*pow(xi2, 11) + 549.75830078125*pow(xi2, 9) - 164.2587890625*pow(xi2, 7) + 26.0654296875*pow(xi2, 5) - 1.9482421875*pow(xi2, 3) + 0.076904296875*xi2;
case 13:
return -276.276977539063*pow(xi1, 18) + 1237.86437988281*pow(xi1, 16) - 2311.435546875*pow(xi1, 14) + 2327.8759765625*pow(xi1, 12) - 1366.56469726563*pow(xi1, 10) + 471.289306640625*pow(xi1, 8) - 91.3623046875*pow(xi1, 6) + 9.0234375*pow(xi1, 4) - 0.4229736328125*pow(xi1, 2) + 0.0001220703125*pow(xi2, 2)*(2263261.0*pow(xi2, 16) - 10140585.0*pow(xi2, 14) + 18935280.0*pow(xi2, 12) - 19069960.0*pow(xi2, 10) + 11194898.0*pow(xi2, 8) - 3860802.0*pow(xi2, 6) + 748440.0*pow(xi2, 4) - 73920.0*pow(xi2, 2) + 3465.0);
case 14:
return -501.660827636719*pow(xi1, 19) + 2373.47039794922*pow(xi1, 17) - 4729.00073242188*pow(xi1, 15) + 5153.51928710938*pow(xi1, 13) - 3338.01818847656*pow(xi1, 11) + 1306.88244628906*pow(xi1, 9) - 300.665771484375*pow(xi1, 7) + 37.729248046875*pow(xi1, 5) - 2.32635498046875*pow(xi1, 3) + 0.07049560546875*xi1 + 501.660827636719*pow(xi2, 19) - 2373.47039794922*pow(xi2, 17) + 4729.00073242188*pow(xi2, 15) - 5153.51928710938*pow(xi2, 13) + 3338.01818847656*pow(xi2, 11) - 1306.88244628906*pow(xi2, 9) + 300.665771484375*pow(xi2, 7) - 37.729248046875*pow(xi2, 5) + 2.32635498046875*pow(xi2, 3) - 0.07049560546875*xi2;
case 15:
return -916.495742797852*pow(xi1, 20) + 4565.8151550293*pow(xi1, 18) - 9668.48670959473*pow(xi1, 16) + 11336.3458251953*pow(xi1, 14) - 8033.13552856445*pow(xi1, 12) + 3523.35626220703*pow(xi1, 10) - 940.964263916016*pow(xi1, 8) + 144.797973632813*pow(xi1, 6) - 11.6846466064453*pow(xi1, 4) + 0.458221435546875*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(60063465.0*pow(xi2, 18) - 299225262.0*pow(xi2, 16) + 633633945.0*pow(xi2, 14) - 742938760.0*pow(xi2, 12) + 526459570.0*pow(xi2, 10) - 230906676.0*pow(xi2, 8) + 61667034.0*pow(xi2, 6) - 9489480.0*pow(xi2, 4) + 765765.0*pow(xi2, 2) - 30030.0);
case 16:
return -1683.35952758789*pow(xi1, 21) + 8807.88116455078*pow(xi1, 19) - 19753.4588928223*pow(xi1, 17) + 24796.6374511719*pow(xi1, 15) - 19086.1575317383*pow(xi1, 13) + 9276.90124511719*pow(xi1, 11) - 2826.61529541016*pow(xi1, 9) + 518.549560546875*pow(xi1, 7) - 53.0620422363281*pow(xi1, 5) + 2.74932861328125*pow(xi1, 3) - 0.065460205078125*xi1 + 1683.35952758789*pow(xi2, 21) - 8807.88116455078*pow(xi2, 19) + 19753.4588928223*pow(xi2, 17) - 24796.6374511719*pow(xi2, 15) + 19086.1575317383*pow(xi2, 13) - 9276.90124511719*pow(xi2, 11) + 2826.61529541016*pow(xi2, 9) - 518.549560546875*pow(xi2, 7) + 53.0620422363281*pow(xi2, 5) - 2.74932861328125*pow(xi2, 3) + 0.065460205078125*xi2;
case 17:
return -3106.56349182129*pow(xi1, 22) + 17032.5377655029*pow(xi1, 20) - 40329.7801971436*pow(xi1, 18) + 53967.8263092041*pow(xi1, 16) - 44844.786529541*pow(xi1, 14) + 23938.3236999512*pow(xi1, 12) - 8206.77645874023*pow(xi1, 10) + 1755.44631958008*pow(xi1, 8) - 220.63362121582*pow(xi1, 6) + 14.8921966552734*pow(xi1, 4) - 0.490951538085938*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(203591745.0*pow(xi2, 20) - 1116244395.0*pow(xi2, 18) + 2643052475.0*pow(xi2, 16) - 3536835465.0*pow(xi2, 14) + 2938947930.0*pow(xi2, 12) - 1568821982.0*pow(xi2, 10) + 537839302.0*pow(xi2, 8) - 115044930.0*pow(xi2, 6) + 14459445.0*pow(xi2, 4) - 975975.0*pow(xi2, 2) + 32175.0);
case 18:
return -5757.27255821228*pow(xi1, 23) + 33007.2371006012*pow(xi1, 21) - 82283.7614536285*pow(xi1, 19) + 116930.786275864*pow(xi1, 17) - 104341.16991806*pow(xi1, 15) + 60706.0439186096*pow(xi1, 13) - 23152.2125434875*pow(xi1, 11) + 5673.22050094604*pow(xi1, 9) - 852.549619674683*pow(xi1, 7) + 72.8285694122314*pow(xi1, 5) - 3.21164131164551*pow(xi1, 3) + 0.0613689422607422*xi1 + 5757.27255821228*pow(xi2, 23) - 33007.2371006012*pow(xi2, 21) + 82283.7614536285*pow(xi2, 19) - 116930.786275864*pow(xi2, 17) + 104341.16991806*pow(xi2, 15) - 60706.0439186096*pow(xi2, 13) + 23152.2125434875*pow(xi2, 11) - 5673.22050094604*pow(xi2, 9) + 852.549619674683*pow(xi2, 7) - 72.8285694122314*pow(xi2, 5) + 3.21164131164551*pow(xi2, 3) - 0.0613689422607422*xi2;
case 19:
return -10710.2202737331*pow(xi1, 24) + 64084.2932081223*pow(xi1, 22) - 167771.560342312*pow(xi1, 20) + 252330.548357964*pow(xi1, 18) - 240678.833252192*pow(xi1, 16) + 151630.777410507*pow(xi1, 14) - 63727.5063905716*pow(xi1, 12) + 17635.4748363495*pow(xi1, 10) - 3100.26537537575*pow(xi1, 8) + 325.466094017029*pow(xi1, 6) - 18.6919569969177*pow(xi1, 4) + 0.521636009216309*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(44921919735.0*pow(xi2, 22) - 268789007340.0*pow(xi2, 20) + 703684926630.0*pow(xi2, 18) - 1058351028300.0*pow(xi2, 16) + 1009480193025.0*pow(xi2, 14) - 635985576216.0*pow(xi2, 12) + 267292534964.0*pow(xi2, 10) - 73968542648.0*pow(xi2, 8) + 13003455465.0*pow(xi2, 6) - 1365103740.0*pow(xi2, 4) + 78399750.0*pow(xi2, 2) - 2187900.0);
case 20:
return -19992.4111776352*pow(xi1, 25) + 124628.017730713*pow(xi1, 23) - 341861.576414108*pow(xi1, 21) + 542531.872558594*pow(xi1, 19) - 550892.626976967*pow(xi1, 17) + 373726.219482422*pow(xi1, 15) - 171716.18970108*pow(xi1, 13) + 53039.797668457*pow(xi1, 11) - 10716.5249490738*pow(xi1, 9) + 1347.62924194336*pow(xi1, 7) - 97.8589153289795*pow(xi1, 5) + 3.70941162109375*pow(xi1, 3) - 0.0579595565795898*xi1 + 19992.4111776352*pow(xi2, 25) - 124628.017730713*pow(xi2, 23) + 341861.576414108*pow(xi2, 21) - 542531.872558594*pow(xi2, 19) + 550892.626976967*pow(xi2, 17) - 373726.219482422*pow(xi2, 15) + 171716.18970108*pow(xi2, 13) - 53039.797668457*pow(xi2, 11) + 10716.5249490738*pow(xi2, 9) - 1347.62924194336*pow(xi2, 7) + 97.8589153289795*pow(xi2, 5) - 3.70941162109375*pow(xi2, 3) + 0.0579595565795898*xi2;
case 21:
return -37435.1828731023*pow(xi1, 26) + 242730.829489231*pow(xi1, 24) - 696181.399483681*pow(xi1, 22) + 1162625.44245243*pow(xi1, 20) - 1252241.40361547*pow(xi1, 18) + 910307.749307156*pow(xi1, 16) - 454159.560728073*pow(xi1, 14) + 155054.118558884*pow(xi1, 12) - 35489.4119925499*pow(xi1, 10) + 5233.38281393051*pow(xi1, 8) - 467.142434120178*pow(xi1, 6) + 23.1258630752563*pow(xi1, 4) - 0.550615787506104*pow(xi1, 2) + 3.66797814002404e-8*pow(xi2, 2)*(1020594492225.0*pow(xi2, 24) - 6617564778825.0*pow(xi2, 22) + 18979976785770.0*pow(xi2, 20) - 31696629534570.0*pow(xi2, 18) + 34139827332975.0*pow(xi2, 16) - 24817698321975.0*pow(xi2, 14) + 12381741204300.0*pow(xi2, 12) - 4227236712972.0*pow(xi2, 10) + 967546987407.0*pow(xi2, 8) - 142677590055.0*pow(xi2, 6) + 12735692970.0*pow(xi2, 4) - 630479850.0*pow(xi2, 2) + 15011425.0);
case 22:
return -70294.9545061588*pow(xi1, 27) + 473384.903422594*pow(xi1, 25) - 1416926.27066374*pow(xi1, 23) + 2483930.03357649*pow(xi1, 21) - 2828756.50350451*pow(xi1, 19) + 2194030.45318007*pow(xi1, 17) - 1181610.30903339*pow(xi1, 15) + 442227.793622017*pow(xi1, 13) - 113300.856317282*pow(xi1, 11) + 19251.8955790997*pow(xi1, 9) - 2061.04299116135*pow(xi1, 7) + 129.04231595993*pow(xi1, 5) - 4.239741563797*pow(xi1, 3) + 0.0550615787506104*xi1 + 70294.9545061588*pow(xi2, 27) - 473384.903422594*pow(xi2, 25) + 1416926.27066374*pow(xi2, 23) - 2483930.03357649*pow(xi2, 21) + 2828756.50350451*pow(xi2, 19) - 2194030.45318007*pow(xi2, 17) + 1181610.30903339*pow(xi2, 15) - 442227.793622017*pow(xi2, 13) + 113300.856317282*pow(xi2, 11) - 19251.8955790997*pow(xi2, 9) + 2061.04299116135*pow(xi2, 7) - 129.04231595993*pow(xi2, 5) + 4.239741563797*pow(xi2, 3) - 0.0550615787506104*xi2;
case 23:
return -132341.011289656*pow(xi1, 28) + 924333.005681634*pow(xi1, 26) - 2882286.2527594*pow(xi1, 24) + 5292172.23957181*pow(xi1, 22) - 6353932.12669283*pow(xi1, 20) + 5238217.27822244*pow(xi1, 18) - 3029728.63045782*pow(xi1, 16) + 1234258.81294012*pow(xi1, 14) - 350443.153385818*pow(xi1, 12) + 67627.7707961798*pow(xi1, 10) - 8505.12255173922*pow(xi1, 8) + 654.847356081009*pow(xi1, 6) - 28.2328245043755*pow(xi1, 4) + 0.578146576881409*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2220313732065.0*pow(xi2, 26) - 15507734492250.0*pow(xi2, 24) + 48356739036375.0*pow(xi2, 22) - 88787916772500.0*pow(xi2, 20) + 106601291738865.0*pow(xi2, 18) - 87882702731670.0*pow(xi2, 16) + 50830411654575.0*pow(xi2, 14) - 20707426704600.0*pow(xi2, 12) + 5879460480075.0*pow(xi2, 10) - 1134605718246.0*pow(xi2, 8) + 142692278157.0*pow(xi2, 6) - 10986515540.0*pow(xi2, 4) + 473668195.0*pow(xi2, 2) - 9699690.0);
case 24:
return -249746.986822486*pow(xi1, 29) + 1806837.60868192*pow(xi1, 27) - 5860084.52208102*pow(xi1, 25) + 11246581.6746354*pow(xi1, 23) - 14198689.9865001*pow(xi1, 21) + 12399650.7613456*pow(xi1, 19) - 7667706.33566916*pow(xi1, 17) + 3379488.03859234*pow(xi1, 15) - 1054394.5972234*pow(xi1, 13) + 228315.864676237*pow(xi1, 11) - 33153.3859709501*pow(xi1, 9) + 3064.44115304947*pow(xi1, 7) - 167.322627186775*pow(xi1, 5) + 4.80036854743958*pow(xi1, 3) - 0.0525587797164917*xi1 + 249746.986822486*pow(xi2, 29) - 1806837.60868192*pow(xi2, 27) + 5860084.52208102*pow(xi2, 25) - 11246581.6746354*pow(xi2, 23) + 14198689.9865001*pow(xi2, 21) - 12399650.7613456*pow(xi2, 19) + 7667706.33566916*pow(xi2, 17) - 3379488.03859234*pow(xi2, 15) + 1054394.5972234*pow(xi2, 13) - 228315.864676237*pow(xi2, 11) + 33153.3859709501*pow(xi2, 9) - 3064.44115304947*pow(xi2, 7) + 167.322627186775*pow(xi2, 5) - 4.80036854743958*pow(xi2, 3) + 0.0525587797164917*xi2;
case 25:
return -472347.562033832*pow(xi1, 30) + 3535449.9340108*pow(xi1, 28) - 11908551.1147007*pow(xi1, 26) + 23844310.0991026*pow(xi1, 24) - 31579394.0735087*pow(xi1, 22) + 29124851.166729*pow(xi1, 20) - 19179056.4950797*pow(xi1, 18) + 9096790.49992114*pow(xi1, 16) - 3096188.05515915*pow(xi1, 14) + 744686.034451425*pow(xi1, 12) - 123066.221275628*pow(xi1, 10) + 13381.5246321559*pow(xi1, 8) - 899.184363186359*pow(xi1, 6) + 34.0493294596672*pow(xi1, 4) - 0.604425966739655*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(7924677075315.0*pow(xi2, 28) - 59315007200085.0*pow(xi2, 26) + 199792334298375.0*pow(xi2, 24) - 400041140903625.0*pow(xi2, 22) + 529814315520375.0*pow(xi2, 20) - 488633918992065.0*pow(xi2, 18) + 321771173494155.0*pow(xi2, 16) - 152618819123925.0*pow(xi2, 14) + 51945415778025.0*pow(xi2, 12) - 12493758452175.0*pow(xi2, 10) + 2064708576645.0*pow(xi2, 8) - 224504729163.0*pow(xi2, 6) + 15085810285.0*pow(xi2, 4) - 571252955.0*pow(xi2, 2) + 10140585.0);
case 26:
return -895174.815144762*pow(xi1, 31) + 6924185.8525414*pow(xi1, 29) - 24188727.8042527*pow(xi1, 27) + 50443217.3199738*pow(xi1, 25) - 69932128.9454531*pow(xi1, 23) + 67927236.8258033*pow(xi1, 21) - 47465195.5647927*pow(xi1, 19) + 24114852.0421258*pow(xi1, 17) - 8897819.76002522*pow(xi1, 15) + 2356624.70512949*pow(xi1, 13) - 437897.870313004*pow(xi1, 11) + 55065.7599892467*pow(xi1, 9) - 4446.10128606856*pow(xi1, 7) + 213.694800540805*pow(xi1, 5) - 5.38946487009525*pow(xi1, 3) + 0.0503688305616379*xi1 + 895174.815144762*pow(xi2, 31) - 6924185.8525414*pow(xi2, 29) + 24188727.8042527*pow(xi2, 27) - 50443217.3199738*pow(xi2, 25) + 69932128.9454531*pow(xi2, 23) - 67927236.8258033*pow(xi2, 21) + 47465195.5647927*pow(xi2, 19) - 24114852.0421258*pow(xi2, 17) + 8897819.76002522*pow(xi2, 15) - 2356624.70512949*pow(xi2, 13) + 437897.870313004*pow(xi2, 11) - 55065.7599892467*pow(xi2, 9) + 4446.10128606856*pow(xi2, 7) - 213.694800540805*pow(xi2, 5) + 5.38946487009525*pow(xi2, 3) - 0.0503688305616379*xi2;
case 27:
return -1699713.18025612*pow(xi1, 32) + 13572477.7881676*pow(xi1, 30) - 49110727.486688*pow(xi1, 28) + 106498272.480833*pow(xi1, 26) - 154246386.564348*pow(xi1, 24) + 157401903.208298*pow(xi1, 22) - 116340051.261704*pow(xi1, 20) + 63051164.7932561*pow(xi1, 18) - 25082662.6889706*pow(xi1, 16) + 7261397.49628846*pow(xi1, 14) - 1501655.10006906*pow(xi1, 12) + 215279.573045634*pow(xi1, 10) - 20471.3273524772*pow(xi1, 8) + 1212.25182954222*pow(xi1, 6) - 40.6098696403205*pow(xi1, 4) + 0.629610382020473*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.65010626089009e+15*pow(xi2, 30) - 2.91466741129331e+16*pow(xi2, 28) + 1.05464484219047e+17*pow(xi2, 26) - 2.28703298692836e+17*pow(xi2, 24) + 3.31241592910024e+17*pow(xi2, 22) - 3.380180133039e+17*pow(xi2, 20) + 2.49838357691991e+17*pow(xi2, 18) - 1.35401345380871e+17*pow(xi2, 16) + 5.38646079728641e+16*pow(xi2, 14) - 1.55937323849076e+16*pow(xi2, 12) + 3.22477977233412e+15*pow(xi2, 10) - 462309362863920.0*pow(xi2, 8) + 43961840742300.0*pow(xi2, 6) - 2603290981200.0*pow(xi2, 4) + 87209031000.0*pow(xi2, 2) - 1352078000.0);
case 28:
return -3233020.87433331*pow(xi1, 33) + 26624877.7886273*pow(xi1, 31) - 99668638.718943*pow(xi1, 29) + 224421795.69438*pow(xi1, 27) - 338960904.584224*pow(xi1, 25) + 362568410.607603*pow(xi1, 23) - 282653208.096126*pow(xi1, 21) + 162807565.128513*pow(xi1, 19) - 69493811.927836*pow(xi1, 17) + 21849539.0316908*pow(xi1, 15) - 4984958.43316376*pow(xi1, 13) + 804945.792270452*pow(xi1, 11) - 88641.442552954*pow(xi1, 9) + 6313.27903792262*pow(xi1, 7) - 269.202026724815*pow(xi1, 5) + 6.00551441311836*pow(xi1, 3) - 0.0484315678477287*xi1 + 3233020.87433331*pow(xi2, 33) - 26624877.7886273*pow(xi2, 31) + 99668638.718943*pow(xi2, 29) - 224421795.69438*pow(xi2, 27) + 338960904.584224*pow(xi2, 25) - 362568410.607603*pow(xi2, 23) + 282653208.096126*pow(xi2, 21) - 162807565.128513*pow(xi2, 19) + 69493811.927836*pow(xi2, 17) - 21849539.0316908*pow(xi2, 15) + 4984958.43316376*pow(xi2, 13) - 804945.792270452*pow(xi2, 11) + 88641.442552954*pow(xi2, 9) - 6313.27903792262*pow(xi2, 7) + 269.202026724815*pow(xi2, 5) - 6.00551441311836*pow(xi2, 3) + 0.0484315678477287*xi2;
case 29:
return -6159644.34554354*pow(xi1, 34) + 52267170.8017219*pow(xi1, 32) - 202194111.58739*pow(xi1, 30) + 472090210.646781*pow(xi1, 28) - 742330528.164016*pow(xi1, 26) + 830587403.930279*pow(xi1, 24) - 681190082.905951*pow(xi1, 22) + 415637119.889813*pow(xi1, 20) - 189551172.160955*pow(xi1, 18) + 64362896.3166805*pow(xi1, 16) - 16078796.4261874*pow(xi1, 14) + 2894443.79047908*pow(xi1, 12) - 363906.137368977*pow(xi1, 10) + 30556.7713536322*pow(xi1, 8) - 1607.71495364606*pow(xi1, 6) + 47.9472521692514*pow(xi1, 4) - 0.653826165944338*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.6534669386938e+15*pow(xi2, 32) - 1.40303618279901e+16*pow(xi2, 30) + 5.4276068544476e+16*pow(xi2, 28) - 1.26725750968105e+17*pow(xi2, 26) + 1.99267833830428e+17*pow(xi2, 24) - 2.22959108521881e+17*pow(xi2, 22) + 1.82855570527537e+17*pow(xi2, 20) - 1.11571739808149e+17*pow(xi2, 18) + 5.08822553343604e+16*pow(xi2, 16) - 1.72772834222489e+16*pow(xi2, 14) + 4.31611905059478e+15*pow(xi2, 12) - 776971338763620.0*pow(xi2, 10) + 97685309925840.0*pow(xi2, 8) - 8202520852200.0*pow(xi2, 6) + 431567696700.0*pow(xi2, 4) - 12870742500.0*pow(xi2, 2) + 175510125.0);
default:
return 0.;
}
case 9:
switch(j) {
case 0:
return 0.03125*y1t*(-143.0*pow(xi1, 9) + 297.0*pow(xi1, 7) - 189.0*pow(xi1, 5) + 35.0*pow(xi1, 3) + 143.0*pow(xi2, 9) - 297.0*pow(xi2, 7) + 189.0*pow(xi2, 5) - 35.0*pow(xi2, 3));
case 1:
return 0.001953125*y1r*(-1144.0*pow(xi1, 9) + 429.0*pow(xi1, 8) + 2376.0*pow(xi1, 7) - 924.0*pow(xi1, 6) - 1512.0*pow(xi1, 5) + 630.0*pow(xi1, 4) + 280.0*pow(xi1, 3) - 140.0*pow(xi1, 2) + pow(xi2, 2)*(1144.0*pow(xi2, 7) - 429.0*pow(xi2, 6) - 2376.0*pow(xi2, 5) + 924.0*pow(xi2, 4) + 1512.0*pow(xi2, 3) - 630.0*pow(xi2, 2) - 280.0*xi2 + 140.0));
case 2:
return 0.03125*y2t*(143.0*pow(xi1, 9) - 297.0*pow(xi1, 7) + 189.0*pow(xi1, 5) - 35.0*pow(xi1, 3) - 143.0*pow(xi2, 9) + 297.0*pow(xi2, 7) - 189.0*pow(xi2, 5) + 35.0*pow(xi2, 3));
case 3:
return 0.001953125*y2r*(-1144.0*pow(xi1, 9) - 429.0*pow(xi1, 8) + 2376.0*pow(xi1, 7) + 924.0*pow(xi1, 6) - 1512.0*pow(xi1, 5) - 630.0*pow(xi1, 4) + 280.0*pow(xi1, 3) + 140.0*pow(xi1, 2) + pow(xi2, 2)*(1144.0*pow(xi2, 7) + 429.0*pow(xi2, 6) - 2376.0*pow(xi2, 5) - 924.0*pow(xi2, 4) + 1512.0*pow(xi2, 3) + 630.0*pow(xi2, 2) - 280.0*xi2 - 140.0));
case 4:
return -4.021875*pow(xi1, 10) + 9.796875*pow(xi1, 8) - 8.53125*pow(xi1, 6) + 3.28125*pow(xi1, 4) - 0.546875*pow(xi1, 2) + 0.003125*pow(xi2, 2)*(1287.0*pow(xi2, 8) - 3135.0*pow(xi2, 6) + 2730.0*pow(xi2, 4) - 1050.0*pow(xi2, 2) + 175.0);
case 5:
return -6.09375*pow(xi1, 11) + 16.5*pow(xi1, 9) - 16.3125*pow(xi1, 7) + 7.0*pow(xi1, 5) - 1.09375*pow(xi1, 3) + 0.03125*pow(xi2, 3)*(195.0*pow(xi2, 8) - 528.0*pow(xi2, 6) + 522.0*pow(xi2, 4) - 224.0*pow(xi2, 2) + 35.0);
case 6:
return -9.775390625*pow(xi1, 12) + 29.00390625*pow(xi1, 10) - 32.326171875*pow(xi1, 8) + 16.6067708333333*pow(xi1, 6) - 3.896484375*pow(xi1, 4) + 0.41015625*pow(xi1, 2) + 0.000651041666666667*pow(xi2, 2)*(15015.0*pow(xi2, 10) - 44550.0*pow(xi2, 8) + 49653.0*pow(xi2, 6) - 25508.0*pow(xi2, 4) + 5985.0*pow(xi2, 2) - 630.0);
case 7:
return -16.2421875*pow(xi1, 13) + 52.3359375*pow(xi1, 11) - 64.921875*pow(xi1, 9) + 38.671875*pow(xi1, 7) - 11.2109375*pow(xi1, 5) + 1.3671875*pow(xi1, 3) + 0.0078125*pow(xi2, 3)*(2079.0*pow(xi2, 10) - 6699.0*pow(xi2, 8) + 8310.0*pow(xi2, 6) - 4950.0*pow(xi2, 4) + 1435.0*pow(xi2, 2) - 175.0);
case 8:
return -27.650390625*pow(xi1, 14) + 96.099609375*pow(xi1, 12) - 131.291015625*pow(xi1, 10) + 88.974609375*pow(xi1, 8) - 30.966796875*pow(xi1, 6) + 5.126953125*pow(xi1, 4) - 0.341796875*pow(xi1, 2) + 0.001953125*pow(xi2, 2)*(14157.0*pow(xi2, 12) - 49203.0*pow(xi2, 10) + 67221.0*pow(xi2, 8) - 45555.0*pow(xi2, 6) + 15855.0*pow(xi2, 4) - 2625.0*pow(xi2, 2) + 175.0);
case 9:
return -47.92734375*pow(xi1, 15) + 178.6640625*pow(xi1, 13) - 266.51953125*pow(xi1, 11) + 202.526041666667*pow(xi1, 9) - 82.44140625*pow(xi1, 7) + 17.2265625*pow(xi1, 5) - 1.59505208333333*pow(xi1, 3) + 0.000260416666666667*pow(xi2, 3)*(184041.0*pow(xi2, 12) - 686070.0*pow(xi2, 10) + 1023435.0*pow(xi2, 8) - 777700.0*pow(xi2, 6) + 316575.0*pow(xi2, 4) - 66150.0*pow(xi2, 2) + 6125.0);
case 10:
return -84.2472839355469*pow(xi1, 16) + 335.260986328125*pow(xi1, 14) - 542.167602539063*pow(xi1, 12) + 456.642333984375*pow(xi1, 10) - 213.108215332031*pow(xi1, 8) + 54.012451171875*pow(xi1, 6) - 6.7291259765625*pow(xi1, 4) + 0.299072265625*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(2760615.0*pow(xi2, 14) - 10985832.0*pow(xi2, 12) + 17765748.0*pow(xi2, 10) - 14963256.0*pow(xi2, 8) + 6983130.0*pow(xi2, 6) - 1769880.0*pow(xi2, 4) + 220500.0*pow(xi2, 2) - 9800.0);
case 11:
return -149.77294921875*pow(xi1, 17) + 633.65478515625*pow(xi1, 15) - 1104.13037109375*pow(xi1, 13) + 1021.03955078125*pow(xi1, 11) - 537.83447265625*pow(xi1, 9) + 160.72998046875*pow(xi1, 7) - 25.48095703125*pow(xi1, 5) + 1.79443359375*pow(xi1, 3) + 0.00048828125*pow(xi2, 3)*(306735.0*pow(xi2, 14) - 1297725.0*pow(xi2, 12) + 2261259.0*pow(xi2, 10) - 2091089.0*pow(xi2, 8) + 1101485.0*pow(xi2, 6) - 329175.0*pow(xi2, 4) + 52185.0*pow(xi2, 2) - 3675.0);
case 12:
return -268.759236653646*pow(xi1, 18) + 1204.52014160156*pow(xi1, 16) - 2249.736328125*pow(xi1, 14) + 2266.26139322917*pow(xi1, 12) - 1330.67504882813*pow(xi1, 10) + 459.010986328125*pow(xi1, 8) - 88.9560546875*pow(xi1, 6) + 8.61328125*pow(xi1, 4) - 0.2691650390625*pow(xi1, 2) + 4.06901041666667e-5*pow(xi2, 2)*(6605027.0*pow(xi2, 16) - 29602287.0*pow(xi2, 14) + 55289520.0*pow(xi2, 12) - 55695640.0*pow(xi2, 10) + 32702670.0*pow(xi2, 8) - 11280654.0*pow(xi2, 6) + 2186184.0*pow(xi2, 4) - 211680.0*pow(xi2, 2) + 6615.0);
case 13:
return -486.081298828125*pow(xi1, 19) + 2300.4287109375*pow(xi1, 17) - 4584.6708984375*pow(xi1, 15) + 4997.4462890625*pow(xi1, 13) - 3237.65380859375*pow(xi1, 11) + 1267.8681640625*pow(xi1, 9) - 291.6826171875*pow(xi1, 7) + 36.3193359375*pow(xi1, 5) - 1.973876953125*pow(xi1, 3) + 0.000244140625*pow(xi2, 3)*(1990989.0*pow(xi2, 16) - 9422556.0*pow(xi2, 14) + 18778812.0*pow(xi2, 12) - 20469540.0*pow(xi2, 10) + 13261430.0*pow(xi2, 8) - 5193188.0*pow(xi2, 6) + 1194732.0*pow(xi2, 4) - 148764.0*pow(xi2, 2) + 8085.0);
case 14:
return -885.073031616211*pow(xi1, 20) + 4410.56460571289*pow(xi1, 18) - 9342.22398376465*pow(xi1, 16) + 10956.5228271484*pow(xi1, 14) - 7765.78414916992*pow(xi1, 12) + 3406.85804443359*pow(xi1, 10) - 909.936126708984*pow(xi1, 8) + 139.553100585938*pow(xi1, 6) - 10.7329559326172*pow(xi1, 4) + 0.246734619140625*pow(xi1, 2) + 3.0517578125e-6*pow(xi2, 2)*(290020731.0*pow(xi2, 18) - 1445253810.0*pow(xi2, 16) + 3061259955.0*pow(xi2, 14) - 3590233400.0*pow(xi2, 12) + 2544692150.0*pow(xi2, 10) - 1116359244.0*pow(xi2, 8) + 298167870.0*pow(xi2, 6) - 45728760.0*pow(xi2, 4) + 3516975.0*pow(xi2, 2) - 80850.0);
case 15:
return -1621.01287841797*pow(xi1, 21) + 8484.13201904297*pow(xi1, 19) - 19032.4753417969*pow(xi1, 17) + 23897.5576985677*pow(xi1, 15) - 18398.4429931641*pow(xi1, 13) + 8944.64904785156*pow(xi1, 11) - 2725.78621419271*pow(xi1, 9) + 499.278076171875*pow(xi1, 7) - 50.0377807617188*pow(xi1, 5) + 2.13836669921875*pow(xi1, 3) + 2.03450520833333e-5*pow(xi2, 3)*(79676025.0*pow(xi2, 18) - 417012057.0*pow(xi2, 16) + 935484228.0*pow(xi2, 14) - 1174612756.0*pow(xi2, 12) + 904320270.0*pow(xi2, 10) - 439647390.0*pow(xi2, 8) + 133977844.0*pow(xi2, 6) - 24540516.0*pow(xi2, 4) + 2459457.0*pow(xi2, 2) - 105105.0);
case 16:
return -2984.13734436035*pow(xi1, 22) + 16365.9954071045*pow(xi1, 20) - 38761.818649292*pow(xi1, 18) + 51882.5600738525*pow(xi1, 16) - 43122.1461486816*pow(xi1, 14) + 23023.9469909668*pow(xi1, 12) - 7894.69711303711*pow(xi1, 10) + 1687.47244262695*pow(xi1, 8) - 210.002883911133*pow(xi1, 6) + 13.0593109130859*pow(xi1, 4) - 0.229110717773438*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(195568425.0*pow(xi2, 20) - 1072561875.0*pow(xi2, 18) + 2540294547.0*pow(xi2, 16) - 3400175457.0*pow(xi2, 14) + 2826052970.0*pow(xi2, 12) - 1508897390.0*pow(xi2, 10) + 517386870.0*pow(xi2, 8) - 110590194.0*pow(xi2, 6) + 13762749.0*pow(xi2, 4) - 855855.0*pow(xi2, 2) + 15015.0);
case 17:
return -5518.49166870117*pow(xi1, 23) + 31647.1591186523*pow(xi1, 21) - 78913.8542175293*pow(xi1, 19) + 112169.556884766*pow(xi1, 17) - 100115.90423584*pow(xi1, 15) + 58260.7701416016*pow(xi1, 13) - 22223.8673706055*pow(xi1, 11) + 5444.01977539063*pow(xi1, 9) - 813.997650146484*pow(xi1, 7) + 66.9003295898438*pow(xi1, 5) - 2.29110717773438*pow(xi1, 3) + 3.0517578125e-5*pow(xi2, 3)*(180829935.0*pow(xi2, 20) - 1037014110.0*pow(xi2, 18) + 2585849175.0*pow(xi2, 16) - 3675572040.0*pow(xi2, 14) + 3280597950.0*pow(xi2, 12) - 1909088916.0*pow(xi2, 10) + 728231686.0*pow(xi2, 8) - 178389640.0*pow(xi2, 6) + 26673075.0*pow(xi2, 4) - 2192190.0*pow(xi2, 2) + 75075.0);
case 18:
return -10246.5743744373*pow(xi1, 24) + 61326.8917894363*pow(xi1, 22) - 160593.9336133*pow(xi1, 20) + 241593.914977709*pow(xi1, 18) - 230491.054247618*pow(xi1, 16) + 145244.379724503*pow(xi1, 14) - 61055.4647487005*pow(xi1, 12) + 16894.2880268097*pow(xi1, 10) - 2961.98580622673*pow(xi1, 8) + 304.893860816956*pow(xi1, 6) - 15.5723690986633*pow(xi1, 4) + 0.214791297912598*pow(xi1, 2) + 7.94728597005208e-8*pow(xi2, 2)*(128931743655.0*pow(xi2, 22) - 771670882620.0*pow(xi2, 20) + 2020739334390.0*pow(xi2, 18) - 3039954971900.0*pow(xi2, 16) + 2900248652385.0*pow(xi2, 14) - 1827597248568.0*pow(xi2, 12) + 768255540052.0*pow(xi2, 10) - 212579339544.0*pow(xi2, 8) + 37270406745.0*pow(xi2, 6) - 3836452620.0*pow(xi2, 4) + 195945750.0*pow(xi2, 2) - 2702700.0);
case 19:
return -19094.7927165985*pow(xi1, 25) + 119064.266939163*pow(xi1, 23) - 326681.909379959*pow(xi1, 21) + 518565.316343307*pow(xi1, 19) - 526676.111125946*pow(xi1, 17) + 357375.374311066*pow(xi1, 15) - 164236.218235016*pow(xi1, 13) + 50730.0305137634*pow(xi1, 11) - 10234.6607875824*pow(xi1, 9) + 1273.41782569885*pow(xi1, 7) - 87.1479892730713*pow(xi1, 5) + 2.43430137634277*pow(xi1, 3) + 3.814697265625e-7*pow(xi2, 3)*(50055853419.0*pow(xi2, 22) - 312119831925.0*pow(xi2, 20) + 856377024525.0*pow(xi2, 18) - 1359387862875.0*pow(xi2, 16) + 1380649824750.0*pow(xi2, 14) - 936838101234.0*pow(xi2, 12) + 430535391930.0*pow(xi2, 10) - 132985731190.0*pow(xi2, 8) + 26829549175.0*pow(xi2, 6) - 3338188425.0*pow(xi2, 4) + 228453225.0*pow(xi2, 2) - 6381375.0);
case 20:
return -35700.7342457771*pow(xi1, 26) + 231544.762108326*pow(xi1, 24) - 664261.264958382*pow(xi1, 22) + 1109577.42443562*pow(xi1, 20) - 1195370.44476271*pow(xi1, 18) + 869151.521766186*pow(xi1, 16) - 433712.863775253*pow(xi1, 14) + 148085.07665062*pow(xi1, 12) - 33866.3728480339*pow(xi1, 10) + 4964.00997877121*pow(xi1, 8) - 429.167332649231*pow(xi1, 6) + 18.2572603225708*pow(xi1, 4) - 0.202858448028564*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(74869866225.0*pow(xi2, 24) - 485584560945.0*pow(xi2, 22) + 1393056840330.0*pow(xi2, 20) - 2326952514810.0*pow(xi2, 18) + 2506873518975.0*pow(xi2, 16) - 1822742852175.0*pow(xi2, 14) + 909561799692.0*pow(xi2, 12) - 310556914668.0*pow(xi2, 10) + 71022931551.0*pow(xi2, 8) - 10410283455.0*pow(xi2, 6) + 900029130.0*pow(xi2, 4) - 38288250.0*pow(xi2, 2) + 425425.0);
case 21:
return -66947.5757201513*pow(xi1, 27) + 450956.643104553*pow(xi1, 25) - 1350117.33681679*pow(xi1, 23) + 2367351.01711273*pow(xi1, 21) - 2696581.86814785*pow(xi1, 19) + 2091952.29377747*pow(xi1, 17) - 1126858.29648972*pow(xi1, 15) + 421785.623886108*pow(xi1, 13) - 108014.851653099*pow(xi1, 11) + 18288.6666742961*pow(xi1, 9) - 1922.75032997131*pow(xi1, 7) + 111.00414276123*pow(xi1, 5) - 2.56954034169515*pow(xi1, 3) + 3.17891438802083e-7*pow(xi2, 3)*(210598863475.0*pow(xi2, 24) - 1418586939000.0*pow(xi2, 22) + 4247101909710.0*pow(xi2, 20) - 7447042380360.0*pow(xi2, 18) + 8482713086925.0*pow(xi2, 16) - 6580712905200.0*pow(xi2, 14) + 3544789695300.0*pow(xi2, 12) - 1326822847056.0*pow(xi2, 10) + 339785343261.0*pow(xi2, 8) - 57531170840.0*pow(xi2, 6) + 6048449550.0*pow(xi2, 4) - 349188840.0*pow(xi2, 2) + 8083075.0);
case 22:
return -125885.352202356*pow(xi1, 28) + 879459.403354526*pow(xi1, 26) - 2742999.29717928*pow(xi1, 24) + 5037549.29947257*pow(xi1, 22) - 6049516.46395773*pow(xi1, 20) + 4988280.7302314*pow(xi1, 18) - 2885731.76894814*pow(xi1, 16) + 1175760.47526598*pow(xi1, 14) - 333757.370148003*pow(xi1, 12) + 64269.6642190218*pow(xi1, 10) - 7996.5022303462*pow(xi1, 8) + 588.090698003769*pow(xi1, 6) - 21.1023500561714*pow(xi1, 4) + 0.192715525627136*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2112005745135.0*pow(xi2, 26) - 14754880373310.0*pow(xi2, 24) + 46019891696625.0*pow(xi2, 22) - 84516052707900.0*pow(xi2, 20) + 101494044411375.0*pow(xi2, 18) - 83689463279730.0*pow(xi2, 16) + 48414545205705.0*pow(xi2, 14) - 19725987457800.0*pow(xi2, 12) + 5599519490565.0*pow(xi2, 10) - 1078266038850.0*pow(xi2, 8) + 134159045163.0*pow(xi2, 6) - 9866524668.0*pow(xi2, 4) + 354038685.0*pow(xi2, 2) - 3233230.0);
case 23:
return -237301.123691797*pow(xi1, 29) + 1717205.31722188*pow(xi1, 27) - 5570646.91424131*pow(xi1, 25) + 10693423.2775569*pow(xi1, 23) - 13503154.0309131*pow(xi1, 21) + 11794617.2651803*pow(xi1, 19) - 7294968.68435383*pow(xi1, 17) + 3215695.24364948*pow(xi1, 15) - 1003197.3931253*pow(xi1, 13) + 216942.985686064*pow(xi1, 11) - 31295.3054652214*pow(xi1, 9) + 2815.34257078171*pow(xi1, 7) - 138.678092241287*pow(xi1, 5) + 2.69801735877991*pow(xi1, 3) + 2.38418579101563e-7*pow(xi2, 3)*(995313052305.0*pow(xi2, 26) - 7202481130845.0*pow(xi2, 24) + 23364986634990.0*pow(xi2, 22) - 44851468026750.0*pow(xi2, 20) + 56636332964475.0*pow(xi2, 18) - 49470210373815.0*pow(xi2, 16) + 30597316332660.0*pow(xi2, 14) - 13487603423220.0*pow(xi2, 12) + 4207714838775.0*pow(xi2, 10) - 909924832635.0*pow(xi2, 8) + 131262024894.0*pow(xi2, 6) - 11808402606.0*pow(xi2, 4) + 581658077.0*pow(xi2, 2) - 11316305.0);
case 24:
return -448355.304914653*pow(xi1, 30) + 3356649.28634673*pow(xi1, 28) - 11308794.1731486*pow(xi1, 26) + 22648233.4607616*pow(xi1, 24) - 30001437.7402291*pow(xi1, 22) + 27674998.2284423*pow(xi1, 20) - 18227758.1421468*pow(xi1, 18) + 8646958.25716048*pow(xi1, 16) - 2943054.94313389*pow(xi1, 14) + 707276.096616685*pow(xi1, 12) - 116399.603186524*pow(xi1, 10) + 12447.9005028605*pow(xi1, 8) - 787.236498335997*pow(xi1, 6) + 24.0982005000114*pow(xi1, 4) - 0.183955729007721*pow(xi1, 2) + 3.97364298502604e-9*pow(xi2, 2)*(112832306929485.0*pow(xi2, 28) - 844728451699275.0*pow(xi2, 26) + 2.84595123813683e+15*pow(xi2, 24) - 5.69961457184438e+15*pow(xi2, 22) + 7.55010901917563e+15*pow(xi2, 20) - 6.9646413461729e+15*pow(xi2, 18) + 4.58716553319833e+15*pow(xi2, 16) - 2.17607829635048e+15*pow(xi2, 14) + 740644027212375.0*pow(xi2, 12) - 177991857668625.0*pow(xi2, 10) + 29292919274619.0*pow(xi2, 8) - 3132616732245.0*pow(xi2, 6) + 198114551635.0*pow(xi2, 4) - 6064510725.0*pow(xi2, 2) + 46293975.0);
case 25:
return -848919.581535459*pow(xi1, 31) + 6567880.38637519*pow(xi1, 29) - 22948968.0209559*pow(xi1, 27) + 47867735.5486178*pow(xi1, 25) - 66374849.7944623*pow(xi1, 23) + 64484380.0577223*pow(xi1, 21) - 45067812.6132363*pow(xi1, 19) + 22900583.7163782*pow(xi1, 17) - 8450156.6509527*pow(xi1, 15) + 2236934.93848443*pow(xi1, 13) - 414545.549288392*pow(xi1, 11) + 51583.1626238823*pow(xi1, 9) - 4013.14664876461*pow(xi1, 7) + 170.367532491684*pow(xi1, 5) - 2.82065451145172*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(7121253593025.0*pow(xi2, 28) - 55095373952190.0*pow(xi2, 26) + 192509896732335.0*pow(xi2, 24) - 401543669365020.0*pow(xi2, 22) + 556792595984625.0*pow(xi2, 20) - 540934186427250.0*pow(xi2, 18) + 378056213429895.0*pow(xi2, 16) - 192104019767880.0*pow(xi2, 14) + 70885051683435.0*pow(xi2, 12) - 18764770320450.0*pow(xi2, 10) + 3477460111125.0*pow(xi2, 8) - 432710930652.0*pow(xi2, 6) + 33664714083.0*pow(xi2, 4) - 1429146446.0*pow(xi2, 2) + 23661365.0);
case 26:
return -1610515.40403276*pow(xi1, 32) + 12863036.2875285*pow(xi1, 30) - 46553456.1889886*pow(xi1, 28) + 100973154.142899*pow(xi1, 26) - 146272634.545407*pow(xi1, 24) + 149293201.91956*pow(xi1, 22) - 110366783.018132*pow(xi1, 20) + 59823745.9727661*pow(xi1, 18) - 23800627.8061373*pow(xi1, 16) + 6888187.31875923*pow(xi1, 14) - 1421973.09600106*pow(xi1, 12) + 202464.943845011*pow(xi1, 10) - 18805.9319790099*pow(xi1, 8) + 1032.46532573551*pow(xi1, 6) - 27.2369451262057*pow(xi1, 4) + 0.176290906965733*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.45855549501248e+15*pow(xi2, 30) - 2.7623160091098e+16*pow(xi2, 28) + 9.99727859237375e+16*pow(xi2, 26) - 2.16838197408858e+17*pow(xi2, 24) + 3.1411809083614e+17*pow(xi2, 22) - 3.20604709879818e+17*pow(xi2, 20) + 2.37010861813803e+17*pow(xi2, 18) - 1.28470516238621e+17*pow(xi2, 16) + 5.11114590258139e+16*pow(xi2, 14) - 1.47922696313964e+16*pow(xi2, 12) + 3.0536639715582e+15*pow(xi2, 10) - 434790156200400.0*pow(xi2, 8) + 40385431410324.0*pow(xi2, 6) - 2217202404144.0*pow(xi2, 4) + 58490894280.0*pow(xi2, 2) - 378581840.0);
case 27:
return -3060955.33760409*pow(xi1, 33) + 25213238.0791345*pow(xi1, 31) - 94403567.7795993*pow(xi1, 29) + 212608488.378715*pow(xi1, 27) - 321179615.28731*pow(xi1, 25) + 343612154.357964*pow(xi1, 23) - 267922999.822594*pow(xi1, 21) + 154348350.525506*pow(xi1, 19) - 65889718.4853975*pow(xi1, 17) + 20712941.0533648*pow(xi1, 15) - 4720135.0192485*pow(xi1, 13) + 758719.445440695*pow(xi1, 11) - 82283.9487223575*pow(xi1, 9) + 5587.16253004968*pow(xi1, 7) - 206.260361149907*pow(xi1, 5) + 2.93818178276221*pow(xi1, 3) + 4.96705373128255e-9*pow(xi2, 3)*(616251706384041.0*pow(xi2, 30) - 5.07609529575677e+15*pow(xi2, 28) + 1.90059485737077e+16*pow(xi2, 26) - 4.28037423955582e+16*pow(xi2, 24) + 6.46619973656652e+16*pow(xi2, 22) - 6.91782640066668e+16*pow(xi2, 20) + 5.39400244726994e+16*pow(xi2, 18) - 3.10744273921216e+16*pow(xi2, 16) + 1.32653524705045e+16*pow(xi2, 14) - 4.17006583257083e+15*pow(xi2, 12) + 950288697205155.0*pow(xi2, 10) - 152750400234705.0*pow(xi2, 8) + 16565946972575.0*pow(xi2, 6) - 1124844391125.0*pow(xi2, 4) + 41525695575.0*pow(xi2, 2) - 591534125.0);
case 28:
return -5827588.0465924*pow(xi1, 34) + 49459785.7287714*pow(xi1, 32) - 191371992.258556*pow(xi1, 30) + 446908389.876074*pow(xi1, 28) - 702864733.260658*pow(xi1, 26) + 786571534.918486*pow(xi1, 24) - 645204185.079993*pow(xi1, 22) + 393744121.477465*pow(xi1, 20) - 179587759.860223*pow(xi1, 18) + 60975122.6641322*pow(xi1, 16) - 15220645.8223283*pow(xi1, 14) + 2731517.74901457*pow(xi1, 12) - 339940.64778775*pow(xi1, 10) + 27672.1318222582*pow(xi1, 8) - 1329.91148047149*pow(xi1, 6) + 30.5118877440691*pow(xi1, 4) - 0.169510487467051*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.56433125466718e+15*pow(xi2, 32) - 1.3276760135765e+16*pow(xi2, 30) + 5.1371028007554e+16*pow(xi2, 28) - 1.1996605742661e+17*pow(xi2, 26) + 1.88673815179143e+17*pow(xi2, 24) - 2.11143688652464e+17*pow(xi2, 22) + 1.73195679635056e+17*pow(xi2, 20) - 1.05694882796123e+17*pow(xi2, 18) + 4.82077222100974e+16*pow(xi2, 16) - 1.63678848570023e+16*pow(xi2, 14) + 4.08576100193118e+15*pow(xi2, 12) - 733236212528820.0*pow(xi2, 10) + 91252122801840.0*pow(xi2, 8) - 7428181324200.0*pow(xi2, 6) + 356995394700.0*pow(xi2, 4) - 8190472500.0*pow(xi2, 2) + 45502625.0);
case 29:
return -11112501.2274704*pow(xi1, 35) + 97093261.8133116*pow(xi1, 33) - 387817607.62591*pow(xi1, 31) + 937921252.467321*pow(xi1, 29) - 1533331634.12215*pow(xi1, 27) + 1791534433.11565*pow(xi1, 25) - 1542331961.52872*pow(xi1, 23) + 994100047.035712*pow(xi1, 21) - 482601965.041428*pow(xi1, 19) + 176100565.554967*pow(xi1, 17) - 47831521.5085922*pow(xi1, 15) + 9494731.97971299*pow(xi1, 13) - 1337246.817251*pow(xi1, 11) + 127520.279397815*pow(xi1, 9) - 7617.85942465067*pow(xi1, 7) + 246.536052972078*pow(xi1, 5) - 3.05118877440691*pow(xi1, 3) + 1.49011611938477e-9*pow(xi2, 3)*(7.45747333574143e+15*pow(xi2, 32) - 6.51581850234592e+16*pow(xi2, 30) + 2.60259990869726e+17*pow(xi2, 28) - 6.29428297745391e+17*pow(xi2, 26) + 1.02900144101201e+18*pow(xi2, 24) - 1.20227840623275e+18*pow(xi2, 22) + 1.03504145849084e+18*pow(xi2, 20) - 6.67129248589132e+17*pow(xi2, 18) + 3.2386869638098e+17*pow(xi2, 16) - 1.18179089041513e+17*pow(xi2, 14) + 3.20991907183319e+16*pow(xi2, 12) - 6.3718067714301e+15*pow(xi2, 10) + 897411147933300.0*pow(xi2, 8) - 85577410873500.0*pow(xi2, 6) + 5112258921000.0*pow(xi2, 4) - 165447544500.0*pow(xi2, 2) + 2047618125.0);
default:
return 0.;
}
case 10:
switch(j) {
case 0:
return 0.001953125*y1t*(-3861.0*pow(xi1, 10) + 9009.0*pow(xi1, 8) - 6930.0*pow(xi1, 6) + 1890.0*pow(xi1, 4) - 105.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-1287.0*pow(xi2, 8) + 3003.0*pow(xi2, 6) - 2310.0*pow(xi2, 4) + 630.0*pow(xi2, 2) - 35.0));
case 1:
return 0.0009765625*y1r*(-3861.0*pow(xi1, 10) + 1430.0*pow(xi1, 9) + 9009.0*pow(xi1, 8) - 3432.0*pow(xi1, 7) - 6930.0*pow(xi1, 6) + 2772.0*pow(xi1, 5) + 1890.0*pow(xi1, 4) - 840.0*pow(xi1, 3) - 105.0*pow(xi1, 2) + 70.0*xi1 + xi2*(3861.0*pow(xi2, 9) - 1430.0*pow(xi2, 8) - 9009.0*pow(xi2, 7) + 3432.0*pow(xi2, 6) + 6930.0*pow(xi2, 5) - 2772.0*pow(xi2, 4) - 1890.0*pow(xi2, 3) + 840.0*pow(xi2, 2) + 105.0*xi2 - 70.0));
case 2:
return 0.001953125*y2t*(3861.0*pow(xi1, 10) - 9009.0*pow(xi1, 8) + 6930.0*pow(xi1, 6) - 1890.0*pow(xi1, 4) + 105.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-1287.0*pow(xi2, 8) + 3003.0*pow(xi2, 6) - 2310.0*pow(xi2, 4) + 630.0*pow(xi2, 2) - 35.0));
case 3:
return 0.0009765625*y2r*(-3861.0*pow(xi1, 10) - 1430.0*pow(xi1, 9) + 9009.0*pow(xi1, 8) + 3432.0*pow(xi1, 7) - 6930.0*pow(xi1, 6) - 2772.0*pow(xi1, 5) + 1890.0*pow(xi1, 4) + 840.0*pow(xi1, 3) - 105.0*pow(xi1, 2) - 70.0*xi1 + xi2*(3861.0*pow(xi2, 9) + 1430.0*pow(xi2, 8) - 9009.0*pow(xi2, 7) - 3432.0*pow(xi2, 6) + 6930.0*pow(xi2, 5) + 2772.0*pow(xi2, 4) - 1890.0*pow(xi2, 3) - 840.0*pow(xi2, 2) + 105.0*xi2 + 70.0));
case 4:
return -6.85546875*pow(xi1, 11) + 18.43359375*pow(xi1, 9) - 18.3046875*pow(xi1, 7) + 8.3671875*pow(xi1, 5) - 1.77734375*pow(xi1, 3) + 0.13671875*xi1 + 6.85546875*pow(xi2, 11) - 18.43359375*pow(xi2, 9) + 18.3046875*pow(xi2, 7) - 8.3671875*pow(xi2, 5) + 1.77734375*pow(xi2, 3) - 0.13671875*xi2;
case 5:
return -10.4736328125*pow(xi1, 12) + 31.001953125*pow(xi1, 10) - 34.5146484375*pow(xi1, 8) + 17.63671875*pow(xi1, 6) - 3.8623046875*pow(xi1, 4) + 0.205078125*pow(xi1, 2) + 0.0009765625*pow(xi2, 2)*(10725.0*pow(xi2, 10) - 31746.0*pow(xi2, 8) + 35343.0*pow(xi2, 6) - 18060.0*pow(xi2, 4) + 3955.0*pow(xi2, 2) - 210.0);
case 6:
return -16.9189453125*pow(xi1, 13) + 54.462890625*pow(xi1, 11) - 67.5146484375*pow(xi1, 9) + 40.18359375*pow(xi1, 7) - 11.6826171875*pow(xi1, 5) + 1.572265625*pow(xi1, 3) - 0.1025390625*xi1 + 16.9189453125*pow(xi2, 13) - 54.462890625*pow(xi2, 11) + 67.5146484375*pow(xi2, 9) - 40.18359375*pow(xi2, 7) + 11.6826171875*pow(xi2, 5) - 1.572265625*pow(xi2, 3) + 0.1025390625*xi2;
case 7:
return -28.27880859375*pow(xi1, 14) + 98.24267578125*pow(xi1, 12) - 134.17529296875*pow(xi1, 10) + 90.90087890625*pow(xi1, 8) - 31.63330078125*pow(xi1, 6) + 5.21240234375*pow(xi1, 4) - 0.25634765625*pow(xi1, 2) + 0.00048828125*pow(xi2, 2)*(57915.0*pow(xi2, 12) - 201201.0*pow(xi2, 10) + 274791.0*pow(xi2, 8) - 186165.0*pow(xi2, 6) + 64785.0*pow(xi2, 4) - 10675.0*pow(xi2, 2) + 525.0);
case 8:
return -48.38818359375*pow(xi1, 15) + 180.35595703125*pow(xi1, 13) - 269.01123046875*pow(xi1, 11) + 204.39697265625*pow(xi1, 9) - 83.19580078125*pow(xi1, 7) + 17.38037109375*pow(xi1, 5) - 1.62353515625*pow(xi1, 3) + 0.08544921875*xi1 + 48.38818359375*pow(xi2, 15) - 180.35595703125*pow(xi2, 13) + 269.01123046875*pow(xi2, 11) - 204.39697265625*pow(xi2, 9) + 83.19580078125*pow(xi2, 7) - 17.38037109375*pow(xi2, 5) + 1.62353515625*pow(xi2, 3) - 0.08544921875*xi2;
case 9:
return -84.2472839355469*pow(xi1, 16) + 335.260986328125*pow(xi1, 14) - 542.167602539063*pow(xi1, 12) + 456.642333984375*pow(xi1, 10) - 213.108215332031*pow(xi1, 8) + 54.012451171875*pow(xi1, 6) - 6.7291259765625*pow(xi1, 4) + 0.299072265625*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(2760615.0*pow(xi2, 14) - 10985832.0*pow(xi2, 12) + 17765748.0*pow(xi2, 10) - 14963256.0*pow(xi2, 8) + 6983130.0*pow(xi2, 6) - 1769880.0*pow(xi2, 4) + 220500.0*pow(xi2, 2) - 9800.0);
case 10:
return -148.671677533318*pow(xi1, 17) + 629.04638671875*pow(xi1, 15) - 1096.17846679688*pow(xi1, 13) + 1013.75244140625*pow(xi1, 11) - 534.027709960938*pow(xi1, 9) + 159.60205078125*pow(xi1, 7) - 25.301513671875*pow(xi1, 5) + 1.79443359375*pow(xi1, 3) - 0.07476806640625*xi1 + 148.671677533318*pow(xi2, 17) - 629.04638671875*pow(xi2, 15) + 1096.17846679688*pow(xi2, 13) - 1013.75244140625*pow(xi2, 11) + 534.027709960938*pow(xi2, 9) - 159.60205078125*pow(xi2, 7) + 25.301513671875*pow(xi2, 5) - 1.79443359375*pow(xi2, 3) + 0.07476806640625*xi2;
case 11:
return -265.222930908203*pow(xi1, 18) + 1188.82278442383*pow(xi1, 16) - 2220.67199707031*pow(xi1, 14) + 2237.22033691406*pow(xi1, 12) - 1313.75140380859*pow(xi1, 10) + 453.216247558594*pow(xi1, 8) - 87.8375244140625*pow(xi1, 6) + 8.5235595703125*pow(xi1, 4) - 0.336456298828125*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(8690825.0*pow(xi2, 16) - 38955345.0*pow(xi2, 14) + 72766980.0*pow(xi2, 12) - 73309236.0*pow(xi2, 10) + 43049006.0*pow(xi2, 8) - 14850990.0*pow(xi2, 6) + 2878260.0*pow(xi2, 4) - 279300.0*pow(xi2, 2) + 11025.0);
case 12:
return -477.401275634766*pow(xi1, 19) + 2259.69937133789*pow(xi1, 17) - 4504.13342285156*pow(xi1, 15) + 4910.30090332031*pow(xi1, 13) - 3181.58416748047*pow(xi1, 11) + 1246.05682373047*pow(xi1, 9) - 286.691528320313*pow(xi1, 7) + 35.7271728515625*pow(xi1, 5) - 2.04116821289063*pow(xi1, 3) + 0.067291259765625*xi1 + 477.401275634766*pow(xi2, 19) - 2259.69937133789*pow(xi2, 17) + 4504.13342285156*pow(xi2, 15) - 4910.30090332031*pow(xi2, 13) + 3181.58416748047*pow(xi2, 11) - 1246.05682373047*pow(xi2, 9) + 286.691528320313*pow(xi2, 7) - 35.7271728515625*pow(xi2, 5) + 2.04116821289063*pow(xi2, 3) - 0.067291259765625*xi2;
case 13:
return -865.832313537598*pow(xi1, 20) + 4315.41819763184*pow(xi1, 18) - 9142.12314605713*pow(xi1, 16) + 10723.4170532227*pow(xi1, 14) - 7601.6089630127*pow(xi1, 12) + 3335.27163696289*pow(xi1, 10) - 890.919937133789*pow(xi1, 8) + 136.690979003906*pow(xi1, 6) - 10.671272277832*pow(xi1, 4) + 0.370101928710938*pow(xi1, 2) + 7.62939453125e-6*pow(xi2, 2)*(113486373.0*pow(xi2, 18) - 565630494.0*pow(xi2, 16) + 1198276365.0*pow(xi2, 14) - 1405539720.0*pow(xi2, 12) + 996358090.0*pow(xi2, 10) - 437160724.0*pow(xi2, 8) + 116774658.0*pow(xi2, 6) - 17916360.0*pow(xi2, 4) + 1398705.0*pow(xi2, 2) - 48510.0);
case 14:
return -1580.48755645752*pow(xi1, 21) + 8273.50877380371*pow(xi1, 19) - 18563.0642166138*pow(xi1, 17) + 23311.7905883789*pow(xi1, 15) - 17950.1096343994*pow(xi1, 13) + 8727.91030883789*pow(xi1, 11) - 2660.08235168457*pow(xi1, 9) + 487.364318847656*pow(xi1, 7) - 49.1125259399414*pow(xi1, 5) + 2.34397888183594*pow(xi1, 3) - 0.0616836547851563*xi1 + 1580.48755645752*pow(xi2, 21) - 8273.50877380371*pow(xi2, 19) + 18563.0642166138*pow(xi2, 17) - 23311.7905883789*pow(xi2, 15) + 17950.1096343994*pow(xi2, 13) - 8727.91030883789*pow(xi2, 11) + 2660.08235168457*pow(xi2, 9) - 487.364318847656*pow(xi2, 7) + 49.1125259399414*pow(xi2, 5) - 2.34397888183594*pow(xi2, 3) + 0.0616836547851563*xi2;
case 15:
return -2901.24464035034*pow(xi1, 22) + 15914.2939338684*pow(xi1, 20) - 37698.4300117493*pow(xi1, 18) + 50467.3515129089*pow(xi1, 16) - 41952.306022644*pow(xi1, 14) + 22402.6091384888*pow(xi1, 12) - 7682.70096588135*pow(xi1, 10) + 1642.471824646*pow(xi1, 8) - 204.882259368896*pow(xi1, 6) + 13.231143951416*pow(xi1, 4) - 0.400943756103516*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(760543875.0*pow(xi2, 20) - 4171836669.0*pow(xi2, 18) + 9882417237.0*pow(xi2, 16) - 13229713395.0*pow(xi2, 14) + 10997545310.0*pow(xi2, 12) - 5872709570.0*pow(xi2, 10) + 2013973962.0*pow(xi2, 8) - 430564134.0*pow(xi2, 6) + 53708655.0*pow(xi2, 4) - 3468465.0*pow(xi2, 2) + 105105.0);
case 16:
return -5351.98545455933*pow(xi1, 23) + 30697.9313850403*pow(xi1, 21) - 76560.1265144348*pow(xi1, 19) + 108841.735485077*pow(xi1, 17) - 97160.8135299683*pow(xi1, 15) + 56549.5268630981*pow(xi1, 13) - 21574.1586685181*pow(xi1, 11) + 5285.74245452881*pow(xi1, 9) - 791.235500335693*pow(xi1, 7) + 66.018253326416*pow(xi1, 5) - 2.69205093383789*pow(xi1, 3) + 0.0572776794433594*xi1 + 5351.98545455933*pow(xi2, 23) - 30697.9313850403*pow(xi2, 21) + 76560.1265144348*pow(xi2, 19) - 108841.735485077*pow(xi2, 17) + 97160.8135299683*pow(xi2, 15) - 56549.5268630981*pow(xi2, 13) + 21574.1586685181*pow(xi2, 11) - 5285.74245452881*pow(xi2, 9) + 791.235500335693*pow(xi2, 7) - 66.018253326416*pow(xi2, 5) + 2.69205093383789*pow(xi2, 3) - 0.0572776794433594*xi2;
case 17:
return -9916.03971719742*pow(xi1, 24) + 59359.465341568*pow(xi1, 22) - 155468.773369789*pow(xi1, 20) + 233922.147989273*pow(xi1, 18) - 223206.835935116*pow(xi1, 16) + 140675.350513458*pow(xi1, 14) - 59143.3052806854*pow(xi1, 12) + 16367.7127723694*pow(xi1, 10) - 2871.48042440414*pow(xi1, 8) + 297.586183547974*pow(xi1, 6) - 16.2525415420532*pow(xi1, 4) + 0.429582595825195*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(20795442525.0*pow(xi2, 22) - 124485821460.0*pow(xi2, 20) + 326041649010.0*pow(xi2, 18) - 490570300500.0*pow(xi2, 16) + 468098662395.0*pow(xi2, 14) - 295017592680.0*pow(xi2, 12) + 124032500956.0*pow(xi2, 10) - 34325581576.0*pow(xi2, 8) + 6021930915.0*pow(xi2, 6) - 624083460.0*pow(xi2, 4) + 34084050.0*pow(xi2, 2) - 900900.0);
case 18:
return -18443.8338739872*pow(xi1, 25) + 115026.06071949*pow(xi1, 23) - 315656.213915348*pow(xi1, 21) + 501145.377087593*pow(xi1, 19) - 509063.357251883*pow(xi1, 17) + 345476.188196182*pow(xi1, 15) - 158790.70818615*pow(xi1, 13) + 49055.2678394318*pow(xi1, 11) - 9900.71094870567*pow(xi1, 9) + 1235.98890781403*pow(xi1, 7) - 87.0835518836975*pow(xi1, 5) + 3.07867527008057*pow(xi1, 3) - 0.0536978244781494*xi1 + 18443.8338739872*pow(xi2, 25) - 115026.06071949*pow(xi2, 23) + 315656.213915348*pow(xi2, 21) - 501145.377087593*pow(xi2, 19) + 509063.357251883*pow(xi2, 17) - 345476.188196182*pow(xi2, 15) + 158790.70818615*pow(xi2, 13) - 49055.2678394318*pow(xi2, 11) + 9900.71094870567*pow(xi2, 9) - 1235.98890781403*pow(xi2, 7) + 87.0835518836975*pow(xi2, 5) - 3.07867527008057*pow(xi2, 3) + 0.0536978244781494*xi2;
case 19:
return -34425.7080227137*pow(xi1, 26) + 223315.047395825*pow(xi1, 24) - 640760.128458738*pow(xi1, 22) + 1070494.58503604*pow(xi1, 20) - 1153444.84326541*pow(xi1, 18) + 838792.879251838*pow(xi1, 16) - 418623.917339802*pow(xi1, 14) + 142953.808037281*pow(xi1, 12) - 32702.0305608511*pow(xi1, 10) + 4801.93332374096*pow(xi1, 8) - 420.951565504074*pow(xi1, 6) + 19.778698682785*pow(xi1, 4) - 0.45643150806427*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(288783769725.0*pow(xi2, 24) - 1873302393105.0*pow(xi2, 22) + 5375085539670.0*pow(xi2, 20) - 8979959439990.0*pow(xi2, 18) + 9675796639775.0*pow(xi2, 16) - 7036304657235.0*pow(xi2, 14) + 3511671941988.0*pow(xi2, 12) - 1199183457732.0*pow(xi2, 10) + 274324515179.0*pow(xi2, 8) - 40281536295.0*pow(xi2, 6) + 3531197670.0*pow(xi2, 4) - 165915750.0*pow(xi2, 2) + 3828825.0);
case 20:
return -64459.6590548754*pow(xi1, 27) + 434273.931575418*pow(xi1, 25) - 1300387.65375495*pow(xi1, 23) + 2280517.13728309*pow(xi1, 21) - 2598070.78379095*pow(xi1, 19) + 2015827.85172164*pow(xi1, 17) - 1086007.95365381*pow(xi1, 15) + 406552.760191441*pow(xi1, 13) - 104136.594859958*pow(xi1, 11) + 17650.3092950583*pow(xi1, 9) - 1868.9087998867*pow(xi1, 7) + 113.012441396713*pow(xi1, 5) - 3.49930822849274*pow(xi1, 3) + 0.0507146120071411*xi1 + 64459.6590548754*pow(xi2, 27) - 434273.931575418*pow(xi2, 25) + 1300387.65375495*pow(xi2, 23) - 2280517.13728309*pow(xi2, 21) + 2598070.78379095*pow(xi2, 19) - 2015827.85172164*pow(xi2, 17) + 1086007.95365381*pow(xi2, 15) - 406552.760191441*pow(xi2, 13) + 104136.594859958*pow(xi2, 11) - 17650.3092950583*pow(xi2, 9) + 1868.9087998867*pow(xi2, 7) - 113.012441396713*pow(xi2, 5) + 3.49930822849274*pow(xi2, 3) - 0.0507146120071411*xi2;
case 21:
return -121043.607886881*pow(xi1, 28) + 845778.579072654*pow(xi1, 26) - 2638381.56539574*pow(xi1, 24) + 4846179.01085794*pow(xi1, 22) - 5820583.71478423*pow(xi1, 20) + 4800210.0817278*pow(xi1, 18) - 2777324.87994209*pow(xi1, 16) + 1131748.51436734*pow(xi1, 14) - 321322.880017787*pow(xi1, 12) + 61915.3605063558*pow(xi1, 10) - 7733.72222229838*pow(xi1, 8) + 582.193602919579*pow(xi1, 6) - 23.8485462963581*pow(xi1, 4) + 0.481788814067841*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(4061549509875.0*pow(xi2, 26) - 28379619818550.0*pow(xi2, 24) + 88529394826125.0*pow(xi2, 22) - 162610784079660.0*pow(xi2, 20) + 195306380458035.0*pow(xi2, 18) - 161068322773050.0*pow(xi2, 16) + 93191558825925.0*pow(xi2, 14) - 37975178566440.0*pow(xi2, 12) + 10781806727601.0*pow(xi2, 10) - 2077534753866.0*pow(xi2, 8) + 259500656415.0*pow(xi2, 6) - 19535175660.0*pow(xi2, 4) + 800224425.0*pow(xi2, 2) - 16166150.0);
case 22:
return -227895.896228403*pow(xi1, 29) + 1649420.89680523*pow(xi1, 27) - 5351610.52541748*pow(xi1, 25) + 10274545.6434935*pow(xi1, 23) - 12976146.7507325*pow(xi1, 21) + 11335923.7640038*pow(xi1, 19) - 7012244.4740881*pow(xi1, 17) + 3091489.85211968*pow(xi1, 15) - 964606.306213886*pow(xi1, 13) + 208688.813287318*pow(xi1, 11) - 30172.9123489559*pow(xi1, 9) + 2748.55838191509*pow(xi1, 7) - 144.565551549196*pow(xi1, 5) + 3.95066827535629*pow(xi1, 3) - 0.0481788814067841*xi1 + 227895.896228403*pow(xi2, 29) - 1649420.89680523*pow(xi2, 27) + 5351610.52541748*pow(xi2, 25) - 10274545.6434935*pow(xi2, 23) + 12976146.7507325*pow(xi2, 21) - 11335923.7640038*pow(xi2, 19) + 7012244.4740881*pow(xi2, 17) - 3091489.85211968*pow(xi2, 15) + 964606.306213886*pow(xi2, 13) - 208688.813287318*pow(xi2, 11) + 30172.9123489559*pow(xi2, 9) - 2748.55838191509*pow(xi2, 7) + 144.565551549196*pow(xi2, 5) - 3.95066827535629*pow(xi2, 3) + 0.0481788814067841*xi2;
case 23:
return -430108.286691383*pow(xi1, 30) + 3220566.92717694*pow(xi1, 28) - 10852024.9993969*pow(xi1, 26) + 21736745.4230245*pow(xi1, 24) - 28798227.5263164*pow(xi1, 22) + 26568852.6144587*pow(xi1, 20) - 17501613.8303212*pow(xi1, 18) + 8303601.8471282*pow(xi1, 16) - 2826614.7797104*pow(xi1, 14) + 679508.515860513*pow(xi1, 12) - 111985.127419218*pow(xi1, 10) + 12060.9036379606*pow(xi1, 8) - 789.675955697894*pow(xi1, 6) + 28.4978083521128*pow(xi1, 4) - 0.505878254771233*pow(xi1, 2) + 1.49011611938477e-8*pow(xi2, 2)*(28864078516845.0*pow(xi2, 28) - 216128587918815.0*pow(xi2, 26) + 728267069809125.0*pow(xi2, 24) - 1.45872829239638e+15*pow(xi2, 22) + 1.93261633450463e+15*pow(xi2, 20) - 1.78300551673976e+15*pow(xi2, 18) + 1.17451342231955e+15*pow(xi2, 16) - 557245287069075.0*pow(xi2, 14) + 189690906831975.0*pow(xi2, 12) - 45601044577725.0*pow(xi2, 10) + 7515194685999.0*pow(xi2, 8) - 809393541957.0*pow(xi2, 6) + 52994256315.0*pow(xi2, 4) - 1912455545.0*pow(xi2, 2) + 33948915.0);
case 24:
return -813547.932304814*pow(xi1, 31) + 6295221.28702842*pow(xi1, 29) - 21999639.0535594*pow(xi1, 27) + 45894394.1861918*pow(xi1, 25) - 63647685.3472386*pow(xi1, 23) + 61843493.4318345*pow(xi1, 21) - 43227949.0107802*pow(xi1, 19) + 21968581.144582*pow(xi1, 17) - 8107398.1842526*pow(xi1, 15) + 2146726.9782532*pow(xi1, 13) - 398184.796114191*pow(xi1, 11) + 49755.7135626823*pow(xi1, 9) - 3946.58752410114*pow(xi1, 7) + 182.554599538445*pow(xi1, 5) - 4.43026714026928*pow(xi1, 3) + 0.0459889322519302*xi1 + 813547.932304814*pow(xi2, 31) - 6295221.28702842*pow(xi2, 29) + 21999639.0535594*pow(xi2, 27) - 45894394.1861918*pow(xi2, 25) + 63647685.3472386*pow(xi2, 23) - 61843493.4318345*pow(xi2, 21) + 43227949.0107802*pow(xi2, 19) - 21968581.144582*pow(xi2, 17) + 8107398.1842526*pow(xi2, 15) - 2146726.9782532*pow(xi2, 13) + 398184.796114191*pow(xi2, 11) - 49755.7135626823*pow(xi2, 9) + 3946.58752410114*pow(xi2, 7) - 182.554599538445*pow(xi2, 5) + 4.43026714026928*pow(xi2, 3) - 0.0459889322519302*xi2;
case 25:
return -1541982.83364839*pow(xi1, 32) + 12317587.3170846*pow(xi1, 30) - 44586072.4801485*pow(xi1, 28) + 96719986.2192655*pow(xi1, 26) - 140131079.561139*pow(xi1, 24) + 143044354.576721*pow(xi1, 22) - 105761285.988215*pow(xi1, 20) + 57334791.4309478*pow(xi1, 18) - 22813482.6754338*pow(xi1, 16) + 6603828.05723269*pow(xi1, 14) - 1364100.44298442*pow(xi1, 12) + 194729.530543976*pow(xi1, 10) - 18292.9027737658*pow(xi1, 8) + 1052.98558730632*pow(xi1, 6) - 33.7597086839378*pow(xi1, 4) + 0.528872720897198*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.31138292075663e+15*pow(xi2, 30) - 2.64518173462514e+16*pow(xi2, 28) + 9.57478615796617e+16*pow(xi2, 26) - 2.07704588840658e+17*pow(xi2, 24) + 3.00929201934133e+17*pow(xi2, 22) - 3.07185412392222e+17*pow(xi2, 20) + 2.27120632251143e+17*pow(xi2, 18) - 1.23125527059451e+17*pow(xi2, 16) + 4.89915809994253e+16*pow(xi2, 14) - 1.41816127671108e+16*pow(xi2, 12) + 2.9293833955386e+15*pow(xi2, 10) - 418178482625904.0*pow(xi2, 8) + 39283709581116.0*pow(xi2, 6) - 2261269330320.0*pow(xi2, 4) + 72498422360.0*pow(xi2, 2) - 1135745520.0);
case 26:
return -2928209.82551412*pow(xi1, 33) + 24123464.7752993*pow(xi1, 31) - 90336471.2389704*pow(xi1, 29) + 203477776.253399*pow(xi1, 27) - 307428557.336709*pow(xi1, 25) + 328944724.965613*pow(xi1, 23) - 256519873.326385*pow(xi1, 21) + 147797910.676081*pow(xi1, 19) - 63101603.4300435*pow(xi1, 17) + 19839920.0978507*pow(xi1, 15) - 4523153.89852859*pow(xi1, 13) + 728271.336259693*pow(xi1, 11) - 79525.7599556074*pow(xi1, 9) + 5549.65789881349*pow(xi1, 7) - 227.838368162513*pow(xi1, 5) + 4.93614539504051*pow(xi1, 3) - 0.0440727267414331*xi1 + 2928209.82551412*pow(xi2, 33) - 24123464.7752993*pow(xi2, 31) + 90336471.2389704*pow(xi2, 29) - 203477776.253399*pow(xi2, 27) + 307428557.336709*pow(xi2, 25) - 328944724.965613*pow(xi2, 23) + 256519873.326385*pow(xi2, 21) - 147797910.676081*pow(xi2, 19) + 63101603.4300435*pow(xi2, 17) - 19839920.0978507*pow(xi2, 15) + 4523153.89852859*pow(xi2, 13) - 728271.336259693*pow(xi2, 11) + 79525.7599556074*pow(xi2, 9) - 5549.65789881349*pow(xi2, 7) + 227.838368162513*pow(xi2, 5) - 4.93614539504051*pow(xi2, 3) + 0.0440727267414331*xi2;
case 27:
return -5570488.57394862*pow(xi1, 34) + 47284732.262402*pow(xi1, 32) - 182982384.66517*pow(xi1, 30) + 427375626.699867*pow(xi1, 28) - 672235775.597369*pow(xi1, 26) + 752393678.105771*pow(xi1, 24) - 617247943.398835*pow(xi1, 22) + 376730544.227549*pow(xi1, 20) - 171849479.01199*pow(xi1, 18) + 58356796.5482171*pow(xi1, 16) - 14571815.0302654*pow(xi1, 14) + 2617997.25941163*pow(xi1, 12) - 327223.789883908*pow(xi1, 10) + 27078.8499592803*pow(xi1, 8) - 1383.00216514617*pow(xi1, 6) + 39.6654540672898*pow(xi1, 4) - 0.550909084267914*pow(xi1, 2) + 5.4783680859734e-11*pow(xi2, 2)*(1.01681531553367e+17*pow(xi2, 32) - 8.63117109335313e+17*pow(xi2, 30) + 3.34008927099425e+18*pow(xi2, 28) - 7.8011484440796e+18*pow(xi2, 26) + 1.22707303534156e+19*pow(xi2, 24) - 1.37339015250211e+19*pow(xi2, 22) + 1.12670038542903e+19*pow(xi2, 20) - 6.87669280916182e+18*pow(xi2, 18) + 3.13687354181233e+18*pow(xi2, 16) - 1.06522226386415e+18*pow(xi2, 14) + 2.65988243242993e+17*pow(xi2, 12) - 4.77879035933099e+16*pow(xi2, 10) + 5.97301577310438e+15*pow(xi2, 8) - 494286793700700.0*pow(xi2, 6) + 25244783545800.0*pow(xi2, 4) - 724037769000.0*pow(xi2, 2) + 10056080125.0);
case 28:
return -10614535.370579*pow(xi1, 35) + 92755776.4082624*pow(xi1, 33) - 370544334.663235*pow(xi1, 31) + 896268350.896106*pow(xi1, 29) - 1465430395.17544*pow(xi1, 27) + 1712419554.36447*pow(xi1, 25) - 1474407039.04468*pow(xi1, 23) + 950436059.72244*pow(xi1, 21) - 461461192.923372*pow(xi1, 19) + 168410243.079443*pow(xi1, 17) - 45754476.8418039*pow(xi1, 15) + 9089465.50231274*pow(xi1, 13) - 1283771.85423849*pow(xi1, 11) + 123681.481937598*pow(xi1, 9) - 7661.47689465433*pow(xi1, 7) + 281.319605000317*pow(xi1, 5) - 5.46671322081238*pow(xi1, 3) + 0.0423776218667626*xi1 + 10614535.370579*pow(xi2, 35) - 92755776.4082624*pow(xi2, 33) + 370544334.663235*pow(xi2, 31) - 896268350.896106*pow(xi2, 29) + 1465430395.17544*pow(xi2, 27) - 1712419554.36447*pow(xi2, 25) + 1474407039.04468*pow(xi2, 23) - 950436059.72244*pow(xi2, 21) + 461461192.923372*pow(xi2, 19) - 168410243.079443*pow(xi2, 17) + 45754476.8418039*pow(xi2, 15) - 9089465.50231274*pow(xi2, 13) + 1283771.85423849*pow(xi2, 11) - 123681.481937598*pow(xi2, 9) + 7661.47689465433*pow(xi2, 7) - 281.319605000317*pow(xi2, 5) + 5.46671322081238*pow(xi2, 3) - 0.0423776218667626*xi2;
case 29:
return -20257163.6959095*pow(xi1, 36) + 182085146.881723*pow(xi1, 34) - 750168100.803257*pow(xi1, 32) + 1876902117.73599*pow(xi1, 30) - 3185397290.65285*pow(xi1, 28) + 3879469079.53952*pow(xi1, 26) - 3498141721.81091*pow(xi1, 24) + 2375254474.90776*pow(xi1, 22) - 1223317230.13363*pow(xi1, 20) + 477702027.144423*pow(xi1, 18) - 140396380.678918*pow(xi1, 16) + 30599953.4447357*pow(xi1, 14) - 4831031.28381934*pow(xi1, 12) + 533608.341681669*pow(xi1, 10) - 39235.2255529957*pow(xi1, 8) + 1791.96316720918*pow(xi1, 6) - 46.2445798621047*pow(xi1, 4) + 0.572097895201296*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(8.700385558365e+16*pow(xi2, 34) - 7.82049750944356e+17*pow(xi2, 32) + 3.22194745945242e+18*pow(xi2, 30) - 8.0612332134692e+18*pow(xi2, 28) + 1.3681177188121e+19*pow(xi2, 26) - 1.66621928224655e+19*pow(xi2, 24) + 1.5024404291951e+19*pow(xi2, 22) - 1.02016402894065e+19*pow(xi2, 20) + 5.25410749605725e+18*pow(xi2, 18) - 2.0517145838182e+18*pow(xi2, 16) + 6.02997863492717e+17*pow(xi2, 14) - 1.31425799304262e+17*pow(xi2, 12) + 2.0749121369957e+16*pow(xi2, 10) - 2.29183037639556e+15*pow(xi2, 8) + 168514010601300.0*pow(xi2, 6) - 7696423198800.0*pow(xi2, 4) + 198618958125.0*pow(xi2, 2) - 2457141750.0);
default:
return 0.;
}
case 11:
switch(j) {
case 0:
return 0.00390625*y1t*(-3315.0*pow(xi1, 11) + 8580.0*pow(xi1, 9) - 7722.0*pow(xi1, 7) + 2772.0*pow(xi1, 5) - 315.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-1105.0*pow(xi2, 8) + 2860.0*pow(xi2, 6) - 2574.0*pow(xi2, 4) + 924.0*pow(xi2, 2) - 105.0));
case 1:
return 0.0009765625*y1r*(-6630.0*pow(xi1, 11) + 2431.0*pow(xi1, 10) + 17160.0*pow(xi1, 9) - 6435.0*pow(xi1, 8) - 15444.0*pow(xi1, 7) + 6006.0*pow(xi1, 6) + 5544.0*pow(xi1, 5) - 2310.0*pow(xi1, 4) - 630.0*pow(xi1, 3) + 315.0*pow(xi1, 2) + pow(xi2, 2)*(6630.0*pow(xi2, 9) - 2431.0*pow(xi2, 8) - 17160.0*pow(xi2, 7) + 6435.0*pow(xi2, 6) + 15444.0*pow(xi2, 5) - 6006.0*pow(xi2, 4) - 5544.0*pow(xi2, 3) + 2310.0*pow(xi2, 2) + 630.0*xi2 - 315.0));
case 2:
return 0.00390625*y2t*(3315.0*pow(xi1, 11) - 8580.0*pow(xi1, 9) + 7722.0*pow(xi1, 7) - 2772.0*pow(xi1, 5) + 315.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-1105.0*pow(xi2, 8) + 2860.0*pow(xi2, 6) - 2574.0*pow(xi2, 4) + 924.0*pow(xi2, 2) - 105.0));
case 3:
return 0.0009765625*y2r*(-6630.0*pow(xi1, 11) - 2431.0*pow(xi1, 10) + 17160.0*pow(xi1, 9) + 6435.0*pow(xi1, 8) - 15444.0*pow(xi1, 7) - 6006.0*pow(xi1, 6) + 5544.0*pow(xi1, 5) + 2310.0*pow(xi1, 4) - 630.0*pow(xi1, 3) - 315.0*pow(xi1, 2) + pow(xi2, 2)*(6630.0*pow(xi2, 9) + 2431.0*pow(xi2, 8) - 17160.0*pow(xi2, 7) - 6435.0*pow(xi2, 6) + 15444.0*pow(xi2, 5) + 6006.0*pow(xi2, 4) - 5544.0*pow(xi2, 3) - 2310.0*pow(xi2, 2) + 630.0*xi2 + 315.0));
case 4:
return -11.8701171875*pow(xi1, 12) + 34.912109375*pow(xi1, 10) - 38.9619140625*pow(xi1, 8) + 20.75390625*pow(xi1, 6) - 5.4345703125*pow(xi1, 4) + 0.615234375*pow(xi1, 2) + 0.0009765625*pow(xi2, 2)*(12155.0*pow(xi2, 10) - 35750.0*pow(xi2, 8) + 39897.0*pow(xi2, 6) - 21252.0*pow(xi2, 4) + 5565.0*pow(xi2, 2) - 630.0);
case 5:
return -18.26171875*pow(xi1, 13) + 58.65234375*pow(xi1, 11) - 72.6171875*pow(xi1, 9) + 43.0546875*pow(xi1, 7) - 12.05859375*pow(xi1, 5) + 1.23046875*pow(xi1, 3) + 0.00390625*pow(xi2, 3)*(4675.0*pow(xi2, 10) - 15015.0*pow(xi2, 8) + 18590.0*pow(xi2, 6) - 11022.0*pow(xi2, 4) + 3087.0*pow(xi2, 2) - 315.0);
case 6:
return -29.67529296875*pow(xi1, 14) + 102.99072265625*pow(xi1, 12) - 140.55615234375*pow(xi1, 10) + 95.14892578125*pow(xi1, 8) - 33.15087890625*pow(xi1, 6) + 5.69091796875*pow(xi1, 4) - 0.46142578125*pow(xi1, 2) + 0.00048828125*pow(xi2, 2)*(60775.0*pow(xi2, 12) - 210925.0*pow(xi2, 10) + 287859.0*pow(xi2, 8) - 194865.0*pow(xi2, 6) + 67893.0*pow(xi2, 4) - 11655.0*pow(xi2, 2) + 945.0);
case 7:
return -49.8544921875*pow(xi1, 15) + 185.732421875*pow(xi1, 13) - 276.9228515625*pow(xi1, 11) + 210.33203125*pow(xi1, 9) - 85.5908203125*pow(xi1, 7) + 17.841796875*pow(xi1, 5) - 1.5380859375*pow(xi1, 3) + 0.0009765625*pow(xi2, 3)*(51051.0*pow(xi2, 12) - 190190.0*pow(xi2, 10) + 283569.0*pow(xi2, 8) - 215380.0*pow(xi2, 6) + 87645.0*pow(xi2, 4) - 18270.0*pow(xi2, 2) + 1575.0);
case 8:
return -85.6874084472656*pow(xi1, 16) + 340.916748046875*pow(xi1, 14) - 551.209838867188*pow(xi1, 12) + 464.177978515625*pow(xi1, 10) - 216.592712402344*pow(xi1, 8) + 54.884033203125*pow(xi1, 6) - 6.8572998046875*pow(xi1, 4) + 0.384521484375*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(2807805.0*pow(xi2, 14) - 11171160.0*pow(xi2, 12) + 18062044.0*pow(xi2, 10) - 15210184.0*pow(xi2, 8) + 7097310.0*pow(xi2, 6) - 1798440.0*pow(xi2, 4) + 224700.0*pow(xi2, 2) - 12600.0);
case 9:
return -149.77294921875*pow(xi1, 17) + 633.65478515625*pow(xi1, 15) - 1104.13037109375*pow(xi1, 13) + 1021.03955078125*pow(xi1, 11) - 537.83447265625*pow(xi1, 9) + 160.72998046875*pow(xi1, 7) - 25.48095703125*pow(xi1, 5) + 1.79443359375*pow(xi1, 3) + 0.00048828125*pow(xi2, 3)*(306735.0*pow(xi2, 14) - 1297725.0*pow(xi2, 12) + 2261259.0*pow(xi2, 10) - 2091089.0*pow(xi2, 8) + 1101485.0*pow(xi2, 6) - 329175.0*pow(xi2, 4) + 52185.0*pow(xi2, 2) - 3675.0);
case 10:
return -265.222930908203*pow(xi1, 18) + 1188.82278442383*pow(xi1, 16) - 2220.67199707031*pow(xi1, 14) + 2237.22033691406*pow(xi1, 12) - 1313.75140380859*pow(xi1, 10) + 453.216247558594*pow(xi1, 8) - 87.8375244140625*pow(xi1, 6) + 8.5235595703125*pow(xi1, 4) - 0.336456298828125*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(8690825.0*pow(xi2, 16) - 38955345.0*pow(xi2, 14) + 72766980.0*pow(xi2, 12) - 73309236.0*pow(xi2, 10) + 43049006.0*pow(xi2, 8) - 14850990.0*pow(xi2, 6) + 2878260.0*pow(xi2, 4) - 279300.0*pow(xi2, 2) + 11025.0);
case 11:
return -474.609455309416*pow(xi1, 19) + 2246.59423828125*pow(xi1, 17) - 4478.21118164063*pow(xi1, 15) + 4882.24365234375*pow(xi1, 13) - 3163.52746582031*pow(xi1, 11) + 1239.03076171875*pow(xi1, 9) - 285.084228515625*pow(xi1, 7) + 35.52978515625*pow(xi1, 5) - 2.01873779296875*pow(xi1, 3) + 3.21237664473684e-6*pow(xi2, 3)*(147744025.0*pow(xi2, 16) - 699355800.0*pow(xi2, 14) + 1394049228.0*pow(xi2, 12) - 1519822920.0*pow(xi2, 10) + 984793446.0*pow(xi2, 8) - 385705320.0*pow(xi2, 6) + 88745580.0*pow(xi2, 4) - 11060280.0*pow(xi2, 2) + 628425.0);
case 12:
return -856.670066833496*pow(xi1, 20) + 4270.08918762207*pow(xi1, 18) - 9046.75417327881*pow(xi1, 16) + 10612.2775268555*pow(xi1, 14) - 7523.30863952637*pow(xi1, 12) + 3301.1188659668*pow(xi1, 10) - 881.847152709961*pow(xi1, 8) + 135.309265136719*pow(xi1, 6) - 10.5479049682617*pow(xi1, 4) + 0.302810668945313*pow(xi1, 2) + 7.62939453125e-6*pow(xi2, 2)*(112285459.0*pow(xi2, 18) - 559689130.0*pow(xi2, 16) + 1185776163.0*pow(xi2, 14) - 1390972440.0*pow(xi2, 12) + 986095110.0*pow(xi2, 10) - 432684252.0*pow(xi2, 8) + 115585470.0*pow(xi2, 6) - 17735256.0*pow(xi2, 4) + 1382535.0*pow(xi2, 2) - 39690.0);
case 13:
return -1557.58193969727*pow(xi1, 21) + 8154.39956665039*pow(xi1, 19) - 18297.4888916016*pow(xi1, 17) + 22980.2501220703*pow(xi1, 15) - 17696.2619018555*pow(xi1, 13) + 8605.14862060547*pow(xi1, 11) - 2622.85949707031*pow(xi1, 9) + 480.582641601563*pow(xi1, 7) - 48.4093322753906*pow(xi1, 5) + 2.22061157226563*pow(xi1, 3) + 3.0517578125e-5*pow(xi2, 3)*(51038845.0*pow(xi2, 18) - 267203365.0*pow(xi2, 16) + 599572116.0*pow(xi2, 14) - 753016836.0*pow(xi2, 12) + 579871110.0*pow(xi2, 10) - 281973510.0*pow(xi2, 8) + 85945860.0*pow(xi2, 6) - 15747732.0*pow(xi2, 4) + 1586277.0*pow(xi2, 2) - 72765.0);
case 14:
return -2849.66695785522*pow(xi1, 22) + 15633.0834388733*pow(xi1, 20) - 37036.0917396545*pow(xi1, 18) + 49585.4949302673*pow(xi1, 16) - 41223.053855896*pow(xi1, 14) + 22015.1343154907*pow(xi1, 12) - 7550.45825958252*pow(xi1, 10) + 1614.33702850342*pow(xi1, 8) - 201.353954315186*pow(xi1, 6) + 12.8610420227051*pow(xi1, 4) - 0.277576446533203*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(747023095.0*pow(xi2, 20) - 4098119025.0*pow(xi2, 18) + 9708789233.0*pow(xi2, 16) - 12998539983.0*pow(xi2, 14) + 10806376230.0*pow(xi2, 12) - 5771135370.0*pow(xi2, 10) + 1979307330.0*pow(xi2, 8) - 423188766.0*pow(xi2, 6) + 52783731.0*pow(xi2, 4) - 3371445.0*pow(xi2, 2) + 72765.0);
case 15:
return -5241.86229705811*pow(xi1, 23) + 30069.7888946533*pow(xi1, 21) - 75001.7991256714*pow(xi1, 19) + 106637.491882324*pow(xi1, 17) - 95202.6352386475*pow(xi1, 15) + 55415.131072998*pow(xi1, 13) - 21143.3159637451*pow(xi1, 11) + 5180.65155029297*pow(xi1, 9) - 775.516868591309*pow(xi1, 7) + 64.4717559814453*pow(xi1, 5) - 2.40566253662109*pow(xi1, 3) + 7.62939453125e-6*pow(xi2, 3)*(687061375.0*pow(xi2, 20) - 3941307370.0*pow(xi2, 18) + 9830635815.0*pow(xi2, 16) - 13977189336.0*pow(xi2, 14) + 12478399806.0*pow(xi2, 12) - 7263372060.0*pow(xi2, 10) + 2771296710.0*pow(xi2, 8) - 679038360.0*pow(xi2, 6) + 101648547.0*pow(xi2, 4) - 8450442.0*pow(xi2, 2) + 315315.0);
case 16:
return -9688.08478116989*pow(xi1, 24) + 58001.8670558929*pow(xi1, 22) - 151930.445162773*pow(xi1, 20) + 228623.231115341*pow(xi1, 18) - 218173.43846941*pow(xi1, 16) + 137516.871471405*pow(xi1, 14) - 57820.9868717194*pow(xi1, 12) + 16003.2707176208*pow(xi1, 10) - 2807.71195650101*pow(xi1, 8) + 290.586851119995*pow(xi1, 6) - 15.4220151901245*pow(xi1, 4) + 0.257749557495117*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(20317386375.0*pow(xi2, 22) - 121638731500.0*pow(xi2, 20) + 318621236934.0*pow(xi2, 18) - 479457666380.0*pow(xi2, 16) + 457542862833.0*pow(xi2, 14) - 288393782040.0*pow(xi2, 12) + 121259398260.0*pow(xi2, 10) - 33561291192.0*pow(xi2, 8) + 5888198745.0*pow(xi2, 6) - 609404796.0*pow(xi2, 4) + 32342310.0*pow(xi2, 2) - 540540.0);
case 17:
return -17981.0853538513*pow(xi1, 25) + 112153.828525543*pow(xi1, 23) - 307810.082950592*pow(xi1, 21) + 488743.176174164*pow(xi1, 19) - 496518.425559998*pow(xi1, 17) + 336997.347633362*pow(xi1, 15) - 154909.011726379*pow(xi1, 13) + 47860.7222213745*pow(xi1, 11) - 9660.37977218628*pow(xi1, 9) + 1205.35966873169*pow(xi1, 7) - 84.0263557434082*pow(xi1, 5) + 2.57749557495117*pow(xi1, 3) + 3.814697265625e-6*pow(xi2, 3)*(4713633639.0*pow(xi2, 22) - 29400453225.0*pow(xi2, 20) + 80690566385.0*pow(xi2, 18) - 128121091175.0*pow(xi2, 16) + 130159326150.0*pow(xi2, 14) - 88341832698.0*pow(xi2, 12) + 40608467970.0*pow(xi2, 10) - 12546401166.0*pow(xi2, 8) + 2532410595.0*pow(xi2, 6) - 315977805.0*pow(xi2, 4) + 22027005.0*pow(xi2, 2) - 675675.0);
case 18:
return -33498.416224122*pow(xi1, 26) + 217326.537135243*pow(xi1, 24) - 623650.511730909*pow(xi1, 22) + 1042027.70098567*pow(xi1, 20) - 1122894.03705299*pow(xi1, 18) + 816661.687039733*pow(xi1, 16) - 407619.976494312*pow(xi1, 14) + 139209.812054157*pow(xi1, 12) - 31848.3535255194*pow(xi1, 10) + 4675.69127261639*pow(xi1, 8) - 408.09272646904*pow(xi1, 6) + 18.2035624980927*pow(xi1, 4) - 0.241640210151672*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(281005082325.0*pow(xi2, 24) - 1823067128025.0*pow(xi2, 22) + 5231559671910.0*pow(xi2, 20) - 8741161908710.0*pow(xi2, 18) + 9419517902375.0*pow(xi2, 16) - 6850654761195.0*pow(xi2, 14) + 3419364195780.0*pow(xi2, 12) - 1167776543076.0*pow(xi2, 10) + 267163353171.0*pow(xi2, 8) - 39222541215.0*pow(xi2, 6) + 3423329910.0*pow(xi2, 4) - 152702550.0*pow(xi2, 2) + 2027025.0);
case 19:
return -62617.9545104504*pow(xi1, 27) + 421917.768359184*pow(xi1, 25) - 1263536.77855253*pow(xi1, 23) + 2216141.37401104*pow(xi1, 21) - 2525006.14107251*pow(xi1, 19) + 1959343.88411522*pow(xi1, 17) - 1055685.46106815*pow(xi1, 15) + 395240.543043137*pow(xi1, 13) - 101248.362429857*pow(xi1, 11) + 17159.9815893173*pow(xi1, 9) - 1813.4675860405*pow(xi1, 7) + 107.352690696716*pow(xi1, 5) - 2.73858904838562*pow(xi1, 3) + 2.38418579101563e-7*pow(xi2, 3)*(262638737075.0*pow(xi2, 24) - 1769651383500.0*pow(xi2, 22) + 5299657364430.0*pow(xi2, 20) - 9295170629580.0*pow(xi2, 18) + 10590643357525.0*pow(xi2, 16) - 8218083890520.0*pow(xi2, 14) + 4427865752100.0*pow(xi2, 12) - 1657758990648.0*pow(xi2, 10) + 424666411533.0*pow(xi2, 8) - 71974179420.0*pow(xi2, 6) + 7606234350.0*pow(xi2, 4) - 450269820.0*pow(xi2, 2) + 11486475.0);
case 20:
return -117408.664707094*pow(xi1, 28) + 820479.374541342*pow(xi1, 26) - 2559760.03214344*pow(xi1, 24) + 4702295.96284211*pow(xi1, 22) - 5648384.72818986*pow(xi1, 20) + 4658688.84687275*pow(xi1, 18) - 2695718.21505412*pow(xi1, 16) + 1098603.18051696*pow(xi1, 14) - 311941.764789551*pow(xi1, 12) + 60108.9683331847*pow(xi1, 10) - 7501.34424760938*pow(xi1, 8) + 559.372027516365*pow(xi1, 6) - 21.1860291659832*pow(xi1, 4) + 0.228215754032135*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(3939581056125.0*pow(xi2, 26) - 27530719380450.0*pow(xi2, 24) + 85891293934875.0*pow(xi2, 22) - 157782870129060.0*pow(xi2, 20) + 189528341271885.0*pow(xi2, 18) - 156319658121550.0*pow(xi2, 16) + 90453293538195.0*pow(xi2, 14) - 36863005715640.0*pow(xi2, 12) + 10467028734591.0*pow(xi2, 10) - 2016922290526.0*pow(xi2, 8) + 251703345465.0*pow(xi2, 6) - 18769410660.0*pow(xi2, 4) + 710885175.0*pow(xi2, 2) - 7657650.0);
case 21:
return -220753.859594464*pow(xi1, 29) + 1597921.02183402*pow(xi1, 27) - 5185115.58801055*pow(xi1, 25) + 9956002.6088655*pow(xi1, 23) - 12575203.3539766*pow(xi1, 21) + 10986811.2805098*pow(xi1, 19) - 6796979.6032548*pow(xi1, 17) + 2996882.53331995*pow(xi1, 15) - 935175.832545161*pow(xi1, 13) + 202332.507389426*pow(xi1, 11) - 29241.6076886654*pow(xi1, 9) + 2651.71057105064*pow(xi1, 7) - 134.708152413368*pow(xi1, 5) + 2.89073288440704*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(1851817592625.0*pow(xi2, 26) - 13404333067125.0*pow(xi2, 24) + 43495902102510.0*pow(xi2, 22) - 83517003132750.0*pow(xi2, 20) + 105488451456795.0*pow(xi2, 18) - 92164053002175.0*pow(xi2, 16) + 57017197475700.0*pow(xi2, 14) - 25139672794068.0*pow(xi2, 12) + 7844823470295.0*pow(xi2, 10) - 1697288090147.0*pow(xi2, 8) + 245296384190.0*pow(xi2, 6) - 22244160510.0*pow(xi2, 4) + 1130013885.0*pow(xi2, 2) - 24249225.0);
case 22:
return -416121.025335565*pow(xi1, 30) + 3116200.43859892*pow(xi1, 28) - 10501547.1333341*pow(xi1, 26) + 21037051.9058537*pow(xi1, 24) - 27874207.4076701*pow(xi1, 22) + 25719033.3889248*pow(xi1, 20) - 16943525.1738567*pow(xi1, 18) + 8039608.18552695*pow(xi1, 16) - 2737009.26113538*pow(xi1, 14) + 658014.033508673*pow(xi1, 12) - 108422.541410133*pow(xi1, 10) + 11650.7581970841*pow(xi1, 8) - 750.30417381227*pow(xi1, 6) + 24.3544245511293*pow(xi1, 4) - 0.216804966330528*pow(xi1, 2) + 1.49011611938477e-8*pow(xi2, 2)*(27925409296785.0*pow(xi2, 28) - 209124671430675.0*pow(xi2, 26) + 704746898360505.0*pow(xi2, 24) - 1.41177265531088e+15*pow(xi2, 22) + 1.87060639402913e+15*pow(xi2, 20) - 1.72597511390882e+15*pow(xi2, 18) + 1.13706072657293e+15*pow(xi2, 16) - 539528972335815.0*pow(xi2, 14) + 183677582272275.0*pow(xi2, 12) - 44158574284825.0*pow(xi2, 10) + 7276113586027.0*pow(xi2, 8) - 781869147345.0*pow(xi2, 6) + 50352060759.0*pow(xi2, 4) - 1634397765.0*pow(xi2, 2) + 14549535.0);
case 23:
return -786219.448790699*pow(xi1, 31) + 6084458.68978053*pow(xi1, 29) - 21265479.0051578*pow(xi1, 27) + 44367651.1797434*pow(xi1, 25) - 61536845.3039266*pow(xi1, 23) + 59798623.1011078*pow(xi1, 21) - 41802781.6162907*pow(xi1, 19) + 21246375.4476535*pow(xi1, 17) - 7841612.93932602*pow(xi1, 15) + 2076515.09504765*pow(xi1, 13) - 385135.903046876*pow(xi1, 11) + 48068.4554105997*pow(xi1, 9) - 3781.04970547557*pow(xi1, 7) + 166.332770168781*pow(xi1, 5) - 3.0352695286274*pow(xi1, 3) + 2.98023223876953e-8*pow(xi2, 3)*(26381147031525.0*pow(xi2, 28) - 204160555363050.0*pow(xi2, 26) + 713551069225995.0*pow(xi2, 24) - 1.48873133451042e+15*pow(xi2, 22) + 2.06483389124513e+15*pow(xi2, 20) - 2.00650883253975e+15*pow(xi2, 18) + 1.40266859315468e+15*pow(xi2, 16) - 712910060204760.0*pow(xi2, 14) + 263120868142935.0*pow(xi2, 12) - 69676284553750.0*pow(xi2, 10) + 12923016469545.0*pow(xi2, 8) - 1612909718420.0*pow(xi2, 6) + 126870975231.0*pow(xi2, 4) - 5581201626.0*pow(xi2, 2) + 101846745.0);
case 24:
return -1488679.72334943*pow(xi1, 32) + 11893145.806239*pow(xi1, 30) - 43054459.3877993*pow(xi1, 28) + 93407464.6031898*pow(xi1, 26) - 135345860.163132*pow(xi1, 24) + 138173637.360835*pow(xi1, 22) - 102170151.372404*pow(xi1, 20) + 55393315.5756378*pow(xi1, 18) - 22043036.0687566*pow(xi1, 16) + 6381339.80813455*pow(xi1, 14) - 1318139.46433848*pow(xi1, 12) + 188051.027000137*pow(xi1, 10) - 17587.6326048765*pow(xi1, 8) + 987.120238535106*pow(xi1, 6) - 27.696834448725*pow(xi1, 4) + 0.206950195133686*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.19691536300208e+15*pow(xi2, 30) - 2.5540336142178e+16*pow(xi2, 28) + 9.24587475087791e+16*pow(xi2, 26) - 2.00591002836489e+17*pow(xi2, 24) + 2.9065302152482e+17*pow(xi2, 22) - 2.96725626817074e+17*pow(xi2, 20) + 2.19408729385923e+17*pow(xi2, 18) - 1.18956239407186e+17*pow(xi2, 16) + 4.73370595099291e+16*pow(xi2, 14) - 1.37038228903004e+16*pow(xi2, 12) + 2.83068294545036e+15*pow(xi2, 10) - 403836505472400.0*pow(xi2, 8) + 37769153426004.0*pow(xi2, 6) - 2119824570864.0*pow(xi2, 4) + 59478499080.0*pow(xi2, 2) - 444422160.0);
case 25:
return -2824372.59765901*pow(xi1, 33) + 23270615.010516*pow(xi1, 31) - 87152179.1195009*pow(xi1, 29) + 196325971.199349*pow(xi1, 27) - 296653455.869637*pow(xi1, 25) + 317447154.463163*pow(xi1, 23) - 247577847.014235*pow(xi1, 21) + 142659378.333813*pow(xi1, 19) - 60913376.9486629*pow(xi1, 17) + 19153554.6350793*pow(xi1, 15) - 4366818.15360002*pow(xi1, 13) + 702868.975049034*pow(xi1, 11) - 76565.7097055763*pow(xi1, 9) + 5272.0752735883*pow(xi1, 7) - 202.452477559447*pow(xi1, 5) + 3.17323632538319*pow(xi1, 3) + 1.49011611938477e-8*pow(xi2, 3)*(189540436541625.0*pow(xi2, 30) - 1.56166453793708e+15*pow(xi2, 28) + 5.84868373583423e+15*pow(xi2, 26) - 1.3175212900885e+16*pow(xi2, 24) + 1.99080764250855e+16*pow(xi2, 22) - 2.13035179160554e+16*pow(xi2, 20) + 1.66146680646911e+16*pow(xi2, 18) - 9.57370881892837e+15*pow(xi2, 16) + 4.08782752942856e+15*pow(xi2, 14) - 1.28537329312211e+15*pow(xi2, 12) + 293052205582675.0*pow(xi2, 10) - 47168738456385.0*pow(xi2, 8) + 5138237799695.0*pow(xi2, 6) - 353802982533.0*pow(xi2, 4) + 13586355783.0*pow(xi2, 2) - 212952285.0);
case 26:
return -5368384.68010921*pow(xi1, 34) + 45574159.305608*pow(xi1, 32) - 176381514.925256*pow(xi1, 30) + 412001085.264459*pow(xi1, 28) - 648117747.563351*pow(xi1, 26) + 725470987.473485*pow(xi1, 24) - 595218173.30991*pow(xi1, 22) + 363318946.840418*pow(xi1, 20) - 165746807.477536*pow(xi1, 18) + 56289305.4453993*pow(xi1, 16) - 14056301.5180623*pow(xi1, 14) + 2524964.4175617*pow(xi1, 12) - 315162.630897876*pow(xi1, 10) + 25888.73523077*pow(xi1, 8) - 1276.3814246133*pow(xi1, 6) + 31.2034905329347*pow(xi1, 4) - 0.198327270336449*pow(xi1, 2) + 9.31322574615479e-10*pow(xi2, 2)*(5.76425915835413e+15*pow(xi2, 32) - 4.89348809400701e+16*pow(xi2, 30) + 1.89388209555728e+17*pow(xi2, 28) - 4.4238279678184e+17*pow(xi2, 26) + 6.95911132435444e+17*pow(xi2, 24) - 7.78968541348861e+17*pow(xi2, 22) + 6.39110647087731e+17*pow(xi2, 20) - 3.90110748674189e+17*pow(xi2, 18) + 1.77969279383107e+17*pow(xi2, 16) - 6.04401815006362e+16*pow(xi2, 14) + 1.50928388306982e+16*pow(xi2, 12) - 2.7111598992478e+15*pow(xi2, 10) + 338403298156924.0*pow(xi2, 8) - 27797817787740.0*pow(xi2, 6) + 1370504118984.0*pow(xi2, 4) - 33504492840.0*pow(xi2, 2) + 212952285.0);
case 27:
return -10221404.4309279*pow(xi1, 35) + 89329921.0770173*pow(xi1, 33) - 356895696.139291*pow(xi1, 31) + 863342628.482774*pow(xi1, 29) - 1411735169.97465*pow(xi1, 27) + 1649833527.66496*pow(xi1, 25) - 1420653947.98565*pow(xi1, 23) + 915870100.569113*pow(xi1, 21) - 444718654.137696*pow(xi1, 19) + 162314054.739406*pow(xi1, 17) - 44101073.3600514*pow(xi1, 15) + 8760388.7429215*pow(xi1, 13) - 1236316.72201056*pow(xi1, 11) + 118607.011141628*pow(xi1, 9) - 7205.51305599511*pow(xi1, 7) + 243.281451612711*pow(xi1, 5) - 3.30545450560749*pow(xi1, 3) + 1.86264514923096e-9*pow(xi2, 3)*(5.48757471875313e+15*pow(xi2, 32) - 4.79586361975063e+16*pow(xi2, 30) + 1.91606917875176e+17*pow(xi2, 28) - 4.63503544322024e+17*pow(xi2, 26) + 7.57919548206765e+17*pow(xi2, 24) - 8.85747630645665e+17*pow(xi2, 22) + 7.62707780691457e+17*pow(xi2, 20) - 4.91704016166071e+17*pow(xi2, 18) + 2.38756509430317e+17*pow(xi2, 16) - 8.71416945983628e+16*pow(xi2, 14) + 2.36765834749897e+16*pow(xi2, 12) - 4.7031978938868e+15*pow(xi2, 10) + 663742486066660.0*pow(xi2, 8) - 63676654241200.0*pow(xi2, 6) + 3868430365800.0*pow(xi2, 4) - 130610734800.0*pow(xi2, 2) + 1774602375.0);
case 28:
return -19492742.4243658*pow(xi1, 36) + 175232335.012119*pow(xi1, 34) - 722008921.923926*pow(xi1, 32) + 1806628056.05124*pow(xi1, 30) - 3066428693.32447*pow(xi1, 28) + 3734932372.32101*pow(xi1, 26) - 3368124476.71676*pow(xi1, 24) + 2287179847.95449*pow(xi1, 22) - 1178061248.61469*pow(xi1, 20) + 460069121.41871*pow(xi1, 18) - 135223661.775479*pow(xi1, 16) + 29472096.8897768*pow(xi1, 14) - 4650842.96896293*pow(xi1, 12) + 512427.983994139*pow(xi1, 10) - 37260.1692651166*pow(xi1, 8) + 1624.96143495664*pow(xi1, 6) - 34.866188390879*pow(xi1, 4) + 0.190699298400432*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(8.37206912220028e+16*pow(xi2, 34) - 7.52617148078766e+17*pow(xi2, 32) + 3.10100470708348e+18*pow(xi2, 30) - 7.75940841677612e+18*pow(xi2, 28) + 1.31702109533446e+19*pow(xi2, 26) - 1.60414123918904e+19*pow(xi2, 24) + 1.44659844763556e+19*pow(xi2, 22) - 9.8233626470348e+18*pow(xi2, 20) + 5.059734535485e+18*pow(xi2, 18) - 1.97598183039281e+18*pow(xi2, 16) + 5.80781204971046e+17*pow(xi2, 14) - 1.26581692286135e+17*pow(xi2, 12) + 1.99752184505273e+16*pow(xi2, 10) - 2.20086143281004e+15*pow(xi2, 8) + 160031208437100.0*pow(xi2, 6) - 6979156220400.0*pow(xi2, 4) + 149749138875.0*pow(xi2, 2) - 819047250.0);
case 29:
return -37229381.9276175*pow(xi1, 37) + 343989572.19469*pow(xi1, 35) - 1460350397.15719*pow(xi1, 33) + 3775623106.58272*pow(xi1, 31) - 6643091344.53323*pow(xi1, 29) + 8419444305.04878*pow(xi1, 27) - 7935772040.54214*pow(xi1, 25) + 5662484321.43375*pow(xi1, 23) - 3084320984.90706*pow(xi1, 21) + 1283814730.95024*pow(xi1, 19) - 406127401.700268*pow(xi1, 17) + 96463492.5990974*pow(xi1, 15) - 16863098.3571735*pow(xi1, 13) + 2104960.9899391*pow(xi1, 11) - 179227.787553705*pow(xi1, 9) + 9672.70429898053*pow(xi1, 7) - 289.023856655695*pow(xi1, 5) + 3.43258737120777*pow(xi1, 3) + 9.31322574615479e-10*pow(xi2, 3)*(3.99747444573527e+16*pow(xi2, 34) - 3.69355990685307e+17*pow(xi2, 32) + 1.56803929912269e+18*pow(xi2, 30) - 4.05404444119867e+18*pow(xi2, 28) + 7.13296501727773e+18*pow(xi2, 26) - 9.04030948516949e+18*pow(xi2, 24) + 8.52097034565992e+18*pow(xi2, 22) - 6.08004624366768e+18*pow(xi2, 20) + 3.31176444013558e+18*pow(xi2, 18) - 1.37848557088858e+18*pow(xi2, 16) + 4.36075977078027e+17*pow(xi2, 14) - 1.03576886492765e+17*pow(xi2, 12) + 1.81066139883229e+16*pow(xi2, 10) - 2.26018465278606e+15*pow(xi2, 8) + 192444371519400.0*pow(xi2, 6) - 10385987157000.0*pow(xi2, 4) + 310337003025.0*pow(xi2, 2) - 3685712625.0);
default:
return 0.;
}
case 12:
switch(j) {
case 0:
return 0.00048828125*y1t*(-46189.0*pow(xi1, 12) + 131274.0*pow(xi1, 10) - 135135.0*pow(xi1, 8) + 60060.0*pow(xi1, 6) - 10395.0*pow(xi1, 4) + 378.0*pow(xi1, 2) + pow(xi2, 2)*(46189.0*pow(xi2, 10) - 131274.0*pow(xi2, 8) + 135135.0*pow(xi2, 6) - 60060.0*pow(xi2, 4) + 10395.0*pow(xi2, 2) - 378.0));
case 1:
return 0.000244140625*y1r*(xi1*(xi1*(xi1*(xi1*(-13.0*xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(11.0*xi1 - 4.0) - 594.0) + 220.0) + 10395.0) - 3960.0) - 4620.0) + 1848.0) - 10395.0) + 4620.0) + 378.0) - 252.0) + xi2*(xi2*(xi2*(xi2*(13.0*xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(11.0*xi2 - 4.0) - 594.0) + 220.0) + 10395.0) - 3960.0) - 4620.0) + 1848.0) + 10395.0) - 4620.0) - 378.0) + 252.0));
case 2:
return 0.00048828125*y2t*(46189.0*pow(xi1, 12) - 131274.0*pow(xi1, 10) + 135135.0*pow(xi1, 8) - 60060.0*pow(xi1, 6) + 10395.0*pow(xi1, 4) - 378.0*pow(xi1, 2) + pow(xi2, 2)*(-46189.0*pow(xi2, 10) + 131274.0*pow(xi2, 8) - 135135.0*pow(xi2, 6) + 60060.0*pow(xi2, 4) - 10395.0*pow(xi2, 2) + 378.0));
case 3:
return 0.000244140625*y2r*(xi1*(xi1*(-xi1*(xi1*(13.0*xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(11.0*xi1 + 4.0) - 594.0) - 220.0) + 10395.0) + 3960.0) - 4620.0) - 1848.0) + 10395.0) + 4620.0) + 378.0) + 252.0) + xi2*(xi2*(xi2*(xi2*(13.0*xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(11.0*xi2 + 4.0) - 594.0) - 220.0) + 10395.0) + 3960.0) - 4620.0) - 1848.0) + 10395.0) + 4620.0) - 378.0) - 252.0));
case 4:
return -20.818359375*pow(xi1, 13) + 66.47265625*pow(xi1, 11) - 82.392578125*pow(xi1, 9) + 50.2734375*pow(xi1, 7) - 15.791015625*pow(xi1, 5) + 2.37890625*pow(xi1, 3) - 0.123046875*xi1 + 20.818359375*pow(xi2, 13) - 66.47265625*pow(xi2, 11) + 82.392578125*pow(xi2, 9) - 50.2734375*pow(xi2, 7) + 15.791015625*pow(xi2, 5) - 2.37890625*pow(xi2, 3) + 0.123046875*xi2;
case 5:
return -32.2188895089286*pow(xi1, 14) + 111.5791015625*pow(xi1, 12) - 152.0771484375*pow(xi1, 10) + 102.6416015625*pow(xi1, 8) - 34.9658203125*pow(xi1, 6) + 5.2294921875*pow(xi1, 4) - 0.1845703125*pow(xi1, 2) + 0.000139508928571429*pow(xi2, 2)*(230945.0*pow(xi2, 12) - 799799.0*pow(xi2, 10) + 1090089.0*pow(xi2, 8) - 735735.0*pow(xi2, 6) + 250635.0*pow(xi2, 4) - 37485.0*pow(xi2, 2) + 1323.0);
case 6:
return -52.6241861979167*pow(xi1, 15) + 195.85693359375*pow(xi1, 13) - 291.79541015625*pow(xi1, 11) + 221.459147135417*pow(xi1, 9) - 90.15380859375*pow(xi1, 7) + 19.16455078125*pow(xi1, 5) - 1.99951171875*pow(xi1, 3) + 0.09228515625*xi1 + 52.6241861979167*pow(xi2, 15) - 195.85693359375*pow(xi2, 13) + 291.79541015625*pow(xi2, 11) - 221.459147135417*pow(xi2, 9) + 90.15380859375*pow(xi2, 7) - 19.16455078125*pow(xi2, 5) + 1.99951171875*pow(xi2, 3) - 0.09228515625*xi2;
case 7:
return -88.8033142089844*pow(xi1, 16) + 353.135986328125*pow(xi1, 14) - 570.725708007813*pow(xi1, 12) + 480.425537109375*pow(xi1, 10) - 224.105529785156*pow(xi1, 8) + 56.719482421875*pow(xi1, 6) - 6.8829345703125*pow(xi1, 4) + 0.230712890625*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(2909907.0*pow(xi2, 14) - 11571560.0*pow(xi2, 12) + 18701540.0*pow(xi2, 10) - 15742584.0*pow(xi2, 8) + 7343490.0*pow(xi2, 6) - 1858584.0*pow(xi2, 4) + 225540.0*pow(xi2, 2) - 7560.0);
case 8:
return -153.229248046875*pow(xi1, 17) + 648.1083984375*pow(xi1, 15) - 1129.0576171875*pow(xi1, 13) + 1043.8720703125*pow(xi1, 11) - 549.75830078125*pow(xi1, 9) + 164.2587890625*pow(xi1, 7) - 26.0654296875*pow(xi1, 5) + 1.9482421875*pow(xi1, 3) - 0.076904296875*xi1 + 153.229248046875*pow(xi2, 17) - 648.1083984375*pow(xi2, 15) + 1129.0576171875*pow(xi2, 13) - 1043.8720703125*pow(xi2, 11) + 549.75830078125*pow(xi2, 9) - 164.2587890625*pow(xi2, 7) + 26.0654296875*pow(xi2, 5) - 1.9482421875*pow(xi2, 3) + 0.076904296875*xi2;
case 9:
return -268.759236653646*pow(xi1, 18) + 1204.52014160156*pow(xi1, 16) - 2249.736328125*pow(xi1, 14) + 2266.26139322917*pow(xi1, 12) - 1330.67504882813*pow(xi1, 10) + 459.010986328125*pow(xi1, 8) - 88.9560546875*pow(xi1, 6) + 8.61328125*pow(xi1, 4) - 0.2691650390625*pow(xi1, 2) + 4.06901041666667e-5*pow(xi2, 2)*(6605027.0*pow(xi2, 16) - 29602287.0*pow(xi2, 14) + 55289520.0*pow(xi2, 12) - 55695640.0*pow(xi2, 10) + 32702670.0*pow(xi2, 8) - 11280654.0*pow(xi2, 6) + 2186184.0*pow(xi2, 4) - 211680.0*pow(xi2, 2) + 6615.0);
case 10:
return -477.401275634766*pow(xi1, 19) + 2259.69937133789*pow(xi1, 17) - 4504.13342285156*pow(xi1, 15) + 4910.30090332031*pow(xi1, 13) - 3181.58416748047*pow(xi1, 11) + 1246.05682373047*pow(xi1, 9) - 286.691528320313*pow(xi1, 7) + 35.7271728515625*pow(xi1, 5) - 2.04116821289063*pow(xi1, 3) + 0.067291259765625*xi1 + 477.401275634766*pow(xi2, 19) - 2259.69937133789*pow(xi2, 17) + 4504.13342285156*pow(xi2, 15) - 4910.30090332031*pow(xi2, 13) + 3181.58416748047*pow(xi2, 11) - 1246.05682373047*pow(xi2, 9) + 286.691528320313*pow(xi2, 7) - 35.7271728515625*pow(xi2, 5) + 2.04116821289063*pow(xi2, 3) - 0.067291259765625*xi2;
case 11:
return -856.670066833496*pow(xi1, 20) + 4270.08918762207*pow(xi1, 18) - 9046.75417327881*pow(xi1, 16) + 10612.2775268555*pow(xi1, 14) - 7523.30863952637*pow(xi1, 12) + 3301.1188659668*pow(xi1, 10) - 881.847152709961*pow(xi1, 8) + 135.309265136719*pow(xi1, 6) - 10.5479049682617*pow(xi1, 4) + 0.302810668945313*pow(xi1, 2) + 7.62939453125e-6*pow(xi2, 2)*(112285459.0*pow(xi2, 18) - 559689130.0*pow(xi2, 16) + 1185776163.0*pow(xi2, 14) - 1390972440.0*pow(xi2, 12) + 986095110.0*pow(xi2, 10) - 432684252.0*pow(xi2, 8) + 115585470.0*pow(xi2, 6) - 17735256.0*pow(xi2, 4) + 1382535.0*pow(xi2, 2) - 39690.0);
case 12:
return -1550.16488284156*pow(xi1, 21) + 8115.82168579102*pow(xi1, 19) - 18211.4545440674*pow(xi1, 17) + 22872.8255615234*pow(xi1, 15) - 17613.9967346191*pow(xi1, 13) + 8565.35833740234*pow(xi1, 11) - 2610.79299926758*pow(xi1, 9) + 478.383178710938*pow(xi1, 7) - 48.1872711181641*pow(xi1, 5) + 2.22061157226563*pow(xi1, 3) - 0.0605621337890625*xi1 + 1550.16488284156*pow(xi2, 21) - 8115.82168579102*pow(xi2, 19) + 18211.4545440674*pow(xi2, 17) - 22872.8255615234*pow(xi2, 15) + 17613.9967346191*pow(xi2, 13) - 8565.35833740234*pow(xi2, 11) + 2610.79299926758*pow(xi2, 9) - 478.383178710938*pow(xi2, 7) + 48.1872711181641*pow(xi2, 5) - 2.22061157226563*pow(xi2, 3) + 0.0605621337890625*xi2;
case 13:
return -2824.88724517822*pow(xi1, 22) + 15497.9402999878*pow(xi1, 20) - 36717.703666687*pow(xi1, 18) + 49161.4813613892*pow(xi1, 16) - 40872.3374176025*pow(xi1, 14) + 21828.7485809326*pow(xi1, 12) - 7486.83421325684*pow(xi1, 10) + 1600.79658508301*pow(xi1, 8) - 199.669990539551*pow(xi1, 6) + 12.7685165405273*pow(xi1, 4) - 0.333091735839844*pow(xi1, 2) + 7.62939453125e-6*pow(xi2, 2)*(370263621.0*pow(xi2, 20) - 2031346031.0*pow(xi2, 18) + 4812662855.0*pow(xi2, 16) - 6443693685.0*pow(xi2, 14) + 5357219010.0*pow(xi2, 12) - 2861137734.0*pow(xi2, 10) + 981314334.0*pow(xi2, 8) - 209819610.0*pow(xi2, 6) + 26171145.0*pow(xi2, 4) - 1673595.0*pow(xi2, 2) + 43659.0);
case 14:
return -5178.95994949341*pow(xi1, 23) + 29710.8754997253*pow(xi1, 21) - 74111.1230278015*pow(xi1, 19) + 105377.289905548*pow(xi1, 17) - 94082.8270339966*pow(xi1, 15) + 54766.2573165894*pow(xi1, 13) - 20896.8199081421*pow(xi1, 11) + 5120.50998687744*pow(xi1, 9) - 766.547183990479*pow(xi1, 7) + 63.750057220459*pow(xi1, 5) - 2.46117782592773*pow(xi1, 3) + 0.0555152893066406*xi1 + 5178.95994949341*pow(xi2, 23) - 29710.8754997253*pow(xi2, 21) + 74111.1230278015*pow(xi2, 19) - 105377.289905548*pow(xi2, 17) + 94082.8270339966*pow(xi2, 15) - 54766.2573165894*pow(xi2, 13) + 20896.8199081421*pow(xi2, 11) - 5120.50998687744*pow(xi2, 9) + 766.547183990479*pow(xi2, 7) - 63.750057220459*pow(xi2, 5) + 2.46117782592773*pow(xi2, 3) - 0.0555152893066406*xi2;
case 15:
return -9544.55759922663*pow(xi1, 24) + 57146.7827625275*pow(xi1, 22) - 149701.111962318*pow(xi1, 20) + 225283.641888301*pow(xi1, 18) - 215000.310380459*pow(xi1, 16) + 135525.19952774*pow(xi1, 14) - 56986.956861496*pow(xi1, 12) + 15773.3450202942*pow(xi1, 10) - 2767.52143621445*pow(xi1, 8) + 286.474313735962*pow(xi1, 6) - 15.3360986709595*pow(xi1, 4) + 0.360849380493164*pow(xi1, 2) + 1.58945719401042e-7*pow(xi2, 2)*(60049164175.0*pow(xi2, 22) - 359536469292.0*pow(xi2, 20) + 941837959062.0*pow(xi2, 18) - 1417362120460.0*pow(xi2, 16) + 1352664992745.0*pow(xi2, 14) - 852650829720.0*pow(xi2, 12) + 358530931668.0*pow(xi2, 10) - 99237306168.0*pow(xi2, 8) + 17411739345.0*pow(xi2, 6) - 1802340540.0*pow(xi2, 4) + 96486390.0*pow(xi2, 2) - 2270268.0);
case 16:
return -17671.0666408539*pow(xi1, 25) + 110228.875732422*pow(xi1, 23) - 302549.896160126*pow(xi1, 21) + 480425.929870605*pow(xi1, 19) - 488103.004846573*pow(xi1, 17) + 331307.98425293*pow(xi1, 15) - 152303.689613342*pow(xi1, 13) + 47058.755859375*pow(xi1, 11) - 9499.08173561096*pow(xi1, 9) + 1185.35339355469*pow(xi1, 7) - 82.8578910827637*pow(xi1, 5) + 2.74932861328125*pow(xi1, 3) - 0.0515499114990234*xi1 + 17671.0666408539*pow(xi2, 25) - 110228.875732422*pow(xi2, 23) + 302549.896160126*pow(xi2, 21) - 480425.929870605*pow(xi2, 19) + 488103.004846573*pow(xi2, 17) - 331307.98425293*pow(xi2, 15) + 152303.689613342*pow(xi2, 13) - 47058.755859375*pow(xi2, 11) + 9499.08173561096*pow(xi2, 9) - 1185.35339355469*pow(xi2, 7) + 82.8578910827637*pow(xi2, 5) - 2.74932861328125*pow(xi2, 3) + 0.0515499114990234*xi2;
case 17:
return -32850.0597810745*pow(xi1, 26) + 213137.865185738*pow(xi1, 24) - 611679.07834053*pow(xi1, 22) + 1022103.32902718*pow(xi1, 20) - 1101504.66350079*pow(xi1, 18) + 801162.67781353*pow(xi1, 16) - 399911.571865082*pow(xi1, 14) + 136586.399288177*pow(xi1, 12) - 31250.190905571*pow(xi1, 10) + 4588.24283123016*pow(xi1, 8) - 400.869295120239*pow(xi1, 6) + 18.3002185821533*pow(xi1, 4) - 0.386624336242676*pow(xi1, 2) + 9.5367431640625e-7*pow(xi2, 2)*(34445784285.0*pow(xi2, 24) - 223491250125.0*pow(xi2, 22) + 641392001250.0*pow(xi2, 20) - 1071753020338.0*pow(xi2, 18) + 1155011354035.0*pow(xi2, 16) - 840079956051.0*pow(xi2, 14) + 419337676380.0*pow(xi2, 12) - 143221220220.0*pow(xi2, 10) + 32768200179.0*pow(xi2, 8) - 4811121315.0*pow(xi2, 6) + 420341922.0*pow(xi2, 4) - 19189170.0*pow(xi2, 2) + 405405.0);
case 18:
return -61289.6948693196*pow(xi1, 27) + 413003.054221272*pow(xi1, 25) - 1236940.47161937*pow(xi1, 23) + 2169664.52764074*pow(xi1, 21) - 2472240.10607421*pow(xi1, 19) + 1918540.2736448*pow(xi1, 17) - 1033774.66102648*pow(xi1, 15) + 387064.230816364*pow(xi1, 13) - 99160.5335086584*pow(xi1, 11) + 16807.3628920317*pow(xi1, 9) - 1776.99817156792*pow(xi1, 7) + 106.044611692429*pow(xi1, 5) - 3.07688534259796*pow(xi1, 3) + 0.0483280420303345*xi1 + 61289.6948693196*pow(xi2, 27) - 413003.054221272*pow(xi2, 25) + 1236940.47161937*pow(xi2, 23) - 2169664.52764074*pow(xi2, 21) + 2472240.10607421*pow(xi2, 19) - 1918540.2736448*pow(xi2, 17) + 1033774.66102648*pow(xi2, 15) - 387064.230816364*pow(xi2, 13) + 99160.5335086584*pow(xi2, 11) - 16807.3628920317*pow(xi2, 9) + 1776.99817156792*pow(xi2, 7) - 106.044611692429*pow(xi2, 5) + 3.07688534259796*pow(xi2, 3) - 0.0483280420303345*xi2;
case 19:
return -114725.038085218*pow(xi1, 28) + 801794.444799721*pow(xi1, 26) - 2501673.42693731*pow(xi1, 24) + 4595958.69847834*pow(xi1, 22) - 5521081.21116832*pow(xi1, 20) + 4554034.10654563*pow(xi1, 18) - 2635353.3188543*pow(xi1, 16) + 1074078.76940336*pow(xi1, 14) - 304999.325132221*pow(xi1, 12) + 58775.3960224986*pow(xi1, 10) - 7336.62985315919*pow(xi1, 8) + 548.831502556801*pow(xi1, 6) - 21.703318208456*pow(xi1, 4) + 0.410788357257843*pow(xi1, 2) + 4.25747462681362e-9*pow(xi2, 2)*(26946734423895.0*pow(xi2, 26) - 188326300232070.0*pow(xi2, 24) + 587595616232625.0*pow(xi2, 22) - 1.0795034853603e+15*pow(xi2, 20) + 1.29679720846638e+15*pow(xi2, 18) - 1.06965619427636e+15*pow(xi2, 16) + 618994486134297.0*pow(xi2, 14) - 252280721214120.0*pow(xi2, 12) + 71638553806365.0*pow(xi2, 10) - 13805225203770.0*pow(xi2, 8) + 1723235132619.0*pow(xi2, 6) - 128910105324.0*pow(xi2, 4) + 5097697605.0*pow(xi2, 2) - 96486390.0);
case 20:
return -215384.171117842*pow(xi1, 29) + 1559187.06731021*pow(xi1, 27) - 5059848.83704752*pow(xi1, 25) + 9716260.68171859*pow(xi1, 23) - 12273352.074565*pow(xi1, 21) + 10723903.6297828*pow(xi1, 19) - 6634823.52170509*pow(xi1, 17) + 2925596.79840517*pow(xi1, 15) - 912995.348572433*pow(xi1, 13) + 197547.517040372*pow(xi1, 11) - 28554.2153170705*pow(xi1, 9) + 2592.99522185326*pow(xi1, 7) - 133.913961589336*pow(xi1, 5) + 3.43845069408417*pow(xi1, 3) - 0.045643150806427*xi1 + 215384.171117842*pow(xi2, 29) - 1559187.06731021*pow(xi2, 27) + 5059848.83704752*pow(xi2, 25) - 9716260.68171859*pow(xi2, 23) + 12273352.074565*pow(xi2, 21) - 10723903.6297828*pow(xi2, 19) + 6634823.52170509*pow(xi2, 17) - 2925596.79840517*pow(xi2, 15) + 912995.348572433*pow(xi2, 13) - 197547.517040372*pow(xi2, 11) + 28554.2153170705*pow(xi2, 9) - 2592.99522185326*pow(xi2, 7) + 133.913961589336*pow(xi2, 5) - 3.43845069408417*pow(xi2, 3) + 0.045643150806427*xi2;
case 21:
return -405451.255455166*pow(xi1, 30) + 3036558.8335298*pow(xi1, 28) - 10234008.0454154*pow(xi1, 26) + 20502764.8258321*pow(xi1, 24) - 27168407.1926661*pow(xi1, 22) + 25069719.7046261*pow(xi1, 20) - 16516991.3616178*pow(xi1, 18) + 7837789.40442404*pow(xi1, 16) - 2668491.02463529*pow(xi1, 14) + 641586.375719259*pow(xi1, 12) - 105726.973603338*pow(xi1, 10) + 11368.8188244402*pow(xi1, 8) - 737.262150615454*pow(xi1, 6) + 25.5829860270023*pow(xi1, 4) - 0.433609932661057*pow(xi1, 2) + 9.9341074625651e-9*pow(xi2, 2)*(40814059741455.0*pow(xi2, 28) - 305670020681025.0*pow(xi2, 26) + 1.03018898114204e+15*pow(xi2, 24) - 2.06387588448113e+15*pow(xi2, 22) + 2.73486141508388e+15*pow(xi2, 20) - 2.52360061526381e+15*pow(xi2, 18) + 1.66265479046398e+15*pow(xi2, 16) - 788977714803201.0*pow(xi2, 14) + 268619101886205.0*pow(xi2, 12) - 64584199248595.0*pow(xi2, 10) + 10642825639017.0*pow(xi2, 8) - 1144422774495.0*pow(xi2, 6) + 74215238097.0*pow(xi2, 4) - 2575267695.0*pow(xi2, 2) + 43648605.0);
case 22:
return -765125.756262168*pow(xi1, 31) + 5921722.2836215*pow(xi1, 29) - 20698420.5992248*pow(xi1, 27) + 43188032.1491528*pow(xi1, 25) - 59905433.2374316*pow(xi1, 23) + 58217735.3508566*pow(xi1, 21) - 40700676.7005455*pow(xi1, 19) + 20687731.1349157*pow(xi1, 17) - 7635970.62332113*pow(xi1, 15) + 2022201.05743848*pow(xi1, 13) - 375095.230757907*pow(xi1, 11) + 46832.4571802467*pow(xi1, 9) - 3695.62648393214*pow(xi1, 7) + 167.127721711993*pow(xi1, 5) - 3.83022107183933*pow(xi1, 3) + 0.0433609932661057*xi1 + 765125.756262168*pow(xi2, 31) - 5921722.2836215*pow(xi2, 29) + 20698420.5992248*pow(xi2, 27) - 43188032.1491528*pow(xi2, 25) + 59905433.2374316*pow(xi2, 23) - 58217735.3508566*pow(xi2, 21) + 40700676.7005455*pow(xi2, 19) - 20687731.1349157*pow(xi2, 17) + 7635970.62332113*pow(xi2, 15) - 2022201.05743848*pow(xi2, 13) + 375095.230757907*pow(xi2, 11) - 46832.4571802467*pow(xi2, 9) + 3695.62648393214*pow(xi2, 7) - 167.127721711993*pow(xi2, 5) + 3.83022107183933*pow(xi2, 3) - 0.0433609932661057*xi2;
case 23:
return -1447135.17293038*pow(xi1, 32) + 11562219.9182525*pow(xi1, 30) - 41859905.6974805*pow(xi1, 28) + 90823108.3086038*pow(xi1, 26) - 131611410.038288*pow(xi1, 24) + 134371362.125239*pow(xi1, 22) - 99365988.1704175*pow(xi1, 20) + 53876892.8339118*pow(xi1, 18) - 21441114.7105898*pow(xi1, 16) + 6207519.21943057*pow(xi1, 14) - 1282336.02874777*pow(xi1, 12) + 182983.673429422*pow(xi1, 10) - 17140.8084095176*pow(xi1, 8) + 974.068579562008*pow(xi1, 6) - 29.9732865951955*pow(xi1, 4) + 0.455290429294109*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.10769912031365e+15*pow(xi2, 30) - 2.48296782090271e+16*pow(xi2, 28) + 8.98934629921614e+16*pow(xi2, 26) - 1.9504113995326e+17*pow(xi2, 24) + 2.82633350947447e+17*pow(xi2, 22) - 2.88560302923438e+17*pow(xi2, 20) + 2.13386834763333e+17*pow(xi2, 18) - 1.15699746365874e+17*pow(xi2, 16) + 4.60444432358839e+16*pow(xi2, 14) - 1.33305460183729e+16*pow(xi2, 12) + 2.7537956529771e+15*pow(xi2, 10) - 392954446540656.0*pow(xi2, 8) + 36809605772940.0*pow(xi2, 6) - 2091796346640.0*pow(xi2, 4) + 64367142840.0*pow(xi2, 2) - 977728752.0);
case 24:
return -2742779.61150441*pow(xi1, 33) + 22600235.4279654*pow(xi1, 31) - 84648362.5869781*pow(xi1, 29) + 190700740.01478*pow(xi1, 27) - 288175803.705125*pow(xi1, 25) + 308398483.842205*pow(xi1, 23) - 240538465.619668*pow(xi1, 21) + 138613122.14585*pow(xi1, 19) - 59189858.1177827*pow(xi1, 17) + 18612900.9589193*pow(xi1, 15) - 4243868.11019075*pow(xi1, 13) + 683181.726775736*pow(xi1, 11) - 74483.69949465*pow(xi1, 9) + 5159.52458873391*pow(xi1, 7) - 206.398327946663*pow(xi1, 5) + 4.24937734007835*pow(xi1, 3) - 0.0413900390267372*xi1 + 2742779.61150441*pow(xi2, 33) - 22600235.4279654*pow(xi2, 31) + 84648362.5869781*pow(xi2, 29) - 190700740.01478*pow(xi2, 27) + 288175803.705125*pow(xi2, 25) - 308398483.842205*pow(xi2, 23) + 240538465.619668*pow(xi2, 21) - 138613122.14585*pow(xi2, 19) + 59189858.1177827*pow(xi2, 17) - 18612900.9589193*pow(xi2, 15) + 4243868.11019075*pow(xi2, 13) - 683181.726775736*pow(xi2, 11) + 74483.69949465*pow(xi2, 9) - 5159.52458873391*pow(xi2, 7) + 206.398327946663*pow(xi2, 5) - 4.24937734007835*pow(xi2, 3) + 0.0413900390267372*xi2;
case 25:
return -5208475.34921234*pow(xi1, 34) + 44220260.3040145*pow(xi1, 32) - 171155330.901526*pow(xi1, 30) + 399824691.036655*pow(xi1, 28) - 629011031.974561*pow(xi1, 26) + 704136332.023367*pow(xi1, 24) - 577756105.294866*pow(xi1, 22) + 352685335.281925*pow(xi1, 20) - 160906983.145731*pow(xi1, 18) + 54649403.6016254*pow(xi1, 16) - 13647760.1367895*pow(xi1, 14) + 2451853.86356305*pow(xi1, 12) - 306183.941086113*pow(xi1, 10) + 25228.4376387298*pow(xi1, 8) - 1268.23678471148*pow(xi1, 6) + 34.905599579215*pow(xi1, 4) - 0.475985448807478*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.39813945543058e+15*pow(xi2, 32) - 1.18702857391468e+16*pow(xi2, 30) + 4.59441592973821e+16*pow(xi2, 28) - 1.07327123258484e+17*pow(xi2, 26) + 1.68848863197122e+17*pow(xi2, 24) - 1.8901515737286e+17*pow(xi2, 22) + 1.55090223581611e+17*pow(xi2, 20) - 9.46732488009165e+16*pow(xi2, 18) + 4.31931393943087e+16*pow(xi2, 16) - 1.46698375759304e+16*pow(xi2, 14) + 3.6635427156977e+15*pow(xi2, 12) - 658164509910908.0*pow(xi2, 10) + 82190625845328.0*pow(xi2, 8) - 6772207161720.0*pow(xi2, 6) + 340439719620.0*pow(xi2, 4) - 9369900540.0*pow(xi2, 2) + 127771371.0);
case 26:
return -9908504.29528729*pow(xi1, 35) + 86602324.7757193*pow(xi1, 33) - 346025516.708725*pow(xi1, 31) + 837111711.565737*pow(xi1, 29) - 1368945433.05878*pow(xi1, 27) + 1599944782.75468*pow(xi1, 25) - 1377794584.83228*pow(xi1, 23) + 888302170.752598*pow(xi1, 21) - 431362373.068038*pow(xi1, 19) + 157449965.765871*pow(xi1, 17) - 42782436.1134295*pow(xi1, 15) + 8499237.64101472*pow(xi1, 13) - 1199816.01963915*pow(xi1, 11) + 115296.38123868*pow(xi1, 9) - 7073.37042901665*pow(xi1, 7) + 252.483836956322*pow(xi1, 5) - 4.69374539796263*pow(xi1, 3) + 0.0396654540672898*xi1 + 9908504.29528729*pow(xi2, 35) - 86602324.7757193*pow(xi2, 33) + 346025516.708725*pow(xi2, 31) - 837111711.565737*pow(xi2, 29) + 1368945433.05878*pow(xi2, 27) - 1599944782.75468*pow(xi2, 25) + 1377794584.83228*pow(xi2, 23) - 888302170.752598*pow(xi2, 21) + 431362373.068038*pow(xi2, 19) - 157449965.765871*pow(xi2, 17) + 42782436.1134295*pow(xi2, 15) - 8499237.64101472*pow(xi2, 13) + 1199816.01963915*pow(xi2, 11) - 115296.38123868*pow(xi2, 9) + 7073.37042901665*pow(xi2, 7) - 252.483836956322*pow(xi2, 5) + 4.69374539796263*pow(xi2, 3) - 0.0396654540672898*xi2;
case 27:
return -18881205.4071308*pow(xi1, 36) + 169748323.585053*pow(xi1, 34) - 699467399.742545*pow(xi1, 32) + 1750356773.84535*pow(xi1, 30) - 2971138571.87629*pow(xi1, 28) + 3619131142.81016*pow(xi1, 26) - 3263928373.91906*pow(xi1, 24) + 2216578467.81839*pow(xi1, 22) - 1141774660.52333*pow(xi1, 20) + 445928084.89317*pow(xi1, 18) - 131076153.815987*pow(xi1, 16) + 28570462.2379647*pow(xi1, 14) - 4509449.15763886*pow(xi1, 12) + 497319.399947701*pow(xi1, 10) - 36350.1304189442*pow(xi1, 8) + 1629.89758035168*pow(xi1, 6) - 40.4091813310515*pow(xi1, 4) + 0.495818175841123*pow(xi1, 2) + 7.76102145512899e-11*pow(xi2, 2)*(2.43282479198055e+17*pow(xi2, 34) - 2.18719049504589e+18*pow(xi2, 32) + 9.01256881953717e+18*pow(xi2, 30) - 2.25531752999935e+19*pow(xi2, 28) + 3.82828289942784e+19*pow(xi2, 26) - 4.66321496949142e+19*pow(xi2, 24) + 4.20553968674065e+19*pow(xi2, 22) - 2.85603960848933e+19*pow(xi2, 20) + 1.47116544790477e+19*pow(xi2, 18) - 5.74573962295223e+18*pow(xi2, 16) + 1.68890338177539e+18*pow(xi2, 14) - 3.68127602830984e+17*pow(xi2, 12) + 5.81038099651009e+16*pow(xi2, 10) - 6.40791167532516e+15*pow(xi2, 8) + 468367864064100.0*pow(xi2, 6) - 21001070410320.0*pow(xi2, 4) + 520668336825.0*pow(xi2, 2) - 6388568550.0);
case 28:
return -36035231.94126*pow(xi1, 37) + 332981905.88446*pow(xi1, 35) - 1413726939.76667*pow(xi1, 33) + 3655354391.35564*pow(xi1, 31) - 6431952084.25*pow(xi1, 29) + 8152430288.7193*pow(xi1, 27) - 7684636644.4594*pow(xi1, 25) + 5483667102.29229*pow(xi1, 23) - 2987122332.19582*pow(xi1, 21) + 1243439492.18471*pow(xi1, 19) - 393380943.358236*pow(xi1, 17) + 93442880.9754944*pow(xi1, 15) - 16337382.0053395*pow(xi1, 13) + 2040497.55025906*pow(xi1, 11) - 174241.619613813*pow(xi1, 9) + 9541.69497068971*pow(xi1, 7) - 306.184250854421*pow(xi1, 5) + 5.16159434337169*pow(xi1, 3) - 0.0381398596800864*xi1 + 36035231.94126*pow(xi2, 37) - 332981905.88446*pow(xi2, 35) + 1413726939.76667*pow(xi2, 33) - 3655354391.35564*pow(xi2, 31) + 6431952084.25*pow(xi2, 29) - 8152430288.7193*pow(xi2, 27) + 7684636644.4594*pow(xi2, 25) - 5483667102.29229*pow(xi2, 23) + 2987122332.19582*pow(xi2, 21) - 1243439492.18471*pow(xi2, 19) + 393380943.358236*pow(xi2, 17) - 93442880.9754944*pow(xi2, 15) + 16337382.0053395*pow(xi2, 13) - 2040497.55025906*pow(xi2, 11) + 174241.619613813*pow(xi2, 9) - 9541.69497068971*pow(xi2, 7) + 306.184250854421*pow(xi2, 5) - 5.16159434337169*pow(xi2, 3) + 0.0381398596800864*xi2;
case 29:
return -68874356.5660925*pow(xi1, 38) + 653656629.297066*pow(xi1, 36) - 2856934570.48049*pow(xi1, 34) + 7624657571.27675*pow(xi1, 32) - 13890356342.0884*pow(xi1, 30) + 18292482306.1948*pow(xi1, 28) - 17989567245.6529*pow(xi1, 26) + 13458767751.5738*pow(xi1, 24) - 7731565722.77115*pow(xi1, 22) + 3418271096.48544*pow(xi1, 20) - 1158704884.14768*pow(xi1, 18) + 298182338.803168*pow(xi1, 16) - 57291281.6304182*pow(xi1, 14) + 8014068.54624802*pow(xi1, 12) - 786727.024230338*pow(xi1, 10) + 51392.5738947513*pow(xi1, 8) - 2070.38795685978*pow(xi1, 6) + 46.5115588798653*pow(xi1, 4) - 0.514888105681166*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(2.9581310898441e+17*pow(xi2, 36) - 2.80743384564449e+18*pow(xi2, 34) + 1.22704405470255e+19*pow(xi2, 32) - 3.27476549118324e+19*pow(xi2, 30) + 5.9658626219056e+19*pow(xi2, 28) - 7.85656132677653e+19*pow(xi2, 26) + 7.72646029892722e+19*pow(xi2, 24) - 5.78049673374688e+19*pow(xi2, 22) + 3.32068219261767e+19*pow(xi2, 20) - 1.4681362568267e+19*pow(xi2, 18) + 4.97659958312977e+18*pow(xi2, 16) - 1.2806833934044e+18*pow(xi2, 14) + 2.46064180948572e+17*pow(xi2, 12) - 3.44201623140375e+16*pow(xi2, 10) + 3.3789668399487e+15*pow(xi2, 8) - 220729424135220.0*pow(xi2, 6) + 8892248564745.0*pow(xi2, 4) - 199765624275.0*pow(xi2, 2) + 2211427575.0);
default:
return 0.;
}
case 13:
switch(j) {
case 0:
return 0.001953125*y1t*(-20349.0*pow(xi1, 13) + 62985.0*pow(xi1, 11) - 72930.0*pow(xi1, 9) + 38610.0*pow(xi1, 7) - 9009.0*pow(xi1, 5) + 693.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-6783.0*pow(xi2, 10) + 20995.0*pow(xi2, 8) - 24310.0*pow(xi2, 6) + 12870.0*pow(xi2, 4) - 3003.0*pow(xi2, 2) + 231.0));
case 1:
return 0.000244140625*y1r*(pow(xi1, 2)*(xi1*(xi1*(xi1*(xi1*(xi1*(-17.0*xi1*(xi1*(19.0*xi1*(xi1*(7.0*xi1*(36.0*xi1 - 13.0) - 780.0) + 286.0) + 17160.0) - 6435.0) + 154440.0) - 60060.0) - 36036.0) + 15015.0) + 2772.0) - 1386.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(7.0*xi2*(36.0*xi2 - 13.0) - 780.0) + 286.0) + 17160.0) - 6435.0) - 154440.0) + 60060.0) + 36036.0) - 15015.0) - 2772.0) + 1386.0));
case 2:
return 0.001953125*y2t*(20349.0*pow(xi1, 13) - 62985.0*pow(xi1, 11) + 72930.0*pow(xi1, 9) - 38610.0*pow(xi1, 7) + 9009.0*pow(xi1, 5) - 693.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-6783.0*pow(xi2, 10) + 20995.0*pow(xi2, 8) - 24310.0*pow(xi2, 6) + 12870.0*pow(xi2, 4) - 3003.0*pow(xi2, 2) + 231.0));
case 3:
return 0.000244140625*y2r*(pow(xi1, 2)*(xi1*(-xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(xi1*(7.0*xi1*(36.0*xi1 + 13.0) - 780.0) - 286.0) + 17160.0) + 6435.0) - 154440.0) - 60060.0) + 36036.0) + 15015.0) + 2772.0) + 1386.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(7.0*xi2*(36.0*xi2 + 13.0) - 780.0) - 286.0) + 17160.0) + 6435.0) - 154440.0) - 60060.0) + 36036.0) + 15015.0) - 2772.0) - 1386.0));
case 4:
return -36.9052734375*pow(xi1, 14) + 127.1181640625*pow(xi1, 12) - 173.3037109375*pow(xi1, 10) + 119.3994140625*pow(xi1, 8) - 43.9892578125*pow(xi1, 6) + 8.3466796875*pow(xi1, 4) - 0.6767578125*pow(xi1, 2) + 0.0009765625*pow(xi2, 2)*(37791.0*pow(xi2, 12) - 130169.0*pow(xi2, 10) + 177463.0*pow(xi2, 8) - 122265.0*pow(xi2, 6) + 45045.0*pow(xi2, 4) - 8547.0*pow(xi2, 2) + 693.0);
case 5:
return -57.408203125*pow(xi1, 15) + 213.23046875*pow(xi1, 13) - 317.255859375*pow(xi1, 11) + 240.1953125*pow(xi1, 9) - 96.357421875*pow(xi1, 7) + 18.94921875*pow(xi1, 5) - 1.353515625*pow(xi1, 3) + 0.001953125*pow(xi2, 3)*(29393.0*pow(xi2, 12) - 109174.0*pow(xi2, 10) + 162435.0*pow(xi2, 8) - 122980.0*pow(xi2, 6) + 49335.0*pow(xi2, 4) - 9702.0*pow(xi2, 2) + 693.0);
case 6:
return -94.1853332519531*pow(xi1, 16) + 374.178466796875*pow(xi1, 14) - 604.269897460938*pow(xi1, 12) + 508.285400390625*pow(xi1, 10) - 237.096862792969*pow(xi1, 8) + 60.626220703125*pow(xi1, 6) - 8.0364990234375*pow(xi1, 4) + 0.507568359375*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(3086265.0*pow(xi2, 14) - 12261080.0*pow(xi2, 12) + 19800716.0*pow(xi2, 10) - 16655496.0*pow(xi2, 8) + 7769190.0*pow(xi2, 6) - 1986600.0*pow(xi2, 4) + 263340.0*pow(xi2, 2) - 16632.0);
case 7:
return -159.56103515625*pow(xi1, 17) + 674.54638671875*pow(xi1, 15) - 1174.60205078125*pow(xi1, 13) + 1085.54443359375*pow(xi1, 11) - 571.51123046875*pow(xi1, 9) + 170.62353515625*pow(xi1, 7) - 26.73193359375*pow(xi1, 5) + 1.69189453125*pow(xi1, 3) + 0.00048828125*pow(xi2, 3)*(326781.0*pow(xi2, 14) - 1381471.0*pow(xi2, 12) + 2405585.0*pow(xi2, 10) - 2223195.0*pow(xi2, 8) + 1170455.0*pow(xi2, 6) - 349437.0*pow(xi2, 4) + 54747.0*pow(xi2, 2) - 3465.0);
case 8:
return -276.276977539063*pow(xi1, 18) + 1237.86437988281*pow(xi1, 16) - 2311.435546875*pow(xi1, 14) + 2327.8759765625*pow(xi1, 12) - 1366.56469726563*pow(xi1, 10) + 471.289306640625*pow(xi1, 8) - 91.3623046875*pow(xi1, 6) + 9.0234375*pow(xi1, 4) - 0.4229736328125*pow(xi1, 2) + 0.0001220703125*pow(xi2, 2)*(2263261.0*pow(xi2, 16) - 10140585.0*pow(xi2, 14) + 18935280.0*pow(xi2, 12) - 19069960.0*pow(xi2, 10) + 11194898.0*pow(xi2, 8) - 3860802.0*pow(xi2, 6) + 748440.0*pow(xi2, 4) - 73920.0*pow(xi2, 2) + 3465.0);
case 9:
return -486.081298828125*pow(xi1, 19) + 2300.4287109375*pow(xi1, 17) - 4584.6708984375*pow(xi1, 15) + 4997.4462890625*pow(xi1, 13) - 3237.65380859375*pow(xi1, 11) + 1267.8681640625*pow(xi1, 9) - 291.6826171875*pow(xi1, 7) + 36.3193359375*pow(xi1, 5) - 1.973876953125*pow(xi1, 3) + 0.000244140625*pow(xi2, 3)*(1990989.0*pow(xi2, 16) - 9422556.0*pow(xi2, 14) + 18778812.0*pow(xi2, 12) - 20469540.0*pow(xi2, 10) + 13261430.0*pow(xi2, 8) - 5193188.0*pow(xi2, 6) + 1194732.0*pow(xi2, 4) - 148764.0*pow(xi2, 2) + 8085.0);
case 10:
return -865.832313537598*pow(xi1, 20) + 4315.41819763184*pow(xi1, 18) - 9142.12314605713*pow(xi1, 16) + 10723.4170532227*pow(xi1, 14) - 7601.6089630127*pow(xi1, 12) + 3335.27163696289*pow(xi1, 10) - 890.919937133789*pow(xi1, 8) + 136.690979003906*pow(xi1, 6) - 10.671272277832*pow(xi1, 4) + 0.370101928710938*pow(xi1, 2) + 7.62939453125e-6*pow(xi2, 2)*(113486373.0*pow(xi2, 18) - 565630494.0*pow(xi2, 16) + 1198276365.0*pow(xi2, 14) - 1405539720.0*pow(xi2, 12) + 996358090.0*pow(xi2, 10) - 437160724.0*pow(xi2, 8) + 116774658.0*pow(xi2, 6) - 17916360.0*pow(xi2, 4) + 1398705.0*pow(xi2, 2) - 48510.0);
case 11:
return -1557.58193969727*pow(xi1, 21) + 8154.39956665039*pow(xi1, 19) - 18297.4888916016*pow(xi1, 17) + 22980.2501220703*pow(xi1, 15) - 17696.2619018555*pow(xi1, 13) + 8605.14862060547*pow(xi1, 11) - 2622.85949707031*pow(xi1, 9) + 480.582641601563*pow(xi1, 7) - 48.4093322753906*pow(xi1, 5) + 2.22061157226563*pow(xi1, 3) + 3.0517578125e-5*pow(xi2, 3)*(51038845.0*pow(xi2, 18) - 267203365.0*pow(xi2, 16) + 599572116.0*pow(xi2, 14) - 753016836.0*pow(xi2, 12) + 579871110.0*pow(xi2, 10) - 281973510.0*pow(xi2, 8) + 85945860.0*pow(xi2, 6) - 15747732.0*pow(xi2, 4) + 1586277.0*pow(xi2, 2) - 72765.0);
case 12:
return -2824.88724517822*pow(xi1, 22) + 15497.9402999878*pow(xi1, 20) - 36717.703666687*pow(xi1, 18) + 49161.4813613892*pow(xi1, 16) - 40872.3374176025*pow(xi1, 14) + 21828.7485809326*pow(xi1, 12) - 7486.83421325684*pow(xi1, 10) + 1600.79658508301*pow(xi1, 8) - 199.669990539551*pow(xi1, 6) + 12.7685165405273*pow(xi1, 4) - 0.333091735839844*pow(xi1, 2) + 7.62939453125e-6*pow(xi2, 2)*(370263621.0*pow(xi2, 20) - 2031346031.0*pow(xi2, 18) + 4812662855.0*pow(xi2, 16) - 6443693685.0*pow(xi2, 14) + 5357219010.0*pow(xi2, 12) - 2861137734.0*pow(xi2, 10) + 981314334.0*pow(xi2, 8) - 209819610.0*pow(xi2, 6) + 26171145.0*pow(xi2, 4) - 1673595.0*pow(xi2, 2) + 43659.0);
case 13:
return -5158.48975206458*pow(xi1, 23) + 29594.056854248*pow(xi1, 21) - 73821.1861419678*pow(xi1, 19) + 104967.009887695*pow(xi1, 17) - 93718.2104187012*pow(xi1, 15) + 54554.955871582*pow(xi1, 13) - 20816.541595459*pow(xi1, 11) + 5100.92102050781*pow(xi1, 9) - 763.626022338867*pow(xi1, 7) + 63.5094909667969*pow(xi1, 5) - 2.44267272949219*pow(xi1, 3) + 6.63425611413043e-7*pow(xi2, 3)*(7775536041.0*pow(xi2, 20) - 44607950530.0*pow(xi2, 18) + 111272740865.0*pow(xi2, 16) - 158219713080.0*pow(xi2, 14) + 141264082674.0*pow(xi2, 12) - 82232212524.0*pow(xi2, 10) + 31377356010.0*pow(xi2, 8) - 7688761080.0*pow(xi2, 6) + 1151034885.0*pow(xi2, 4) - 95729634.0*pow(xi2, 2) + 3681909.0);
case 14:
return -9475.14263486862*pow(xi1, 24) + 56733.152173996*pow(xi1, 22) - 148622.521708488*pow(xi1, 20) + 223667.621259689*pow(xi1, 18) - 213464.600594044*pow(xi1, 16) + 134561.141475677*pow(xi1, 14) - 56583.1933078766*pow(xi1, 12) + 15662.0201225281*pow(xi1, 10) - 2748.06134462357*pow(xi1, 8) + 284.469594955444*pow(xi1, 6) - 15.2158155441284*pow(xi1, 4) + 0.305334091186523*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(19870814327.0*pow(xi2, 22) - 118978043548.0*pow(xi2, 20) + 311684018646.0*pow(xi2, 18) - 469064999260.0*pow(xi2, 16) + 447667714065.0*pow(xi2, 14) - 282195166968.0*pow(xi2, 12) + 118663557012.0*pow(xi2, 10) - 32845636824.0*pow(xi2, 8) + 5763102345.0*pow(xi2, 6) - 596575980.0*pow(xi2, 4) + 31909878.0*pow(xi2, 2) - 640332.0);
case 15:
return -17492.571018219*pow(xi1, 25) + 109120.323970795*pow(xi1, 23) - 299520.0116539*pow(xi1, 21) + 475634.251041412*pow(xi1, 19) - 483253.892555237*pow(xi1, 17) + 328029.114830017*pow(xi1, 15) - 150801.959220886*pow(xi1, 13) + 46596.4232254028*pow(xi1, 11) - 9406.08324050903*pow(xi1, 9) + 1173.79148483276*pow(xi1, 7) - 82.0330924987793*pow(xi1, 5) + 2.6462287902832*pow(xi1, 3) + 3.814697265625e-6*pow(xi2, 3)*(4585572537.0*pow(xi2, 22) - 28605238207.0*pow(xi2, 20) + 78517373935.0*pow(xi2, 18) - 124684665105.0*pow(xi2, 16) + 126682108410.0*pow(xi2, 14) - 85990864278.0*pow(xi2, 12) + 39531828798.0*pow(xi2, 10) - 12214972770.0*pow(xi2, 8) + 2465748285.0*pow(xi2, 6) - 307702395.0*pow(xi2, 4) + 21504483.0*pow(xi2, 2) - 693693.0);
case 16:
return -32438.1468057632*pow(xi1, 26) + 210476.088356972*pow(xi1, 24) - 604069.896524429*pow(xi1, 22) + 1009436.52295876*pow(xi1, 20) - 1087903.80975246*pow(xi1, 18) + 791305.484061241*pow(xi1, 16) - 395008.242015839*pow(xi1, 14) + 134917.356273651*pow(xi1, 12) - 30869.5774526596*pow(xi1, 10) + 4532.54437923431*pow(xi1, 8) - 395.989236831665*pow(xi1, 6) + 17.9565525054932*pow(xi1, 4) - 0.283524513244629*pow(xi1, 2) + 9.5367431640625e-7*pow(xi2, 2)*(34013862225.0*pow(xi2, 24) - 220700174825.0*pow(xi2, 22) + 633413195818.0*pow(xi2, 20) - 1058470911498.0*pow(xi2, 18) + 1140749825215.0*pow(xi2, 16) - 829743939255.0*pow(xi2, 14) + 414196162380.0*pow(xi2, 12) - 141471101772.0*pow(xi2, 10) + 32369098047.0*pow(xi2, 8) - 4752717255.0*pow(xi2, 6) + 415224810.0*pow(xi2, 4) - 18828810.0*pow(xi2, 2) + 297297.0);
case 17:
return -60391.0189914703*pow(xi1, 27) + 406970.019607544*pow(xi1, 25) - 1218937.21246719*pow(xi1, 23) + 2138197.03727722*pow(xi1, 21) - 2436507.0156765*pow(xi1, 19) + 1890902.63150024*pow(xi1, 17) - 1018930.93498993*pow(xi1, 15) + 381524.08493042*pow(xi1, 13) - 97745.6159877777*pow(xi1, 11) + 16568.2724761963*pow(xi1, 9) - 1751.74945449829*pow(xi1, 7) + 104.337020874023*pow(xi1, 5) - 2.83524513244629*pow(xi1, 3) + 1.9073486328125e-6*pow(xi2, 3)*(31662286565.0*pow(xi2, 24) - 213369497640.0*pow(xi2, 22) + 639074153250.0*pow(xi2, 20) - 1121031048280.0*pow(xi2, 18) + 1277431390235.0*pow(xi2, 16) - 991377558864.0*pow(xi2, 14) + 534213262044.0*pow(xi2, 12) - 200028499440.0*pow(xi2, 10) + 51246853515.0*pow(xi2, 8) - 8686546440.0*pow(xi2, 6) + 918421218.0*pow(xi2, 4) - 54702648.0*pow(xi2, 2) + 1486485.0);
case 18:
return -112828.756463975*pow(xi1, 28) + 788588.082812726*pow(xi1, 26) - 2460608.39660838*pow(xi1, 24) + 4520765.16227424*pow(xi1, 22) - 5431042.46600339*pow(xi1, 20) + 4479999.0119229*pow(xi1, 18) - 2592641.40994146*pow(xi1, 16) + 1056722.9332602*pow(xi1, 14) - 300085.308234841*pow(xi1, 12) + 57831.1539922357*pow(xi1, 10) - 7219.0231026113*pow(xi1, 8) + 539.700724482536*pow(xi1, 6) - 20.9542335569859*pow(xi1, 4) + 0.26580423116684*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(3785904836415.0*pow(xi2, 26) - 26460625200750.0*pow(xi2, 24) + 82564317122625.0*pow(xi2, 22) - 151691707225500.0*pow(xi2, 20) + 182235545114623.0*pow(xi2, 18) - 150323822205634.0*pow(xi2, 16) + 86994609890265.0*pow(xi2, 14) - 35457737806920.0*pow(xi2, 12) + 10069192069365.0*pow(xi2, 10) - 1940491524114.0*pow(xi2, 8) + 242230219803.0*pow(xi2, 6) - 18109351260.0*pow(xi2, 4) + 703107405.0*pow(xi2, 2) - 8918910.0);
case 19:
return -211468.095279336*pow(xi1, 29) + 1530931.36221707*pow(xi1, 27) - 4968446.72460437*pow(xi1, 25) + 9541290.03068805*pow(xi1, 23) - 12053003.4512252*pow(xi1, 21) + 10531942.866402*pow(xi1, 19) - 6516402.00767183*pow(xi1, 17) + 2873527.1355443*pow(xi1, 15) - 896790.912789702*pow(xi1, 13) + 194050.851504207*pow(xi1, 11) - 28050.0218017101*pow(xi1, 9) + 2546.69480967522*pow(xi1, 7) - 130.74024116993*pow(xi1, 5) + 3.01244795322418*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(1773922955805.0*pow(xi2, 26) - 12842383072545.0*pow(xi2, 24) + 41678351941590.0*pow(xi2, 22) - 80038141881750.0*pow(xi2, 20) + 101107921174975.0*pow(xi2, 18) - 88348340184643.0*pow(xi2, 16) + 54663542012772.0*pow(xi2, 14) - 24104892717444.0*pow(xi2, 12) + 7522827425355.0*pow(xi2, 10) - 1627816525335.0*pow(xi2, 8) + 235300637286.0*pow(xi2, 6) - 21363224454.0*pow(xi2, 4) + 1096728633.0*pow(xi2, 2) - 25270245.0);
case 20:
return -397481.697608382*pow(xi1, 30) + 2977056.79637298*pow(xi1, 28) - 10034074.3945129*pow(xi1, 26) + 20103395.1400928*pow(xi1, 24) - 26640716.4326794*pow(xi1, 22) + 24584156.7905514*pow(xi1, 20) - 16197959.5438677*pow(xi1, 18) + 7686806.28355846*pow(xi1, 16) - 2617221.91839382*pow(xi1, 14) + 629291.577356607*pow(xi1, 12) - 103705.850256771*pow(xi1, 10) + 11150.8845161498*pow(xi1, 8) - 721.564963907003*pow(xi1, 6) + 24.1832627356052*pow(xi1, 4) - 0.251037329435349*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(13337272593645.0*pow(xi2, 28) - 99893449834035.0*pow(xi2, 26) + 336687666953625.0*pow(xi2, 24) - 674558005197375.0*pow(xi2, 22) + 893914107971625.0*pow(xi2, 20) - 824907417305895.0*pow(xi2, 18) + 543513332053461.0*pow(xi2, 16) - 257926418738835.0*pow(xi2, 14) + 87819394889655.0*pow(xi2, 12) - 21115521440585.0*pow(xi2, 10) + 3479790900443.0*pow(xi2, 8) - 374161596237.0*pow(xi2, 6) + 24211702515.0*pow(xi2, 4) - 811455645.0*pow(xi2, 2) + 8423415.0);
case 21:
return -749074.166969955*pow(xi1, 31) + 5797853.33353579*pow(xi1, 29) - 20266690.4669765*pow(xi1, 27) + 42289717.7062619*pow(xi1, 25) - 58662785.4666039*pow(xi1, 23) + 57013311.6029352*pow(xi1, 21) - 39860846.3061646*pow(xi1, 19) + 20261945.3071647*pow(xi1, 17) - 7479204.49236828*pow(xi1, 15) + 1980787.58679807*pow(xi1, 13) - 367431.737764776*pow(xi1, 11) + 45875.8207523823*pow(xi1, 9) - 3617.07494741678*pow(xi1, 7) + 161.534153580666*pow(xi1, 5) - 3.17980617284775*pow(xi1, 3) + 5.96046447753906e-8*pow(xi2, 3)*(12567379099275.0*pow(xi2, 28) - 97271837713050.0*pow(xi2, 26) + 340018643569605.0*pow(xi2, 24) - 709503728536980.0*pow(xi2, 22) + 984198222934875.0*pow(xi2, 20) - 956524643637750.0*pow(xi2, 18) + 668754028421325.0*pow(xi2, 16) - 339939032998488.0*pow(xi2, 14) + 125480229276633.0*pow(xi2, 12) - 33232101193830.0*pow(xi2, 10) + 6164481629735.0*pow(xi2, 8) - 769668553940.0*pow(xi2, 6) + 60684447681.0*pow(xi2, 4) - 2710093386.0*pow(xi2, 2) + 53348295.0);
case 22:
return -1415047.91854168*pow(xi1, 32) + 11306561.1464429*pow(xi1, 30) - 40936820.1382083*pow(xi1, 28) + 88825591.3740283*pow(xi1, 26) - 128724305.723804*pow(xi1, 24) + 131431185.617418*pow(xi1, 22) - 97197166.7331937*pow(xi1, 20) + 52703810.8407026*pow(xi1, 18) - 20975386.6819913*pow(xi1, 16) + 6073001.20285492*pow(xi1, 14) - 1254611.22974331*pow(xi1, 12) + 179032.623164363*pow(xi1, 10) - 16764.9744193722*pow(xi1, 8) + 947.979715280235*pow(xi1, 6) - 27.6245661266148*pow(xi1, 4) + 0.238485462963581*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.0387922662047e+15*pow(xi2, 30) - 2.42806551770983e+16*pow(xi2, 28) + 8.79111518479194e+16*pow(xi2, 26) - 1.90751504999656e+17*pow(xi2, 24) + 2.76433341642022e+17*pow(xi2, 22) - 2.82246321950658e+17*pow(xi2, 20) + 2.08729326191463e+17*pow(xi2, 18) - 1.13180571967694e+17*pow(xi2, 16) + 4.50442999100533e+16*pow(xi2, 14) - 1.30416707774153e+16*pow(xi2, 12) + 2.69425710047094e+15*pow(xi2, 10) - 384469630704016.0*pow(xi2, 8) + 36002508424740.0*pow(xi2, 6) - 2035770937200.0*pow(xi2, 4) + 59323304040.0*pow(xi2, 2) - 512143632.0);
case 23:
return -2678994.03914385*pow(xi1, 33) + 22076031.0194258*pow(xi1, 31) - 82690023.7308931*pow(xi1, 29) + 186299988.107375*pow(xi1, 27) - 281542048.924484*pow(xi1, 25) + 301316378.346892*pow(xi1, 23) - 235027817.674493*pow(xi1, 21) + 135444947.360354*pow(xi1, 19) - 57840098.2291941*pow(xi1, 17) + 18189409.6449181*pow(xi1, 15) - 4147521.9692352*pow(xi1, 13) + 667698.518639132*pow(xi1, 11) - 72786.0282803327*pow(xi1, 9) + 5031.24831698835*pow(xi1, 7) - 196.988992407918*pow(xi1, 5) + 3.33879648149014*pow(xi1, 3) + 1.49011611938477e-8*pow(xi2, 3)*(179784246629715.0*pow(xi2, 30) - 1.48149736334243e+15*pow(xi2, 28) + 5.54923355671328e+15*pow(xi2, 26) - 1.25023805650994e+16*pow(xi2, 24) + 1.88939670715546e+16*pow(xi2, 22) - 2.02209998554541e+16*pow(xi2, 20) + 1.57724498525344e+16*pow(xi2, 18) - 9.08955655189312e+15*pow(xi2, 16) + 3.88158328580963e+15*pow(xi2, 14) - 1.2206706181011e+15*pow(xi2, 12) + 278335487770417.0*pow(xi2, 10) - 44808489080355.0*pow(xi2, 8) + 4884587672965.0*pow(xi2, 6) - 337641359055.0*pow(xi2, 4) + 13219707501.0*pow(xi2, 2) - 224062839.0);
case 24:
return -5082209.28014053*pow(xi1, 34) + 43150939.7019241*pow(xi1, 32) - 167026656.234368*pow(xi1, 30) + 390203143.561572*pow(xi1, 28) - 613909922.174896*pow(xi1, 26) + 687270735.359609*pow(xi1, 24) - 563949022.965526*pow(xi1, 22) + 344275754.593978*pow(xi1, 20) - 157078667.432643*pow(xi1, 18) + 53351986.2105718*pow(xi1, 16) - 13324438.7481877*pow(xi1, 14) + 2393876.62580161*pow(xi1, 12) - 298932.017313659*pow(xi1, 10) + 24607.5082151592*pow(xi1, 8) - 1225.7430113107*pow(xi1, 6) + 31.2632761448622*pow(xi1, 4) - 0.227645214647055*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.36424516560196e+15*pow(xi2, 32) - 1.15832421757145e+16*pow(xi2, 30) + 4.48358766304277e+16*pow(xi2, 28) - 1.04744358774584e+17*pow(xi2, 26) + 1.64795189901943e+17*pow(xi2, 24) - 1.84487833241712e+17*pow(xi2, 22) + 1.51383913140505e+17*pow(xi2, 20) - 9.24158191741785e+16*pow(xi2, 18) + 4.21654837201537e+16*pow(xi2, 16) - 1.43215647469406e+16*pow(xi2, 14) + 3.57675179131384e+15*pow(xi2, 12) - 642601363654796.0*pow(xi2, 10) + 80243952380592.0*pow(xi2, 8) - 6605527688760.0*pow(xi2, 6) + 329032884180.0*pow(xi2, 4) - 8392171788.0*pow(xi2, 2) + 61108047.0);
case 25:
return -9659354.2839938*pow(xi1, 35) + 84429911.5193532*pow(xi1, 33) - 337365833.200063*pow(xi1, 31) + 816210188.947362*pow(xi1, 29) - 1334841870.98294*pow(xi1, 27) + 1560174819.29886*pow(xi1, 25) - 1343621210.16899*pow(xi1, 23) + 866316834.161896*pow(xi1, 21) - 420708715.370866*pow(xi1, 19) + 153569378.028978*pow(xi1, 17) - 41730149.5483515*pow(xi1, 15) + 8290584.15095028*pow(xi1, 13) - 1170365.41226014*pow(xi1, 11) + 112417.084816247*pow(xi1, 9) - 6868.09226006269*pow(xi1, 7) + 237.358077138662*pow(xi1, 5) - 3.4905599579215*pow(xi1, 3) + 7.45058059692383e-9*pow(xi2, 3)*(1.29645658594472e+15*pow(xi2, 32) - 1.13319908993686e+16*pow(xi2, 30) + 4.52804756369394e+16*pow(xi2, 28) - 1.09549877130966e+17*pow(xi2, 26) + 1.791594431626e+17*pow(xi2, 24) - 2.09403119529103e+17*pow(xi2, 22) + 1.80337786121493e+17*pow(xi2, 20) - 1.16275077209362e+17*pow(xi2, 18) + 5.64665679268762e+16*pow(xi2, 16) - 2.06117330094225e+16*pow(xi2, 14) + 5.60092586147996e+15*pow(xi2, 12) - 1.11274336853336e+15*pow(xi2, 10) + 157083786563340.0*pow(xi2, 8) - 15088365712420.0*pow(xi2, 6) + 921819738840.0*pow(xi2, 4) - 31857661836.0*pow(xi2, 2) + 468495027.0);
case 26:
return -18390784.4874651*pow(xi1, 36) + 165349363.264199*pow(xi1, 34) - 681381654.418109*pow(xi1, 32) + 1705198444.91246*pow(xi1, 30) - 2894650533.82591*pow(xi1, 28) + 3526159529.0653*pow(xi1, 26) - 3180256899.49859*pow(xi1, 24) + 2159872956.32263*pow(xi1, 22) - 1112624437.37378*pow(xi1, 20) + 434565975.375618*pow(xi1, 18) - 127742933.221558*pow(xi1, 16) + 27845286.2891282*pow(xi1, 14) - 4395100.23215187*pow(xi1, 12) + 484611.628580892*pow(xi1, 10) - 35350.9576309891*pow(xi1, 8) + 1562.02558116987*pow(xi1, 6) - 35.0873995770235*pow(xi1, 4) + 0.218159997370094*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(7.89878179214465e+16*pow(xi2, 34) - 7.10170107634161e+17*pow(xi2, 32) + 2.92651192182015e+18*pow(xi2, 30) - 7.32377155408906e+18*pow(xi2, 28) + 1.24324293761312e+19*pow(xi2, 26) - 1.51447398578142e+19*pow(xi2, 24) + 1.36590993762248e+19*pow(xi2, 22) - 9.27658371092053e+18*pow(xi2, 20) + 4.77868557125077e+18*pow(xi2, 18) - 1.86644665219262e+18*pow(xi2, 16) + 5.48651720481703e+17*pow(xi2, 14) - 1.19594593959563e+17*pow(xi2, 12) + 1.88768117597343e+16*pow(xi2, 10) - 2.08139109601623e+15*pow(xi2, 8) + 151831206907380.0*pow(xi2, 6) - 6708848786640.0*pow(xi2, 4) + 150699233685.0*pow(xi2, 2) - 936990054.0);
case 27:
return -35071723.0658252*pow(xi1, 37) + 324098167.76767*pow(xi1, 35) - 1376090817.03142*pow(xi1, 33) + 3558247605.06085*pow(xi1, 31) - 6261438377.81587*pow(xi1, 29) + 7936747811.00169*pow(xi1, 27) - 7481739208.62345*pow(xi1, 25) + 5339168617.26796*pow(xi1, 23) - 2908563110.5598*pow(xi1, 21) + 1210800767.34823*pow(xi1, 19) - 383074743.250645*pow(xi1, 17) + 90999253.9513292*pow(xi1, 15) - 15910711.3587747*pow(xi1, 13) + 1987040.60669569*pow(xi1, 11) - 169509.625385143*pow(xi1, 9) + 9217.57154602557*pow(xi1, 7) - 282.880796589889*pow(xi1, 5) + 3.63599995616823*pow(xi1, 3) + 9.31322574615479e-10*pow(xi2, 3)*(3.76579758955221e+16*pow(xi2, 34) - 3.47997757813916e+17*pow(xi2, 32) + 1.47756626386897e+18*pow(xi2, 30) - 3.82063927370167e+18*pow(xi2, 28) + 6.72316826465961e+18*pow(xi2, 26) - 8.52201807121296e+18*pow(xi2, 24) + 8.03345630455966e+18*pow(xi2, 22) - 5.73288864974886e+18*pow(xi2, 20) + 3.1230458595516e+18*pow(xi2, 18) - 1.30008742443309e+18*pow(xi2, 16) + 4.11323373546279e+17*pow(xi2, 14) - 9.77097049203395e+16*pow(xi2, 12) + 1.70839962355083e+16*pow(xi2, 10) - 2.1335686053955e+15*pow(xi2, 8) + 182009574346600.0*pow(xi2, 6) - 9897292084680.0*pow(xi2, 4) + 303740942505.0*pow(xi2, 2) - 3904125225.0);
case 28:
return -66984151.2400934*pow(xi1, 38) + 635755272.974369*pow(xi1, 36) - 2778854981.71771*pow(xi1, 34) + 7416700465.30732*pow(xi1, 32) - 13512264351.8898*pow(xi1, 30) + 17795545479.9828*pow(xi1, 28) - 17501806486.5197*pow(xi1, 26) + 13094549563.7091*pow(xi1, 24) - 7522729401.02621*pow(xi1, 22) + 3326111850.47562*pow(xi1, 20) - 1127522417.34474*pow(xi1, 18) + 290172121.541803*pow(xi1, 16) - 55754538.0001717*pow(xi1, 14) + 7798909.77564694*pow(xi1, 12) - 765222.40460386*pow(xi1, 10) + 49811.8488852354*pow(xi1, 8) - 1964.34897631989*pow(xi1, 6) + 39.0869995288085*pow(xi1, 4) - 0.209769228240475*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(2.87694738926519e+17*pow(xi2, 36) - 2.73054810568447e+18*pow(xi2, 34) + 1.19350912668042e+19*pow(xi2, 32) - 3.18544859427229e+19*pow(xi2, 30) + 5.80347334862732e+19*pow(xi2, 28) - 7.64312858510066e+19*pow(xi2, 26) + 7.5169686480523e+19*pow(xi2, 24) - 5.62406621319816e+19*pow(xi2, 22) + 3.23098767540653e+19*pow(xi2, 20) - 1.42855416206308e+19*pow(xi2, 18) + 4.84267190800251e+18*pow(xi2, 16) - 1.24627977223298e+18*pow(xi2, 14) + 2.39463917314327e+17*pow(xi2, 12) - 3.34960624308583e+16*pow(xi2, 10) + 3.28660520194006e+15*pow(xi2, 8) - 213940261915380.0*pow(xi2, 6) + 8436814611225.0*pow(xi2, 4) - 167877384675.0*pow(xi2, 2) + 900951975.0);
case 29:
return -128115935.990074*pow(xi1, 39) + 1248008066.49091*pow(xi1, 37) - 5611032814.52263*pow(xi1, 35) + 15442659831.8453*pow(xi1, 33) - 29094919819.8133*pow(xi1, 31) + 39756978325.8846*pow(xi1, 29) - 40725769961.2447*pow(xi1, 27) + 31880588934.2862*pow(xi1, 25) - 19266224339.3282*pow(xi1, 23) + 9018966525.34359*pow(xi1, 21) - 3262752368.84387*pow(xi1, 19) + 904978203.88722*pow(xi1, 17) - 189776731.449743*pow(xi1, 15) + 29452783.6369724*pow(xi1, 13) - 3278994.90893944*pow(xi1, 11) + 250145.992870219*pow(xi1, 9) - 12181.2751102983*pow(xi1, 7) + 333.784795976244*pow(xi1, 5) - 3.77584610832855*pow(xi1, 3) + 4.65661287307739e-10*pow(xi2, 3)*(2.75126877586899e+17*pow(xi2, 36) - 2.68007691536133e+18*pow(xi2, 34) + 1.20496012175788e+19*pow(xi2, 32) - 3.31628594705142e+19*pow(xi2, 30) + 6.24808645529203e+19*pow(xi2, 28) - 8.53774608487275e+19*pow(xi2, 26) + 8.74579250439826e+19*pow(xi2, 24) - 6.84630434249894e+19*pow(xi2, 22) + 4.13739017274069e+19*pow(xi2, 20) - 1.93680831350347e+19*pow(xi2, 18) + 7.00670735956548e+18*pow(xi2, 16) - 1.94342589464422e+18*pow(xi2, 14) + 4.0754242755921e+17*pow(xi2, 12) - 6.32493712484802e+16*pow(xi2, 10) + 7.0415879488227e+15*pow(xi2, 8) - 537184429301520.0*pow(xi2, 6) + 26159089111155.0*pow(xi2, 4) - 716797391310.0*pow(xi2, 2) + 8108567775.0);
default:
return 0.;
}
case 14:
switch(j) {
case 0:
return 0.000244140625*y1t*(-289731.0*pow(xi1, 14) + 969969.0*pow(xi1, 12) - 1247103.0*pow(xi1, 10) + 765765.0*pow(xi1, 8) - 225225.0*pow(xi1, 6) + 27027.0*pow(xi1, 4) - 693.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-96577.0*pow(xi2, 12) + 323323.0*pow(xi2, 10) - 415701.0*pow(xi2, 8) + 255255.0*pow(xi2, 6) - 75075.0*pow(xi2, 4) + 9009.0*pow(xi2, 2) - 231.0));
case 1:
return 0.0001220703125*y1r*(xi1*(xi1*(xi1*(xi1*(xi1*(xi1*(-17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(39.0*xi1 - 14.0) - 3003.0) + 1092.0) + 3861.0) - 1430.0) - 45045.0) + 17160.0) - 225225.0) + 90090.0) + 27027.0) - 12012.0) - 693.0) + 462.0) + xi2*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(39.0*xi2 - 14.0) - 3003.0) + 1092.0) + 3861.0) - 1430.0) - 45045.0) + 17160.0) + 225225.0) - 90090.0) - 27027.0) + 12012.0) + 693.0) - 462.0));
case 2:
return 0.000244140625*y2t*(289731.0*pow(xi1, 14) - 969969.0*pow(xi1, 12) + 1247103.0*pow(xi1, 10) - 765765.0*pow(xi1, 8) + 225225.0*pow(xi1, 6) - 27027.0*pow(xi1, 4) + 693.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-96577.0*pow(xi2, 12) + 323323.0*pow(xi2, 10) - 415701.0*pow(xi2, 8) + 255255.0*pow(xi2, 6) - 75075.0*pow(xi2, 4) + 9009.0*pow(xi2, 2) - 231.0));
case 3:
return 0.0001220703125*y2r*(-xi1*(xi1*(xi1*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(39.0*xi1 + 14.0) - 3003.0) - 1092.0) + 3861.0) + 1430.0) - 45045.0) - 17160.0) + 225225.0) + 90090.0) - 27027.0) - 12012.0) + 693.0) + 462.0) + xi2*(xi2*(xi2*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(39.0*xi2 + 14.0) - 3003.0) - 1092.0) + 3861.0) + 1430.0) - 45045.0) - 17160.0) + 225225.0) + 90090.0) - 27027.0) - 12012.0) + 693.0) + 462.0));
case 4:
return -66.01943359375*pow(xi1, 15) + 243.98486328125*pow(xi1, 13) - 362.90185546875*pow(xi1, 11) + 278.94775390625*pow(xi1, 9) - 118.35205078125*pow(xi1, 7) + 27.27333984375*pow(xi1, 5) - 3.04541015625*pow(xi1, 3) + 0.11279296875*xi1 + 66.01943359375*pow(xi2, 15) - 243.98486328125*pow(xi2, 13) + 362.90185546875*pow(xi2, 11) - 278.94775390625*pow(xi2, 9) + 118.35205078125*pow(xi2, 7) - 27.27333984375*pow(xi2, 5) + 3.04541015625*pow(xi2, 3) - 0.11279296875*xi2;
case 5:
return -103.155364990234*pow(xi1, 16) + 409.033447265625*pow(xi1, 14) - 659.681762695313*pow(xi1, 12) + 553.740966796875*pow(xi1, 10) - 255.687561035156*pow(xi1, 8) + 62.318115234375*pow(xi1, 6) - 6.7393798828125*pow(xi1, 4) + 0.169189453125*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(3380195.0*pow(xi2, 14) - 13403208.0*pow(xi2, 12) + 21616452.0*pow(xi2, 10) - 18144984.0*pow(xi2, 8) + 8378370.0*pow(xi2, 6) - 2042040.0*pow(xi2, 4) + 220836.0*pow(xi2, 2) - 5544.0);
case 6:
return -169.902954101563*pow(xi1, 17) + 717.6025390625*pow(xi1, 15) - 1248.62841796875*pow(xi1, 13) + 1153.1279296875*pow(xi1, 11) - 606.947021484375*pow(xi1, 9) + 182.2412109375*pow(xi1, 7) - 29.89013671875*pow(xi1, 5) + 2.4814453125*pow(xi1, 3) - 0.0845947265625*xi1 + 169.902954101563*pow(xi2, 17) - 717.6025390625*pow(xi2, 15) + 1248.62841796875*pow(xi2, 13) - 1153.1279296875*pow(xi2, 11) + 606.947021484375*pow(xi2, 9) - 182.2412109375*pow(xi2, 7) + 29.89013671875*pow(xi2, 5) - 2.4814453125*pow(xi2, 3) + 0.0845947265625*xi2;
case 7:
return -288.835021972656*pow(xi1, 18) + 1293.47857666016*pow(xi1, 16) - 2414.21997070313*pow(xi1, 14) + 2430.40649414063*pow(xi1, 12) - 1426.24694824219*pow(xi1, 10) + 491.579956054688*pow(xi1, 8) - 94.689697265625*pow(xi1, 6) + 8.741455078125*pow(xi1, 4) - 0.21148681640625*pow(xi1, 2) + 6.103515625e-5*pow(xi2, 2)*(4732273.0*pow(xi2, 16) - 21192353.0*pow(xi2, 14) + 39554580.0*pow(xi2, 12) - 39819780.0*pow(xi2, 10) + 23367630.0*pow(xi2, 8) - 8054046.0*pow(xi2, 6) + 1551396.0*pow(xi2, 4) - 143220.0*pow(xi2, 2) + 3465.0);
case 8:
return -501.660827636719*pow(xi1, 19) + 2373.47039794922*pow(xi1, 17) - 4729.00073242188*pow(xi1, 15) + 5153.51928710938*pow(xi1, 13) - 3338.01818847656*pow(xi1, 11) + 1306.88244628906*pow(xi1, 9) - 300.665771484375*pow(xi1, 7) + 37.729248046875*pow(xi1, 5) - 2.32635498046875*pow(xi1, 3) + 0.07049560546875*xi1 + 501.660827636719*pow(xi2, 19) - 2373.47039794922*pow(xi2, 17) + 4729.00073242188*pow(xi2, 15) - 5153.51928710938*pow(xi2, 13) + 3338.01818847656*pow(xi2, 11) - 1306.88244628906*pow(xi2, 9) + 300.665771484375*pow(xi2, 7) - 37.729248046875*pow(xi2, 5) + 2.32635498046875*pow(xi2, 3) - 0.07049560546875*xi2;
case 9:
return -885.073031616211*pow(xi1, 20) + 4410.56460571289*pow(xi1, 18) - 9342.22398376465*pow(xi1, 16) + 10956.5228271484*pow(xi1, 14) - 7765.78414916992*pow(xi1, 12) + 3406.85804443359*pow(xi1, 10) - 909.936126708984*pow(xi1, 8) + 139.553100585938*pow(xi1, 6) - 10.7329559326172*pow(xi1, 4) + 0.246734619140625*pow(xi1, 2) + 3.0517578125e-6*pow(xi2, 2)*(290020731.0*pow(xi2, 18) - 1445253810.0*pow(xi2, 16) + 3061259955.0*pow(xi2, 14) - 3590233400.0*pow(xi2, 12) + 2544692150.0*pow(xi2, 10) - 1116359244.0*pow(xi2, 8) + 298167870.0*pow(xi2, 6) - 45728760.0*pow(xi2, 4) + 3516975.0*pow(xi2, 2) - 80850.0);
case 10:
return -1580.48755645752*pow(xi1, 21) + 8273.50877380371*pow(xi1, 19) - 18563.0642166138*pow(xi1, 17) + 23311.7905883789*pow(xi1, 15) - 17950.1096343994*pow(xi1, 13) + 8727.91030883789*pow(xi1, 11) - 2660.08235168457*pow(xi1, 9) + 487.364318847656*pow(xi1, 7) - 49.1125259399414*pow(xi1, 5) + 2.34397888183594*pow(xi1, 3) - 0.0616836547851563*xi1 + 1580.48755645752*pow(xi2, 21) - 8273.50877380371*pow(xi2, 19) + 18563.0642166138*pow(xi2, 17) - 23311.7905883789*pow(xi2, 15) + 17950.1096343994*pow(xi2, 13) - 8727.91030883789*pow(xi2, 11) + 2660.08235168457*pow(xi2, 9) - 487.364318847656*pow(xi2, 7) + 49.1125259399414*pow(xi2, 5) - 2.34397888183594*pow(xi2, 3) + 0.0616836547851563*xi2;
case 11:
return -2849.66695785522*pow(xi1, 22) + 15633.0834388733*pow(xi1, 20) - 37036.0917396545*pow(xi1, 18) + 49585.4949302673*pow(xi1, 16) - 41223.053855896*pow(xi1, 14) + 22015.1343154907*pow(xi1, 12) - 7550.45825958252*pow(xi1, 10) + 1614.33702850342*pow(xi1, 8) - 201.353954315186*pow(xi1, 6) + 12.8610420227051*pow(xi1, 4) - 0.277576446533203*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(747023095.0*pow(xi2, 20) - 4098119025.0*pow(xi2, 18) + 9708789233.0*pow(xi2, 16) - 12998539983.0*pow(xi2, 14) + 10806376230.0*pow(xi2, 12) - 5771135370.0*pow(xi2, 10) + 1979307330.0*pow(xi2, 8) - 423188766.0*pow(xi2, 6) + 52783731.0*pow(xi2, 4) - 3371445.0*pow(xi2, 2) + 72765.0);
case 12:
return -5178.95994949341*pow(xi1, 23) + 29710.8754997253*pow(xi1, 21) - 74111.1230278015*pow(xi1, 19) + 105377.289905548*pow(xi1, 17) - 94082.8270339966*pow(xi1, 15) + 54766.2573165894*pow(xi1, 13) - 20896.8199081421*pow(xi1, 11) + 5120.50998687744*pow(xi1, 9) - 766.547183990479*pow(xi1, 7) + 63.750057220459*pow(xi1, 5) - 2.46117782592773*pow(xi1, 3) + 0.0555152893066406*xi1 + 5178.95994949341*pow(xi2, 23) - 29710.8754997253*pow(xi2, 21) + 74111.1230278015*pow(xi2, 19) - 105377.289905548*pow(xi2, 17) + 94082.8270339966*pow(xi2, 15) - 54766.2573165894*pow(xi2, 13) + 20896.8199081421*pow(xi2, 11) - 5120.50998687744*pow(xi2, 9) + 766.547183990479*pow(xi2, 7) - 63.750057220459*pow(xi2, 5) + 2.46117782592773*pow(xi2, 3) - 0.0555152893066406*xi2;
case 13:
return -9475.14263486862*pow(xi1, 24) + 56733.152173996*pow(xi1, 22) - 148622.521708488*pow(xi1, 20) + 223667.621259689*pow(xi1, 18) - 213464.600594044*pow(xi1, 16) + 134561.141475677*pow(xi1, 14) - 56583.1933078766*pow(xi1, 12) + 15662.0201225281*pow(xi1, 10) - 2748.06134462357*pow(xi1, 8) + 284.469594955444*pow(xi1, 6) - 15.2158155441284*pow(xi1, 4) + 0.305334091186523*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(19870814327.0*pow(xi2, 22) - 118978043548.0*pow(xi2, 20) + 311684018646.0*pow(xi2, 18) - 469064999260.0*pow(xi2, 16) + 447667714065.0*pow(xi2, 14) - 282195166968.0*pow(xi2, 12) + 118663557012.0*pow(xi2, 10) - 32845636824.0*pow(xi2, 8) + 5763102345.0*pow(xi2, 6) - 596575980.0*pow(xi2, 4) + 31909878.0*pow(xi2, 2) - 640332.0);
case 14:
return -17434.2624481583*pow(xi1, 25) + 108758.158939362*pow(xi1, 23) - 298530.048517227*pow(xi1, 21) + 474068.508396149*pow(xi1, 19) - 481669.246230125*pow(xi1, 17) + 326957.522309876*pow(xi1, 15) - 150311.129161835*pow(xi1, 13) + 46445.3017959595*pow(xi1, 11) - 9375.68311214447*pow(xi1, 9) + 1170.0111579895*pow(xi1, 7) - 81.768469619751*pow(xi1, 5) + 2.6462287902832*pow(xi1, 3) - 0.0508890151977539*xi1 + 17434.2624481583*pow(xi2, 25) - 108758.158939362*pow(xi2, 23) + 298530.048517227*pow(xi2, 21) - 474068.508396149*pow(xi2, 19) + 481669.246230125*pow(xi2, 17) - 326957.522309876*pow(xi2, 15) + 150311.129161835*pow(xi2, 13) - 46445.3017959595*pow(xi2, 11) + 9375.68311214447*pow(xi2, 9) - 1170.0111579895*pow(xi2, 7) + 81.768469619751*pow(xi2, 5) - 2.6462287902832*pow(xi2, 3) + 0.0508890151977539*xi2;
case 15:
return -32237.9113316536*pow(xi1, 26) + 209181.995092869*pow(xi1, 24) - 600370.026732445*pow(xi1, 22) + 1003276.71807003*pow(xi1, 20) - 1081289.04205084*pow(xi1, 18) + 786510.933558941*pow(xi1, 16) - 392623.01508522*pow(xi1, 14) + 134105.370706558*pow(xi1, 12) - 30684.3931918144*pow(xi1, 10) + 4505.44078588486*pow(xi1, 8) - 393.626532554626*pow(xi1, 6) + 17.8620443344116*pow(xi1, 4) - 0.3307785987854*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(67607800225.0*pow(xi2, 24) - 438686439373.0*pow(xi2, 22) + 1259067202302.0*pow(xi2, 20) - 2104023775854.0*pow(xi2, 18) + 2267627477115.0*pow(xi2, 16) - 1649432977335.0*pow(xi2, 14) + 823390141332.0*pow(xi2, 12) - 281239346388.0*pow(xi2, 10) + 64349836551.0*pow(xi2, 8) - 9448594155.0*pow(xi2, 6) + 825494670.0*pow(xi2, 4) - 37459422.0*pow(xi2, 2) + 693693.0);
case 16:
return -59870.4067587852*pow(xi1, 27) + 403474.480330944*pow(xi1, 25) - 1208504.61304951*pow(xi1, 23) + 2119959.62926197*pow(xi1, 21) - 2415794.7218442*pow(xi1, 19) + 1874880.78451395*pow(xi1, 17) - 1010324.84072685*pow(xi1, 15) + 378311.653501511*pow(xi1, 13) - 96925.0929780006*pow(xi1, 11) + 16429.6042370796*pow(xi1, 9) - 1737.12769031525*pow(xi1, 7) + 103.48644733429*pow(xi1, 5) - 2.88249921798706*pow(xi1, 3) + 0.0472540855407715*xi1 + 59870.4067587852*pow(xi2, 27) - 403474.480330944*pow(xi2, 25) + 1208504.61304951*pow(xi2, 23) - 2119959.62926197*pow(xi2, 21) + 2415794.7218442*pow(xi2, 19) - 1874880.78451395*pow(xi2, 17) + 1010324.84072685*pow(xi2, 15) - 378311.653501511*pow(xi2, 13) + 96925.0929780006*pow(xi2, 11) - 16429.6042370796*pow(xi2, 9) + 1737.12769031525*pow(xi2, 7) - 103.48644733429*pow(xi2, 5) + 2.88249921798706*pow(xi2, 3) - 0.0472540855407715*xi2;
case 17:
return -111615.544028878*pow(xi1, 28) + 780137.430678606*pow(xi1, 26) - 2434327.0201534*pow(xi1, 24) + 4472634.49228525*pow(xi1, 22) - 5373401.24265254*pow(xi1, 20) + 4432596.53837848*pow(xi1, 18) - 2565290.6451391*pow(xi1, 16) + 1045607.6396513*pow(xi1, 14) - 296937.816326022*pow(xi1, 12) + 57226.2783515453*pow(xi1, 10) - 7143.71907627583*pow(xi1, 8) + 534.11292886734*pow(xi1, 6) - 20.8508652448654*pow(xi1, 4) + 0.354405641555786*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(936299045565.0*pow(xi2, 26) - 6544267092090.0*pow(xi2, 24) + 20420615115875.0*pow(xi2, 22) - 37519177483060.0*pow(xi2, 20) + 45075356651325.0*pow(xi2, 18) - 37183314782614.0*pow(xi2, 16) + 21519217628139.0*pow(xi2, 14) - 8771192610840.0*pow(xi2, 12) + 2490894941535.0*pow(xi2, 10) - 480048816390.0*pow(xi2, 8) + 59925858993.0*pow(xi2, 6) - 4480463988.0*pow(xi2, 4) + 174909735.0*pow(xi2, 2) - 2972970.0);
case 18:
return -208798.043571264*pow(xi1, 29) + 1511662.69413024*pow(xi1, 27) - 4906105.58279559*pow(xi1, 25) + 9421931.56315386*pow(xi1, 23) - 11902666.8263753*pow(xi1, 21) + 10400955.1452*pow(xi1, 19) - 6435583.67661783*pow(xi1, 17) + 2837986.68655086*pow(xi1, 15) - 885729.038971514*pow(xi1, 13) + 191663.560399711*pow(xi1, 11) - 27705.8257147372*pow(xi1, 9) + 2515.56618082523*pow(xi1, 7) - 129.337385505438*pow(xi1, 5) + 3.16011697053909*pow(xi1, 3) - 0.0443007051944733*xi1 + 208798.043571264*pow(xi2, 29) - 1511662.69413024*pow(xi2, 27) + 4906105.58279559*pow(xi2, 25) - 9421931.56315386*pow(xi2, 23) + 11902666.8263753*pow(xi2, 21) - 10400955.1452*pow(xi2, 19) + 6435583.67661783*pow(xi2, 17) - 2837986.68655086*pow(xi2, 15) + 885729.038971514*pow(xi2, 13) - 191663.560399711*pow(xi2, 11) + 27705.8257147372*pow(xi2, 9) - 2515.56618082523*pow(xi2, 7) + 129.337385505438*pow(xi2, 5) - 3.16011697053909*pow(xi2, 3) + 0.0443007051944733*xi2;
case 19:
return -391803.387642547*pow(xi1, 30) + 2934653.8323424*pow(xi1, 28) - 9891570.76237254*pow(xi1, 26) + 19818695.1768938*pow(xi1, 24) - 26264479.8180815*pow(xi1, 22) + 24237903.7461447*pow(xi1, 20) - 15970425.639332*pow(xi1, 18) + 7579109.61396427*pow(xi1, 16) - 2580646.50840618*pow(xi1, 14) + 620519.280194566*pow(xi1, 12) - 102263.733961907*pow(xi1, 10) + 10996.2634524554*pow(xi1, 8) - 711.916762545705*pow(xi1, 6) + 24.2251022905111*pow(xi1, 4) - 0.376555994153023*pow(xi1, 2) + 2.98023223876953e-9*pow(xi2, 2)*(131467401280215.0*pow(xi2, 28) - 984706424608725.0*pow(xi2, 26) + 3.31906038519218e+15*pow(xi2, 24) - 6.65005059641813e+15*pow(xi2, 22) + 8.81289702071188e+15*pow(xi2, 20) - 8.13289093072556e+15*pow(xi2, 18) + 5.35878561126024e+15*pow(xi2, 16) - 2.54312718162311e+15*pow(xi2, 14) + 865921277823525.0*pow(xi2, 12) - 208211719919775.0*pow(xi2, 10) + 34314015072909.0*pow(xi2, 8) - 3689733742695.0*pow(xi2, 6) + 238879625985.0*pow(xi2, 4) - 8128595475.0*pow(xi2, 2) + 126351225.0);
case 20:
return -737264.439112321*pow(xi1, 31) + 5706701.51566319*pow(xi1, 29) - 19948935.3299687*pow(xi1, 27) + 41628441.8250643*pow(xi1, 25) - 57747885.7514877*pow(xi1, 23) + 56126414.4955482*pow(xi1, 21) - 39242329.4288853*pow(xi1, 19) + 19948317.2103351*pow(xi1, 17) - 7363716.27477591*pow(xi1, 15) + 1950274.42433514*pow(xi1, 13) - 361784.81152229*pow(xi1, 11) + 45172.5006237179*pow(xi1, 9) - 3562.3404416889*pow(xi1, 7) + 159.835467651486*pow(xi1, 5) - 3.47268305718899*pow(xi1, 3) + 0.0418395549058914*xi1 + 737264.439112321*pow(xi2, 31) - 5706701.51566319*pow(xi2, 29) + 19948935.3299687*pow(xi2, 27) - 41628441.8250643*pow(xi2, 25) + 57747885.7514877*pow(xi2, 23) - 56126414.4955482*pow(xi2, 21) + 39242329.4288853*pow(xi2, 19) - 19948317.2103351*pow(xi2, 17) + 7363716.27477591*pow(xi2, 15) - 1950274.42433514*pow(xi2, 13) + 361784.81152229*pow(xi2, 11) - 45172.5006237179*pow(xi2, 9) + 3562.3404416889*pow(xi2, 7) - 159.835467651486*pow(xi2, 5) + 3.47268305718899*pow(xi2, 3) - 0.0418395549058914*xi2;
case 21:
return -1390859.06523328*pow(xi1, 32) + 11113797.4660238*pow(xi1, 30) - 40240699.1092844*pow(xi1, 28) + 87318955.0707993*pow(xi1, 26) - 126546331.339768*pow(xi1, 24) + 129212818.351678*pow(xi1, 22) - 95560534.0450485*pow(xi1, 20) + 51818448.6328783*pow(xi1, 18) - 20623835.859613*pow(xi1, 16) + 5971447.06099082*pow(xi1, 14) - 1233677.99478771*pow(xi1, 12) + 176052.183267586*pow(xi1, 10) - 16487.5533654671*pow(xi1, 8) + 933.829577811062*pow(xi1, 6) - 28.0220418982208*pow(xi1, 4) + 0.397475771605968*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.98684709926103e+15*pow(xi2, 30) - 2.386669832547e+16*pow(xi2, 28) + 8.64162433212764e+16*pow(xi2, 26) - 1.87516028174988e+17*pow(xi2, 24) + 2.71756177266541e+17*pow(xi2, 22) - 2.77482414522222e+17*pow(xi2, 20) + 2.05214684255889e+17*pow(xi2, 18) - 1.11279271103834e+17*pow(xi2, 16) + 4.42893502675548e+16*pow(xi2, 14) - 1.28235849183754e+16*pow(xi2, 12) + 2.64930332070404e+15*pow(xi2, 10) - 378069184761840.0*pow(xi2, 8) + 35406751247868.0*pow(xi2, 6) - 2005383748368.0*pow(xi2, 4) + 60176876760.0*pow(xi2, 2) - 853572720.0);
case 22:
return -2629988.05062292*pow(xi1, 33) + 21673212.5643307*pow(xi1, 31) - 81184889.5904638*pow(xi1, 29) + 182917081.974193*pow(xi1, 27) - 276441752.001857*pow(xi1, 25) + 295870487.432912*pow(xi1, 23) - 230789656.99729*pow(xi1, 21) + 133007978.589758*pow(xi1, 19) - 56801705.9862845*pow(xi1, 17) + 17863564.1120404*pow(xi1, 15) - 4073381.09373626*pow(xi1, 13) + 655788.077647805*pow(xi1, 11) - 71492.3014260083*pow(xi1, 9) + 4945.05285680294*pow(xi1, 7) - 195.558079630136*pow(xi1, 5) + 3.8157674074173*pow(xi1, 3) - 0.0397475771605968*xi1 + 2629988.05062292*pow(xi2, 33) - 21673212.5643307*pow(xi2, 31) + 81184889.5904638*pow(xi2, 29) - 182917081.974193*pow(xi2, 27) + 276441752.001857*pow(xi2, 25) - 295870487.432912*pow(xi2, 23) + 230789656.99729*pow(xi2, 21) - 133007978.589758*pow(xi2, 19) + 56801705.9862845*pow(xi2, 17) - 17863564.1120404*pow(xi2, 15) + 4073381.09373626*pow(xi2, 13) - 655788.077647805*pow(xi2, 11) + 71492.3014260083*pow(xi2, 9) - 4945.05285680294*pow(xi2, 7) + 195.558079630136*pow(xi2, 5) - 3.8157674074173*pow(xi2, 3) + 0.0397475771605968*xi2;
case 23:
return -4983716.85223083*pow(xi1, 34) + 42316671.0878179*pow(xi1, 32) - 163804940.004247*pow(xi1, 30) + 382693879.671142*pow(xi1, 28) - 602122074.063587*pow(xi1, 26) + 674103390.262549*pow(xi1, 24) - 553167824.13291*pow(xi1, 22) + 337708164.141526*pow(xi1, 20) - 154088440.688562*pow(xi1, 18) + 52338450.6070863*pow(xi1, 16) - 13071827.5511526*pow(xi1, 14) + 2348583.8959056*pow(xi1, 12) - 293290.932760544*pow(xi1, 10) + 24150.230407007*pow(xi1, 8) - 1207.53139413893*pow(xi1, 6) + 32.2750326544046*pow(xi1, 4) - 0.417349560186267*pow(xi1, 2) + 1.86264514923096e-9*pow(xi2, 2)*(2.67561261160694e+15*pow(xi2, 32) - 2.27185897997208e+16*pow(xi2, 30) + 8.79421075301855e+16*pow(xi2, 28) - 2.05457212195864e+17*pow(xi2, 26) + 3.2326182703785e+17*pow(xi2, 24) - 3.61906501912546e+17*pow(xi2, 22) + 2.96979714231291e+17*pow(xi2, 20) - 1.81305690072507e+17*pow(xi2, 18) + 8.27256016811262e+16*pow(xi2, 16) - 2.80989917100934e+16*pow(xi2, 14) + 7.01788397889401e+15*pow(xi2, 12) - 1.26088637810335e+15*pow(xi2, 10) + 157459370552484.0*pow(xi2, 8) - 12965556223620.0*pow(xi2, 6) + 648288480840.0*pow(xi2, 4) - 17327526216.0*pow(xi2, 2) + 224062839.0);
case 24:
return -9462589.65969023*pow(xi1, 35) + 82713940.9585662*pow(xi1, 33) - 330524390.007123*pow(xi1, 31) + 799694402.640513*pow(xi1, 29) - 1307889670.50919*pow(xi1, 27) + 1528739306.45805*pow(xi1, 25) - 1316605152.29215*pow(xi1, 23) + 848933462.981639*pow(xi1, 21) - 412283819.498231*pow(xi1, 19) + 150500168.595666*pow(xi1, 17) - 40897766.306323*pow(xi1, 15) + 8125532.61845206*pow(xi1, 13) - 1147116.31001519*pow(xi1, 11) + 110200.627421848*pow(xi1, 9) - 6743.28486777842*pow(xi1, 7) + 237.135490706563*pow(xi1, 5) - 4.18614255823195*pow(xi1, 3) + 0.0379408691078424*xi1 + 9462589.65969023*pow(xi2, 35) - 82713940.9585662*pow(xi2, 33) + 330524390.007123*pow(xi2, 31) - 799694402.640513*pow(xi2, 29) + 1307889670.50919*pow(xi2, 27) - 1528739306.45805*pow(xi2, 25) + 1316605152.29215*pow(xi2, 23) - 848933462.981639*pow(xi2, 21) + 412283819.498231*pow(xi2, 19) - 150500168.595666*pow(xi2, 17) + 40897766.306323*pow(xi2, 15) - 8125532.61845206*pow(xi2, 13) + 1147116.31001519*pow(xi2, 11) - 110200.627421848*pow(xi2, 9) + 6743.28486777842*pow(xi2, 7) - 237.135490706563*pow(xi2, 5) + 4.18614255823195*pow(xi2, 3) - 0.0379408691078424*xi2;
case 25:
return -17999491.2004977*pow(xi1, 36) + 161838903.489692*pow(xi1, 34) - 666946277.861088*pow(xi1, 32) + 1669148486.73721*pow(xi1, 30) - 2833579781.90386*pow(xi1, 28) + 3451915628.97939*pow(xi1, 26) - 3113429207.75544*pow(xi1, 24) + 2114575789.32407*pow(xi1, 22) - 1089335343.24622*pow(xi1, 20) + 425487080.889746*pow(xi1, 18) - 125079149.104517*pow(xi1, 16) + 27265712.6321411*pow(xi1, 14) - 4303799.71730652*pow(xi1, 12) + 474588.083970297*pow(xi1, 10) - 34644.4308966491*pow(xi1, 8) + 1541.66398141533*pow(xi1, 6) - 37.0144795537926*pow(xi1, 4) + 0.436319994740188*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.86536130253887e+16*pow(xi2, 34) - 3.47546398854365e+17*pow(xi2, 32) + 1.43225622580115e+18*pow(xi2, 30) - 3.5844690813521e+18*pow(xi2, 28) + 6.08506624694195e+18*pow(xi2, 26) - 7.41293236750887e+18*pow(xi2, 24) + 6.68603831286041e+18*pow(xi2, 22) - 4.54101693003013e+18*pow(xi2, 20) + 2.33932983680972e+18*pow(xi2, 18) - 9.13726548645982e+17*pow(xi2, 16) + 2.68605427407705e+17*pow(xi2, 14) - 5.85526720285901e+16*pow(xi2, 12) + 9.24233951718277e+15*pow(xi2, 10) - 1.01917014986186e+15*pow(xi2, 8) + 74398348844820.0*pow(xi2, 6) - 3310698190800.0*pow(xi2, 4) + 79487989581.0*pow(xi2, 2) - 936990054.0);
case 26:
return -34296327.8279754*pow(xi1, 37) + 316947562.443547*pow(xi1, 35) - 1345791771.57908*pow(xi1, 33) + 3480058140.28836*pow(xi1, 31) - 6124119482.10734*pow(xi1, 29) + 7763025283.9491*pow(xi1, 27) - 7318288745.93586*pow(xi1, 25) + 5222745456.02108*pow(xi1, 23) - 2845258105.69757*pow(xi1, 21) + 1184495832.35406*pow(xi1, 19) - 374767367.763486*pow(xi1, 17) + 89029356.3545286*pow(xi1, 15) - 15566914.4021732*pow(xi1, 13) + 1944230.40113592*pow(xi1, 11) - 165915.906914179*pow(xi1, 9) + 9050.10777661577*pow(xi1, 7) - 285.244196561398*pow(xi1, 5) + 4.58135994477198*pow(xi1, 3) - 0.0363599995616823*xi1 + 34296327.8279754*pow(xi2, 37) - 316947562.443547*pow(xi2, 35) + 1345791771.57908*pow(xi2, 33) - 3480058140.28836*pow(xi2, 31) + 6124119482.10734*pow(xi2, 29) - 7763025283.9491*pow(xi2, 27) + 7318288745.93586*pow(xi2, 25) - 5222745456.02108*pow(xi2, 23) + 2845258105.69757*pow(xi2, 21) - 1184495832.35406*pow(xi2, 19) + 374767367.763486*pow(xi2, 17) - 89029356.3545286*pow(xi2, 15) + 15566914.4021732*pow(xi2, 13) - 1944230.40113592*pow(xi2, 11) + 165915.906914179*pow(xi2, 9) - 9050.10777661577*pow(xi2, 7) + 285.244196561398*pow(xi2, 5) - 4.58135994477198*pow(xi2, 3) + 0.0363599995616823*xi2;
case 27:
return -65451834.0548625*pow(xi1, 38) + 621240699.986569*pow(xi1, 36) - 2715536282.22465*pow(xi1, 34) + 7248028820.61917*pow(xi1, 32) - 13205547592.7004*pow(xi1, 30) + 17392354377.2915*pow(xi1, 28) - 17105998563.4686*pow(xi1, 26) + 12798948921.0048*pow(xi1, 24) - 7353212013.68346*pow(xi1, 22) + 3251293169.35963*pow(xi1, 20) - 1102203636.20301*pow(xi1, 18) + 283667425.441783*pow(xi1, 16) - 54506868.3388107*pow(xi1, 14) + 7624781.68265513*pow(xi1, 12) - 748280.220408097*pow(xi1, 10) + 48779.5884976792*pow(xi1, 8) - 1945.89627654233*pow(xi1, 6) + 42.2684994904557*pow(xi1, 4) - 0.454499994521029*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(5.62226973457707e+17*pow(xi2, 36) - 5.33641697877293e+18*pow(xi2, 34) + 2.33262790465126e+19*pow(xi2, 32) - 6.22600934900496e+19*pow(xi2, 30) + 1.1343479007284e+20*pow(xi2, 28) - 1.49399186501819e+20*pow(xi2, 26) + 1.46939408791041e+20*pow(xi2, 24) - 1.0994213407778e+20*pow(xi2, 22) + 6.31636102386496e+19*pow(xi2, 20) - 2.79283956642156e+19*pow(xi2, 18) + 9.46785714204841e+18*pow(xi2, 16) - 2.43668463042595e+18*pow(xi2, 14) + 4.6821043384514e+17*pow(xi2, 12) - 6.54963759322873e+16*pow(xi2, 10) + 6.4276781497929e+15*pow(xi2, 8) - 419013474619740.0*pow(xi2, 6) + 16715121738315.0*pow(xi2, 4) - 363083645925.0*pow(xi2, 2) + 3904125225.0);
case 28:
return -125094333.726157*pow(xi1, 39) + 1218629967.16863*pow(xi1, 37) - 5479196736.83039*pow(xi1, 35) + 15080490963.6401*pow(xi1, 33) - 28413812500.6887*pow(xi1, 31) + 38827942540.1858*pow(xi1, 29) - 39775778008.2976*pow(xi1, 27) + 31138221454.6458*pow(xi1, 25) - 18818365412.316*pow(xi1, 23) + 8809669483.95246*pow(xi1, 21) - 3187162871.2602*pow(xi1, 19) + 884046946.742028*pow(xi1, 17) - 185394647.761177*pow(xi1, 15) + 28774004.6464238*pow(xi1, 13) - 3203798.15636541*pow(xi1, 11) + 244586.1160801*pow(xi1, 9) - 11973.6984699435*pow(xi1, 7) + 340.602295894059*pow(xi1, 5) - 4.99949993973132*pow(xi1, 3) + 0.0349615380400792*xi1 + 125094333.726157*pow(xi2, 39) - 1218629967.16863*pow(xi2, 37) + 5479196736.83039*pow(xi2, 35) - 15080490963.6401*pow(xi2, 33) + 28413812500.6887*pow(xi2, 31) - 38827942540.1858*pow(xi2, 29) + 39775778008.2976*pow(xi2, 27) - 31138221454.6458*pow(xi2, 25) + 18818365412.316*pow(xi2, 23) - 8809669483.95246*pow(xi2, 21) + 3187162871.2602*pow(xi2, 19) - 884046946.742028*pow(xi2, 17) + 185394647.761177*pow(xi2, 15) - 28774004.6464238*pow(xi2, 13) + 3203798.15636541*pow(xi2, 11) - 244586.1160801*pow(xi2, 9) + 11973.6984699435*pow(xi2, 7) - 340.602295894059*pow(xi2, 5) + 4.99949993973132*pow(xi2, 3) - 0.0349615380400792*xi2;
case 29:
return -239416655.381451*pow(xi1, 40) + 2392202512.34296*pow(xi1, 38) - 11054929261.3249*pow(xi1, 36) + 31346745935.6135*pow(xi1, 34) - 61011867959.9384*pow(xi1, 32) + 86393672600.7061*pow(xi1, 30) - 92038058619.7648*pow(xi1, 28) + 75244727145.7414*pow(xi1, 26) - 47725511673.3336*pow(xi1, 24) + 23587877790.3469*pow(xi1, 22) - 9074343443.38154*pow(xi1, 20) + 2700324281.39419*pow(xi1, 18) - 614338874.893327*pow(xi1, 16) + 104935950.467495*pow(xi1, 14) - 13107241.3893501*pow(xi1, 12) + 1152668.27657894*pow(xi1, 10) - 67538.8728697514*pow(xi1, 8) + 2430.98412069463*pow(xi1, 6) - 48.0633744205988*pow(xi1, 4) + 0.471980763541069*pow(xi1, 2) + 2.91038304567337e-12*pow(xi2, 2)*(8.22629363984827e+19*pow(xi2, 38) - 8.21954524473765e+20*pow(xi2, 36) + 3.79844477095871e+21*pow(xi2, 34) - 1.07706598903585e+22*pow(xi2, 32) + 2.09635182044644e+22*pow(xi2, 30) - 2.96846398721091e+22*pow(xi2, 28) + 3.16240361407376e+22*pow(xi2, 26) - 2.58538913829922e+22*pow(xi2, 24) + 1.63983609457467e+22*pow(xi2, 22) - 8.10473309532676e+21*pow(xi2, 20) + 3.11792066575966e+21*pow(xi2, 18) - 9.27824358174619e+20*pow(xi2, 16) + 2.11085230106262e+20*pow(xi2, 14) - 3.60557180346053e+19*pow(xi2, 12) + 4.50361384864291e+18*pow(xi2, 10) - 3.96053804083457e+17*pow(xi2, 8) + 2.32061800147427e+16*pow(xi2, 6) - 835279783638300.0*pow(xi2, 4) + 16514449701750.0*pow(xi2, 2) - 162171355500.0);
default:
return 0.;
}
case 15:
switch(j) {
case 0:
return 0.00048828125*y1t*(-260015.0*pow(xi1, 15) + 936054.0*pow(xi1, 13) - 1322685.0*pow(xi1, 11) + 923780.0*pow(xi1, 9) - 328185.0*pow(xi1, 7) + 54054.0*pow(xi1, 5) - 3003.0*pow(xi1, 3) + pow(xi2, 3)*(260015.0*pow(xi2, 12) - 936054.0*pow(xi2, 10) + 1322685.0*pow(xi2, 8) - 923780.0*pow(xi2, 6) + 328185.0*pow(xi2, 4) - 54054.0*pow(xi2, 2) + 3003.0));
case 1:
return 0.0001220703125*y1r*(pow(xi1, 2)*(xi1*(xi1*(xi1*(-17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(xi1*(5.0*xi1*(14.0*xi1 - 5.0) - 252.0) + 91.0) + 8190.0) - 3003.0) - 5720.0) + 2145.0) + 38610.0) - 15015.0) + 108108.0) - 45045.0) - 6006.0) + 3003.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(xi2*(5.0*xi2*(14.0*xi2 - 5.0) - 252.0) + 91.0) + 8190.0) - 3003.0) - 5720.0) + 2145.0) + 38610.0) - 15015.0) - 108108.0) + 45045.0) + 6006.0) - 3003.0));
case 2:
return 0.00048828125*y2t*(260015.0*pow(xi1, 15) - 936054.0*pow(xi1, 13) + 1322685.0*pow(xi1, 11) - 923780.0*pow(xi1, 9) + 328185.0*pow(xi1, 7) - 54054.0*pow(xi1, 5) + 3003.0*pow(xi1, 3) + pow(xi2, 3)*(-260015.0*pow(xi2, 12) + 936054.0*pow(xi2, 10) - 1322685.0*pow(xi2, 8) + 923780.0*pow(xi2, 6) - 328185.0*pow(xi2, 4) + 54054.0*pow(xi2, 2) - 3003.0));
case 3:
return 0.0001220703125*y2r*(-pow(xi1, 2)*(xi1*(xi1*(xi1*(17.0*xi1*(xi1*(19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(xi1*(5.0*xi1*(14.0*xi1 + 5.0) - 252.0) - 91.0) + 8190.0) + 3003.0) - 5720.0) - 2145.0) + 38610.0) + 15015.0) - 108108.0) - 45045.0) + 6006.0) + 3003.0) + pow(xi2, 2)*(xi2*(xi2*(xi2*(17.0*xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(xi2*(5.0*xi2*(14.0*xi2 + 5.0) - 252.0) - 91.0) + 8190.0) + 3003.0) - 5720.0) - 2145.0) + 38610.0) + 15015.0) - 108108.0) - 45045.0) + 6006.0) + 3003.0));
case 4:
return -119.025421142578*pow(xi1, 16) + 469.753662109375*pow(xi1, 14) - 757.070678710938*pow(xi1, 12) + 642.766845703125*pow(xi1, 10) - 309.364929199219*pow(xi1, 8) + 84.312744140625*pow(xi1, 6) - 12.0970458984375*pow(xi1, 4) + 0.733154296875*pow(xi1, 2) + 3.0517578125e-5*pow(xi2, 2)*(3900225.0*pow(xi2, 14) - 15392888.0*pow(xi2, 12) + 24807692.0*pow(xi2, 10) - 21062184.0*pow(xi2, 8) + 10137270.0*pow(xi2, 6) - 2762760.0*pow(xi2, 4) + 396396.0*pow(xi2, 2) - 24024.0);
case 5:
return -186.70654296875*pow(xi1, 17) + 787.15478515625*pow(xi1, 15) - 1367.86083984375*pow(xi1, 13) + 1260.93017578125*pow(xi1, 11) - 658.79150390625*pow(xi1, 9) + 191.66748046875*pow(xi1, 7) - 27.85986328125*pow(xi1, 5) + 1.46630859375*pow(xi1, 3) + 0.00048828125*pow(xi2, 3)*(382375.0*pow(xi2, 14) - 1612093.0*pow(xi2, 12) + 2801379.0*pow(xi2, 10) - 2582385.0*pow(xi2, 8) + 1349205.0*pow(xi2, 6) - 392535.0*pow(xi2, 4) + 57057.0*pow(xi2, 2) - 3003.0);
case 6:
return -308.584425184462*pow(xi1, 18) + 1380.69488525391*pow(xi1, 16) - 2575.08911132813*pow(xi1, 14) + 2590.54516601563*pow(xi1, 12) - 1519.67175292969*pow(xi1, 10) + 525.514526367188*pow(xi1, 8) - 103.863525390625*pow(xi1, 6) + 10.997314453125*pow(xi1, 4) - 0.54986572265625*pow(xi1, 2) + 6.78168402777778e-6*pow(xi2, 2)*(45502625.0*pow(xi2, 16) - 203591745.0*pow(xi2, 14) + 379712340.0*pow(xi2, 12) - 381991428.0*pow(xi2, 10) + 224084718.0*pow(xi2, 8) - 77490270.0*pow(xi2, 6) + 15315300.0*pow(xi2, 4) - 1621620.0*pow(xi2, 2) + 81081.0);
case 7:
return -526.217651367188*pow(xi1, 19) + 2488.4248046875*pow(xi1, 17) - 4955.87353515625*pow(xi1, 15) + 5398.5791015625*pow(xi1, 13) - 3495.47973632813*pow(xi1, 11) + 1367.8564453125*pow(xi1, 9) - 313.58056640625*pow(xi1, 7) + 38.1240234375*pow(xi1, 5) - 1.8328857421875*pow(xi1, 3) + 0.0001220703125*pow(xi2, 3)*(4310775.0*pow(xi2, 16) - 20385176.0*pow(xi2, 14) + 40598516.0*pow(xi2, 12) - 44225160.0*pow(xi2, 10) + 28634970.0*pow(xi2, 8) - 11205480.0*pow(xi2, 6) + 2568852.0*pow(xi2, 4) - 312312.0*pow(xi2, 2) + 15015.0);
case 8:
return -916.495742797852*pow(xi1, 20) + 4565.8151550293*pow(xi1, 18) - 9668.48670959473*pow(xi1, 16) + 11336.3458251953*pow(xi1, 14) - 8033.13552856445*pow(xi1, 12) + 3523.35626220703*pow(xi1, 10) - 940.964263916016*pow(xi1, 8) + 144.797973632813*pow(xi1, 6) - 11.6846466064453*pow(xi1, 4) + 0.458221435546875*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(60063465.0*pow(xi2, 18) - 299225262.0*pow(xi2, 16) + 633633945.0*pow(xi2, 14) - 742938760.0*pow(xi2, 12) + 526459570.0*pow(xi2, 10) - 230906676.0*pow(xi2, 8) + 61667034.0*pow(xi2, 6) - 9489480.0*pow(xi2, 4) + 765765.0*pow(xi2, 2) - 30030.0);
case 9:
return -1621.01287841797*pow(xi1, 21) + 8484.13201904297*pow(xi1, 19) - 19032.4753417969*pow(xi1, 17) + 23897.5576985677*pow(xi1, 15) - 18398.4429931641*pow(xi1, 13) + 8944.64904785156*pow(xi1, 11) - 2725.78621419271*pow(xi1, 9) + 499.278076171875*pow(xi1, 7) - 50.0377807617188*pow(xi1, 5) + 2.13836669921875*pow(xi1, 3) + 2.03450520833333e-5*pow(xi2, 3)*(79676025.0*pow(xi2, 18) - 417012057.0*pow(xi2, 16) + 935484228.0*pow(xi2, 14) - 1174612756.0*pow(xi2, 12) + 904320270.0*pow(xi2, 10) - 439647390.0*pow(xi2, 8) + 133977844.0*pow(xi2, 6) - 24540516.0*pow(xi2, 4) + 2459457.0*pow(xi2, 2) - 105105.0);
case 10:
return -2901.24464035034*pow(xi1, 22) + 15914.2939338684*pow(xi1, 20) - 37698.4300117493*pow(xi1, 18) + 50467.3515129089*pow(xi1, 16) - 41952.306022644*pow(xi1, 14) + 22402.6091384888*pow(xi1, 12) - 7682.70096588135*pow(xi1, 10) + 1642.471824646*pow(xi1, 8) - 204.882259368896*pow(xi1, 6) + 13.231143951416*pow(xi1, 4) - 0.400943756103516*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(760543875.0*pow(xi2, 20) - 4171836669.0*pow(xi2, 18) + 9882417237.0*pow(xi2, 16) - 13229713395.0*pow(xi2, 14) + 10997545310.0*pow(xi2, 12) - 5872709570.0*pow(xi2, 10) + 2013973962.0*pow(xi2, 8) - 430564134.0*pow(xi2, 6) + 53708655.0*pow(xi2, 4) - 3468465.0*pow(xi2, 2) + 105105.0);
case 11:
return -5241.86229705811*pow(xi1, 23) + 30069.7888946533*pow(xi1, 21) - 75001.7991256714*pow(xi1, 19) + 106637.491882324*pow(xi1, 17) - 95202.6352386475*pow(xi1, 15) + 55415.131072998*pow(xi1, 13) - 21143.3159637451*pow(xi1, 11) + 5180.65155029297*pow(xi1, 9) - 775.516868591309*pow(xi1, 7) + 64.4717559814453*pow(xi1, 5) - 2.40566253662109*pow(xi1, 3) + 7.62939453125e-6*pow(xi2, 3)*(687061375.0*pow(xi2, 20) - 3941307370.0*pow(xi2, 18) + 9830635815.0*pow(xi2, 16) - 13977189336.0*pow(xi2, 14) + 12478399806.0*pow(xi2, 12) - 7263372060.0*pow(xi2, 10) + 2771296710.0*pow(xi2, 8) - 679038360.0*pow(xi2, 6) + 101648547.0*pow(xi2, 4) - 8450442.0*pow(xi2, 2) + 315315.0);
case 12:
return -9544.55759922663*pow(xi1, 24) + 57146.7827625275*pow(xi1, 22) - 149701.111962318*pow(xi1, 20) + 225283.641888301*pow(xi1, 18) - 215000.310380459*pow(xi1, 16) + 135525.19952774*pow(xi1, 14) - 56986.956861496*pow(xi1, 12) + 15773.3450202942*pow(xi1, 10) - 2767.52143621445*pow(xi1, 8) + 286.474313735962*pow(xi1, 6) - 15.3360986709595*pow(xi1, 4) + 0.360849380493164*pow(xi1, 2) + 1.58945719401042e-7*pow(xi2, 2)*(60049164175.0*pow(xi2, 22) - 359536469292.0*pow(xi2, 20) + 941837959062.0*pow(xi2, 18) - 1417362120460.0*pow(xi2, 16) + 1352664992745.0*pow(xi2, 14) - 852650829720.0*pow(xi2, 12) + 358530931668.0*pow(xi2, 10) - 99237306168.0*pow(xi2, 8) + 17411739345.0*pow(xi2, 6) - 1802340540.0*pow(xi2, 4) + 96486390.0*pow(xi2, 2) - 2270268.0);
case 13:
return -17492.571018219*pow(xi1, 25) + 109120.323970795*pow(xi1, 23) - 299520.0116539*pow(xi1, 21) + 475634.251041412*pow(xi1, 19) - 483253.892555237*pow(xi1, 17) + 328029.114830017*pow(xi1, 15) - 150801.959220886*pow(xi1, 13) + 46596.4232254028*pow(xi1, 11) - 9406.08324050903*pow(xi1, 9) + 1173.79148483276*pow(xi1, 7) - 82.0330924987793*pow(xi1, 5) + 2.6462287902832*pow(xi1, 3) + 3.814697265625e-6*pow(xi2, 3)*(4585572537.0*pow(xi2, 22) - 28605238207.0*pow(xi2, 20) + 78517373935.0*pow(xi2, 18) - 124684665105.0*pow(xi2, 16) + 126682108410.0*pow(xi2, 14) - 85990864278.0*pow(xi2, 12) + 39531828798.0*pow(xi2, 10) - 12214972770.0*pow(xi2, 8) + 2465748285.0*pow(xi2, 6) - 307702395.0*pow(xi2, 4) + 21504483.0*pow(xi2, 2) - 693693.0);
case 14:
return -32237.9113316536*pow(xi1, 26) + 209181.995092869*pow(xi1, 24) - 600370.026732445*pow(xi1, 22) + 1003276.71807003*pow(xi1, 20) - 1081289.04205084*pow(xi1, 18) + 786510.933558941*pow(xi1, 16) - 392623.01508522*pow(xi1, 14) + 134105.370706558*pow(xi1, 12) - 30684.3931918144*pow(xi1, 10) + 4505.44078588486*pow(xi1, 8) - 393.626532554626*pow(xi1, 6) + 17.8620443344116*pow(xi1, 4) - 0.3307785987854*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(67607800225.0*pow(xi2, 24) - 438686439373.0*pow(xi2, 22) + 1259067202302.0*pow(xi2, 20) - 2104023775854.0*pow(xi2, 18) + 2267627477115.0*pow(xi2, 16) - 1649432977335.0*pow(xi2, 14) + 823390141332.0*pow(xi2, 12) - 281239346388.0*pow(xi2, 10) + 64349836551.0*pow(xi2, 8) - 9448594155.0*pow(xi2, 6) + 825494670.0*pow(xi2, 4) - 37459422.0*pow(xi2, 2) + 693693.0);
case 15:
return -59699.8357993585*pow(xi1, 27) + 402329.133419037*pow(xi1, 25) - 1205086.03384209*pow(xi1, 23) + 2113983.15740585*pow(xi1, 21) - 2409006.79417133*pow(xi1, 19) + 1869629.71721649*pow(xi1, 17) - 1007504.08179092*pow(xi1, 15) + 377258.679588318*pow(xi1, 13) - 96656.1270189285*pow(xi1, 11) + 16384.1465568542*pow(xi1, 9) - 1732.33477592468*pow(xi1, 7) + 103.202922821045*pow(xi1, 5) - 2.86674785614014*pow(xi1, 3) + 3.53212709780093e-8*pow(xi2, 3)*(1690195005625.0*pow(xi2, 24) - 11390562181908.0*pow(xi2, 22) + 34117855911594.0*pow(xi2, 20) - 59850144088020.0*pow(xi2, 18) + 68202721121535.0*pow(xi2, 16) - 52932118959720.0*pow(xi2, 14) + 28524004201836.0*pow(xi2, 12) - 10680778724616.0*pow(xi2, 10) + 2736484966215.0*pow(xi2, 8) - 463860617220.0*pow(xi2, 6) + 49045086090.0*pow(xi2, 4) - 2921834916.0*pow(xi2, 2) + 81162081.0);
case 16:
return -111023.419126868*pow(xi1, 28) + 776012.579911947*pow(xi1, 26) - 2421497.64727652*pow(xi1, 24) + 4449137.26589155*pow(xi1, 22) - 5345258.68610036*pow(xi1, 20) + 4409451.09540582*pow(xi1, 18) - 2551934.9433285*pow(xi1, 16) + 1040179.51673985*pow(xi1, 14) - 295400.64020741*pow(xi1, 12) + 56930.848058939*pow(xi1, 10) - 7106.93852126598*pow(xi1, 8) + 531.372191905975*pow(xi1, 6) - 20.7327300310135*pow(xi1, 4) + 0.307151556015015*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(931331941875.0*pow(xi2, 26) - 6509665335950.0*pow(xi2, 24) + 20312994535925.0*pow(xi2, 22) - 37322068461756.0*pow(xi2, 20) + 44839279776291.0*pow(xi2, 18) - 36989156734530.0*pow(xi2, 16) + 21407181881085.0*pow(xi2, 14) - 8725658215560.0*pow(xi2, 12) + 2478000173649.0*pow(xi2, 10) - 477570567474.0*pow(xi2, 8) + 59617321335.0*pow(xi2, 6) - 4457473020.0*pow(xi2, 4) + 173918745.0*pow(xi2, 2) - 2576574.0);
case 17:
return -207243.715703487*pow(xi1, 29) + 1500444.50169325*pow(xi1, 27) - 4869806.82453632*pow(xi1, 25) + 9352426.89430714*pow(xi1, 23) - 11815114.5594144*pow(xi1, 21) + 10324664.1370225*pow(xi1, 19) - 6388508.57412529*pow(xi1, 17) + 2817283.29321098*pow(xi1, 15) - 879284.628088474*pow(xi1, 13) + 190272.663624287*pow(xi1, 11) - 27505.2755784988*pow(xi1, 9) + 2497.40542316437*pow(xi1, 7) - 128.389350414276*pow(xi1, 5) + 3.07151556015015*pow(xi1, 3) + 4.76837158203125e-7*pow(xi2, 3)*(434621572875.0*pow(xi2, 26) - 3146660187615.0*pow(xi2, 24) + 10212725121690.0*pow(xi2, 22) - 19613460766250.0*pow(xi2, 20) + 24778091128505.0*pow(xi2, 18) - 21652390044285.0*pow(xi2, 16) + 13397673533244.0*pow(xi2, 14) - 5908271292924.0*pow(xi2, 12) + 1843993516365.0*pow(xi2, 10) - 399030697065.0*pow(xi2, 8) + 57682743690.0*pow(xi2, 6) - 5237438778.0*pow(xi2, 4) + 269251983.0*pow(xi2, 2) - 6441435.0);
case 18:
return -388150.20920299*pow(xi1, 30) + 2907370.2766753*pow(xi1, 28) - 9799868.25764738*pow(xi1, 26) + 19635467.5225535*pow(xi1, 24) - 26022314.9884176*pow(xi1, 22) + 24015014.9454261*pow(xi1, 20) - 15823943.7997347*pow(xi1, 18) + 7509769.99117948*pow(xi1, 16) - 2557095.55194207*pow(xi1, 14) + 614870.278818831*pow(xi1, 12) - 101334.994345263*pow(xi1, 10) + 10896.6374951452*pow(xi1, 8) - 705.456735268235*pow(xi1, 6) + 23.9002304524183*pow(xi1, 4) - 0.287954583764076*pow(xi1, 2) + 4.96705373128255e-9*pow(xi2, 2)*(78144958802925.0*pow(xi2, 28) - 585330949485135.0*pow(xi2, 26) + 1.97297407836113e+15*pow(xi2, 24) - 3.95314175864238e+15*pow(xi2, 22) + 5.23898399256863e+15*pow(xi2, 20) - 4.83486111579171e+15*pow(xi2, 18) + 3.18578067720012e+15*pow(xi2, 16) - 1.51191639902804e+15*pow(xi2, 14) + 514811332890855.0*pow(xi2, 12) - 123789737756685.0*pow(xi2, 10) + 20401429061871.0*pow(xi2, 8) - 2193782891157.0*pow(xi2, 6) + 142027200315.0*pow(xi2, 4) - 4811751945.0*pow(xi2, 2) + 57972915.0);
case 19:
return -729162.632089108*pow(xi1, 31) + 5644160.68911642*pow(xi1, 29) - 19730891.0453005*pow(xi1, 27) + 41174618.8415927*pow(xi1, 25) - 57119932.9378419*pow(xi1, 23) + 55517614.4424215*pow(xi1, 21) - 38817710.5718181*pow(xi1, 19) + 19732985.769913*pow(xi1, 17) - 7284416.2171289*pow(xi1, 15) + 1929320.51155955*pow(xi1, 13) - 357906.614608616*pow(xi1, 11) + 44689.359359622*pow(xi1, 9) - 3524.28437796235*pow(xi1, 7) + 157.952687680721*pow(xi1, 5) - 3.26348528265953*pow(xi1, 3) + 2.98023223876953e-8*pow(xi2, 3)*(24466637955375.0*pow(xi2, 28) - 189386606040030.0*pow(xi2, 26) + 662058841878945.0*pow(xi2, 24) - 1.38159094804614e+15*pow(xi2, 22) + 1.91662690560738e+15*pow(xi2, 20) - 1.86286201861045e+15*pow(xi2, 18) + 1.30250622977775e+15*pow(xi2, 16) - 662129129173512.0*pow(xi2, 14) + 244424448617349.0*pow(xi2, 12) - 64737253911330.0*pow(xi2, 10) + 12009353162235.0*pow(xi2, 8) - 1499526069756.0*pow(xi2, 6) + 118255360509.0*pow(xi2, 4) - 5300012718.0*pow(xi2, 2) + 109504395.0);
case 20:
return -1373509.47190396*pow(xi1, 32) + 10975517.9743457*pow(xi1, 30) - 39741270.4156874*pow(xi1, 28) + 86237891.5732345*pow(xi1, 26) - 124983372.13927*pow(xi1, 24) + 127620687.931434*pow(xi1, 22) - 94385785.032511*pow(xi1, 20) + 51182880.666102*pow(xi1, 18) - 20371444.2763663*pow(xi1, 16) + 5898530.05603891*pow(xi1, 14) - 1218646.21992296*pow(xi1, 12) + 173911.651316531*pow(xi1, 10) - 16287.4470273647*pow(xi1, 8) + 922.206549458206*pow(xi1, 6) - 27.3316892422736*pow(xi1, 4) + 0.271957106888294*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.94958913128688e+15*pow(xi2, 30) - 2.35697453782375e+16*pow(xi2, 28) + 8.53437283684348e+16*pow(xi2, 26) - 1.85194461991518e+17*pow(xi2, 24) + 2.6839974794098e+17*pow(xi2, 22) - 2.74063340479266e+17*pow(xi2, 20) + 2.0269192996096e+17*pow(xi2, 18) - 1.09914399287989e+17*pow(xi2, 16) + 4.37473434696398e+16*pow(xi2, 14) - 1.26669968425801e+16*pow(xi2, 12) + 2.61702282998156e+15*pow(xi2, 10) - 373472427398928.0*pow(xi2, 8) + 34977026158932.0*pow(xi2, 6) - 1980423485040.0*pow(xi2, 4) + 58694355720.0*pow(xi2, 2) - 584023440.0);
case 21:
return -2593676.57852359*pow(xi1, 33) + 21374698.9817139*pow(xi1, 31) - 80069343.0678237*pow(xi1, 29) + 180409482.926837*pow(xi1, 27) - 272660658.817659*pow(xi1, 25) + 291832705.291657*pow(xi1, 23) - 227646965.371663*pow(xi1, 21) + 131200707.86478*pow(xi1, 19) - 56031543.8303474*pow(xi1, 17) + 17621862.9742209*pow(xi1, 15) - 4018380.24838351*pow(xi1, 13) + 646951.29511781*pow(xi1, 11) - 70530.7633705189*pow(xi1, 9) + 4878.1179368645*pow(xi1, 7) - 192.219283148646*pow(xi1, 5) + 3.44479002058506*pow(xi1, 3) + 4.96705373128255e-9*pow(xi2, 3)*(522176066304375.0*pow(xi2, 30) - 4.30329530101433e+15*pow(xi2, 28) + 1.61200879635238e+16*pow(xi2, 26) - 3.63212263621424e+16*pow(xi2, 24) + 5.48938412122341e+16*pow(xi2, 22) - 5.87536839905096e+16*pow(xi2, 20) + 4.58313877174189e+16*pow(xi2, 18) - 2.64141913824038e+16*pow(xi2, 16) + 1.12806397638625e+16*pow(xi2, 14) - 3.54774961729088e+15*pow(xi2, 12) + 809006800767165.0*pow(xi2, 10) - 130248499436055.0*pow(xi2, 8) + 14199718220545.0*pow(xi2, 6) - 982094859603.0*pow(xi2, 4) + 38698853193.0*pow(xi2, 2) - 693527835.0);
case 22:
return -4908914.34788215*pow(xi1, 34) + 41682976.2934526*pow(xi1, 32) - 161357453.758476*pow(xi1, 30) + 376988466.755545*pow(xi1, 28) - 593164732.277684*pow(xi1, 26) + 664096571.54609*pow(xi1, 24) - 544973436.806207*pow(xi1, 22) + 332715807.100391*pow(xi1, 20) - 151815163.18702*pow(xi1, 18) + 51567840.3122956*pow(xi1, 16) - 12879742.0744171*pow(xi1, 14) + 2314139.34894989*pow(xi1, 12) - 288997.558465965*pow(xi1, 10) + 23796.3634057716*pow(xi1, 8) - 1188.45255710185*pow(xi1, 6) + 31.0031101852655*pow(xi1, 4) - 0.25835925154388*pow(xi1, 2) + 1.86264514923096e-9*pow(xi2, 2)*(2.63545332287738e+15*pow(xi2, 32) - 2.23783774975403e+16*pow(xi2, 30) + 8.66281233573109e+16*pow(xi2, 28) - 2.02394141960531e+17*pow(xi2, 26) + 3.18452890784156e+17*pow(xi2, 24) - 3.56534132022022e+17*pow(xi2, 22) + 2.92580386033923e+17*pow(xi2, 20) - 1.78625438794803e+17*pow(xi2, 18) + 8.15051451156442e+16*pow(xi2, 16) - 2.76852734583325e+16*pow(xi2, 14) + 6.91475887381708e+15*pow(xi2, 12) - 1.24239410276582e+15*pow(xi2, 10) + 155154382779396.0*pow(xi2, 8) - 12775575323940.0*pow(xi2, 6) + 638045608200.0*pow(xi2, 4) - 16644668040.0*pow(xi2, 2) + 138705567.0);
case 23:
return -9310240.27339825*pow(xi1, 35) + 81385124.7313643*pow(xi1, 33) - 325225778.020873*pow(xi1, 31) + 786901443.045491*pow(xi1, 29) - 1287010097.68695*pow(xi1, 27) + 1504383534.87654*pow(xi1, 25) - 1295670982.26369*pow(xi1, 23) + 835461875.914782*pow(xi1, 21) - 405754033.635682*pow(xi1, 19) + 148121087.247014*pow(xi1, 17) - 40252478.8666085*pow(xi1, 15) + 7997565.65664124*pow(xi1, 13) - 1129083.48007344*pow(xi1, 11) + 108469.548168182*pow(xi1, 9) - 6634.66557964683*pow(xi1, 7) + 231.489889383316*pow(xi1, 5) - 3.61702952161431*pow(xi1, 3) + 3.72529029846191e-9*pow(xi2, 3)*(2.49919859325923e+15*pow(xi2, 32) - 2.18466530688806e+16*pow(xi2, 30) + 8.73021300259878e+16*pow(xi2, 28) - 2.11232247690974e+17*pow(xi2, 26) + 3.45479142449202e+17*pow(xi2, 24) - 4.03829880183475e+17*pow(xi2, 22) + 3.47804030949921e+17*pow(xi2, 20) - 2.242675896318e+17*pow(xi2, 18) + 1.08918769042834e+17*pow(xi2, 16) - 3.9760951598368e+16*pow(xi2, 14) + 1.08051925196884e+16*pow(xi2, 12) - 2.14683018393043e+15*pow(xi2, 10) + 303086038835580.0*pow(xi2, 8) - 29117072624640.0*pow(xi2, 6) + 1780979480280.0*pow(xi2, 4) - 62140094016.0*pow(xi2, 2) + 970938969.0);
case 24:
return -17691807.5902328*pow(xi1, 36) + 159078150.8532*pow(xi1, 34) - 655592218.992931*pow(xi1, 32) + 1640789841.43268*pow(xi1, 30) - 2785532373.16041*pow(xi1, 28) + 3393496929.74806*pow(xi1, 26) - 3060839533.17806*pow(xi1, 24) + 2078925210.23867*pow(xi1, 22) - 1071003828.3239*pow(xi1, 20) + 418340016.31884*pow(xi1, 18) - 122981940.948562*pow(xi1, 16) + 26809361.5972113*pow(xi1, 14) - 4231892.43185647*pow(xi1, 12) + 466669.101904269*pow(xi1, 10) - 34061.4965434279*pow(xi1, 8) + 1511.47991221398*pow(xi1, 6) - 34.8961143619381*pow(xi1, 4) + 0.246615649200976*pow(xi1, 2) + 5.17401430341932e-11*pow(xi2, 2)*(3.41935807532285e+17*pow(xi2, 34) - 3.07455954940192e+18*pow(xi2, 32) + 1.26708621303902e+19*pow(xi2, 30) - 3.17121241885307e+19*pow(xi2, 28) + 5.38369670010296e+19*pow(xi2, 26) - 6.55873124955496e+19*pow(xi2, 24) + 5.91579256198666e+19*pow(xi2, 22) - 4.01801210496226e+19*pow(xi2, 20) + 2.06996688744388e+19*pow(xi2, 18) - 8.08540509913887e+18*pow(xi2, 16) + 2.37691536467705e+18*pow(xi2, 14) - 5.18153990789974e+17*pow(xi2, 12) + 8.17912781775606e+16*pow(xi2, 10) - 9.01947838829638e+15*pow(xi2, 8) + 658318561680780.0*pow(xi2, 6) - 29212905561840.0*pow(xi2, 4) + 674449514739.0*pow(xi2, 2) - 4766427666.0);
case 25:
return -33678881.6641329*pow(xi1, 37) + 311252740.143991*pow(xi1, 35) - 1321657965.61896*pow(xi1, 33) + 3417770359.80975*pow(xi1, 31) - 6014713509.51296*pow(xi1, 29) + 7624598077.02301*pow(xi1, 27) - 7188030678.28592*pow(xi1, 25) + 5129953639.24709*pow(xi1, 23) - 2794796753.96302*pow(xi1, 21) + 1163525398.80544*pow(xi1, 19) - 368143949.138997*pow(xi1, 17) + 87458596.6151419*pow(xi1, 15) - 15292728.0635515*pow(xi1, 13) + 1910036.75112527*pow(xi1, 11) - 162990.86614944*pow(xi1, 9) + 8880.98183579743*pow(xi1, 7) - 276.045116672292*pow(xi1, 5) + 3.78143995441496*pow(xi1, 3) + 1.86264514923096e-9*pow(xi2, 3)*(1.80812119141631e+16*pow(xi2, 34) - 1.67102542463604e+17*pow(xi2, 32) + 7.09559717353916e+17*pow(xi2, 30) - 1.83490149007763e+18*pow(xi2, 28) + 3.22912472727094e+18*pow(xi2, 26) - 4.09342492324479e+18*pow(xi2, 24) + 3.85904458573534e+18*pow(xi2, 22) - 2.7541228888203e+18*pow(xi2, 20) + 1.50044508215477e+18*pow(xi2, 18) - 6.24662941991839e+17*pow(xi2, 16) + 1.97645777721535e+17*pow(xi2, 14) - 4.69539765270113e+16*pow(xi2, 12) + 8.21022086244688e+15*pow(xi2, 10) - 1.02544317253014e+15*pow(xi2, 8) + 87505054957320.0*pow(xi2, 6) - 4767940817640.0*pow(xi2, 4) + 148200593541.0*pow(xi2, 2) - 2030145117.0);
case 26:
return -64218832.4714114*pow(xi1, 38) + 609559692.386086*pow(xi1, 36) - 2664571836.57134*pow(xi1, 34) + 7112249072.16354*pow(xi1, 32) - 12958610422.2982*pow(xi1, 30) + 17067705071.5141*pow(xi1, 28) - 16787255145.7937*pow(xi1, 26) + 12560873795.7298*pow(xi1, 24) - 7216667713.14824*pow(xi1, 22) + 3191020712.83802*pow(xi1, 20) - 1081805051.19921*pow(xi1, 18) + 278426210.632151*pow(xi1, 16) - 53501402.6224166*pow(xi1, 14) + 7484344.83168108*pow(xi1, 12) - 734495.95757998*pow(xi1, 10) + 47860.1999373338*pow(xi1, 8) - 1898.99187710776*pow(xi1, 6) + 38.9960995299043*pow(xi1, 4) - 0.236339997150935*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(5.51635570504029e+17*pow(xi2, 36) - 5.23607788751612e+18*pow(xi2, 34) + 2.28884977918331e+19*pow(xi2, 32) - 6.10937543318975e+19*pow(xi2, 30) + 1.11313615930751e+20*pow(xi2, 28) - 1.46610470199853e+20*pow(xi2, 26) + 1.44201423681584e+20*pow(xi2, 24) - 1.07897084323686e+20*pow(xi2, 22) + 6.19907036281416e+19*pow(xi2, 20) - 2.74106592049958e+19*pow(xi2, 18) + 9.29263463109642e+18*pow(xi2, 16) - 2.39166293802859e+18*pow(xi2, 14) + 4.59573549106816e+17*pow(xi2, 12) - 6.42900325681137e+16*pow(xi2, 10) + 6.30927223370044e+15*pow(xi2, 8) - 411115987021740.0*pow(xi2, 6) + 16312216015095.0*pow(xi2, 4) - 334973944305.0*pow(xi2, 2) + 2030145117.0);
case 27:
return -122641503.653095*pow(xi1, 39) + 1194778534.36411*pow(xi1, 37) - 5372147407.37006*pow(xi1, 35) + 14786375338.0881*pow(xi1, 33) - 27860617378.6798*pow(xi1, 31) + 38073285463.0875*pow(xi1, 29) - 39004003866.1513*pow(xi1, 27) + 30535049585.1998*pow(xi1, 25) - 18454438615.023*pow(xi1, 23) + 8639576881.10214*pow(xi1, 21) - 3125725551.60628*pow(xi1, 19) + 867032659.727804*pow(xi1, 17) - 181832151.94781*pow(xi1, 15) + 28221925.8980201*pow(xi1, 13) - 3142373.53276822*pow(xi1, 11) + 239854.335394284*pow(xi1, 9) - 11716.0489159066*pow(xi1, 7) + 326.149196068291*pow(xi1, 5) - 3.93899995251559*pow(xi1, 3) + 7.76102145512899e-11*pow(xi2, 3)*(1.58022374196693e+18*pow(xi2, 36) - 1.539460419317e+19*pow(xi2, 34) + 6.92195922718368e+19*pow(xi2, 32) - 1.90520995510407e+20*pow(xi2, 30) + 3.58981321463397e+20*pow(xi2, 28) - 4.90570547745699e+20*pow(xi2, 26) + 5.02562763054532e+20*pow(xi2, 24) - 3.93441118050514e+20*pow(xi2, 22) + 2.37783630952689e+20*pow(xi2, 20) - 1.11320100466834e+20*pow(xi2, 18) + 4.02746670612616e+19*pow(xi2, 16) - 1.11716307542844e+19*pow(xi2, 14) + 2.34288943793144e+18*pow(xi2, 12) - 3.63636746286395e+17*pow(xi2, 10) + 4.04891746651665e+16*pow(xi2, 8) - 3.0904995789668e+15*pow(xi2, 6) + 150960140796465.0*pow(xi2, 4) - 4202400392190.0*pow(xi2, 2) + 50753627925.0);
case 28:
return -234551875.736545*pow(xi1, 40) + 2343679134.81065*pow(xi1, 38) - 10831075689.4263*pow(xi1, 36) + 30713072121.1401*pow(xi1, 34) - 59780571314.211*pow(xi1, 32) + 84653008995.6795*pow(xi1, 30) - 90186685266.1405*pow(xi1, 28) + 73733585896.2953*pow(xi1, 26) - 46768558930.8651*pow(xi1, 24) + 23115653989.3216*pow(xi1, 22) - 8892958492.16441*pow(xi1, 20) + 2646430745.77703*pow(xi1, 18) - 602096347.338786*pow(xi1, 16) + 102847878.539102*pow(xi1, 14) - 12846714.7480362*pow(xi1, 12) + 1129681.26669604*pow(xi1, 10) - 66128.2185117568*pow(xi1, 8) + 2359.0822215614*pow(xi1, 6) - 43.291124478128*pow(xi1, 4) + 0.227249997260515*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(1.61182821680627e+19*pow(xi2, 38) - 1.61056403781269e+20*pow(xi2, 36) + 7.44305853865387e+20*pow(xi2, 34) - 2.11058624511978e+21*pow(xi2, 32) + 4.10808957969171e+21*pow(xi2, 30) - 5.817310482311e+21*pow(xi2, 28) + 6.19758182004349e+21*pow(xi2, 26) - 5.06693344066232e+21*pow(xi2, 24) + 3.21391089742583e+21*pow(xi2, 22) - 1.58849564655661e+21*pow(xi2, 20) + 6.11119454216506e+20*pow(xi2, 18) - 1.8186133606786e+20*pow(xi2, 16) + 4.13757459337783e+19*pow(xi2, 14) - 7.06765239661478e+18*pow(xi2, 12) + 8.82819515261702e+17*pow(xi2, 10) - 7.76311055258138e+16*pow(xi2, 8) + 4.5442965736118e+15*pow(xi2, 6) - 162114895842900.0*pow(xi2, 4) + 2974943421450.0*pow(xi2, 2) - 15616500900.0);
case 29:
return -449186970.696906*pow(xi1, 41) + 4600691607.03978*pow(xi1, 39) - 21836906271.7554*pow(xi1, 37) + 63739269950.2658*pow(xi1, 35) - 128029808068.442*pow(xi1, 33) + 187639118172.457*pow(xi1, 31) - 207591696263.244*pow(xi1, 29) + 176935105732.693*pow(xi1, 27) - 117536872874.726*pow(xi1, 25) + 61173279940.9544*pow(xi1, 23) - 24944876505.7779*pow(xi1, 21) + 7931390553.5376*pow(xi1, 19) - 1947290061.31368*pow(xi1, 17) + 363525099.100395*pow(xi1, 15) - 50454477.3027972*pow(xi1, 13) + 5041918.86101217*pow(xi1, 11) - 346355.058153282*pow(xi1, 9) + 15251.3706304313*pow(xi1, 7) - 382.052695394377*pow(xi1, 5) + 4.09049995068926*pow(xi1, 3) + 1.16415321826935e-10*pow(xi2, 3)*(3.85848669786504e+18*pow(xi2, 38) - 3.95196399824351e+19*pow(xi2, 36) + 1.87577596566014e+20*pow(xi2, 34) - 5.47516159814615e+20*pow(xi2, 32) + 1.09976767713423e+21*pow(xi2, 30) - 1.61180775200196e+21*pow(xi2, 28) + 1.7831990927436e+21*pow(xi2, 26) - 1.51986098527244e+21*pow(xi2, 24) + 1.00963405014212e+21*pow(xi2, 22) - 5.25474473470904e+20*pow(xi2, 20) + 2.14274857590149e+20*pow(xi2, 18) - 6.81301260784947e+19*pow(xi2, 16) + 1.67270942583362e+19*pow(xi2, 14) - 3.12265682382271e+18*pow(xi2, 12) + 4.33400659904577e+17*pow(xi2, 10) - 4.33097532342657e+16*pow(xi2, 8) + 2.97516729514505e+15*pow(xi2, 6) - 131008276153755.0*pow(xi2, 4) + 3281807664135.0*pow(xi2, 2) - 35137127025.0);
default:
return 0.;
}
case 16:
switch(j) {
case 0:
return 1.52587890625e-5*y1t*(-15043725.0*pow(xi1, 16) + 57946200.0*pow(xi1, 14) - 89237148.0*pow(xi1, 12) + 69837768.0*pow(xi1, 10) - 29099070.0*pow(xi1, 8) + 6126120.0*pow(xi1, 6) - 540540.0*pow(xi1, 4) + 10296.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-5014575.0*pow(xi2, 14) + 19315400.0*pow(xi2, 12) - 29745716.0*pow(xi2, 10) + 23279256.0*pow(xi2, 8) - 9699690.0*pow(xi2, 6) + 2042040.0*pow(xi2, 4) - 180180.0*pow(xi2, 2) + 3432.0));
case 1:
return 7.62939453125e-6*y1r*(-15043725.0*pow(xi1, 16) + 5348880.0*pow(xi1, 15) + 57946200.0*pow(xi1, 14) - 20801200.0*pow(xi1, 13) - 89237148.0*pow(xi1, 12) + 32449872.0*pow(xi1, 11) + 69837768.0*pow(xi1, 10) - 25865840.0*pow(xi1, 9) - 29099070.0*pow(xi1, 8) + 11085360.0*pow(xi1, 7) + 6126120.0*pow(xi1, 6) - 2450448.0*pow(xi1, 5) - 540540.0*pow(xi1, 4) + 240240.0*pow(xi1, 3) + 10296.0*pow(xi1, 2) - 6864.0*xi1 + xi2*(15043725.0*pow(xi2, 15) - 5348880.0*pow(xi2, 14) - 57946200.0*pow(xi2, 13) + 20801200.0*pow(xi2, 12) + 89237148.0*pow(xi2, 11) - 32449872.0*pow(xi2, 10) - 69837768.0*pow(xi2, 9) + 25865840.0*pow(xi2, 8) + 29099070.0*pow(xi2, 7) - 11085360.0*pow(xi2, 6) - 6126120.0*pow(xi2, 5) + 2450448.0*pow(xi2, 4) + 540540.0*pow(xi2, 3) - 240240.0*pow(xi2, 2) - 10296.0*xi2 + 6864.0));
case 2:
return 1.52587890625e-5*y2t*(15043725.0*pow(xi1, 16) - 57946200.0*pow(xi1, 14) + 89237148.0*pow(xi1, 12) - 69837768.0*pow(xi1, 10) + 29099070.0*pow(xi1, 8) - 6126120.0*pow(xi1, 6) + 540540.0*pow(xi1, 4) - 10296.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-5014575.0*pow(xi2, 14) + 19315400.0*pow(xi2, 12) - 29745716.0*pow(xi2, 10) + 23279256.0*pow(xi2, 8) - 9699690.0*pow(xi2, 6) + 2042040.0*pow(xi2, 4) - 180180.0*pow(xi2, 2) + 3432.0));
case 3:
return 7.62939453125e-6*y2r*(-15043725.0*pow(xi1, 16) - 5348880.0*pow(xi1, 15) + 57946200.0*pow(xi1, 14) + 20801200.0*pow(xi1, 13) - 89237148.0*pow(xi1, 12) - 32449872.0*pow(xi1, 11) + 69837768.0*pow(xi1, 10) + 25865840.0*pow(xi1, 9) - 29099070.0*pow(xi1, 8) - 11085360.0*pow(xi1, 7) + 6126120.0*pow(xi1, 6) + 2450448.0*pow(xi1, 5) - 540540.0*pow(xi1, 4) - 240240.0*pow(xi1, 3) + 10296.0*pow(xi1, 2) + 6864.0*xi1 + xi2*(15043725.0*pow(xi2, 15) + 5348880.0*pow(xi2, 14) - 57946200.0*pow(xi2, 13) - 20801200.0*pow(xi2, 12) + 89237148.0*pow(xi2, 11) + 32449872.0*pow(xi2, 10) - 69837768.0*pow(xi2, 9) - 25865840.0*pow(xi2, 8) + 29099070.0*pow(xi2, 7) + 11085360.0*pow(xi2, 6) - 6126120.0*pow(xi2, 5) - 2450448.0*pow(xi2, 4) + 540540.0*pow(xi2, 3) + 240240.0*pow(xi2, 2) - 10296.0*xi2 - 6864.0));
case 4:
return -216.046142578125*pow(xi1, 17) + 906.8603515625*pow(xi1, 15) - 1574.3095703125*pow(xi1, 13) + 1463.9091796875*pow(xi1, 11) - 789.36279296875*pow(xi1, 9) + 249.2724609375*pow(xi1, 7) - 43.9892578125*pow(xi1, 5) + 3.7705078125*pow(xi1, 3) - 0.104736328125*xi1 + 216.046142578125*pow(xi2, 17) - 906.8603515625*pow(xi2, 15) + 1574.3095703125*pow(xi2, 13) - 1463.9091796875*pow(xi2, 11) + 789.36279296875*pow(xi2, 9) - 249.2724609375*pow(xi2, 7) + 43.9892578125*pow(xi2, 5) - 3.7705078125*pow(xi2, 3) + 0.104736328125*xi2;
case 5:
return -340.072631835938*pow(xi1, 18) + 1518.99108886719*pow(xi1, 16) - 2829.404296875*pow(xi1, 14) + 2841.7060546875*pow(xi1, 12) - 1657.66186523438*pow(xi1, 10) + 560.863037109375*pow(xi1, 8) - 102.6416015625*pow(xi1, 6) + 8.37890625*pow(xi1, 4) - 0.1571044921875*pow(xi1, 2) + 0.0001220703125*pow(xi2, 2)*(2785875.0*pow(xi2, 16) - 12443575.0*pow(xi2, 14) + 23178480.0*pow(xi2, 12) - 23279256.0*pow(xi2, 10) + 13579566.0*pow(xi2, 8) - 4594590.0*pow(xi2, 6) + 840840.0*pow(xi2, 4) - 68640.0*pow(xi2, 2) + 1287.0);
case 6:
return -563.804626464844*pow(xi1, 19) + 2663.90228271484*pow(xi1, 17) - 5301.50561523438*pow(xi1, 15) + 5771.18041992188*pow(xi1, 13) - 3735.12121582031*pow(xi1, 11) + 1464.47570800781*pow(xi1, 9) - 340.916748046875*pow(xi1, 7) + 44.722412109375*pow(xi1, 5) - 3.01116943359375*pow(xi1, 3) + 0.07855224609375*xi1 + 563.804626464844*pow(xi2, 19) - 2663.90228271484*pow(xi2, 17) + 5301.50561523438*pow(xi2, 15) - 5771.18041992188*pow(xi2, 13) + 3735.12121582031*pow(xi2, 11) - 1464.47570800781*pow(xi2, 9) + 340.916748046875*pow(xi2, 7) - 44.722412109375*pow(xi2, 5) + 3.01116943359375*pow(xi2, 3) - 0.07855224609375*xi2;
case 7:
return -964.105911254883*pow(xi1, 20) + 4800.69198608398*pow(xi1, 18) - 10161.4835968018*pow(xi1, 16) + 11909.6392822266*pow(xi1, 14) - 8436.31484985352*pow(xi1, 12) + 3698.58013916016*pow(xi1, 10) - 985.634307861328*pow(xi1, 8) + 149.196899414063*pow(xi1, 6) - 10.7682037353516*pow(xi1, 4) + 0.196380615234375*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(63183645.0*pow(xi2, 18) - 314618150.0*pow(xi2, 16) + 665942989.0*pow(xi2, 14) - 780510120.0*pow(xi2, 12) + 552882330.0*pow(xi2, 10) - 242390148.0*pow(xi2, 8) + 64594530.0*pow(xi2, 6) - 9777768.0*pow(xi2, 4) + 705705.0*pow(xi2, 2) - 12870.0);
case 8:
return -1683.35952758789*pow(xi1, 21) + 8807.88116455078*pow(xi1, 19) - 19753.4588928223*pow(xi1, 17) + 24796.6374511719*pow(xi1, 15) - 19086.1575317383*pow(xi1, 13) + 9276.90124511719*pow(xi1, 11) - 2826.61529541016*pow(xi1, 9) + 518.549560546875*pow(xi1, 7) - 53.0620422363281*pow(xi1, 5) + 2.74932861328125*pow(xi1, 3) - 0.065460205078125*xi1 + 1683.35952758789*pow(xi2, 21) - 8807.88116455078*pow(xi2, 19) + 19753.4588928223*pow(xi2, 17) - 24796.6374511719*pow(xi2, 15) + 19086.1575317383*pow(xi2, 13) - 9276.90124511719*pow(xi2, 11) + 2826.61529541016*pow(xi2, 9) - 518.549560546875*pow(xi2, 7) + 53.0620422363281*pow(xi2, 5) - 2.74932861328125*pow(xi2, 3) + 0.065460205078125*xi2;
case 9:
return -2984.13734436035*pow(xi1, 22) + 16365.9954071045*pow(xi1, 20) - 38761.818649292*pow(xi1, 18) + 51882.5600738525*pow(xi1, 16) - 43122.1461486816*pow(xi1, 14) + 23023.9469909668*pow(xi1, 12) - 7894.69711303711*pow(xi1, 10) + 1687.47244262695*pow(xi1, 8) - 210.002883911133*pow(xi1, 6) + 13.0593109130859*pow(xi1, 4) - 0.229110717773438*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(195568425.0*pow(xi2, 20) - 1072561875.0*pow(xi2, 18) + 2540294547.0*pow(xi2, 16) - 3400175457.0*pow(xi2, 14) + 2826052970.0*pow(xi2, 12) - 1508897390.0*pow(xi2, 10) + 517386870.0*pow(xi2, 8) - 110590194.0*pow(xi2, 6) + 13762749.0*pow(xi2, 4) - 855855.0*pow(xi2, 2) + 15015.0);
case 10:
return -5351.98545455933*pow(xi1, 23) + 30697.9313850403*pow(xi1, 21) - 76560.1265144348*pow(xi1, 19) + 108841.735485077*pow(xi1, 17) - 97160.8135299683*pow(xi1, 15) + 56549.5268630981*pow(xi1, 13) - 21574.1586685181*pow(xi1, 11) + 5285.74245452881*pow(xi1, 9) - 791.235500335693*pow(xi1, 7) + 66.018253326416*pow(xi1, 5) - 2.69205093383789*pow(xi1, 3) + 0.0572776794433594*xi1 + 5351.98545455933*pow(xi2, 23) - 30697.9313850403*pow(xi2, 21) + 76560.1265144348*pow(xi2, 19) - 108841.735485077*pow(xi2, 17) + 97160.8135299683*pow(xi2, 15) - 56549.5268630981*pow(xi2, 13) + 21574.1586685181*pow(xi2, 11) - 5285.74245452881*pow(xi2, 9) + 791.235500335693*pow(xi2, 7) - 66.018253326416*pow(xi2, 5) + 2.69205093383789*pow(xi2, 3) - 0.0572776794433594*xi2;
case 11:
return -9688.08478116989*pow(xi1, 24) + 58001.8670558929*pow(xi1, 22) - 151930.445162773*pow(xi1, 20) + 228623.231115341*pow(xi1, 18) - 218173.43846941*pow(xi1, 16) + 137516.871471405*pow(xi1, 14) - 57820.9868717194*pow(xi1, 12) + 16003.2707176208*pow(xi1, 10) - 2807.71195650101*pow(xi1, 8) + 290.586851119995*pow(xi1, 6) - 15.4220151901245*pow(xi1, 4) + 0.257749557495117*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(20317386375.0*pow(xi2, 22) - 121638731500.0*pow(xi2, 20) + 318621236934.0*pow(xi2, 18) - 479457666380.0*pow(xi2, 16) + 457542862833.0*pow(xi2, 14) - 288393782040.0*pow(xi2, 12) + 121259398260.0*pow(xi2, 10) - 33561291192.0*pow(xi2, 8) + 5888198745.0*pow(xi2, 6) - 609404796.0*pow(xi2, 4) + 32342310.0*pow(xi2, 2) - 540540.0);
case 12:
return -17671.0666408539*pow(xi1, 25) + 110228.875732422*pow(xi1, 23) - 302549.896160126*pow(xi1, 21) + 480425.929870605*pow(xi1, 19) - 488103.004846573*pow(xi1, 17) + 331307.98425293*pow(xi1, 15) - 152303.689613342*pow(xi1, 13) + 47058.755859375*pow(xi1, 11) - 9499.08173561096*pow(xi1, 9) + 1185.35339355469*pow(xi1, 7) - 82.8578910827637*pow(xi1, 5) + 2.74932861328125*pow(xi1, 3) - 0.0515499114990234*xi1 + 17671.0666408539*pow(xi2, 25) - 110228.875732422*pow(xi2, 23) + 302549.896160126*pow(xi2, 21) - 480425.929870605*pow(xi2, 19) + 488103.004846573*pow(xi2, 17) - 331307.98425293*pow(xi2, 15) + 152303.689613342*pow(xi2, 13) - 47058.755859375*pow(xi2, 11) + 9499.08173561096*pow(xi2, 9) - 1185.35339355469*pow(xi2, 7) + 82.8578910827637*pow(xi2, 5) - 2.74932861328125*pow(xi2, 3) + 0.0515499114990234*xi2;
case 13:
return -32438.1468057632*pow(xi1, 26) + 210476.088356972*pow(xi1, 24) - 604069.896524429*pow(xi1, 22) + 1009436.52295876*pow(xi1, 20) - 1087903.80975246*pow(xi1, 18) + 791305.484061241*pow(xi1, 16) - 395008.242015839*pow(xi1, 14) + 134917.356273651*pow(xi1, 12) - 30869.5774526596*pow(xi1, 10) + 4532.54437923431*pow(xi1, 8) - 395.989236831665*pow(xi1, 6) + 17.9565525054932*pow(xi1, 4) - 0.283524513244629*pow(xi1, 2) + 9.5367431640625e-7*pow(xi2, 2)*(34013862225.0*pow(xi2, 24) - 220700174825.0*pow(xi2, 22) + 633413195818.0*pow(xi2, 20) - 1058470911498.0*pow(xi2, 18) + 1140749825215.0*pow(xi2, 16) - 829743939255.0*pow(xi2, 14) + 414196162380.0*pow(xi2, 12) - 141471101772.0*pow(xi2, 10) + 32369098047.0*pow(xi2, 8) - 4752717255.0*pow(xi2, 6) + 415224810.0*pow(xi2, 4) - 18828810.0*pow(xi2, 2) + 297297.0);
case 14:
return -59870.4067587852*pow(xi1, 27) + 403474.480330944*pow(xi1, 25) - 1208504.61304951*pow(xi1, 23) + 2119959.62926197*pow(xi1, 21) - 2415794.7218442*pow(xi1, 19) + 1874880.78451395*pow(xi1, 17) - 1010324.84072685*pow(xi1, 15) + 378311.653501511*pow(xi1, 13) - 96925.0929780006*pow(xi1, 11) + 16429.6042370796*pow(xi1, 9) - 1737.12769031525*pow(xi1, 7) + 103.48644733429*pow(xi1, 5) - 2.88249921798706*pow(xi1, 3) + 0.0472540855407715*xi1 + 59870.4067587852*pow(xi2, 27) - 403474.480330944*pow(xi2, 25) + 1208504.61304951*pow(xi2, 23) - 2119959.62926197*pow(xi2, 21) + 2415794.7218442*pow(xi2, 19) - 1874880.78451395*pow(xi2, 17) + 1010324.84072685*pow(xi2, 15) - 378311.653501511*pow(xi2, 13) + 96925.0929780006*pow(xi2, 11) - 16429.6042370796*pow(xi2, 9) + 1737.12769031525*pow(xi2, 7) - 103.48644733429*pow(xi2, 5) + 2.88249921798706*pow(xi2, 3) - 0.0472540855407715*xi2;
case 15:
return -111023.419126868*pow(xi1, 28) + 776012.579911947*pow(xi1, 26) - 2421497.64727652*pow(xi1, 24) + 4449137.26589155*pow(xi1, 22) - 5345258.68610036*pow(xi1, 20) + 4409451.09540582*pow(xi1, 18) - 2551934.9433285*pow(xi1, 16) + 1040179.51673985*pow(xi1, 14) - 295400.64020741*pow(xi1, 12) + 56930.848058939*pow(xi1, 10) - 7106.93852126598*pow(xi1, 8) + 531.372191905975*pow(xi1, 6) - 20.7327300310135*pow(xi1, 4) + 0.307151556015015*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(931331941875.0*pow(xi2, 26) - 6509665335950.0*pow(xi2, 24) + 20312994535925.0*pow(xi2, 22) - 37322068461756.0*pow(xi2, 20) + 44839279776291.0*pow(xi2, 18) - 36989156734530.0*pow(xi2, 16) + 21407181881085.0*pow(xi2, 14) - 8725658215560.0*pow(xi2, 12) + 2478000173649.0*pow(xi2, 10) - 477570567474.0*pow(xi2, 8) + 59617321335.0*pow(xi2, 6) - 4457473020.0*pow(xi2, 4) + 173918745.0*pow(xi2, 2) - 2576574.0);
case 16:
return -206733.263201755*pow(xi1, 29) + 1496760.16896963*pow(xi1, 27) - 4857884.80440784*pow(xi1, 25) + 9329597.56286144*pow(xi1, 23) - 11786356.0179684*pow(xi1, 21) + 10299603.4912133*pow(xi1, 19) - 6373044.32309031*pow(xi1, 17) + 2810481.91080666*pow(xi1, 15) - 877167.455323935*pow(xi1, 13) + 189815.69656992*pow(xi1, 11) - 27439.3842566013*pow(xi1, 9) + 2491.43790721893*pow(xi1, 7) - 128.082198858261*pow(xi1, 5) + 3.07151556015015*pow(xi1, 3) - 0.0438787937164307*xi1 + 206733.263201755*pow(xi2, 29) - 1496760.16896963*pow(xi2, 27) + 4857884.80440784*pow(xi2, 25) - 9329597.56286144*pow(xi2, 23) + 11786356.0179684*pow(xi2, 21) - 10299603.4912133*pow(xi2, 19) + 6373044.32309031*pow(xi2, 17) - 2810481.91080666*pow(xi2, 15) + 877167.455323935*pow(xi2, 13) - 189815.69656992*pow(xi2, 11) + 27439.3842566013*pow(xi2, 9) - 2491.43790721893*pow(xi2, 7) + 128.082198858261*pow(xi2, 5) - 3.07151556015015*pow(xi2, 3) + 0.0438787937164307*xi2;
case 17:
return -386361.498561502*pow(xi1, 30) + 2894010.4585737*pow(xi1, 28) - 9754961.69816315*pow(xi1, 26) + 19545735.5108708*pow(xi1, 24) - 25903712.4025375*pow(xi1, 22) + 23905846.5192221*pow(xi1, 20) - 15752194.5456511*pow(xi1, 18) + 7475804.41044366*pow(xi1, 16) - 2545558.64732444*pow(xi1, 14) + 612102.859781384*pow(xi1, 12) - 100879.986794829*pow(xi1, 10) + 10847.8250795603*pow(xi1, 8) - 702.302032828331*pow(xi1, 6) + 23.8042455911636*pow(xi1, 4) - 0.32909095287323*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(3241035157725.0*pow(xi2, 28) - 24276719284875.0*pow(xi2, 26) + 81830549740905.0*pow(xi2, 24) - 163961513272375.0*pow(xi2, 22) + 217296089089625.0*pow(xi2, 20) - 200536775357919.0*pow(xi2, 18) + 132138985183205.0*pow(xi2, 16) - 62711592683883.0*pow(xi2, 14) + 21353693633415.0*pow(xi2, 12) - 5134690946385.0*pow(xi2, 10) + 846242664267.0*pow(xi2, 8) - 90998152245.0*pow(xi2, 6) + 5891336451.0*pow(xi2, 4) - 199684485.0*pow(xi2, 2) + 2760615.0);
case 18:
return -724427.809802815*pow(xi1, 31) + 5607607.86106624*pow(xi1, 29) - 19603442.1230375*pow(xi1, 27) + 40909335.0543521*pow(xi1, 25) - 56752834.2872765*pow(xi1, 23) + 55161687.4630291*pow(xi1, 21) - 38569445.8929905*pow(xi1, 19) + 19607078.2719415*pow(xi1, 17) - 7238045.34529294*pow(xi1, 15) + 1917066.91166751*pow(xi1, 13) - 355638.555911556*pow(xi1, 11) + 44406.788155362*pow(xi1, 9) - 3502.04605682194*pow(xi1, 7) + 156.973642095923*pow(xi1, 5) - 3.30462165176868*pow(xi1, 3) + 0.0411363691091537*xi1 + 724427.809802815*pow(xi2, 31) - 5607607.86106624*pow(xi2, 29) + 19603442.1230375*pow(xi2, 27) - 40909335.0543521*pow(xi2, 25) + 56752834.2872765*pow(xi2, 23) - 55161687.4630291*pow(xi2, 21) + 38569445.8929905*pow(xi2, 19) - 19607078.2719415*pow(xi2, 17) + 7238045.34529294*pow(xi2, 15) - 1917066.91166751*pow(xi2, 13) + 355638.555911556*pow(xi2, 11) - 44406.788155362*pow(xi2, 9) + 3502.04605682194*pow(xi2, 7) - 156.973642095923*pow(xi2, 5) + 3.30462165176868*pow(xi2, 3) - 0.0411363691091537*xi2;
case 19:
return -1362297.14968434*pow(xi1, 32) + 10886145.5732351*pow(xi1, 30) - 39418452.9770324*pow(xi1, 28) + 85539062.1861455*pow(xi1, 26) - 123972950.147591*pow(xi1, 24) + 126591326.678001*pow(xi1, 22) - 93626216.0619297*pow(xi1, 20) + 50771905.0317212*pow(xi1, 18) - 20208229.3198293*pow(xi1, 16) + 5851373.28615982*pow(xi1, 14) - 1208924.23957804*pow(xi1, 12) + 172527.140995972*pow(xi1, 10) - 16158.0459508058*pow(xi1, 8) + 914.918098993599*pow(xi1, 6) - 27.2151361964643*pow(xi1, 4) + 0.349659137427807*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.92551085266413e+15*pow(xi2, 30) - 2.337781960827e+16*pow(xi2, 28) + 8.4650483197634e+16*pow(xi2, 26) - 1.83693737310003e+17*pow(xi2, 24) + 2.66229883236271e+17*pow(xi2, 22) - 2.71852804019633e+17*pow(xi2, 20) + 2.01060768017109e+17*pow(xi2, 18) - 1.0903183583343e+17*pow(xi2, 16) + 4.33968420193677e+16*pow(xi2, 14) - 1.25657284503722e+16*pow(xi2, 12) + 2.59614503616468e+15*pow(xi2, 10) - 370499214125040.0*pow(xi2, 8) + 34699139462988.0*pow(xi2, 6) - 1964771656848.0*pow(xi2, 4) + 58444059960.0*pow(xi2, 2) - 750887280.0);
case 20:
return -2568641.0903139*pow(xi1, 33) + 21168864.3506505*pow(xi1, 31) - 79300066.27011*pow(xi1, 29) + 178680095.728121*pow(xi1, 27) - 270052767.826836*pow(xi1, 25) + 289047535.62412*pow(xi1, 23) - 225479030.866805*pow(xi1, 21) + 129953892.378422*pow(xi1, 19) - 55500176.6003122*pow(xi1, 17) + 17455090.6417334*pow(xi1, 15) - 3980427.21410811*pow(xi1, 13) + 640853.077293187*pow(xi1, 11) - 69867.2311975062*pow(xi1, 9) + 4832.35144087672*pow(xi1, 7) - 190.587540507317*pow(xi1, 5) + 3.57429340481758*pow(xi1, 3) - 0.0388510152697563*xi1 + 2568641.0903139*pow(xi2, 33) - 21168864.3506505*pow(xi2, 31) + 79300066.27011*pow(xi2, 29) - 178680095.728121*pow(xi2, 27) + 270052767.826836*pow(xi2, 25) - 289047535.62412*pow(xi2, 23) + 225479030.866805*pow(xi2, 21) - 129953892.378422*pow(xi2, 19) + 55500176.6003122*pow(xi2, 17) - 17455090.6417334*pow(xi2, 15) + 3980427.21410811*pow(xi2, 13) - 640853.077293187*pow(xi2, 11) + 69867.2311975062*pow(xi2, 9) - 4832.35144087672*pow(xi2, 7) + 190.587540507317*pow(xi2, 5) - 3.57429340481758*pow(xi2, 3) + 0.0388510152697563*xi2;
case 21:
return -4854970.23416916*pow(xi1, 34) + 41225938.4348919*pow(xi1, 32) - 159592087.223465*pow(xi1, 30) + 372872774.309806*pow(xi1, 28) - 586702614.054534*pow(xi1, 26) + 656876682.631329*pow(xi1, 24) - 539060699.397119*pow(xi1, 22) + 329113221.379803*pow(xi1, 20) - 150174585.707234*pow(xi1, 18) + 51011662.3364239*pow(xi1, 16) - 12741096.0830762*pow(xi1, 14) + 2289275.60617186*pow(xi1, 12) - 285898.280884445*pow(xi1, 10) + 23541.6950006783*pow(xi1, 8) - 1176.05131302774*pow(xi1, 6) + 31.0031101852655*pow(xi1, 4) - 0.369084645062685*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.30324614867563e+15*pow(xi2, 32) - 1.10665035827981e+16*pow(xi2, 30) + 4.28401747078226e+16*pow(xi2, 28) - 1.00092273201838e+17*pow(xi2, 26) + 1.57491783740121e+17*pow(xi2, 24) - 1.76328991837908e+17*pow(xi2, 22) + 1.44703004654344e+17*pow(xi2, 20) - 8.83456576567164e+16*pow(xi2, 18) + 4.03121833939324e+16*pow(xi2, 16) - 1.3693338840596e+16*pow(xi2, 14) + 3.42016193700038e+15*pow(xi2, 12) - 614522741252420.0*pow(xi2, 10) + 76745235398832.0*pow(xi2, 8) - 6319425632520.0*pow(xi2, 6) + 315693870492.0*pow(xi2, 4) - 8322334020.0*pow(xi2, 2) + 99075405.0);
case 22:
return -9196700.75786901*pow(xi1, 35) + 80394710.8035937*pow(xi1, 33) - 321276134.119334*pow(xi1, 31) + 777364493.20886*pow(xi1, 29) - 1271443221.77745*pow(xi1, 27) + 1486223279.32134*pow(xi1, 25) - 1280060550.32711*pow(xi1, 23) + 825415347.600242*pow(xi1, 21) - 400883985.039707*pow(xi1, 19) + 146346571.587733*pow(xi1, 17) - 39771130.9808454*pow(xi1, 15) + 7902101.94451205*pow(xi1, 13) - 1115630.10317823*pow(xi1, 11) + 107179.474305473*pow(xi1, 9) - 6556.41963489354*pow(xi1, 7) + 229.423015370965*pow(xi1, 5) - 3.87538877315819*pow(xi1, 3) + 0.0369084645062685*xi1 + 9196700.75786901*pow(xi2, 35) - 80394710.8035937*pow(xi2, 33) + 321276134.119334*pow(xi2, 31) - 777364493.20886*pow(xi2, 29) + 1271443221.77745*pow(xi2, 27) - 1486223279.32134*pow(xi2, 25) + 1280060550.32711*pow(xi2, 23) - 825415347.600242*pow(xi2, 21) + 400883985.039707*pow(xi2, 19) - 146346571.587733*pow(xi2, 17) + 39771130.9808454*pow(xi2, 15) - 7902101.94451205*pow(xi2, 13) + 1115630.10317823*pow(xi2, 11) - 107179.474305473*pow(xi2, 9) + 6556.41963489354*pow(xi2, 7) - 229.423015370965*pow(xi2, 5) + 3.87538877315819*pow(xi2, 3) - 0.0369084645062685*xi2;
case 23:
return -17456700.5126217*pow(xi1, 36) + 156968380.219184*pow(xi1, 34) - 646914534.321435*pow(xi1, 32) + 1619113705.96732*pow(xi1, 30) - 2748803401.56655*pow(xi1, 28) + 3348835568.88779*pow(xi1, 26) - 3020630767.10615*pow(xi1, 24) + 2051665199.17433*pow(xi1, 22) - 1056985506.89965*pow(xi1, 20) + 412874103.839298*pow(xi1, 18) - 121377909.228796*pow(xi1, 16) + 26460296.7336268*pow(xi1, 14) - 4176886.19847074*pow(xi1, 12) + 460613.724740993*pow(xi1, 10) - 33621.2121150177*pow(xi1, 8) + 1493.31647392362*pow(xi1, 6) - 35.2014480228536*pow(xi1, 4) + 0.387538877315819*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.74879788988884e+16*pow(xi2, 34) - 3.37087029773744e+17*pow(xi2, 32) + 1.38923838410882e+18*pow(xi2, 30) - 3.47702020781751e+18*pow(xi2, 28) + 5.90301035643093e+18*pow(xi2, 26) - 7.1915696240273e+18*pow(xi2, 24) + 6.48675517900615e+18*pow(xi2, 22) - 4.40591746639754e+18*pow(xi2, 20) + 2.26985909223999e+18*pow(xi2, 18) - 8.86640386677545e+17*pow(xi2, 16) + 2.60657075297269e+17*pow(xi2, 14) - 5.68230545566913e+16*pow(xi2, 12) + 8.9697948107728e+15*pow(xi2, 10) - 989160441925656.0*pow(xi2, 8) + 72201003242940.0*pow(xi2, 6) - 3206872709040.0*pow(xi2, 4) + 75594534015.0*pow(xi2, 2) - 832233402.0);
case 24:
return -33197754.7832167*pow(xi1, 37) + 306814736.282442*pow(xi1, 35) - 1302848393.68207*pow(xi1, 33) + 3369219126.11369*pow(xi1, 31) - 5929426758.38608*pow(xi1, 29) + 7516677563.57637*pow(xi1, 27) - 7086469405.995*pow(xi1, 25) + 5057597873.96622*pow(xi1, 23) - 2755445247.24114*pow(xi1, 21) + 1147170493.78579*pow(xi1, 19) - 362977881.300088*pow(xi1, 17) + 86233348.1594231*pow(xi1, 15) - 15078836.0463731*pow(xi1, 13) + 1883365.51848263*pow(xi1, 11) - 160720.290966164*pow(xi1, 9) + 8760.19049741328*pow(xi1, 7) - 274.036960671656*pow(xi1, 5) + 4.20420963875949*pow(xi1, 3) - 0.0352308070287108*xi1 + 33197754.7832167*pow(xi2, 37) - 306814736.282442*pow(xi2, 35) + 1302848393.68207*pow(xi2, 33) - 3369219126.11369*pow(xi2, 31) + 5929426758.38608*pow(xi2, 29) - 7516677563.57637*pow(xi2, 27) + 7086469405.995*pow(xi2, 25) - 5057597873.96622*pow(xi2, 23) + 2755445247.24114*pow(xi2, 21) - 1147170493.78579*pow(xi2, 19) + 362977881.300088*pow(xi2, 17) - 86233348.1594231*pow(xi2, 15) + 15078836.0463731*pow(xi2, 13) - 1883365.51848263*pow(xi2, 11) + 160720.290966164*pow(xi2, 9) - 8760.19049741328*pow(xi2, 7) + 274.036960671656*pow(xi2, 5) - 4.20420963875949*pow(xi2, 3) + 0.0352308070287108*xi2;
case 25:
return -63242862.3730616*pow(xi1, 38) + 600312701.027588*pow(xi1, 36) - 2624222778.80029*pow(xi1, 34) + 7004739827.56913*pow(xi1, 32) - 12763068066.1337*pow(xi1, 30) + 16810599588.6806*pow(xi1, 28) - 16534802720.9836*pow(xi1, 26) + 12372295008.3099*pow(xi1, 24) - 7108501413.12895*pow(xi1, 22) + 3143270424.39716*pow(xi1, 20) - 1065643053.90079*pow(xi1, 18) + 274273190.369964*pow(xi1, 16) - 52704628.8232462*pow(xi1, 14) + 7373057.56538108*pow(xi1, 12) - 723594.509931805*pow(xi1, 10) + 47156.4855376538*pow(xi1, 8) - 1875.18906310899*pow(xi1, 6) + 39.8401709483005*pow(xi1, 4) - 0.405154280830175*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(1.35813012798864e+17*pow(xi2, 36) - 1.28916170914346e+18*pow(xi2, 34) + 5.63547550618275e+18*pow(xi2, 32) - 1.50425642381991e+19*pow(xi2, 30) + 2.74084799703331e+19*pow(xi2, 28) - 3.6100487729767e+19*pow(xi2, 26) + 3.55082184662182e+19*pow(xi2, 24) - 2.65693012185776e+19*pow(xi2, 22) + 1.52653905464793e+19*pow(xi2, 20) - 6.75012183763493e+18*pow(xi2, 18) + 2.28845103285674e+18*pow(xi2, 16) - 5.8899719140429e+17*pow(xi2, 14) + 1.13182328571831e+17*pow(xi2, 12) - 1.58335205574186e+16*pow(xi2, 10) + 1.55390737786112e+15*pow(xi2, 8) - 101267781589260.0*pow(xi2, 6) + 4026937849935.0*pow(xi2, 4) - 85556115645.0*pow(xi2, 2) + 870062193.0);
case 26:
return -120674948.929795*pow(xi1, 39) + 1175653580.47207*pow(xi1, 37) - 5286302218.13123*pow(xi1, 35) + 14550493221.5513*pow(xi1, 33) - 27416907540.5478*pow(xi1, 31) + 37467926302.5102*pow(xi1, 29) - 38384854462.9983*pow(xi1, 27) + 30051114463.0346*pow(xi1, 25) - 18162427058.8831*pow(xi1, 23) + 8503083836.0135*pow(xi1, 21) - 3076420020.57996*pow(xi1, 19) + 853376938.104283*pow(xi1, 17) - 178972641.335269*pow(xi1, 15) + 27778770.6562195*pow(xi1, 13) - 3093109.45395475*pow(xi1, 11) + 236110.827741453*pow(xi1, 9) - 11542.8213445254*pow(xi1, 7) + 325.035021796008*pow(xi1, 5) - 4.55798565933947*pow(xi1, 3) + 0.0337628567358479*xi1 + 120674948.929795*pow(xi2, 39) - 1175653580.47207*pow(xi2, 37) + 5286302218.13123*pow(xi2, 35) - 14550493221.5513*pow(xi2, 33) + 27416907540.5478*pow(xi2, 31) - 37467926302.5102*pow(xi2, 29) + 38384854462.9983*pow(xi2, 27) - 30051114463.0346*pow(xi2, 25) + 18162427058.8831*pow(xi2, 23) - 8503083836.0135*pow(xi2, 21) + 3076420020.57996*pow(xi2, 19) - 853376938.104283*pow(xi2, 17) + 178972641.335269*pow(xi2, 15) - 27778770.6562195*pow(xi2, 13) + 3093109.45395475*pow(xi2, 11) - 236110.827741453*pow(xi2, 9) + 11542.8213445254*pow(xi2, 7) - 325.035021796008*pow(xi2, 5) + 4.55798565933947*pow(xi2, 3) - 0.0337628567358479*xi2;
case 27:
return -230609827.404838*pow(xi1, 40) + 2304355191.45273*pow(xi1, 38) - 10649642753.0921*pow(xi1, 36) + 30199427443.2348*pow(xi1, 34) - 58782403427.0816*pow(xi1, 32) + 83241776377.9778*pow(xi1, 30) - 88685550540.2*pow(xi1, 28) + 72508203254.0171*pow(xi1, 26) - 45992495366.913*pow(xi1, 24) + 22732658206.1636*pow(xi1, 22) - 8745833685.74116*pow(xi1, 20) + 2602712863.83558*pow(xi1, 18) - 592164491.208723*pow(xi1, 16) + 101153806.264636*pow(xi1, 14) - 12635421.9150379*pow(xi1, 12) + 1111150.22967046*pow(xi1, 10) - 65066.1647220088*pow(xi1, 8) + 2331.07203618478*pow(xi1, 6) - 44.9468030295975*pow(xi1, 4) + 0.422035709198099*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(1.58473866694398e+19*pow(xi2, 38) - 1.58354082970517e+20*pow(xi2, 36) + 7.31837877417824e+20*pow(xi2, 34) - 2.07528885162589e+21*pow(xi2, 32) + 4.0394960047935e+21*pow(xi2, 30) - 5.72033131526976e+21*pow(xi2, 28) + 6.09442462716663e+21*pow(xi2, 26) - 4.98272578668358e+21*pow(xi2, 24) + 3.16058021539716e+21*pow(xi2, 22) - 1.5621763767459e+21*pow(xi2, 20) + 6.01009114504215e+20*pow(xi2, 18) - 1.78857066096837e+20*pow(xi2, 16) + 4.06932339775031e+19*pow(xi2, 14) - 6.95123663636049e+18*pow(xi2, 12) + 8.6829958233999e+17*pow(xi2, 10) - 7.63576623580399e+16*pow(xi2, 8) + 4.47131279291483e+15*pow(xi2, 6) - 160190050560540.0*pow(xi2, 4) + 3088720785150.0*pow(xi2, 2) - 29002073100.0);
case 28:
return -441317118.110572*pow(xi1, 41) + 4520215420.35694*pow(xi1, 39) - 21455533946.584*pow(xi1, 37) + 62627825964.2131*pow(xi1, 35) - 125800745105.801*pow(xi1, 33) + 184377197521.378*pow(xi1, 31) - 203988345809.981*pow(xi1, 29) + 173868453386.539*pow(xi1, 27) - 115502709028.459*pow(xi1, 25) + 60116117167.5139*pow(xi1, 23) - 24514412771.7272*pow(xi1, 21) + 7794716434.77033*pow(xi1, 19) - 1913781501.17792*pow(xi1, 17) + 357278354.291477*pow(xi1, 15) - 49588694.3055459*pow(xi1, 13) + 4955565.44394926*pow(xi1, 11) - 340478.339523105*pow(xi1, 9) + 15018.1416393653*pow(xi1, 7) - 383.065581096453*pow(xi1, 5) + 4.93457136908546*pow(xi1, 3) - 0.0324642853229307*xi1 + 441317118.110572*pow(xi2, 41) - 4520215420.35694*pow(xi2, 39) + 21455533946.584*pow(xi2, 37) - 62627825964.2131*pow(xi2, 35) + 125800745105.801*pow(xi2, 33) - 184377197521.378*pow(xi2, 31) + 203988345809.981*pow(xi2, 29) - 173868453386.539*pow(xi2, 27) + 115502709028.459*pow(xi2, 25) - 60116117167.5139*pow(xi2, 23) + 24514412771.7272*pow(xi2, 21) - 7794716434.77033*pow(xi2, 19) + 1913781501.17792*pow(xi2, 17) - 357278354.291477*pow(xi2, 15) + 49588694.3055459*pow(xi2, 13) - 4955565.44394926*pow(xi2, 11) + 340478.339523105*pow(xi2, 9) - 15018.1416393653*pow(xi2, 7) + 383.065581096453*pow(xi2, 5) - 4.93457136908546*pow(xi2, 3) + 0.0324642853229307*xi2;
case 29:
return -845663225.444685*pow(xi1, 42) + 8873258791.09151*pow(xi1, 40) - 43227100388.3104*pow(xi1, 38) + 129776422613.693*pow(xi1, 36) - 268760127505.3*pow(xi1, 34) + 407220712012.68*pow(xi1, 32) - 467232929734.276*pow(xi1, 30) + 414509044430.427*pow(xi1, 28) - 287829964191.486*pow(xi1, 26) + 157377876444.681*pow(xi1, 24) - 67824279307.8417*pow(xi1, 22) + 22957616604.4428*pow(xi1, 20) - 6054293730.11595*pow(xi1, 18) + 1227723888.89943*pow(xi1, 16) - 187795227.13452*pow(xi1, 14) + 21084402.1336859*pow(xi1, 12) - 1671508.25061792*pow(xi1, 10) + 88451.3556036221*pow(xi1, 8) - 2871.35565824312*pow(xi1, 6) + 50.546892247803*pow(xi1, 4) - 0.438267851859564*pow(xi1, 2) + 2.91038304567337e-11*pow(xi2, 2)*(2.90567671737184e+19*pow(xi2, 40) - 3.0488285053346e+20*pow(xi2, 38) + 1.48527185974962e+21*pow(xi2, 36) - 4.45908392734149e+21*pow(xi2, 34) + 9.23452766483241e+21*pow(xi2, 32) - 1.39919971227864e+22*pow(xi2, 30) + 1.60540012225838e+22*pow(xi2, 28) - 1.42424223177992e+22*pow(xi2, 26) + 9.88976226409026e+21*pow(xi2, 24) - 5.40746265955066e+21*pow(xi2, 22) + 2.3304244920156e+21*pow(xi2, 20) - 7.88817700081508e+20*pow(xi2, 18) + 2.08023948569807e+20*pow(xi2, 16) - 4.21842716107278e+19*pow(xi2, 14) + 6.45259487110124e+18*pow(xi2, 12) - 7.24454540959149e+17*pow(xi2, 10) + 5.74325861711852e+16*pow(xi2, 8) - 3.03916543683539e+15*pow(xi2, 6) + 98659029178710.0*pow(xi2, 4) - 1736777992950.0*pow(xi2, 2) + 15058768725.0);
default:
return 0.;
}
case 17:
switch(j) {
case 0:
return 0.000244140625*y1t*(-1710855.0*pow(xi1, 17) + 7020405.0*pow(xi1, 15) - 11700675.0*pow(xi1, 13) + 10140585.0*pow(xi1, 11) - 4849845.0*pow(xi1, 9) + 1247103.0*pow(xi1, 7) - 153153.0*pow(xi1, 5) + 6435.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-570285.0*pow(xi2, 14) + 2340135.0*pow(xi2, 12) - 3900225.0*pow(xi2, 10) + 3380195.0*pow(xi2, 8) - 1616615.0*pow(xi2, 6) + 415701.0*pow(xi2, 4) - 51051.0*pow(xi2, 2) + 2145.0));
case 1:
return 7.62939453125e-6*y1r*(-27373680.0*pow(xi1, 17) + 9694845.0*pow(xi1, 16) + 112326480.0*pow(xi1, 15) - 40116600.0*pow(xi1, 14) - 187210800.0*pow(xi1, 13) + 67603900.0*pow(xi1, 12) + 162249360.0*pow(xi1, 11) - 59491432.0*pow(xi1, 10) - 77597520.0*pow(xi1, 9) + 29099070.0*pow(xi1, 8) + 19953648.0*pow(xi1, 7) - 7759752.0*pow(xi1, 6) - 2450448.0*pow(xi1, 5) + 1021020.0*pow(xi1, 4) + 102960.0*pow(xi1, 3) - 51480.0*pow(xi1, 2) + pow(xi2, 2)*(27373680.0*pow(xi2, 15) - 9694845.0*pow(xi2, 14) - 112326480.0*pow(xi2, 13) + 40116600.0*pow(xi2, 12) + 187210800.0*pow(xi2, 11) - 67603900.0*pow(xi2, 10) - 162249360.0*pow(xi2, 9) + 59491432.0*pow(xi2, 8) + 77597520.0*pow(xi2, 7) - 29099070.0*pow(xi2, 6) - 19953648.0*pow(xi2, 5) + 7759752.0*pow(xi2, 4) + 2450448.0*pow(xi2, 3) - 1021020.0*pow(xi2, 2) - 102960.0*xi2 + 51480.0));
case 2:
return 0.000244140625*y2t*(1710855.0*pow(xi1, 17) - 7020405.0*pow(xi1, 15) + 11700675.0*pow(xi1, 13) - 10140585.0*pow(xi1, 11) + 4849845.0*pow(xi1, 9) - 1247103.0*pow(xi1, 7) + 153153.0*pow(xi1, 5) - 6435.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-570285.0*pow(xi2, 14) + 2340135.0*pow(xi2, 12) - 3900225.0*pow(xi2, 10) + 3380195.0*pow(xi2, 8) - 1616615.0*pow(xi2, 6) + 415701.0*pow(xi2, 4) - 51051.0*pow(xi2, 2) + 2145.0));
case 3:
return 7.62939453125e-6*y2r*(-27373680.0*pow(xi1, 17) - 9694845.0*pow(xi1, 16) + 112326480.0*pow(xi1, 15) + 40116600.0*pow(xi1, 14) - 187210800.0*pow(xi1, 13) - 67603900.0*pow(xi1, 12) + 162249360.0*pow(xi1, 11) + 59491432.0*pow(xi1, 10) - 77597520.0*pow(xi1, 9) - 29099070.0*pow(xi1, 8) + 19953648.0*pow(xi1, 7) + 7759752.0*pow(xi1, 6) - 2450448.0*pow(xi1, 5) - 1021020.0*pow(xi1, 4) + 102960.0*pow(xi1, 3) + 51480.0*pow(xi1, 2) + pow(xi2, 2)*(27373680.0*pow(xi2, 15) + 9694845.0*pow(xi2, 14) - 112326480.0*pow(xi2, 13) - 40116600.0*pow(xi2, 12) + 187210800.0*pow(xi2, 11) + 67603900.0*pow(xi2, 10) - 162249360.0*pow(xi2, 9) - 59491432.0*pow(xi2, 8) + 77597520.0*pow(xi2, 7) + 29099070.0*pow(xi2, 6) - 19953648.0*pow(xi2, 5) - 7759752.0*pow(xi2, 4) + 2450448.0*pow(xi2, 3) + 1021020.0*pow(xi2, 2) - 102960.0*xi2 - 51480.0));
case 4:
return -394.484252929688*pow(xi1, 18) + 1754.77478027344*pow(xi1, 16) - 3264.697265625*pow(xi1, 14) + 3300.9716796875*pow(xi1, 12) - 1973.40698242188*pow(xi1, 10) + 710.426513671875*pow(xi1, 8) - 149.5634765625*pow(xi1, 6) + 16.7578125*pow(xi1, 4) - 0.7855224609375*pow(xi1, 2) + 0.0001220703125*pow(xi2, 2)*(3231615.0*pow(xi2, 16) - 14375115.0*pow(xi2, 14) + 26744400.0*pow(xi2, 12) - 27041560.0*pow(xi2, 10) + 16166150.0*pow(xi2, 8) - 5819814.0*pow(xi2, 6) + 1225224.0*pow(xi2, 4) - 137280.0*pow(xi2, 2) + 6435.0);
case 5:
return -622.869873046875*pow(xi1, 19) + 2938.2275390625*pow(xi1, 17) - 5840.1806640625*pow(xi1, 15) + 6348.0224609375*pow(xi1, 13) - 4090.33447265625*pow(xi1, 11) + 1578.7255859375*pow(xi1, 9) - 348.9814453125*pow(xi1, 7) + 38.9619140625*pow(xi1, 5) - 1.571044921875*pow(xi1, 3) + 0.000244140625*pow(xi2, 3)*(2551275.0*pow(xi2, 16) - 12034980.0*pow(xi2, 14) + 23921380.0*pow(xi2, 12) - 26001500.0*pow(xi2, 10) + 16754010.0*pow(xi2, 8) - 6466460.0*pow(xi2, 6) + 1429428.0*pow(xi2, 4) - 159588.0*pow(xi2, 2) + 6435.0);
case 6:
return -1035.52116394043*pow(xi1, 20) + 5152.10037231445*pow(xi1, 18) - 10897.6274871826*pow(xi1, 16) + 12764.0594482422*pow(xi1, 14) - 9037.30697631836*pow(xi1, 12) + 3966.54803466797*pow(xi1, 10) - 1067.19772338867*pow(xi1, 8) + 168.992065429688*pow(xi1, 6) - 14.6303558349609*pow(xi1, 4) + 0.589141845703125*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(67863915.0*pow(xi2, 18) - 337648050.0*pow(xi2, 16) + 714186915.0*pow(xi2, 14) - 836505400.0*pow(xi2, 12) + 592268950.0*pow(xi2, 10) - 259951692.0*pow(xi2, 8) + 69939870.0*pow(xi2, 6) - 11075064.0*pow(xi2, 4) + 958815.0*pow(xi2, 2) - 38610.0);
case 7:
return -1775.17913818359*pow(xi1, 21) + 9283.98284912109*pow(xi1, 19) - 20812.4450683594*pow(xi1, 17) + 26115.7644042969*pow(xi1, 15) - 20094.2510986328*pow(xi1, 13) + 9762.98254394531*pow(xi1, 11) - 2970.49682617188*pow(xi1, 9) + 539.915771484375*pow(xi1, 7) - 52.2372436523438*pow(xi1, 5) + 1.96380615234375*pow(xi1, 3) + 6.103515625e-5*pow(xi2, 3)*(29084535.0*pow(xi2, 18) - 152108775.0*pow(xi2, 16) + 340991100.0*pow(xi2, 14) - 427880684.0*pow(xi2, 12) + 329224210.0*pow(xi2, 10) - 159956706.0*pow(xi2, 8) + 48668620.0*pow(xi2, 6) - 8845980.0*pow(xi2, 4) + 855855.0*pow(xi2, 2) - 32175.0);
case 8:
return -3106.56349182129*pow(xi1, 22) + 17032.5377655029*pow(xi1, 20) - 40329.7801971436*pow(xi1, 18) + 53967.8263092041*pow(xi1, 16) - 44844.786529541*pow(xi1, 14) + 23938.3236999512*pow(xi1, 12) - 8206.77645874023*pow(xi1, 10) + 1755.44631958008*pow(xi1, 8) - 220.63362121582*pow(xi1, 6) + 14.8921966552734*pow(xi1, 4) - 0.490951538085938*pow(xi1, 2) + 1.52587890625e-5*pow(xi2, 2)*(203591745.0*pow(xi2, 20) - 1116244395.0*pow(xi2, 18) + 2643052475.0*pow(xi2, 16) - 3536835465.0*pow(xi2, 14) + 2938947930.0*pow(xi2, 12) - 1568821982.0*pow(xi2, 10) + 537839302.0*pow(xi2, 8) - 115044930.0*pow(xi2, 6) + 14459445.0*pow(xi2, 4) - 975975.0*pow(xi2, 2) + 32175.0);
case 9:
return -5518.49166870117*pow(xi1, 23) + 31647.1591186523*pow(xi1, 21) - 78913.8542175293*pow(xi1, 19) + 112169.556884766*pow(xi1, 17) - 100115.90423584*pow(xi1, 15) + 58260.7701416016*pow(xi1, 13) - 22223.8673706055*pow(xi1, 11) + 5444.01977539063*pow(xi1, 9) - 813.997650146484*pow(xi1, 7) + 66.9003295898438*pow(xi1, 5) - 2.29110717773438*pow(xi1, 3) + 3.0517578125e-5*pow(xi2, 3)*(180829935.0*pow(xi2, 20) - 1037014110.0*pow(xi2, 18) + 2585849175.0*pow(xi2, 16) - 3675572040.0*pow(xi2, 14) + 3280597950.0*pow(xi2, 12) - 1909088916.0*pow(xi2, 10) + 728231686.0*pow(xi2, 8) - 178389640.0*pow(xi2, 6) + 26673075.0*pow(xi2, 4) - 2192190.0*pow(xi2, 2) + 75075.0);
case 10:
return -9916.03971719742*pow(xi1, 24) + 59359.465341568*pow(xi1, 22) - 155468.773369789*pow(xi1, 20) + 233922.147989273*pow(xi1, 18) - 223206.835935116*pow(xi1, 16) + 140675.350513458*pow(xi1, 14) - 59143.3052806854*pow(xi1, 12) + 16367.7127723694*pow(xi1, 10) - 2871.48042440414*pow(xi1, 8) + 297.586183547974*pow(xi1, 6) - 16.2525415420532*pow(xi1, 4) + 0.429582595825195*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(20795442525.0*pow(xi2, 22) - 124485821460.0*pow(xi2, 20) + 326041649010.0*pow(xi2, 18) - 490570300500.0*pow(xi2, 16) + 468098662395.0*pow(xi2, 14) - 295017592680.0*pow(xi2, 12) + 124032500956.0*pow(xi2, 10) - 34325581576.0*pow(xi2, 8) + 6021930915.0*pow(xi2, 6) - 624083460.0*pow(xi2, 4) + 34084050.0*pow(xi2, 2) - 900900.0);
case 11:
return -17981.0853538513*pow(xi1, 25) + 112153.828525543*pow(xi1, 23) - 307810.082950592*pow(xi1, 21) + 488743.176174164*pow(xi1, 19) - 496518.425559998*pow(xi1, 17) + 336997.347633362*pow(xi1, 15) - 154909.011726379*pow(xi1, 13) + 47860.7222213745*pow(xi1, 11) - 9660.37977218628*pow(xi1, 9) + 1205.35966873169*pow(xi1, 7) - 84.0263557434082*pow(xi1, 5) + 2.57749557495117*pow(xi1, 3) + 3.814697265625e-6*pow(xi2, 3)*(4713633639.0*pow(xi2, 22) - 29400453225.0*pow(xi2, 20) + 80690566385.0*pow(xi2, 18) - 128121091175.0*pow(xi2, 16) + 130159326150.0*pow(xi2, 14) - 88341832698.0*pow(xi2, 12) + 40608467970.0*pow(xi2, 10) - 12546401166.0*pow(xi2, 8) + 2532410595.0*pow(xi2, 6) - 315977805.0*pow(xi2, 4) + 22027005.0*pow(xi2, 2) - 675675.0);
case 12:
return -32850.0597810745*pow(xi1, 26) + 213137.865185738*pow(xi1, 24) - 611679.07834053*pow(xi1, 22) + 1022103.32902718*pow(xi1, 20) - 1101504.66350079*pow(xi1, 18) + 801162.67781353*pow(xi1, 16) - 399911.571865082*pow(xi1, 14) + 136586.399288177*pow(xi1, 12) - 31250.190905571*pow(xi1, 10) + 4588.24283123016*pow(xi1, 8) - 400.869295120239*pow(xi1, 6) + 18.3002185821533*pow(xi1, 4) - 0.386624336242676*pow(xi1, 2) + 9.5367431640625e-7*pow(xi2, 2)*(34445784285.0*pow(xi2, 24) - 223491250125.0*pow(xi2, 22) + 641392001250.0*pow(xi2, 20) - 1071753020338.0*pow(xi2, 18) + 1155011354035.0*pow(xi2, 16) - 840079956051.0*pow(xi2, 14) + 419337676380.0*pow(xi2, 12) - 143221220220.0*pow(xi2, 10) + 32768200179.0*pow(xi2, 8) - 4811121315.0*pow(xi2, 6) + 420341922.0*pow(xi2, 4) - 19189170.0*pow(xi2, 2) + 405405.0);
case 13:
return -60391.0189914703*pow(xi1, 27) + 406970.019607544*pow(xi1, 25) - 1218937.21246719*pow(xi1, 23) + 2138197.03727722*pow(xi1, 21) - 2436507.0156765*pow(xi1, 19) + 1890902.63150024*pow(xi1, 17) - 1018930.93498993*pow(xi1, 15) + 381524.08493042*pow(xi1, 13) - 97745.6159877777*pow(xi1, 11) + 16568.2724761963*pow(xi1, 9) - 1751.74945449829*pow(xi1, 7) + 104.337020874023*pow(xi1, 5) - 2.83524513244629*pow(xi1, 3) + 1.9073486328125e-6*pow(xi2, 3)*(31662286565.0*pow(xi2, 24) - 213369497640.0*pow(xi2, 22) + 639074153250.0*pow(xi2, 20) - 1121031048280.0*pow(xi2, 18) + 1277431390235.0*pow(xi2, 16) - 991377558864.0*pow(xi2, 14) + 534213262044.0*pow(xi2, 12) - 200028499440.0*pow(xi2, 10) + 51246853515.0*pow(xi2, 8) - 8686546440.0*pow(xi2, 6) + 918421218.0*pow(xi2, 4) - 54702648.0*pow(xi2, 2) + 1486485.0);
case 14:
return -111615.544028878*pow(xi1, 28) + 780137.430678606*pow(xi1, 26) - 2434327.0201534*pow(xi1, 24) + 4472634.49228525*pow(xi1, 22) - 5373401.24265254*pow(xi1, 20) + 4432596.53837848*pow(xi1, 18) - 2565290.6451391*pow(xi1, 16) + 1045607.6396513*pow(xi1, 14) - 296937.816326022*pow(xi1, 12) + 57226.2783515453*pow(xi1, 10) - 7143.71907627583*pow(xi1, 8) + 534.11292886734*pow(xi1, 6) - 20.8508652448654*pow(xi1, 4) + 0.354405641555786*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(936299045565.0*pow(xi2, 26) - 6544267092090.0*pow(xi2, 24) + 20420615115875.0*pow(xi2, 22) - 37519177483060.0*pow(xi2, 20) + 45075356651325.0*pow(xi2, 18) - 37183314782614.0*pow(xi2, 16) + 21519217628139.0*pow(xi2, 14) - 8771192610840.0*pow(xi2, 12) + 2490894941535.0*pow(xi2, 10) - 480048816390.0*pow(xi2, 8) + 59925858993.0*pow(xi2, 6) - 4480463988.0*pow(xi2, 4) + 174909735.0*pow(xi2, 2) - 2972970.0);
case 15:
return -207243.715703487*pow(xi1, 29) + 1500444.50169325*pow(xi1, 27) - 4869806.82453632*pow(xi1, 25) + 9352426.89430714*pow(xi1, 23) - 11815114.5594144*pow(xi1, 21) + 10324664.1370225*pow(xi1, 19) - 6388508.57412529*pow(xi1, 17) + 2817283.29321098*pow(xi1, 15) - 879284.628088474*pow(xi1, 13) + 190272.663624287*pow(xi1, 11) - 27505.2755784988*pow(xi1, 9) + 2497.40542316437*pow(xi1, 7) - 128.389350414276*pow(xi1, 5) + 3.07151556015015*pow(xi1, 3) + 4.76837158203125e-7*pow(xi2, 3)*(434621572875.0*pow(xi2, 26) - 3146660187615.0*pow(xi2, 24) + 10212725121690.0*pow(xi2, 22) - 19613460766250.0*pow(xi2, 20) + 24778091128505.0*pow(xi2, 18) - 21652390044285.0*pow(xi2, 16) + 13397673533244.0*pow(xi2, 14) - 5908271292924.0*pow(xi2, 12) + 1843993516365.0*pow(xi2, 10) - 399030697065.0*pow(xi2, 8) + 57682743690.0*pow(xi2, 6) - 5237438778.0*pow(xi2, 4) + 269251983.0*pow(xi2, 2) - 6441435.0);
case 16:
return -386361.498561502*pow(xi1, 30) + 2894010.4585737*pow(xi1, 28) - 9754961.69816315*pow(xi1, 26) + 19545735.5108708*pow(xi1, 24) - 25903712.4025375*pow(xi1, 22) + 23905846.5192221*pow(xi1, 20) - 15752194.5456511*pow(xi1, 18) + 7475804.41044366*pow(xi1, 16) - 2545558.64732444*pow(xi1, 14) + 612102.859781384*pow(xi1, 12) - 100879.986794829*pow(xi1, 10) + 10847.8250795603*pow(xi1, 8) - 702.302032828331*pow(xi1, 6) + 23.8042455911636*pow(xi1, 4) - 0.32909095287323*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(3241035157725.0*pow(xi2, 28) - 24276719284875.0*pow(xi2, 26) + 81830549740905.0*pow(xi2, 24) - 163961513272375.0*pow(xi2, 22) + 217296089089625.0*pow(xi2, 20) - 200536775357919.0*pow(xi2, 18) + 132138985183205.0*pow(xi2, 16) - 62711592683883.0*pow(xi2, 14) + 21353693633415.0*pow(xi2, 12) - 5134690946385.0*pow(xi2, 10) + 846242664267.0*pow(xi2, 8) - 90998152245.0*pow(xi2, 6) + 5891336451.0*pow(xi2, 4) - 199684485.0*pow(xi2, 2) + 2760615.0);
case 17:
return -722869.900534422*pow(xi1, 31) + 5595580.32399416*pow(xi1, 29) - 19561504.0544569*pow(xi1, 27) + 40822038.1444101*pow(xi1, 25) - 56632028.9066255*pow(xi1, 23) + 55044554.4813228*pow(xi1, 21) - 38487741.0992205*pow(xi1, 19) + 19565640.3415203*pow(xi1, 17) - 7222783.56616902*pow(xi1, 15) + 1913033.83341551*pow(xi1, 13) - 354892.038597822*pow(xi1, 11) + 44313.7788248062*pow(xi1, 9) - 3494.72652554512*pow(xi1, 7) + 156.647293567657*pow(xi1, 5) - 3.2909095287323*pow(xi1, 3) + 7.69092190650202e-9*pow(xi2, 3)*(93990019574025.0*pow(xi2, 28) - 727556512992750.0*pow(xi2, 26) + 2.54345373575038e+15*pow(xi2, 24) - 5.30782117419481e+15*pow(xi2, 22) + 7.36349030650643e+15*pow(xi2, 20) - 7.15708144621613e+15*pow(xi2, 18) + 5.00430787974618e+15*pow(xi2, 16) - 2.543991549957e+15*pow(xi2, 14) + 939131050084227.0*pow(xi2, 12) - 248739209248530.0*pow(xi2, 10) + 46144278008829.0*pow(xi2, 8) - 5761829253180.0*pow(xi2, 6) + 454396308795.0*pow(xi2, 4) - 20367817470.0*pow(xi2, 2) + 427895325.0);
case 18:
return -1356792.91877652*pow(xi1, 32) + 10842269.5533821*pow(xi1, 30) - 39259962.6923692*pow(xi1, 28) + 85195948.6158689*pow(xi1, 26) - 123476826.547754*pow(xi1, 24) + 126085880.85278*pow(xi1, 22) - 93253229.5725235*pow(xi1, 20) + 50570086.7614826*pow(xi1, 18) - 20128075.8467776*pow(xi1, 16) + 5828214.06609189*pow(xi1, 14) - 1204149.47876306*pow(xi1, 12) + 171847.139445908*pow(xi1, 10) - 16094.489574926*pow(xi1, 8) + 911.328265182674*pow(xi1, 6) - 27.098583150655*pow(xi1, 4) + 0.308522768318653*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.91369060679478e+15*pow(xi2, 30) - 2.32835965730964e+16*pow(xi2, 28) + 8.4310127902953e+16*pow(xi2, 26) - 1.82956906528427e+17*pow(xi2, 24) + 2.65164465918234e+17*pow(xi2, 22) - 2.70767367375021e+17*pow(xi2, 20) + 2.00259785630184e+17*pow(xi2, 18) - 1.08598434398225e+17*pow(xi2, 16) + 4.32247137466587e+16*pow(xi2, 14) - 1.25159944039759e+16*pow(xi2, 12) + 2.58589131539138e+15*pow(xi2, 10) - 369038921915664.0*pow(xi2, 8) + 34562653185060.0*pow(xi2, 6) - 1957062547440.0*pow(xi2, 4) + 58193764200.0*pow(xi2, 2) - 662547600.0);
case 19:
return -2553963.1412264*pow(xi1, 33) + 21048178.9914865*pow(xi1, 31) - 78848995.5336358*pow(xi1, 29) + 177665999.267845*pow(xi1, 27) - 268523439.726083*pow(xi1, 25) + 287414158.917535*pow(xi1, 23) - 224207568.133305*pow(xi1, 21) + 129222615.574253*pow(xi1, 19) - 55188505.9515298*pow(xi1, 17) + 17357266.487902*pow(xi1, 15) - 3958163.94090767*pow(xi1, 13) + 637275.694173083*pow(xi1, 11) - 69477.9699251801*pow(xi1, 9) + 4805.48207871616*pow(xi1, 7) - 189.515252485871*pow(xi1, 5) + 3.49659137427807*pow(xi1, 3) + 1.49011611938477e-8*pow(xi2, 3)*(171393565105575.0*pow(xi2, 30) - 1.41251938138733e+15*pow(xi2, 28) + 5.29146651780338e+15*pow(xi2, 26) - 1.19229633822899e+16*pow(xi2, 24) + 1.80203029973899e+16*pow(xi2, 22) - 1.92880377024713e+16*pow(xi2, 20) + 1.50463151976287e+16*pow(xi2, 18) - 8.67198293429683e+15*pow(xi2, 16) + 3.70363794026441e+15*pow(xi2, 14) - 1.16482643614838e+15*pow(xi2, 12) + 265627885600077.0*pow(xi2, 10) - 42766847890767.0*pow(xi2, 8) + 4662587634705.0*pow(xi2, 6) - 322490443275.0*pow(xi2, 4) + 12718153305.0*pow(xi2, 2) - 234652275.0);
case 20:
return -4819979.45770668*pow(xi1, 34) + 40929461.0305161*pow(xi1, 32) - 158446829.516417*pow(xi1, 30) + 370202602.281114*pow(xi1, 28) - 582509869.76183*pow(xi1, 26) + 652191998.055786*pow(xi1, 24) - 535223944.487169*pow(xi1, 22) + 326775381.698712*pow(xi1, 20) - 149109899.969673*pow(xi1, 18) + 50650699.779417*pow(xi1, 16) - 12651109.289059*pow(xi1, 14) + 2273137.20335324*pow(xi1, 12) - 283886.523512423*pow(xi1, 10) + 23376.3450796902*pow(xi1, 8) - 1167.78381697834*pow(xi1, 6) + 30.6923020631075*pow(xi1, 4) - 0.291382614523172*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.29385338364013e+15*pow(xi2, 32) - 1.09869185355608e+16*pow(xi2, 30) + 4.25327469329937e+16*pow(xi2, 28) - 9.93755043557175e+16*pow(xi2, 26) + 1.56366302514017e+17*pow(xi2, 24) - 1.75071456397656e+17*pow(xi2, 22) + 1.43673083600532e+17*pow(xi2, 20) - 8.77180985958677e+16*pow(xi2, 18) + 4.00263839924734e+16*pow(xi2, 16) - 1.35964436920069e+16*pow(xi2, 14) + 3.39600629091438e+15*pow(xi2, 12) - 610190621732692.0*pow(xi2, 10) + 76205208391312.0*pow(xi2, 8) - 6275039851080.0*pow(xi2, 6) + 313474581420.0*pow(xi2, 4) - 8238902100.0*pow(xi2, 2) + 78217425.0);
case 21:
return -9118096.47788722*pow(xi1, 35) + 79708988.7815304*pow(xi1, 33) - 318541366.112857*pow(xi1, 31) + 770760565.57494*pow(xi1, 29) - 1260663100.10732*pow(xi1, 27) + 1473646404.52689*pow(xi1, 25) - 1269248861.795*pow(xi1, 23) + 818456749.903348*pow(xi1, 21) - 397510603.618273*pow(xi1, 19) + 145117328.453817*pow(xi1, 17) - 39437672.1525126*pow(xi1, 15) + 7835964.69822362*pow(xi1, 13) - 1106309.09639171*pow(xi1, 11) + 106285.551295131*pow(xi1, 9) - 6501.79510742426*pow(xi1, 7) + 227.356141358614*pow(xi1, 5) - 3.69084645062685*pow(xi1, 3) + 7.45058059692383e-9*pow(xi2, 3)*(1.22381019294683e+15*pow(xi2, 32) - 1.06983593754345e+16*pow(xi2, 30) + 4.27538984336838e+16*pow(xi2, 28) - 1.03449731943463e+17*pow(xi2, 26) + 1.6920333706984e+17*pow(xi2, 24) - 1.97789472290969e+17*pow(xi2, 22) + 1.70355698496711e+17*pow(xi2, 20) - 1.09851405438292e+17*pow(xi2, 18) + 5.33529700735531e+16*pow(xi2, 16) - 1.94773181185011e+16*pow(xi2, 14) + 5.29323475391911e+15*pow(xi2, 12) - 1.05172537848378e+15*pow(xi2, 10) + 148486293383428.0*pow(xi2, 8) - 14265405214060.0*pow(xi2, 6) + 872656167240.0*pow(xi2, 4) - 30515224740.0*pow(xi2, 2) + 495377025.0);
case 22:
return -17286391.2393279*pow(xi1, 36) + 155439963.663983*pow(xi1, 34) - 640627537.401558*pow(xi1, 32) + 1603408154.14936*pow(xi1, 30) - 2722189337.19028*pow(xi1, 28) + 3316471384.76167*pow(xi1, 26) - 2991491208.6324*pow(xi1, 24) + 2031908379.46927*pow(xi1, 22) - 1046825005.81663*pow(xi1, 20) + 408912151.540302*pow(xi1, 18) - 120215159.194258*pow(xi1, 16) + 26207247.0460324*pow(xi1, 14) - 4137007.85298576*pow(xi1, 12) + 456223.339859758*pow(xi1, 10) - 33301.2157277483*pow(xi1, 8) + 1478.84835583717*pow(xi1, 6) - 34.5555498939939*pow(xi1, 4) + 0.276813483797014*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.7122242519387e+16*pow(xi2, 34) - 3.33804780214117e+17*pow(xi2, 32) + 1.37573716102836e+18*pow(xi2, 30) - 3.44329279210561e+18*pow(xi2, 28) + 5.84585708837608e+18*pow(xi2, 26) - 7.12206806783559e+18*pow(xi2, 24) + 6.42417845367384e+18*pow(xi2, 22) - 4.36349001914444e+18*pow(xi2, 20) + 2.24803958230871e+18*pow(xi2, 18) - 8.78132158901297e+17*pow(xi2, 16) + 2.58160088611386e+17*pow(xi2, 14) - 5.62796344904508e+16*pow(xi2, 12) + 8.8841567159345e+15*pow(xi2, 10) - 979732162184776.0*pow(xi2, 8) + 71513816233860.0*pow(xi2, 6) - 3175802662032.0*pow(xi2, 4) + 74207478345.0*pow(xi2, 2) - 594452430.0);
case 23:
return -32837469.0723911*pow(xi1, 37) + 303491125.009677*pow(xi1, 35) - 1288760839.34582*pow(xi1, 33) + 3332853573.87662*pow(xi1, 31) - 5865541029.76668*pow(xi1, 29) + 7435831693.49892*pow(xi1, 27) - 7010382002.96711*pow(xi1, 25) + 5003386821.33951*pow(xi1, 23) - 2725959954.0341*pow(xi1, 21) + 1134915281.2323*pow(xi1, 19) - 359106543.713533*pow(xi1, 17) + 85315115.7148456*pow(xi1, 15) - 14918529.9824437*pow(xi1, 13) + 1863374.76427998*pow(xi1, 11) - 159016.920591667*pow(xi1, 9) + 8666.99326921999*pow(xi1, 7) - 270.502136366442*pow(xi1, 5) + 3.87538877315819*pow(xi1, 3) + 1.86264514923096e-9*pow(xi2, 3)*(1.76294819686664e+16*pow(xi2, 34) - 1.62935557067851e+17*pow(xi2, 32) + 6.91898207169477e+17*pow(xi2, 30) - 1.7893121377696e+18*pow(xi2, 28) + 3.14903836202425e+18*pow(xi2, 26) - 3.99208174276727e+18*pow(xi2, 24) + 3.76367017940134e+18*pow(xi2, 22) - 2.68617284586132e+18*pow(xi2, 20) + 1.46348860659777e+18*pow(xi2, 18) - 6.0930300207792e+17*pow(xi2, 16) + 1.92793857628652e+17*pow(xi2, 14) - 4.58032039812147e+16*pow(xi2, 12) + 8.0093247973739e+15*pow(xi2, 10) - 1.00039170909678e+15*pow(xi2, 8) + 85371559181480.0*pow(xi2, 6) - 4653056580744.0*pow(xi2, 4) + 145224728649.0*pow(xi2, 2) - 2080583505.0);
case 24:
return -62493317.3375291*pow(xi1, 38) + 593210422.874364*pow(xi1, 36) - 2593229632.47033*pow(xi1, 34) + 6922152726.01049*pow(xi1, 32) - 12612843638.232*pow(xi1, 30) + 16613064815.6171*pow(xi1, 28) - 16340828722.4991*pow(xi1, 26) + 12227388514.1203*pow(xi1, 24) - 7025379152.49504*pow(xi1, 22) + 3106573380.0222*pow(xi1, 20) - 1053221405.90108*pow(xi1, 18) + 271081088.424279*pow(xi1, 16) - 52092171.7263622*pow(xi1, 14) + 7287508.49415471*pow(xi1, 12) - 715211.134725111*pow(xi1, 10) + 46610.0523653235*pow(xi1, 8) - 1852.21857692627*pow(xi1, 6) + 38.6658107140101*pow(xi1, 4) - 0.264231052715331*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(1.34203377091619e+17*pow(xi2, 36) - 1.27390968294586e+18*pow(xi2, 34) + 5.56891823123908e+18*pow(xi2, 32) - 1.48652097880662e+19*pow(xi2, 30) + 2.70858754678841e+19*pow(xi2, 28) - 3.56762850347018e+19*pow(xi2, 26) + 3.50916624763357e+19*pow(xi2, 24) - 2.62581168918163e+19*pow(xi2, 22) + 1.50868868509832e+19*pow(xi2, 20) - 6.67131553490977e+18*pow(xi2, 18) + 2.26177574689614e+18*pow(xi2, 16) - 5.82142204673181e+17*pow(xi2, 14) + 1.11867086971171e+17*pow(xi2, 12) - 1.56498053258583e+16*pow(xi2, 10) + 1.5359042166897e+15*pow(xi2, 8) - 100094325286956.0*pow(xi2, 6) + 3977609106471.0*pow(xi2, 4) - 83034196245.0*pow(xi2, 2) + 567431865.0);
case 25:
return -119134417.666861*pow(xi1, 39) + 1160670487.5222*pow(xi1, 37) - 5219042862.03361*pow(xi1, 35) + 14365665737.576*pow(xi1, 33) - 27069207642.3522*pow(xi1, 31) + 36993518507.7491*pow(xi1, 29) - 37899603270.9539*pow(xi1, 27) + 29671808168.4901*pow(xi1, 25) - 17933533256.272*pow(xi1, 23) + 8396086005.76344*pow(xi1, 21) - 3037766421.81916*pow(xi1, 19) + 842670667.555862*pow(xi1, 17) - 176730598.184079*pow(xi1, 15) + 27431284.8221486*pow(xi1, 13) - 3054473.13668797*pow(xi1, 11) + 233164.102070853*pow(xi1, 9) - 11396.3725418011*pow(xi1, 7) + 319.261573294178*pow(xi1, 5) - 4.05154280830175*pow(xi1, 3) + 9.31322574615479e-10*pow(xi2, 3)*(1.27919606926794e+17*pow(xi2, 36) - 1.24626044633506e+18*pow(xi2, 34) + 5.60390460221414e+18*pow(xi2, 32) - 1.54250161320391e+19*pow(xi2, 30) + 2.9065340388134e+19*pow(xi2, 28) - 3.97214880386883e+19*pow(xi2, 26) + 4.06943891450304e+19*pow(xi2, 24) - 3.18598614242127e+19*pow(xi2, 22) + 1.92559847093541e+19*pow(xi2, 20) - 9.01522870228931e+18*pow(xi2, 18) + 3.26177685865006e+18*pow(xi2, 16) - 9.04810739612729e+17*pow(xi2, 14) + 1.89763034850784e+17*pow(xi2, 12) - 2.94541177995974e+16*pow(xi2, 10) + 3.27971555714634e+15*pow(xi2, 8) - 250358048248880.0*pow(xi2, 6) + 12236761840017.0*pow(xi2, 4) - 342804504042.0*pow(xi2, 2) + 4350310965.0);
case 26:
return -227472278.732664*pow(xi1, 40) + 2273053878.45846*pow(xi1, 38) - 10505212659.9366*pow(xi1, 36) + 29790506288.6914*pow(xi1, 34) - 57987682215.1704*pow(xi1, 32) + 82118094217.2808*pow(xi1, 30) - 87490193887.0504*pow(xi1, 28) + 71532356048.1256*pow(xi1, 26) - 45374423454.5563*pow(xi1, 24) + 22427611247.8239*pow(xi1, 22) - 8628644103.11401*pow(xi1, 20) + 2567887790.32449*pow(xi1, 18) - 584252375.676849*pow(xi1, 16) + 99804149.7685162*pow(xi1, 14) - 12467065.8196333*pow(xi1, 12) + 1096362.40067811*pow(xi1, 10) - 64196.1260493338*pow(xi1, 8) + 2296.0599537497*pow(xi1, 6) - 43.0054387672863*pow(xi1, 4) + 0.253221425518859*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(1.56317759664542e+19*pow(xi2, 38) - 1.56203073120401e+20*pow(xi2, 36) + 7.21912716991248e+20*pow(xi2, 34) - 2.04718800385939e+21*pow(xi2, 32) + 3.98488317895996e+21*pow(xi2, 30) - 5.64311246516908e+21*pow(xi2, 28) + 6.01228034344929e+21*pow(xi2, 26) - 4.91566607732043e+21*pow(xi2, 24) + 3.11810663699479e+21*pow(xi2, 22) - 1.54121370938888e+21*pow(xi2, 20) + 5.92955907707167e+20*pow(xi2, 18) - 1.76463905267862e+20*pow(xi2, 16) + 4.0149517538278e+19*pow(xi2, 14) - 6.85848894817381e+18*pow(xi2, 12) + 8.56730239558468e+17*pow(xi2, 10) - 7.53414504876245e+16*pow(xi2, 8) + 4.41152419058852e+15*pow(xi2, 6) - 157784038576164.0*pow(xi2, 4) + 2955311248890.0*pow(xi2, 2) - 17401243860.0);
case 27:
return -434971381.771727*pow(xi1, 41) + 4455319114.48803*pow(xi1, 39) - 21147968135.187*pow(xi1, 37) + 61731405121.2206*pow(xi1, 35) - 124002779366.724*pow(xi1, 33) + 181745921271.371*pow(xi1, 31) - 201081427440.588*pow(xi1, 29) + 171394317814.652*pow(xi1, 27) - 113861451013.844*pow(xi1, 25) + 59263087448.0283*pow(xi1, 23) - 24167044891.3457*pow(xi1, 21) + 7684417935.61208*pow(xi1, 19) - 1886737635.04339*pow(xi1, 17) + 352236432.233255*pow(xi1, 15) - 48889832.5121684*pow(xi1, 13) + 4885812.67061053*pow(xi1, 11) - 335681.455371747*pow(xi1, 9) + 14797.8983624285*pow(xi1, 7) - 373.923638349515*pow(xi1, 5) + 4.22035709198099*pow(xi1, 3) + 1.16415321826935e-10*pow(xi2, 3)*(3.736375718811e+18*pow(xi2, 38) - 3.82708997799395e+19*pow(xi2, 36) + 1.81659663034956e+20*pow(xi2, 34) - 5.30268732263539e+20*pow(xi2, 32) + 1.06517576398637e+21*pow(xi2, 30) - 1.56118557608386e+21*pow(xi2, 28) + 1.72727630938065e+21*pow(xi2, 26) - 1.47226597946832e+21*pow(xi2, 24) + 9.78062416759128e+20*pow(xi2, 22) - 5.09066044898539e+20*pow(xi2, 20) + 2.07593334898588e+20*pow(xi2, 18) - 6.60086474444994e+19*pow(xi2, 16) + 1.62069528772875e+19*pow(xi2, 14) - 3.0256879138031e+18*pow(xi2, 12) + 4.19960463493362e+17*pow(xi2, 10) - 4.19688112693093e+16*pow(xi2, 8) + 2.88348174539068e+15*pow(xi2, 6) - 127112979032325.0*pow(xi2, 4) + 3211979595825.0*pow(xi2, 2) - 36252591375.0);
case 28:
return -832898497.513445*pow(xi1, 42) + 8739521151.39361*pow(xi1, 40) - 42576535481.4103*pow(xi1, 38) + 127826121298.421*pow(xi1, 36) - 264726932148.851*pow(xi1, 34) + 401118326084.344*pow(xi1, 32) - 460241028009.732*pow(xi1, 30) + 408314713395.208*pow(xi1, 28) - 283534587979.19*pow(xi1, 26) + 155032460976.396*pow(xi1, 24) - 66814844868.7664*pow(xi1, 22) + 22616390444.5483*pow(xi1, 20) - 5964425288.95009*pow(xi1, 18) + 1209523608.00284*pow(xi1, 16) - 185014866.413594*pow(xi1, 14) + 20772630.3016105*pow(xi1, 12) - 1646801.49301984*pow(xi1, 10) + 87125.360217566*pow(xi1, 8) - 2818.97128744604*pow(xi1, 6) + 47.5601779980934*pow(xi1, 4) - 0.24348213992198*pow(xi1, 2) + 2.91038304567337e-11*pow(xi2, 2)*(2.86181744616623e+19*pow(xi2, 40) - 3.00287660223487e+20*pow(xi2, 38) + 1.46291861975713e+21*pow(xi2, 36) - 4.39207208440997e+21*pow(xi2, 34) + 9.0959481275978e+21*pow(xi2, 32) - 1.37823207388682e+22*pow(xi2, 30) + 1.58137613086337e+22*pow(xi2, 28) - 1.40295867240642e+22*pow(xi2, 26) + 9.74217426124363e+21*pow(xi2, 24) - 5.32687479769613e+21*pow(xi2, 22) + 2.29574058878932e+21*pow(xi2, 20) - 7.77093258503214e+20*pow(xi2, 18) + 2.04936092443808e+20*pow(xi2, 16) - 4.15589147208968e+19*pow(xi2, 14) + 6.35706240416157e+18*pow(xi2, 12) - 7.13742142378527e+17*pow(xi2, 10) + 5.65836684441936e+16*pow(xi2, 8) - 2.99360458229333e+15*pow(xi2, 6) + 96859115903550.0*pow(xi2, 4) - 1634155272750.0*pow(xi2, 2) + 8365982625.0);
case 29:
return -1596926835.02578*pow(xi1, 43) + 17155794339.5873*pow(xi1, 41) - 85723491017.7124*pow(xi1, 39) + 264501085869.306*pow(xi1, 37) - 564247100944.487*pow(xi1, 35) + 882930489041.186*pow(xi1, 33) - 1049307583130.46*pow(xi1, 31) + 967502466115.826*pow(xi1, 29) - 701000649302.07*pow(xi1, 27) + 401794420031.072*pow(xi1, 25) - 182520829969.247*pow(xi1, 23) + 65553051819.9223*pow(xi1, 21) - 18491548120.5668*pow(xi1, 19) + 4051446741.34114*pow(xi1, 17) - 678156146.789769*pow(xi1, 15) + 84718393.9058041*pow(xi1, 13) - 7643593.31681862*pow(xi1, 11) + 475270.013535954*pow(xi1, 9) - 18992.8591077769*pow(xi1, 7) + 434.761709044687*pow(xi1, 5) - 4.38267851859564*pow(xi1, 3) + 5.82076609134674e-11*pow(xi2, 3)*(2.7434994122162e+19*pow(xi2, 40) - 2.94734302501717e+20*pow(xi2, 38) + 1.4727183616801e+21*pow(xi2, 36) - 4.54409405426063e+21*pow(xi2, 34) + 9.69369138167753e+21*pow(xi2, 32) - 1.51686303002927e+22*pow(xi2, 30) + 1.80269670119606e+22*pow(xi2, 28) - 1.66215658030673e+22*pow(xi2, 26) + 1.20430994529086e+22*pow(xi2, 24) - 6.90277557499497e+21*pow(xi2, 22) + 3.13568398222678e+21*pow(xi2, 20) - 1.12619285487824e+21*pow(xi2, 18) + 3.17682377720978e+20*pow(xi2, 16) - 6.96033250221839e+19*pow(xi2, 14) + 1.16506338881737e+19*pow(xi2, 12) - 1.4554509247803e+18*pow(xi2, 10) + 1.31315933278641e+17*pow(xi2, 8) - 8.1650766596256e+15*pow(xi2, 6) + 326294834901750.0*pow(xi2, 4) - 7469149287600.0*pow(xi2, 2) + 75293843625.0);
default:
return 0.;
}
case 18:
switch(j) {
case 0:
return 7.62939453125e-6*y1t*(-100180065.0*pow(xi1, 18) + 436268025.0*pow(xi1, 16) - 782273700.0*pow(xi1, 14) + 743642900.0*pow(xi1, 12) - 401567166.0*pow(xi1, 10) + 122216094.0*pow(xi1, 8) - 19399380.0*pow(xi1, 6) + 1312740.0*pow(xi1, 4) - 19305.0*pow(xi1, 2) + pow(xi2, 2)*(100180065.0*pow(xi2, 16) - 436268025.0*pow(xi2, 14) + 782273700.0*pow(xi2, 12) - 743642900.0*pow(xi2, 10) + 401567166.0*pow(xi2, 8) - 122216094.0*pow(xi2, 6) + 19399380.0*pow(xi2, 4) - 1312740.0*pow(xi2, 2) + 19305.0));
case 1:
return 3.814697265625e-6*y1r*(xi1*(xi1*(xi1*(xi1*(-19.0*xi1*(xi1*(xi1*(xi1*(23.0*xi1*(xi1*(5.0*xi1*(xi1*(3.0*xi1*(xi1*(29.0*xi1*(xi1*(31.0*xi1*(17.0*xi1 - 6.0) - 2295.0) + 816.0) + 119340.0) - 42840.0) - 340340.0) + 123760.0) + 918918.0) - 340340.0) - 6432426.0) + 2450448.0) + 1021020.0) - 408408.0) + 1312740.0) - 583440.0) - 19305.0) + 12870.0) + xi2*(xi2*(xi2*(xi2*(19.0*xi2*(xi2*(xi2*(xi2*(23.0*xi2*(xi2*(5.0*xi2*(xi2*(3.0*xi2*(xi2*(29.0*xi2*(xi2*(31.0*xi2*(17.0*xi2 - 6.0) - 2295.0) + 816.0) + 119340.0) - 42840.0) - 340340.0) + 123760.0) + 918918.0) - 340340.0) - 6432426.0) + 2450448.0) + 1021020.0) - 408408.0) - 1312740.0) + 583440.0) + 19305.0) - 12870.0));
case 2:
return 7.62939453125e-6*y2t*(100180065.0*pow(xi1, 18) - 436268025.0*pow(xi1, 16) + 782273700.0*pow(xi1, 14) - 743642900.0*pow(xi1, 12) + 401567166.0*pow(xi1, 10) - 122216094.0*pow(xi1, 8) + 19399380.0*pow(xi1, 6) - 1312740.0*pow(xi1, 4) + 19305.0*pow(xi1, 2) + pow(xi2, 2)*(-100180065.0*pow(xi2, 16) + 436268025.0*pow(xi2, 14) - 782273700.0*pow(xi2, 12) + 743642900.0*pow(xi2, 10) - 401567166.0*pow(xi2, 8) + 122216094.0*pow(xi2, 6) - 19399380.0*pow(xi2, 4) + 1312740.0*pow(xi2, 2) - 19305.0));
case 3:
return 3.814697265625e-6*y2r*(-100180065.0*pow(xi1, 18) - 35357670.0*pow(xi1, 17) + 436268025.0*pow(xi1, 16) + 155117520.0*pow(xi1, 15) - 782273700.0*pow(xi1, 14) - 280816200.0*pow(xi1, 13) + 743642900.0*pow(xi1, 12) + 270415600.0*pow(xi1, 11) - 401567166.0*pow(xi1, 10) - 148728580.0*pow(xi1, 9) + 122216094.0*pow(xi1, 8) + 46558512.0*pow(xi1, 7) - 19399380.0*pow(xi1, 6) - 7759752.0*pow(xi1, 5) + 1312740.0*pow(xi1, 4) + 583440.0*pow(xi1, 3) - 19305.0*pow(xi1, 2) - 12870.0*xi1 + xi2*(100180065.0*pow(xi2, 17) + 35357670.0*pow(xi2, 16) - 436268025.0*pow(xi2, 15) - 155117520.0*pow(xi2, 14) + 782273700.0*pow(xi2, 13) + 280816200.0*pow(xi2, 12) - 743642900.0*pow(xi2, 11) - 270415600.0*pow(xi2, 10) + 401567166.0*pow(xi2, 9) + 148728580.0*pow(xi2, 8) - 122216094.0*pow(xi2, 7) - 46558512.0*pow(xi2, 6) + 19399380.0*pow(xi2, 5) + 7759752.0*pow(xi2, 4) - 1312740.0*pow(xi2, 3) - 583440.0*pow(xi2, 2) + 19305.0*xi2 + 12870.0));
case 4:
return -724.086227416992*pow(xi1, 19) + 3402.42668151855*pow(xi1, 17) - 6753.84246826172*pow(xi1, 15) + 7379.57611083984*pow(xi1, 13) - 4848.30215454102*pow(xi1, 11) + 1963.53994750977*pow(xi1, 9) - 482.075134277344*pow(xi1, 7) + 67.2145385742188*pow(xi1, 5) - 4.54948425292969*pow(xi1, 3) + 0.0981903076171875*xi1 + 724.086227416992*pow(xi2, 19) - 3402.42668151855*pow(xi2, 17) + 6753.84246826172*pow(xi2, 15) - 7379.57611083984*pow(xi2, 13) + 4848.30215454102*pow(xi2, 11) - 1963.53994750977*pow(xi2, 9) + 482.075134277344*pow(xi2, 7) - 67.2145385742188*pow(xi2, 5) + 4.54948425292969*pow(xi2, 3) - 0.0981903076171875*xi2;
case 5:
return -1146.4698600769*pow(xi1, 20) + 5695.36640167236*pow(xi1, 18) - 12032.1948051453*pow(xi1, 16) + 14073.3390808105*pow(xi1, 14) - 9928.70388031006*pow(xi1, 12) + 4306.96073913574*pow(xi1, 10) - 1117.44170379639*pow(xi1, 8) + 159.133758544922*pow(xi1, 6) - 10.1381492614746*pow(xi1, 4) + 0.147285461425781*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(300540195.0*pow(xi2, 18) - 1493006130.0*pow(xi2, 16) + 3154167675.0*pow(xi2, 14) - 3689241400.0*pow(xi2, 12) + 2602750150.0*pow(xi2, 10) - 1129043916.0*pow(xi2, 8) + 292930638.0*pow(xi2, 6) - 41715960.0*pow(xi2, 4) + 2657655.0*pow(xi2, 2) - 38610.0);
case 6:
return -1910.78310012817*pow(xi1, 21) + 9985.38265228271*pow(xi1, 19) - 22369.5526313782*pow(xi1, 17) + 28051.8356831868*pow(xi1, 15) - 21573.3575820923*pow(xi1, 13) + 10488.2096099854*pow(xi1, 11) - 3210.89761098226*pow(xi1, 9) + 600.256988525391*pow(xi1, 7) - 64.6043128967285*pow(xi1, 5) + 3.58394622802734*pow(xi1, 3) - 0.0736427307128906*xi1 + 1910.78310012817*pow(xi2, 21) - 9985.38265228271*pow(xi2, 19) + 22369.5526313782*pow(xi2, 17) - 28051.8356831868*pow(xi2, 15) + 21573.3575820923*pow(xi2, 13) - 10488.2096099854*pow(xi2, 11) + 3210.89761098226*pow(xi2, 9) - 600.256988525391*pow(xi2, 7) + 64.6043128967285*pow(xi2, 5) - 3.58394622802734*pow(xi2, 3) + 0.0736427307128906*xi2;
case 7:
return -3283.07278112932*pow(xi1, 22) + 17992.180223465*pow(xi1, 20) - 42584.5325946808*pow(xi1, 18) + 56963.228559494*pow(xi1, 16) - 47316.9975090027*pow(xi1, 14) + 25248.5089607239*pow(xi1, 12) - 8647.22272109985*pow(xi1, 10) + 1839.3581199646*pow(xi1, 8) - 224.21347618103*pow(xi1, 6) + 12.9488468170166*pow(xi1, 4) - 0.184106826782227*pow(xi1, 2) + 1.73395330255682e-7*pow(xi2, 2)*(18934032285.0*pow(xi2, 20) - 103763926035.0*pow(xi2, 18) + 245592153675.0*pow(xi2, 16) - 328516508925.0*pow(xi2, 14) + 272885073890.0*pow(xi2, 12) - 145612392926.0*pow(xi2, 10) + 49869986166.0*pow(xi2, 8) - 10607887290.0*pow(xi2, 6) + 1293076785.0*pow(xi2, 4) - 74678175.0*pow(xi2, 2) + 1061775.0);
case 8:
return -5757.27255821228*pow(xi1, 23) + 33007.2371006012*pow(xi1, 21) - 82283.7614536285*pow(xi1, 19) + 116930.786275864*pow(xi1, 17) - 104341.16991806*pow(xi1, 15) + 60706.0439186096*pow(xi1, 13) - 23152.2125434875*pow(xi1, 11) + 5673.22050094604*pow(xi1, 9) - 852.549619674683*pow(xi1, 7) + 72.8285694122314*pow(xi1, 5) - 3.21164131164551*pow(xi1, 3) + 0.0613689422607422*xi1 + 5757.27255821228*pow(xi2, 23) - 33007.2371006012*pow(xi2, 21) + 82283.7614536285*pow(xi2, 19) - 116930.786275864*pow(xi2, 17) + 104341.16991806*pow(xi2, 15) - 60706.0439186096*pow(xi2, 13) + 23152.2125434875*pow(xi2, 11) - 5673.22050094604*pow(xi2, 9) + 852.549619674683*pow(xi2, 7) - 72.8285694122314*pow(xi2, 5) + 3.21164131164551*pow(xi2, 3) - 0.0613689422607422*xi2;
case 9:
return -10246.5743744373*pow(xi1, 24) + 61326.8917894363*pow(xi1, 22) - 160593.9336133*pow(xi1, 20) + 241593.914977709*pow(xi1, 18) - 230491.054247618*pow(xi1, 16) + 145244.379724503*pow(xi1, 14) - 61055.4647487005*pow(xi1, 12) + 16894.2880268097*pow(xi1, 10) - 2961.98580622673*pow(xi1, 8) + 304.893860816956*pow(xi1, 6) - 15.5723690986633*pow(xi1, 4) + 0.214791297912598*pow(xi1, 2) + 7.94728597005208e-8*pow(xi2, 2)*(128931743655.0*pow(xi2, 22) - 771670882620.0*pow(xi2, 20) + 2020739334390.0*pow(xi2, 18) - 3039954971900.0*pow(xi2, 16) + 2900248652385.0*pow(xi2, 14) - 1827597248568.0*pow(xi2, 12) + 768255540052.0*pow(xi2, 10) - 212579339544.0*pow(xi2, 8) + 37270406745.0*pow(xi2, 6) - 3836452620.0*pow(xi2, 4) + 195945750.0*pow(xi2, 2) - 2702700.0);
case 10:
return -18443.8338739872*pow(xi1, 25) + 115026.06071949*pow(xi1, 23) - 315656.213915348*pow(xi1, 21) + 501145.377087593*pow(xi1, 19) - 509063.357251883*pow(xi1, 17) + 345476.188196182*pow(xi1, 15) - 158790.70818615*pow(xi1, 13) + 49055.2678394318*pow(xi1, 11) - 9900.71094870567*pow(xi1, 9) + 1235.98890781403*pow(xi1, 7) - 87.0835518836975*pow(xi1, 5) + 3.07867527008057*pow(xi1, 3) - 0.0536978244781494*xi1 + 18443.8338739872*pow(xi2, 25) - 115026.06071949*pow(xi2, 23) + 315656.213915348*pow(xi2, 21) - 501145.377087593*pow(xi2, 19) + 509063.357251883*pow(xi2, 17) - 345476.188196182*pow(xi2, 15) + 158790.70818615*pow(xi2, 13) - 49055.2678394318*pow(xi2, 11) + 9900.71094870567*pow(xi2, 9) - 1235.98890781403*pow(xi2, 7) + 87.0835518836975*pow(xi2, 5) - 3.07867527008057*pow(xi2, 3) + 0.0536978244781494*xi2;
case 11:
return -33498.416224122*pow(xi1, 26) + 217326.537135243*pow(xi1, 24) - 623650.511730909*pow(xi1, 22) + 1042027.70098567*pow(xi1, 20) - 1122894.03705299*pow(xi1, 18) + 816661.687039733*pow(xi1, 16) - 407619.976494312*pow(xi1, 14) + 139209.812054157*pow(xi1, 12) - 31848.3535255194*pow(xi1, 10) + 4675.69127261639*pow(xi1, 8) - 408.09272646904*pow(xi1, 6) + 18.2035624980927*pow(xi1, 4) - 0.241640210151672*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(281005082325.0*pow(xi2, 24) - 1823067128025.0*pow(xi2, 22) + 5231559671910.0*pow(xi2, 20) - 8741161908710.0*pow(xi2, 18) + 9419517902375.0*pow(xi2, 16) - 6850654761195.0*pow(xi2, 14) + 3419364195780.0*pow(xi2, 12) - 1167776543076.0*pow(xi2, 10) + 267163353171.0*pow(xi2, 8) - 39222541215.0*pow(xi2, 6) + 3423329910.0*pow(xi2, 4) - 152702550.0*pow(xi2, 2) + 2027025.0);
case 12:
return -61289.6948693196*pow(xi1, 27) + 413003.054221272*pow(xi1, 25) - 1236940.47161937*pow(xi1, 23) + 2169664.52764074*pow(xi1, 21) - 2472240.10607421*pow(xi1, 19) + 1918540.2736448*pow(xi1, 17) - 1033774.66102648*pow(xi1, 15) + 387064.230816364*pow(xi1, 13) - 99160.5335086584*pow(xi1, 11) + 16807.3628920317*pow(xi1, 9) - 1776.99817156792*pow(xi1, 7) + 106.044611692429*pow(xi1, 5) - 3.07688534259796*pow(xi1, 3) + 0.0483280420303345*xi1 + 61289.6948693196*pow(xi2, 27) - 413003.054221272*pow(xi2, 25) + 1236940.47161937*pow(xi2, 23) - 2169664.52764074*pow(xi2, 21) + 2472240.10607421*pow(xi2, 19) - 1918540.2736448*pow(xi2, 17) + 1033774.66102648*pow(xi2, 15) - 387064.230816364*pow(xi2, 13) + 99160.5335086584*pow(xi2, 11) - 16807.3628920317*pow(xi2, 9) + 1776.99817156792*pow(xi2, 7) - 106.044611692429*pow(xi2, 5) + 3.07688534259796*pow(xi2, 3) - 0.0483280420303345*xi2;
case 13:
return -112828.756463975*pow(xi1, 28) + 788588.082812726*pow(xi1, 26) - 2460608.39660838*pow(xi1, 24) + 4520765.16227424*pow(xi1, 22) - 5431042.46600339*pow(xi1, 20) + 4479999.0119229*pow(xi1, 18) - 2592641.40994146*pow(xi1, 16) + 1056722.9332602*pow(xi1, 14) - 300085.308234841*pow(xi1, 12) + 57831.1539922357*pow(xi1, 10) - 7219.0231026113*pow(xi1, 8) + 539.700724482536*pow(xi1, 6) - 20.9542335569859*pow(xi1, 4) + 0.26580423116684*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(3785904836415.0*pow(xi2, 26) - 26460625200750.0*pow(xi2, 24) + 82564317122625.0*pow(xi2, 22) - 151691707225500.0*pow(xi2, 20) + 182235545114623.0*pow(xi2, 18) - 150323822205634.0*pow(xi2, 16) + 86994609890265.0*pow(xi2, 14) - 35457737806920.0*pow(xi2, 12) + 10069192069365.0*pow(xi2, 10) - 1940491524114.0*pow(xi2, 8) + 242230219803.0*pow(xi2, 6) - 18109351260.0*pow(xi2, 4) + 703107405.0*pow(xi2, 2) - 8918910.0);
case 14:
return -208798.043571264*pow(xi1, 29) + 1511662.69413024*pow(xi1, 27) - 4906105.58279559*pow(xi1, 25) + 9421931.56315386*pow(xi1, 23) - 11902666.8263753*pow(xi1, 21) + 10400955.1452*pow(xi1, 19) - 6435583.67661783*pow(xi1, 17) + 2837986.68655086*pow(xi1, 15) - 885729.038971514*pow(xi1, 13) + 191663.560399711*pow(xi1, 11) - 27705.8257147372*pow(xi1, 9) + 2515.56618082523*pow(xi1, 7) - 129.337385505438*pow(xi1, 5) + 3.16011697053909*pow(xi1, 3) - 0.0443007051944733*xi1 + 208798.043571264*pow(xi2, 29) - 1511662.69413024*pow(xi2, 27) + 4906105.58279559*pow(xi2, 25) - 9421931.56315386*pow(xi2, 23) + 11902666.8263753*pow(xi2, 21) - 10400955.1452*pow(xi2, 19) + 6435583.67661783*pow(xi2, 17) - 2837986.68655086*pow(xi2, 15) + 885729.038971514*pow(xi2, 13) - 191663.560399711*pow(xi2, 11) + 27705.8257147372*pow(xi2, 9) - 2515.56618082523*pow(xi2, 7) + 129.337385505438*pow(xi2, 5) - 3.16011697053909*pow(xi2, 3) + 0.0443007051944733*xi2;
case 15:
return -388150.20920299*pow(xi1, 30) + 2907370.2766753*pow(xi1, 28) - 9799868.25764738*pow(xi1, 26) + 19635467.5225535*pow(xi1, 24) - 26022314.9884176*pow(xi1, 22) + 24015014.9454261*pow(xi1, 20) - 15823943.7997347*pow(xi1, 18) + 7509769.99117948*pow(xi1, 16) - 2557095.55194207*pow(xi1, 14) + 614870.278818831*pow(xi1, 12) - 101334.994345263*pow(xi1, 10) + 10896.6374951452*pow(xi1, 8) - 705.456735268235*pow(xi1, 6) + 23.9002304524183*pow(xi1, 4) - 0.287954583764076*pow(xi1, 2) + 4.96705373128255e-9*pow(xi2, 2)*(78144958802925.0*pow(xi2, 28) - 585330949485135.0*pow(xi2, 26) + 1.97297407836113e+15*pow(xi2, 24) - 3.95314175864238e+15*pow(xi2, 22) + 5.23898399256863e+15*pow(xi2, 20) - 4.83486111579171e+15*pow(xi2, 18) + 3.18578067720012e+15*pow(xi2, 16) - 1.51191639902804e+15*pow(xi2, 14) + 514811332890855.0*pow(xi2, 12) - 123789737756685.0*pow(xi2, 10) + 20401429061871.0*pow(xi2, 8) - 2193782891157.0*pow(xi2, 6) + 142027200315.0*pow(xi2, 4) - 4811751945.0*pow(xi2, 2) + 57972915.0);
case 16:
return -724427.809802815*pow(xi1, 31) + 5607607.86106624*pow(xi1, 29) - 19603442.1230375*pow(xi1, 27) + 40909335.0543521*pow(xi1, 25) - 56752834.2872765*pow(xi1, 23) + 55161687.4630291*pow(xi1, 21) - 38569445.8929905*pow(xi1, 19) + 19607078.2719415*pow(xi1, 17) - 7238045.34529294*pow(xi1, 15) + 1917066.91166751*pow(xi1, 13) - 355638.555911556*pow(xi1, 11) + 44406.788155362*pow(xi1, 9) - 3502.04605682194*pow(xi1, 7) + 156.973642095923*pow(xi1, 5) - 3.30462165176868*pow(xi1, 3) + 0.0411363691091537*xi1 + 724427.809802815*pow(xi2, 31) - 5607607.86106624*pow(xi2, 29) + 19603442.1230375*pow(xi2, 27) - 40909335.0543521*pow(xi2, 25) + 56752834.2872765*pow(xi2, 23) - 55161687.4630291*pow(xi2, 21) + 38569445.8929905*pow(xi2, 19) - 19607078.2719415*pow(xi2, 17) + 7238045.34529294*pow(xi2, 15) - 1917066.91166751*pow(xi2, 13) + 355638.555911556*pow(xi2, 11) - 44406.788155362*pow(xi2, 9) + 3502.04605682194*pow(xi2, 7) - 156.973642095923*pow(xi2, 5) + 3.30462165176868*pow(xi2, 3) - 0.0411363691091537*xi2;
case 17:
return -1356792.91877652*pow(xi1, 32) + 10842269.5533821*pow(xi1, 30) - 39259962.6923692*pow(xi1, 28) + 85195948.6158689*pow(xi1, 26) - 123476826.547754*pow(xi1, 24) + 126085880.85278*pow(xi1, 22) - 93253229.5725235*pow(xi1, 20) + 50570086.7614826*pow(xi1, 18) - 20128075.8467776*pow(xi1, 16) + 5828214.06609189*pow(xi1, 14) - 1204149.47876306*pow(xi1, 12) + 171847.139445908*pow(xi1, 10) - 16094.489574926*pow(xi1, 8) + 911.328265182674*pow(xi1, 6) - 27.098583150655*pow(xi1, 4) + 0.308522768318653*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.91369060679478e+15*pow(xi2, 30) - 2.32835965730964e+16*pow(xi2, 28) + 8.4310127902953e+16*pow(xi2, 26) - 1.82956906528427e+17*pow(xi2, 24) + 2.65164465918234e+17*pow(xi2, 22) - 2.70767367375021e+17*pow(xi2, 20) + 2.00259785630184e+17*pow(xi2, 18) - 1.08598434398225e+17*pow(xi2, 16) + 4.32247137466587e+16*pow(xi2, 14) - 1.25159944039759e+16*pow(xi2, 12) + 2.58589131539138e+15*pow(xi2, 10) - 369038921915664.0*pow(xi2, 8) + 34562653185060.0*pow(xi2, 6) - 1957062547440.0*pow(xi2, 4) + 58193764200.0*pow(xi2, 2) - 662547600.0);
case 18:
return -2549126.08982256*pow(xi1, 33) + 21008406.4842816*pow(xi1, 31) - 78700338.4408196*pow(xi1, 29) + 177331779.269029*pow(xi1, 27) - 268019398.992277*pow(xi1, 25) + 286875811.333441*pow(xi1, 23) - 223788493.707794*pow(xi1, 21) + 128981580.567137*pow(xi1, 19) - 55085774.188775*pow(xi1, 17) + 17325021.2807283*pow(xi1, 15) - 3950825.25901452*pow(xi1, 13) + 636096.448600218*pow(xi1, 11) - 69349.6514969133*pow(xi1, 9) + 4796.62404723465*pow(xi1, 7) - 189.165593348444*pow(xi1, 5) + 3.49659137427807*pow(xi1, 3) - 0.0385653460398316*xi1 + 2549126.08982256*pow(xi2, 33) - 21008406.4842816*pow(xi2, 31) + 78700338.4408196*pow(xi2, 29) - 177331779.269029*pow(xi2, 27) + 268019398.992277*pow(xi2, 25) - 286875811.333441*pow(xi2, 23) + 223788493.707794*pow(xi2, 21) - 128981580.567137*pow(xi2, 19) + 55085774.188775*pow(xi2, 17) - 17325021.2807283*pow(xi2, 15) + 3950825.25901452*pow(xi2, 13) - 636096.448600218*pow(xi2, 11) + 69349.6514969133*pow(xi2, 9) - 4796.62404723465*pow(xi2, 7) + 189.165593348444*pow(xi2, 5) - 3.49659137427807*pow(xi2, 3) + 0.0385653460398316*xi2;
case 19:
return -4802765.24535773*pow(xi1, 34) + 40783598.911459*pow(xi1, 32) - 157883359.35978*pow(xi1, 30) + 368888820.619509*pow(xi1, 28) - 580446875.096901*pow(xi1, 26) + 649886868.128478*pow(xi1, 24) - 533335979.143528*pow(xi1, 22) + 325624954.349418*pow(xi1, 20) - 148585961.788267*pow(xi1, 18) + 50473062.3188808*pow(xi1, 16) - 12606823.4744614*pow(xi1, 14) + 2265194.66060973*pow(xi1, 12) - 282896.404740756*pow(xi1, 10) + 23294.9619154539*pow(xi1, 8) - 1163.72388588265*pow(xi1, 6) + 30.5951745249331*pow(xi1, 4) - 0.327805441338569*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(1.03138598295884e+16*pow(xi2, 32) - 8.75821117689488e+16*pow(xi2, 30) + 3.39051932516435e+17*pow(xi2, 28) - 7.92182710210401e+17*pow(xi2, 26) + 1.24650017280329e+18*pow(xi2, 24) - 1.39562142235584e+18*pow(xi2, 22) + 1.1453302941008e+18*pow(xi2, 20) - 6.99274264846123e+17*pow(xi2, 18) + 3.19085923262657e+17*pow(xi2, 16) - 1.08390075994282e+17*pow(xi2, 14) + 2.70729472646284e+16*pow(xi2, 12) - 4.86446849319631e+15*pow(xi2, 10) + 607515403258764.0*pow(xi2, 8) - 50025549794220.0*pow(xi2, 6) + 2499078015720.0*pow(xi2, 4) - 65702637000.0*pow(xi2, 2) + 703956825.0);
case 20:
return -9071889.90789793*pow(xi1, 35) + 79305876.2916238*pow(xi1, 33) - 316933615.672017*pow(xi1, 31) + 766877990.533416*pow(xi1, 29) - 1254324985.64334*pow(xi1, 27) + 1466251586.22142*pow(xi1, 25) - 1262891657.42003*pow(xi1, 23) + 814364974.334062*pow(xi1, 21) - 395526919.443841*pow(xi1, 19) + 144394456.337024*pow(xi1, 17) - 39241570.1076733*pow(xi1, 15) + 7797068.97306965*pow(xi1, 13) - 1100827.15933084*pow(xi1, 11) + 105759.79021824*pow(xi1, 9) - 6469.68474330381*pow(xi1, 7) + 226.248887423426*pow(xi1, 5) - 3.72726927744225*pow(xi1, 3) + 0.0364228268153965*xi1 + 9071889.90789793*pow(xi2, 35) - 79305876.2916238*pow(xi2, 33) + 316933615.672017*pow(xi2, 31) - 766877990.533416*pow(xi2, 29) + 1254324985.64334*pow(xi2, 27) - 1466251586.22142*pow(xi2, 25) + 1262891657.42003*pow(xi2, 23) - 814364974.334062*pow(xi2, 21) + 395526919.443841*pow(xi2, 19) - 144394456.337024*pow(xi2, 17) + 39241570.1076733*pow(xi2, 15) - 7797068.97306965*pow(xi2, 13) + 1100827.15933084*pow(xi2, 11) - 105759.79021824*pow(xi2, 9) + 6469.68474330381*pow(xi2, 7) - 226.248887423426*pow(xi2, 5) + 3.72726927744225*pow(xi2, 3) - 0.0364228268153965*xi2;
case 21:
return -17175581.0390758*pow(xi1, 36) + 154445460.189213*pow(xi1, 34) - 636536529.850006*pow(xi1, 32) + 1593187891.04673*pow(xi1, 30) - 2704869598.21416*pow(xi1, 28) + 3295408612.9558*pow(xi1, 26) - 2972526156.78936*pow(xi1, 24) + 2019049360.76173*pow(xi1, 22) - 1040211599.82845*pow(xi1, 20) + 406333229.98651*pow(xi1, 18) - 119458267.623672*pow(xi1, 16) + 26042517.6376345*pow(xi1, 14) - 4111046.93219014*pow(xi1, 12) + 453365.068400052*pow(xi1, 10) - 33092.9135811911*pow(xi1, 8) + 1469.6335425321*pow(xi1, 6) - 34.4286770472536*pow(xi1, 4) + 0.346016854746267*pow(xi1, 2) + 3.88051072756449e-11*pow(xi2, 2)*(4.42611353115768e+17*pow(xi2, 34) - 3.98002920317004e+18*pow(xi2, 32) + 1.64034214704906e+19*pow(xi2, 30) - 4.10561393305735e+19*pow(xi2, 28) + 6.97039587856468e+19*pow(xi2, 26) - 8.49220333176112e+19*pow(xi2, 24) + 7.66014157794892e+19*pow(xi2, 22) - 5.2030505840888e+19*pow(xi2, 20) + 2.68060488130982e+19*pow(xi2, 18) - 1.04711276044206e+19*pow(xi2, 16) + 3.07841611608293e+18*pow(xi2, 14) - 6.7111056935486e+17*pow(xi2, 12) + 1.05940872756467e+17*pow(xi2, 10) - 1.16831288515622e+16*pow(xi2, 8) + 852797889363420.0*pow(xi2, 6) - 37872168013680.0*pow(xi2, 4) + 887220251775.0*pow(xi2, 2) - 8916786450.0);
case 22:
return -32587183.4849491*pow(xi1, 37) + 301182124.285212*pow(xi1, 35) - 1278973293.46615*pow(xi1, 33) + 3307586664.76692*pow(xi1, 31) - 5821150644.88581*pow(xi1, 29) + 7379653798.46706*pow(xi1, 27) - 6957507972.42003*pow(xi1, 25) + 4965713056.14373*pow(xi1, 23) - 2705468268.15591*pow(xi1, 21) + 1126397750.97304*pow(xi1, 19) - 356415789.394206*pow(xi1, 17) + 84676873.7027844*pow(xi1, 15) - 14807100.0023584*pow(xi1, 13) + 1849478.42261893*pow(xi1, 11) - 157832.850914726*pow(xi1, 9) + 8602.58799865656*pow(xi1, 7) - 268.64517924597*pow(xi1, 5) + 3.99072772474028*pow(xi1, 3) - 0.0346016854746267*xi1 + 32587183.4849491*pow(xi2, 37) - 301182124.285212*pow(xi2, 35) + 1278973293.46615*pow(xi2, 33) - 3307586664.76692*pow(xi2, 31) + 5821150644.88581*pow(xi2, 29) - 7379653798.46706*pow(xi2, 27) + 6957507972.42003*pow(xi2, 25) - 4965713056.14373*pow(xi2, 23) + 2705468268.15591*pow(xi2, 21) - 1126397750.97304*pow(xi2, 19) + 356415789.394206*pow(xi2, 17) - 84676873.7027844*pow(xi2, 15) + 14807100.0023584*pow(xi2, 13) - 1849478.42261893*pow(xi2, 11) + 157832.850914726*pow(xi2, 9) - 8602.58799865656*pow(xi2, 7) + 268.64517924597*pow(xi2, 5) - 3.99072772474028*pow(xi2, 3) + 0.0346016854746267*xi2;
case 23:
return -61948317.4770274*pow(xi1, 38) + 588045987.694992*pow(xi1, 36) - 2570691567.21059*pow(xi1, 34) + 6862092306.58149*pow(xi1, 32) - 12503588653.0115*pow(xi1, 30) + 16469394098.4744*pow(xi1, 28) - 16199740202.3215*pow(xi1, 26) + 12121984061.9096*pow(xi1, 24) - 6964913198.30605*pow(xi1, 22) + 3079877352.23662*pow(xi1, 20) - 1044184571.43626*pow(xi1, 18) + 268758699.305915*pow(xi1, 16) - 51646562.040118*pow(xi1, 14) + 7225262.03304275*pow(xi1, 12) - 709111.122226401*pow(xi1, 10) + 46213.1483845536*pow(xi1, 8) - 1836.73243531171*pow(xi1, 6) + 38.6327818324207*pow(xi1, 4) - 0.363317697483581*pow(xi1, 2) + 5.82076609134674e-11*pow(xi2, 2)*(1.06426399042423e+18*pow(xi2, 36) - 1.0102553142776e+19*pow(xi2, 34) + 4.41641448370898e+19*pow(xi2, 32) - 1.17889848155603e+20*pow(xi2, 30) + 2.14810017389285e+20*pow(xi2, 28) - 2.82942036151532e+20*pow(xi2, 26) + 2.78309417490669e+20*pow(xi2, 24) - 2.0825410043414e+20*pow(xi2, 22) + 1.19656297624813e+20*pow(xi2, 20) - 5.29118900141894e+19*pow(xi2, 18) + 1.7938954341226e+19*pow(xi2, 16) - 4.61723929613762e+18*pow(xi2, 14) + 8.87281179652568e+17*pow(xi2, 12) - 1.24129056547796e+17*pow(xi2, 10) + 1.2182436316769e+16*pow(xi2, 8) - 793935843827412.0*pow(xi2, 6) + 31554822964665.0*pow(xi2, 4) - 663706138095.0*pow(xi2, 2) + 6241750515.0);
case 24:
return -117976166.383989*pow(xi1, 39) + 1149404705.7981*pow(xi1, 37) - 5168467444.95001*pow(xi1, 35) + 14226677005.8239*pow(xi1, 33) - 26807724752.4166*pow(xi1, 31) + 36636726077.2706*pow(xi1, 29) - 37534635100.886*pow(xi1, 27) + 29386507704.384*pow(xi1, 25) - 17761358284.0216*pow(xi1, 23) + 8315597465.75811*pow(xi1, 21) - 3008687944.80839*pow(xi1, 19) + 834616101.433694*pow(xi1, 17) - 175043774.437964*pow(xi1, 15) + 27169837.4464822*pow(xi1, 13) - 3025402.05860465*pow(xi1, 11) + 230948.140743281*pow(xi1, 9) - 11288.6844422918*pow(xi1, 7) + 316.841657236393*pow(xi1, 5) - 4.28274497942766*pow(xi1, 3) + 0.0330288815894164*xi1 + 117976166.383989*pow(xi2, 39) - 1149404705.7981*pow(xi2, 37) + 5168467444.95001*pow(xi2, 35) - 14226677005.8239*pow(xi2, 33) + 26807724752.4166*pow(xi2, 31) - 36636726077.2706*pow(xi2, 29) + 37534635100.886*pow(xi2, 27) - 29386507704.384*pow(xi2, 25) + 17761358284.0216*pow(xi2, 23) - 8315597465.75811*pow(xi2, 21) + 3008687944.80839*pow(xi2, 19) - 834616101.433694*pow(xi2, 17) + 175043774.437964*pow(xi2, 15) - 27169837.4464822*pow(xi2, 13) + 3025402.05860465*pow(xi2, 11) - 230948.140743281*pow(xi2, 9) + 11288.6844422918*pow(xi2, 7) - 316.841657236393*pow(xi2, 5) + 4.28274497942766*pow(xi2, 3) - 0.0330288815894164*xi2;
case 25:
return -225052360.873805*pow(xi1, 40) + 2248910330.16548*pow(xi1, 38) - 10393802715.0371*pow(xi1, 36) + 29475054534.4272*pow(xi1, 34) - 57374577463.9329*pow(xi1, 32) + 81251153683.8055*pow(xi1, 30) - 86567901261.2371*pow(xi1, 28) + 70779385557.1236*pow(xi1, 26) - 44897488059.1497*pow(xi1, 24) + 22192208682.0584*pow(xi1, 22) - 8538204843.03323*pow(xi1, 20) + 2541010647.06651*pow(xi1, 18) - 578145679.079641*pow(xi1, 16) + 98762409.9830697*pow(xi1, 14) - 12337113.0280166*pow(xi1, 12) + 1084949.75604712*pow(xi1, 10) - 63529.6180163226*pow(xi1, 8) + 2273.46416187924*pow(xi1, 6) - 43.2375584073452*pow(xi1, 4) + 0.379832138278289*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(3.09309609548987e+19*pow(xi2, 38) - 3.09087882230314e+20*pow(xi2, 36) + 1.42851336774913e+21*pow(xi2, 34) - 4.0510206487418e+21*pow(xi2, 32) + 7.88550188254113e+21*pow(xi2, 30) - 1.11670735306949e+22*pow(xi2, 28) + 1.18978017536119e+22*pow(xi2, 26) - 9.72784467836226e+21*pow(xi2, 24) + 6.17066377237116e+21*pow(xi2, 22) - 3.05007393649434e+21*pow(xi2, 20) + 1.17348193815605e+21*pow(xi2, 18) - 3.4923384409403e+20*pow(xi2, 16) + 7.94597370870647e+19*pow(xi2, 14) - 1.35738022704457e+19*pow(xi2, 12) + 1.69559990343638e+18*pow(xi2, 10) - 1.49114359040817e+17*pow(xi2, 8) + 8.73144421463929e+15*pow(xi2, 6) - 312462535164780.0*pow(xi2, 4) + 5942524778190.0*pow(xi2, 2) - 52203731580.0);
case 26:
return -429978087.848327*pow(xi1, 41) + 4404250503.12178*pow(xi1, 39) - 20905920719.0056*pow(xi1, 37) + 61025896951.4279*pow(xi1, 35) - 122587641860.07*pow(xi1, 33) + 179674777476.665*pow(xi1, 31) - 198793181542.137*pow(xi1, 29) + 169446632019.221*pow(xi1, 27) - 112569347434.57*pow(xi1, 25) + 58591489691.1156*pow(xi1, 23) - 23893543905.5802*pow(xi1, 21) + 7597569384.4288*pow(xi1, 19) - 1865442270.4129*pow(xi1, 17) + 348266022.083215*pow(xi1, 15) - 48339465.2060883*pow(xi1, 13) + 4830882.97791334*pow(xi1, 11) - 331913.895870354*pow(xi1, 9) + 14634.4945765412*pow(xi1, 7) - 371.378763023051*pow(xi1, 5) + 4.60018923025928*pow(xi1, 3) - 0.0316526781898574*xi1 + 429978087.848327*pow(xi2, 41) - 4404250503.12178*pow(xi2, 39) + 20905920719.0056*pow(xi2, 37) - 61025896951.4279*pow(xi2, 35) + 122587641860.07*pow(xi2, 33) - 179674777476.665*pow(xi2, 31) + 198793181542.137*pow(xi2, 29) - 169446632019.221*pow(xi2, 27) + 112569347434.57*pow(xi2, 25) - 58591489691.1156*pow(xi2, 23) + 23893543905.5802*pow(xi2, 21) - 7597569384.4288*pow(xi2, 19) + 1865442270.4129*pow(xi2, 17) - 348266022.083215*pow(xi2, 15) + 48339465.2060883*pow(xi2, 13) - 4830882.97791334*pow(xi2, 11) + 331913.895870354*pow(xi2, 9) - 14634.4945765412*pow(xi2, 7) + 371.378763023051*pow(xi2, 5) - 4.60018923025928*pow(xi2, 3) + 0.0316526781898574*xi2;
case 27:
return -822691408.083133*pow(xi1, 42) + 8632572977.90458*pow(xi1, 40) - 42056253141.7558*pow(xi1, 38) + 126266287574.99*pow(xi1, 36) - 261501013397.442*pow(xi1, 34) + 396237078099.193*pow(xi1, 32) - 454647922164.956*pow(xi1, 30) + 403359319727.115*pow(xi1, 28) - 280098134146.143*pow(xi1, 26) + 153155936673.263*pow(xi1, 24) - 66007168841.7615*pow(xi1, 22) + 22343350843.1183*pow(xi1, 20) - 5892511135.08151*pow(xi1, 18) + 1194958667.49436*pow(xi1, 16) - 182789740.258828*pow(xi1, 14) + 20523114.9238803*pow(xi1, 12) - 1627047.87812054*pow(xi1, 10) + 86086.5914944378*pow(xi1, 8) - 2789.11090834172*pow(xi1, 6) + 48.2703342395325*pow(xi1, 4) - 0.395658477373217*pow(xi1, 2) + 1.2126596023639e-12*pow(xi2, 2)*(6.78419076944111e+20*pow(xi2, 40) - 7.11871077512323e+21*pow(xi2, 38) + 3.46810045125385e+22*pow(xi2, 36) - 1.04123438538607e+23*pow(xi2, 34) + 2.15642553679271e+23*pow(xi2, 32) - 3.26750456044538e+23*pow(xi2, 30) + 3.74918007723425e+23*pow(xi2, 28) - 3.32623696658836e+23*pow(xi2, 26) + 2.30978366559034e+23*pow(xi2, 24) - 1.26297549926383e+23*pow(xi2, 22) + 5.44317372435678e+22*pow(xi2, 20) - 1.84250805416155e+22*pow(xi2, 18) + 4.85916338236626e+21*pow(xi2, 16) - 9.85403212216326e+20*pow(xi2, 14) + 1.50734583639552e+20*pow(xi2, 12) - 1.69240526227421e+19*pow(xi2, 10) + 1.34171854570635e+18*pow(xi2, 8) - 7.09899062578027e+16*pow(xi2, 6) + 2.29999490615895e+15*pow(xi2, 4) - 39805345329750.0*pow(xi2, 2) + 326273322375.0);
case 28:
return -1576211982.21294*pow(xi1, 43) + 16933561364.8873*pow(xi1, 41) - 84614559003.2213*pow(xi1, 39) + 261084075522.621*pow(xi1, 37) - 556967491278.751*pow(xi1, 35) + 871554447543.638*pow(xi1, 33) - 1035805550194.54*pow(xi1, 31) + 955069184599.961*pow(xi1, 29) - 692003707251.794*pow(xi1, 27) + 396644167130.276*pow(xi1, 25) - 180184197345.899*pow(xi1, 23) + 64714887198.5536*pow(xi1, 21) - 18255406234.0253*pow(xi1, 19) + 3999772030.77123*pow(xi1, 17) - 669517007.246176*pow(xi1, 15) + 83640451.2585604*pow(xi1, 13) - 7546458.86981693*pow(xi1, 11) + 469247.674788719*pow(xi1, 9) - 18761.013674985*pow(xi1, 7) + 432.842258174969*pow(xi1, 5) - 4.94065842258351*pow(xi1, 3) + 0.0304352674902475*xi1 + 1576211982.21294*pow(xi2, 43) - 16933561364.8873*pow(xi2, 41) + 84614559003.2213*pow(xi2, 39) - 261084075522.621*pow(xi2, 37) + 556967491278.751*pow(xi2, 35) - 871554447543.638*pow(xi2, 33) + 1035805550194.54*pow(xi2, 31) - 955069184599.961*pow(xi2, 29) + 692003707251.794*pow(xi2, 27) - 396644167130.276*pow(xi2, 25) + 180184197345.899*pow(xi2, 23) - 64714887198.5536*pow(xi2, 21) + 18255406234.0253*pow(xi2, 19) - 3999772030.77123*pow(xi2, 17) + 669517007.246176*pow(xi2, 15) - 83640451.2585604*pow(xi2, 13) + 7546458.86981693*pow(xi2, 11) - 469247.674788719*pow(xi2, 9) + 18761.013674985*pow(xi2, 7) - 432.842258174969*pow(xi2, 5) + 4.94065842258351*pow(xi2, 3) - 0.0304352674902475*xi2;
case 29:
return -3023726521.43375*pow(xi1, 44) + 33240747675.0678*pow(xi1, 42) - 170255712367.296*pow(xi1, 40) + 539510185383.932*pow(xi1, 38) - 1184526688778.06*pow(xi1, 36) + 1912326388450.07*pow(xi1, 34) - 2351270564754.81*pow(xi1, 32) + 2250082365455.32*pow(xi1, 30) - 1698284245818.33*pow(xi1, 28) + 1018375869131.64*pow(xi1, 26) - 486441112729.579*pow(xi1, 24) + 184821161665.788*pow(xi1, 22) - 55558771326.0834*pow(xi1, 20) + 13089485207.7017*pow(xi1, 18) - 2382798209.34807*pow(xi1, 16) + 328475493.04593*pow(xi1, 14) - 33341967.2140553*pow(xi1, 12) + 2395791.07105762*pow(xi1, 10) - 115121.977334549*pow(xi1, 8) + 3393.85493899799*pow(xi1, 6) - 53.7562912046496*pow(xi1, 4) + 0.410876111118341*pow(xi1, 2) + 8.26813365248117e-14*pow(xi2, 2)*(3.6570847164842e+22*pow(xi2, 42) - 4.02034474431756e+23*pow(xi2, 40) + 2.0591794898744e+24*pow(xi2, 38) - 6.52517494346541e+24*pow(xi2, 36) + 1.43264095449473e+25*pow(xi2, 34) - 2.31288761022411e+25*pow(xi2, 32) + 2.84377425859489e+25*pow(xi2, 30) - 2.72139089669903e+25*pow(xi2, 28) + 2.05401160310065e+25*pow(xi2, 26) - 1.2316877205124e+25*pow(xi2, 24) + 5.88332425641915e+24*pow(xi2, 22) - 2.23534317941661e+24*pow(xi2, 20) + 6.71962666077741e+23*pow(xi2, 18) - 1.5831245306217e+23*pow(xi2, 16) + 2.88190577160423e+22*pow(xi2, 14) - 3.972788864478e+21*pow(xi2, 12) + 4.03258687092579e+20*pow(xi2, 10) - 2.89762015438475e+19*pow(xi2, 8) + 1.39235747961092e+18*pow(xi2, 6) - 4.10474126525463e+16*pow(xi2, 4) + 650162339701875.0*pow(xi2, 2) - 4969393679250.0);
default:
return 0.;
}
case 19:
switch(j) {
case 0:
return 1.52587890625e-5*y1t*(-92116035.0*pow(xi1, 19) + 424292040.0*pow(xi1, 17) - 814366980.0*pow(xi1, 15) + 842448600.0*pow(xi1, 13) - 507029250.0*pow(xi1, 11) + 178474296.0*pow(xi1, 9) - 34918884.0*pow(xi1, 7) + 3325608.0*pow(xi1, 5) - 109395.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-30705345.0*pow(xi2, 16) + 141430680.0*pow(xi2, 14) - 271455660.0*pow(xi2, 12) + 280816200.0*pow(xi2, 10) - 169009750.0*pow(xi2, 8) + 59491432.0*pow(xi2, 6) - 11639628.0*pow(xi2, 4) + 1108536.0*pow(xi2, 2) - 36465.0));
case 1:
return 3.814697265625e-6*y1r*(-184232070.0*pow(xi1, 19) + 64822395.0*pow(xi1, 18) + 848584080.0*pow(xi1, 17) - 300540195.0*pow(xi1, 16) - 1628733960.0*pow(xi1, 15) + 581690700.0*pow(xi1, 14) + 1684897200.0*pow(xi1, 13) - 608435100.0*pow(xi1, 12) - 1014058500.0*pow(xi1, 11) + 371821450.0*pow(xi1, 10) + 356948592.0*pow(xi1, 9) - 133855722.0*pow(xi1, 8) - 69837768.0*pow(xi1, 7) + 27159132.0*pow(xi1, 6) + 6651216.0*pow(xi1, 5) - 2771340.0*pow(xi1, 4) - 218790.0*pow(xi1, 3) + 109395.0*pow(xi1, 2) + pow(xi2, 2)*(184232070.0*pow(xi2, 17) - 64822395.0*pow(xi2, 16) - 848584080.0*pow(xi2, 15) + 300540195.0*pow(xi2, 14) + 1628733960.0*pow(xi2, 13) - 581690700.0*pow(xi2, 12) - 1684897200.0*pow(xi2, 11) + 608435100.0*pow(xi2, 10) + 1014058500.0*pow(xi2, 9) - 371821450.0*pow(xi2, 8) - 356948592.0*pow(xi2, 7) + 133855722.0*pow(xi2, 6) + 69837768.0*pow(xi2, 5) - 27159132.0*pow(xi2, 4) - 6651216.0*pow(xi2, 3) + 2771340.0*pow(xi2, 2) + 218790.0*xi2 - 109395.0));
case 2:
return 1.52587890625e-5*y2t*(92116035.0*pow(xi1, 19) - 424292040.0*pow(xi1, 17) + 814366980.0*pow(xi1, 15) - 842448600.0*pow(xi1, 13) + 507029250.0*pow(xi1, 11) - 178474296.0*pow(xi1, 9) + 34918884.0*pow(xi1, 7) - 3325608.0*pow(xi1, 5) + 109395.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-30705345.0*pow(xi2, 16) + 141430680.0*pow(xi2, 14) - 271455660.0*pow(xi2, 12) + 280816200.0*pow(xi2, 10) - 169009750.0*pow(xi2, 8) + 59491432.0*pow(xi2, 6) - 11639628.0*pow(xi2, 4) + 1108536.0*pow(xi2, 2) - 36465.0));
case 3:
return 3.814697265625e-6*y2r*(-184232070.0*pow(xi1, 19) - 64822395.0*pow(xi1, 18) + 848584080.0*pow(xi1, 17) + 300540195.0*pow(xi1, 16) - 1628733960.0*pow(xi1, 15) - 581690700.0*pow(xi1, 14) + 1684897200.0*pow(xi1, 13) + 608435100.0*pow(xi1, 12) - 1014058500.0*pow(xi1, 11) - 371821450.0*pow(xi1, 10) + 356948592.0*pow(xi1, 9) + 133855722.0*pow(xi1, 8) - 69837768.0*pow(xi1, 7) - 27159132.0*pow(xi1, 6) + 6651216.0*pow(xi1, 5) + 2771340.0*pow(xi1, 4) - 218790.0*pow(xi1, 3) - 109395.0*pow(xi1, 2) + pow(xi2, 2)*(184232070.0*pow(xi2, 17) + 64822395.0*pow(xi2, 16) - 848584080.0*pow(xi2, 15) - 300540195.0*pow(xi2, 14) + 1628733960.0*pow(xi2, 13) + 581690700.0*pow(xi2, 12) - 1684897200.0*pow(xi2, 11) - 608435100.0*pow(xi2, 10) + 1014058500.0*pow(xi2, 9) + 371821450.0*pow(xi2, 8) - 356948592.0*pow(xi2, 7) - 133855722.0*pow(xi2, 6) + 69837768.0*pow(xi2, 5) + 27159132.0*pow(xi2, 4) - 6651216.0*pow(xi2, 3) - 2771340.0*pow(xi2, 2) + 218790.0*xi2 + 109395.0));
case 4:
return -1335.30018997192*pow(xi1, 20) + 6609.06154632568*pow(xi1, 18) - 13942.5528144836*pow(xi1, 16) + 16374.4972229004*pow(xi1, 14) - 11733.9227676392*pow(xi1, 12) + 5287.74400939941*pow(xi1, 10) - 1487.45551300049*pow(xi1, 8) + 249.495025634766*pow(xi1, 6) - 22.3955726623535*pow(xi1, 4) + 0.834617614746094*pow(xi1, 2) + 7.62939453125e-7*pow(xi2, 2)*(1750204665.0*pow(xi2, 18) - 8662629150.0*pow(xi2, 16) + 18274782825.0*pow(xi2, 14) - 21462381000.0*pow(xi2, 12) + 15379887250.0*pow(xi2, 10) - 6930751828.0*pow(xi2, 8) + 1949637690.0*pow(xi2, 6) - 327018120.0*pow(xi2, 4) + 29354325.0*pow(xi2, 2) - 1093950.0);
case 5:
return -2119.52411106655*pow(xi1, 21) + 11060.0621795654*pow(xi1, 19) - 24748.0856323242*pow(xi1, 17) + 30994.2196655273*pow(xi1, 15) - 23765.4090881348*pow(xi1, 13) + 11450.245513916*pow(xi1, 11) - 3413.99407958984*pow(xi1, 9) + 593.230303083147*pow(xi1, 7) - 52.4139862060547*pow(xi1, 5) + 1.66923522949219*pow(xi1, 3) + 2.17982700892857e-6*pow(xi2, 3)*(972335925.0*pow(xi2, 18) - 5073825645.0*pow(xi2, 16) + 11353233780.0*pow(xi2, 14) - 14218660260.0*pow(xi2, 12) + 10902428950.0*pow(xi2, 10) - 5252823030.0*pow(xi2, 8) + 1566176612.0*pow(xi2, 6) - 272145588.0*pow(xi2, 4) + 24045021.0*pow(xi2, 2) - 765765.0);
case 6:
return -3540.56868553162*pow(xi1, 22) + 19388.8285160065*pow(xi1, 20) - 45859.8821353912*pow(xi1, 18) + 61306.8062496185*pow(xi1, 16) - 50899.6626853943*pow(xi1, 14) + 27168.544254303*pow(xi1, 12) - 9342.84868240356*pow(xi1, 10) + 2023.97553634644*pow(xi1, 8) - 263.558332443237*pow(xi1, 6) + 18.9875507354736*pow(xi1, 4) - 0.62596321105957*pow(xi1, 2) + 1.9073486328125e-6*pow(xi2, 2)*(1856277675.0*pow(xi2, 20) - 10165330125.0*pow(xi2, 18) + 24043785885.0*pow(xi2, 16) - 32142422835.0*pow(xi2, 14) + 26686082350.0*pow(xi2, 12) - 14244141730.0*pow(xi2, 10) + 4898343450.0*pow(xi2, 8) - 1061146086.0*pow(xi2, 6) + 138180471.0*pow(xi2, 4) - 9954945.0*pow(xi2, 2) + 328185.0);
case 7:
return -6095.93564987183*pow(xi1, 23) + 34933.6110305786*pow(xi1, 21) - 87051.21717453*pow(xi1, 19) + 123659.410858154*pow(xi1, 17) - 110306.809043884*pow(xi1, 15) + 64153.908493042*pow(xi1, 13) - 24448.4942550659*pow(xi1, 11) + 5969.55612182617*pow(xi1, 9) - 881.217098236084*pow(xi1, 7) + 69.2732620239258*pow(xi1, 5) - 2.08654403686523*pow(xi1, 3) + 3.814697265625e-6*pow(xi2, 3)*(1598012955.0*pow(xi2, 20) - 9157636530.0*pow(xi2, 18) + 22819954275.0*pow(xi2, 16) - 32416572600.0*pow(xi2, 14) + 28916268150.0*pow(xi2, 12) - 16817562188.0*pow(xi2, 10) + 6409026078.0*pow(xi2, 8) - 1564883320.0*pow(xi2, 6) + 231005775.0*pow(xi2, 4) - 18159570.0*pow(xi2, 2) + 546975.0);
case 8:
return -10710.2202737331*pow(xi1, 24) + 64084.2932081223*pow(xi1, 22) - 167771.560342312*pow(xi1, 20) + 252330.548357964*pow(xi1, 18) - 240678.833252192*pow(xi1, 16) + 151630.777410507*pow(xi1, 14) - 63727.5063905716*pow(xi1, 12) + 17635.4748363495*pow(xi1, 10) - 3100.26537537575*pow(xi1, 8) + 325.466094017029*pow(xi1, 6) - 18.6919569969177*pow(xi1, 4) + 0.521636009216309*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(44921919735.0*pow(xi2, 22) - 268789007340.0*pow(xi2, 20) + 703684926630.0*pow(xi2, 18) - 1058351028300.0*pow(xi2, 16) + 1009480193025.0*pow(xi2, 14) - 635985576216.0*pow(xi2, 12) + 267292534964.0*pow(xi2, 10) - 73968542648.0*pow(xi2, 8) + 13003455465.0*pow(xi2, 6) - 1365103740.0*pow(xi2, 4) + 78399750.0*pow(xi2, 2) - 2187900.0);
case 9:
return -19094.7927165985*pow(xi1, 25) + 119064.266939163*pow(xi1, 23) - 326681.909379959*pow(xi1, 21) + 518565.316343307*pow(xi1, 19) - 526676.111125946*pow(xi1, 17) + 357375.374311066*pow(xi1, 15) - 164236.218235016*pow(xi1, 13) + 50730.0305137634*pow(xi1, 11) - 10234.6607875824*pow(xi1, 9) + 1273.41782569885*pow(xi1, 7) - 87.1479892730713*pow(xi1, 5) + 2.43430137634277*pow(xi1, 3) + 3.814697265625e-7*pow(xi2, 3)*(50055853419.0*pow(xi2, 22) - 312119831925.0*pow(xi2, 20) + 856377024525.0*pow(xi2, 18) - 1359387862875.0*pow(xi2, 16) + 1380649824750.0*pow(xi2, 14) - 936838101234.0*pow(xi2, 12) + 430535391930.0*pow(xi2, 10) - 132985731190.0*pow(xi2, 8) + 26829549175.0*pow(xi2, 6) - 3338188425.0*pow(xi2, 4) + 228453225.0*pow(xi2, 2) - 6381375.0);
case 10:
return -34425.7080227137*pow(xi1, 26) + 223315.047395825*pow(xi1, 24) - 640760.128458738*pow(xi1, 22) + 1070494.58503604*pow(xi1, 20) - 1153444.84326541*pow(xi1, 18) + 838792.879251838*pow(xi1, 16) - 418623.917339802*pow(xi1, 14) + 142953.808037281*pow(xi1, 12) - 32702.0305608511*pow(xi1, 10) + 4801.93332374096*pow(xi1, 8) - 420.951565504074*pow(xi1, 6) + 19.778698682785*pow(xi1, 4) - 0.45643150806427*pow(xi1, 2) + 1.19209289550781e-7*pow(xi2, 2)*(288783769725.0*pow(xi2, 24) - 1873302393105.0*pow(xi2, 22) + 5375085539670.0*pow(xi2, 20) - 8979959439990.0*pow(xi2, 18) + 9675796639775.0*pow(xi2, 16) - 7036304657235.0*pow(xi2, 14) + 3511671941988.0*pow(xi2, 12) - 1199183457732.0*pow(xi2, 10) + 274324515179.0*pow(xi2, 8) - 40281536295.0*pow(xi2, 6) + 3531197670.0*pow(xi2, 4) - 165915750.0*pow(xi2, 2) + 3828825.0);
case 11:
return -62617.9545104504*pow(xi1, 27) + 421917.768359184*pow(xi1, 25) - 1263536.77855253*pow(xi1, 23) + 2216141.37401104*pow(xi1, 21) - 2525006.14107251*pow(xi1, 19) + 1959343.88411522*pow(xi1, 17) - 1055685.46106815*pow(xi1, 15) + 395240.543043137*pow(xi1, 13) - 101248.362429857*pow(xi1, 11) + 17159.9815893173*pow(xi1, 9) - 1813.4675860405*pow(xi1, 7) + 107.352690696716*pow(xi1, 5) - 2.73858904838562*pow(xi1, 3) + 2.38418579101563e-7*pow(xi2, 3)*(262638737075.0*pow(xi2, 24) - 1769651383500.0*pow(xi2, 22) + 5299657364430.0*pow(xi2, 20) - 9295170629580.0*pow(xi2, 18) + 10590643357525.0*pow(xi2, 16) - 8218083890520.0*pow(xi2, 14) + 4427865752100.0*pow(xi2, 12) - 1657758990648.0*pow(xi2, 10) + 424666411533.0*pow(xi2, 8) - 71974179420.0*pow(xi2, 6) + 7606234350.0*pow(xi2, 4) - 450269820.0*pow(xi2, 2) + 11486475.0);
case 12:
return -114725.038085218*pow(xi1, 28) + 801794.444799721*pow(xi1, 26) - 2501673.42693731*pow(xi1, 24) + 4595958.69847834*pow(xi1, 22) - 5521081.21116832*pow(xi1, 20) + 4554034.10654563*pow(xi1, 18) - 2635353.3188543*pow(xi1, 16) + 1074078.76940336*pow(xi1, 14) - 304999.325132221*pow(xi1, 12) + 58775.3960224986*pow(xi1, 10) - 7336.62985315919*pow(xi1, 8) + 548.831502556801*pow(xi1, 6) - 21.703318208456*pow(xi1, 4) + 0.410788357257843*pow(xi1, 2) + 4.25747462681362e-9*pow(xi2, 2)*(26946734423895.0*pow(xi2, 26) - 188326300232070.0*pow(xi2, 24) + 587595616232625.0*pow(xi2, 22) - 1.0795034853603e+15*pow(xi2, 20) + 1.29679720846638e+15*pow(xi2, 18) - 1.06965619427636e+15*pow(xi2, 16) + 618994486134297.0*pow(xi2, 14) - 252280721214120.0*pow(xi2, 12) + 71638553806365.0*pow(xi2, 10) - 13805225203770.0*pow(xi2, 8) + 1723235132619.0*pow(xi2, 6) - 128910105324.0*pow(xi2, 4) + 5097697605.0*pow(xi2, 2) - 96486390.0);
case 13:
return -211468.095279336*pow(xi1, 29) + 1530931.36221707*pow(xi1, 27) - 4968446.72460437*pow(xi1, 25) + 9541290.03068805*pow(xi1, 23) - 12053003.4512252*pow(xi1, 21) + 10531942.866402*pow(xi1, 19) - 6516402.00767183*pow(xi1, 17) + 2873527.1355443*pow(xi1, 15) - 896790.912789702*pow(xi1, 13) + 194050.851504207*pow(xi1, 11) - 28050.0218017101*pow(xi1, 9) + 2546.69480967522*pow(xi1, 7) - 130.74024116993*pow(xi1, 5) + 3.01244795322418*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(1773922955805.0*pow(xi2, 26) - 12842383072545.0*pow(xi2, 24) + 41678351941590.0*pow(xi2, 22) - 80038141881750.0*pow(xi2, 20) + 101107921174975.0*pow(xi2, 18) - 88348340184643.0*pow(xi2, 16) + 54663542012772.0*pow(xi2, 14) - 24104892717444.0*pow(xi2, 12) + 7522827425355.0*pow(xi2, 10) - 1627816525335.0*pow(xi2, 8) + 235300637286.0*pow(xi2, 6) - 21363224454.0*pow(xi2, 4) + 1096728633.0*pow(xi2, 2) - 25270245.0);
case 14:
return -391803.387642547*pow(xi1, 30) + 2934653.8323424*pow(xi1, 28) - 9891570.76237254*pow(xi1, 26) + 19818695.1768938*pow(xi1, 24) - 26264479.8180815*pow(xi1, 22) + 24237903.7461447*pow(xi1, 20) - 15970425.639332*pow(xi1, 18) + 7579109.61396427*pow(xi1, 16) - 2580646.50840618*pow(xi1, 14) + 620519.280194566*pow(xi1, 12) - 102263.733961907*pow(xi1, 10) + 10996.2634524554*pow(xi1, 8) - 711.916762545705*pow(xi1, 6) + 24.2251022905111*pow(xi1, 4) - 0.376555994153023*pow(xi1, 2) + 2.98023223876953e-9*pow(xi2, 2)*(131467401280215.0*pow(xi2, 28) - 984706424608725.0*pow(xi2, 26) + 3.31906038519218e+15*pow(xi2, 24) - 6.65005059641813e+15*pow(xi2, 22) + 8.81289702071188e+15*pow(xi2, 20) - 8.13289093072556e+15*pow(xi2, 18) + 5.35878561126024e+15*pow(xi2, 16) - 2.54312718162311e+15*pow(xi2, 14) + 865921277823525.0*pow(xi2, 12) - 208211719919775.0*pow(xi2, 10) + 34314015072909.0*pow(xi2, 8) - 3689733742695.0*pow(xi2, 6) + 238879625985.0*pow(xi2, 4) - 8128595475.0*pow(xi2, 2) + 126351225.0);
case 15:
return -729162.632089108*pow(xi1, 31) + 5644160.68911642*pow(xi1, 29) - 19730891.0453005*pow(xi1, 27) + 41174618.8415927*pow(xi1, 25) - 57119932.9378419*pow(xi1, 23) + 55517614.4424215*pow(xi1, 21) - 38817710.5718181*pow(xi1, 19) + 19732985.769913*pow(xi1, 17) - 7284416.2171289*pow(xi1, 15) + 1929320.51155955*pow(xi1, 13) - 357906.614608616*pow(xi1, 11) + 44689.359359622*pow(xi1, 9) - 3524.28437796235*pow(xi1, 7) + 157.952687680721*pow(xi1, 5) - 3.26348528265953*pow(xi1, 3) + 2.98023223876953e-8*pow(xi2, 3)*(24466637955375.0*pow(xi2, 28) - 189386606040030.0*pow(xi2, 26) + 662058841878945.0*pow(xi2, 24) - 1.38159094804614e+15*pow(xi2, 22) + 1.91662690560738e+15*pow(xi2, 20) - 1.86286201861045e+15*pow(xi2, 18) + 1.30250622977775e+15*pow(xi2, 16) - 662129129173512.0*pow(xi2, 14) + 244424448617349.0*pow(xi2, 12) - 64737253911330.0*pow(xi2, 10) + 12009353162235.0*pow(xi2, 8) - 1499526069756.0*pow(xi2, 6) + 118255360509.0*pow(xi2, 4) - 5300012718.0*pow(xi2, 2) + 109504395.0);
case 16:
return -1362297.14968434*pow(xi1, 32) + 10886145.5732351*pow(xi1, 30) - 39418452.9770324*pow(xi1, 28) + 85539062.1861455*pow(xi1, 26) - 123972950.147591*pow(xi1, 24) + 126591326.678001*pow(xi1, 22) - 93626216.0619297*pow(xi1, 20) + 50771905.0317212*pow(xi1, 18) - 20208229.3198293*pow(xi1, 16) + 5851373.28615982*pow(xi1, 14) - 1208924.23957804*pow(xi1, 12) + 172527.140995972*pow(xi1, 10) - 16158.0459508058*pow(xi1, 8) + 914.918098993599*pow(xi1, 6) - 27.2151361964643*pow(xi1, 4) + 0.349659137427807*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.92551085266413e+15*pow(xi2, 30) - 2.337781960827e+16*pow(xi2, 28) + 8.4650483197634e+16*pow(xi2, 26) - 1.83693737310003e+17*pow(xi2, 24) + 2.66229883236271e+17*pow(xi2, 22) - 2.71852804019633e+17*pow(xi2, 20) + 2.01060768017109e+17*pow(xi2, 18) - 1.0903183583343e+17*pow(xi2, 16) + 4.33968420193677e+16*pow(xi2, 14) - 1.25657284503722e+16*pow(xi2, 12) + 2.59614503616468e+15*pow(xi2, 10) - 370499214125040.0*pow(xi2, 8) + 34699139462988.0*pow(xi2, 6) - 1964771656848.0*pow(xi2, 4) + 58444059960.0*pow(xi2, 2) - 750887280.0);
case 17:
return -2553963.1412264*pow(xi1, 33) + 21048178.9914865*pow(xi1, 31) - 78848995.5336358*pow(xi1, 29) + 177665999.267845*pow(xi1, 27) - 268523439.726083*pow(xi1, 25) + 287414158.917535*pow(xi1, 23) - 224207568.133305*pow(xi1, 21) + 129222615.574253*pow(xi1, 19) - 55188505.9515298*pow(xi1, 17) + 17357266.487902*pow(xi1, 15) - 3958163.94090767*pow(xi1, 13) + 637275.694173083*pow(xi1, 11) - 69477.9699251801*pow(xi1, 9) + 4805.48207871616*pow(xi1, 7) - 189.515252485871*pow(xi1, 5) + 3.49659137427807*pow(xi1, 3) + 1.49011611938477e-8*pow(xi2, 3)*(171393565105575.0*pow(xi2, 30) - 1.41251938138733e+15*pow(xi2, 28) + 5.29146651780338e+15*pow(xi2, 26) - 1.19229633822899e+16*pow(xi2, 24) + 1.80203029973899e+16*pow(xi2, 22) - 1.92880377024713e+16*pow(xi2, 20) + 1.50463151976287e+16*pow(xi2, 18) - 8.67198293429683e+15*pow(xi2, 16) + 3.70363794026441e+15*pow(xi2, 14) - 1.16482643614838e+15*pow(xi2, 12) + 265627885600077.0*pow(xi2, 10) - 42766847890767.0*pow(xi2, 8) + 4662587634705.0*pow(xi2, 6) - 322490443275.0*pow(xi2, 4) + 12718153305.0*pow(xi2, 2) - 234652275.0);
case 18:
return -4802765.24535773*pow(xi1, 34) + 40783598.911459*pow(xi1, 32) - 157883359.35978*pow(xi1, 30) + 368888820.619509*pow(xi1, 28) - 580446875.096901*pow(xi1, 26) + 649886868.128478*pow(xi1, 24) - 533335979.143528*pow(xi1, 22) + 325624954.349418*pow(xi1, 20) - 148585961.788267*pow(xi1, 18) + 50473062.3188808*pow(xi1, 16) - 12606823.4744614*pow(xi1, 14) + 2265194.66060973*pow(xi1, 12) - 282896.404740756*pow(xi1, 10) + 23294.9619154539*pow(xi1, 8) - 1163.72388588265*pow(xi1, 6) + 30.5951745249331*pow(xi1, 4) - 0.327805441338569*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(1.03138598295884e+16*pow(xi2, 32) - 8.75821117689488e+16*pow(xi2, 30) + 3.39051932516435e+17*pow(xi2, 28) - 7.92182710210401e+17*pow(xi2, 26) + 1.24650017280329e+18*pow(xi2, 24) - 1.39562142235584e+18*pow(xi2, 22) + 1.1453302941008e+18*pow(xi2, 20) - 6.99274264846123e+17*pow(xi2, 18) + 3.19085923262657e+17*pow(xi2, 16) - 1.08390075994282e+17*pow(xi2, 14) + 2.70729472646284e+16*pow(xi2, 12) - 4.86446849319631e+15*pow(xi2, 10) + 607515403258764.0*pow(xi2, 8) - 50025549794220.0*pow(xi2, 6) + 2499078015720.0*pow(xi2, 4) - 65702637000.0*pow(xi2, 2) + 703956825.0);
case 19:
return -9056643.03410314*pow(xi1, 35) + 79172857.3780183*pow(xi1, 33) - 316403078.834838*pow(xi1, 31) + 765596763.042664*pow(xi1, 29) - 1252233399.81885*pow(xi1, 27) + 1463811236.34868*pow(xi1, 25) - 1260793686.29119*pow(xi1, 23) + 813014601.57817*pow(xi1, 21) - 394872249.030352*pow(xi1, 19) + 144155884.163271*pow(xi1, 17) - 39176848.6364614*pow(xi1, 15) + 7784231.60773869*pow(xi1, 13) - 1099017.838176*pow(xi1, 11) + 105586.258920953*pow(xi1, 9) - 6459.08674135272*pow(xi1, 7) + 225.879802778363*pow(xi1, 5) - 3.71512833517045*pow(xi1, 3) + 2.66092164175851e-11*pow(xi2, 3)*(3.40357374376418e+17*pow(xi2, 32) - 2.97539229023278e+18*pow(xi2, 30) + 1.18907326645567e+19*pow(xi2, 28) - 2.87718642679274e+19*pow(xi2, 26) + 4.70601381178323e+19*pow(xi2, 24) - 5.50114371418053e+19*pow(xi2, 22) + 4.73818419342094e+19*pow(xi2, 20) - 3.05538723433012e+19*pow(xi2, 18) + 1.48396797122291e+19*pow(xi2, 16) - 5.4175170700631e+18*pow(xi2, 14) + 1.47230373197201e+18*pow(xi2, 12) - 2.92538926572613e+17*pow(xi2, 10) + 4.13021496360073e+16*pow(xi2, 8) - 3.9680333785092e+15*pow(xi2, 6) + 242738705266200.0*pow(xi2, 4) - 8488780700400.0*pow(xi2, 2) + 139618103625.0);
case 20:
return -17120968.6987289*pow(xi1, 36) + 153955308.142856*pow(xi1, 34) - 634520170.735474*pow(xi1, 32) + 1588150421.7811*pow(xi1, 30) - 2696332621.91209*pow(xi1, 28) + 3285026390.1665*pow(xi1, 26) - 2963177684.40006*pow(xi1, 24) + 2012710576.66574*pow(xi1, 22) - 1036951472.45552*pow(xi1, 20) + 405061899.334431*pow(xi1, 18) - 119085133.628048*pow(xi1, 16) + 25961307.0176306*pow(xi1, 14) - 4098248.04843586*pow(xi1, 12) + 451955.890922382*pow(xi1, 10) - 32990.2157787024*pow(xi1, 8) + 1465.08149857633*pow(xi1, 6) - 34.3133380956715*pow(xi1, 4) + 0.309594027930871*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(1.47068001273761e+17*pow(xi2, 34) - 1.32246602703834e+18*pow(xi2, 32) + 5.45048676392239e+18*pow(xi2, 30) - 1.36421082453568e+19*pow(xi2, 28) + 2.31613208605008e+19*pow(xi2, 26) - 2.82181618245241e+19*pow(xi2, 24) + 2.54535024934705e+19*pow(xi2, 22) - 1.72890522061853e+19*pow(xi2, 20) + 8.90734532347098e+18*pow(xi2, 18) - 3.47945522099405e+18*pow(xi2, 16) + 1.02293350874451e+18*pow(xi2, 14) - 2.23005929204278e+17*pow(xi2, 12) + 3.52036826778557e+16*pow(xi2, 10) - 3.88227154149234e+15*pow(xi2, 8) + 283383795715020.0*pow(xi2, 6) - 12584954244720.0*pow(xi2, 4) + 294749329875.0*pow(xi2, 2) - 2659392450.0);
case 21:
return -32439730.1660127*pow(xi1, 37) + 299821748.504057*pow(xi1, 35) - 1273206633.86498*pow(xi1, 33) + 3292699297.39704*pow(xi1, 31) - 5794994748.83702*pow(xi1, 29) + 7346551305.36478*pow(xi1, 27) - 6926351242.32454*pow(xi1, 25) + 4943512575.58459*pow(xi1, 23) - 2693392503.79356*pow(xi1, 21) + 1121378210.87288*pow(xi1, 19) - 354830029.912586*pow(xi1, 17) + 84300723.3929026*pow(xi1, 15) - 14741426.4360987*pow(xi1, 13) + 1841288.09378052*pow(xi1, 11) - 157134.957986493*pow(xi1, 9) + 8564.60918867961*pow(xi1, 7) - 267.447960928548*pow(xi1, 5) + 3.92152435379103*pow(xi1, 3) + 4.65661287307739e-10*pow(xi2, 3)*(6.96637900770446e+16*pow(xi2, 34) - 6.43862302227231e+17*pow(xi2, 32) + 2.73419042675017e+18*pow(xi2, 30) - 7.07101789894123e+18*pow(xi2, 28) + 1.24446564633734e+19*pow(xi2, 26) - 1.57765987974639e+19*pow(xi2, 24) + 1.48742260331964e+19*pow(xi2, 22) - 1.06161124197503e+19*pow(xi2, 20) + 5.78401635954245e+18*pow(xi2, 18) - 2.40814137107302e+18*pow(xi2, 16) + 7.61991687056628e+17*pow(xi2, 14) - 1.81034425000829e+17*pow(xi2, 12) + 3.16569722197168e+16*pow(xi2, 10) - 3.95413607265076e+15*pow(xi2, 8) + 337444752805160.0*pow(xi2, 6) - 18392358184200.0*pow(xi2, 4) + 574340122785.0*pow(xi2, 2) - 8421409425.0);
case 22:
return -61592803.4599426*pow(xi1, 38) + 584676985.136067*pow(xi1, 36) - 2555988333.59488*pow(xi1, 34) + 6822908928.68779*pow(xi1, 32) - 12432308002.2498*pow(xi1, 30) + 16375656213.2256*pow(xi1, 28) - 16107683650.0167*pow(xi1, 26) + 12053207925.8038*pow(xi1, 24) - 6925457912.8482*pow(xi1, 22) + 3062457034.47476*pow(xi1, 20) - 1038287442.79005*pow(xi1, 18) + 267243136.899296*pow(xi1, 16) - 51355753.1063992*pow(xi1, 14) + 7184638.11364675*pow(xi1, 12) - 705129.947642557*pow(xi1, 10) + 45954.0694179519*pow(xi1, 8) - 1826.4303601564*pow(xi1, 6) + 38.3329005583073*pow(xi1, 4) - 0.294114326534327*pow(xi1, 2) + 5.82076609134674e-11*pow(xi2, 2)*(1.05815630611764e+18*pow(xi2, 36) - 1.00446741195331e+19*pow(xi2, 34) + 4.39115452069901e+19*pow(xi2, 32) - 1.17216682849202e+20*pow(xi2, 30) + 2.13585425133848e+20*pow(xi2, 28) - 2.81331631545373e+20*pow(xi2, 26) + 2.76727897964542e+20*pow(xi2, 24) - 2.07072535412861e+20*pow(xi2, 22) + 1.1897846098203e+20*pow(xi2, 20) - 5.2612611233897e+19*pow(xi2, 18) + 1.7837642442523e+19*pow(xi2, 16) - 4.5912021322517e+18*pow(xi2, 14) + 8.8228512021374e+17*pow(xi2, 12) - 1.23431142926832e+17*pow(xi2, 10) + 1.21140402582199e+16*pow(xi2, 8) - 789484901072868.0*pow(xi2, 6) + 31377834661173.0*pow(xi2, 4) - 658554217035.0*pow(xi2, 2) + 5052845655.0);
case 23:
return -117169215.861527*pow(xi1, 39) + 1141555508.85931*pow(xi1, 37) - 5133228518.34571*pow(xi1, 35) + 14129831014.1259*pow(xi1, 33) - 26625518290.5583*pow(xi1, 31) + 36388095709.5377*pow(xi1, 29) - 37280297135.4758*pow(xi1, 27) + 29187680419.3394*pow(xi1, 25) - 17641364021.031*pow(xi1, 23) + 8259500271.79728*pow(xi1, 21) - 2988420683.98686*pow(xi1, 19) + 829001983.126658*pow(xi1, 17) - 173867997.780774*pow(xi1, 15) + 26987592.7666662*pow(xi1, 13) - 3005137.05266305*pow(xi1, 11) + 229403.31855374*pow(xi1, 9) - 11213.2459524736*pow(xi1, 7) + 314.584683661116*pow(xi1, 5) - 4.11760057148058*pow(xi1, 3) + 1.16415321826935e-10*pow(xi2, 3)*(1.00647590044644e+18*pow(xi2, 36) - 9.80588715423875e+18*pow(xi2, 34) + 4.40940972183787e+19*pow(xi2, 32) - 1.21374324207355e+20*pow(xi2, 30) + 2.28711460593995e+20*pow(xi2, 28) - 3.12571362072365e+20*pow(xi2, 26) + 3.20235313964062e+20*pow(xi2, 24) - 2.50720265694324e+20*pow(xi2, 22) + 1.51538163054319e+20*pow(xi2, 20) - 7.09485670973448e+19*pow(xi2, 18) + 2.5670338208827e+19*pow(xi2, 16) - 7.12107281169628e+18*pow(xi2, 14) + 1.49351472857885e+18*pow(xi2, 12) - 2.31821656661195e+17*pow(xi2, 10) + 2.58139307223712e+16*pow(xi2, 8) - 1.97055950156437e+15*pow(xi2, 6) + 96321049295757.0*pow(xi2, 4) - 2702261856294.0*pow(xi2, 2) + 35369919585.0);
case 24:
return -223287244.317932*pow(xi1, 40) + 2231298889.66052*pow(xi1, 38) - 10312531213.2237*pow(xi1, 36) + 29244927646.0313*pow(xi1, 34) - 56927287899.7051*pow(xi1, 32) + 80618650592.7439*pow(xi1, 30) - 85894985109.8443*pow(xi1, 28) + 70229985530.9422*pow(xi1, 26) - 44549480703.4182*pow(xi1, 24) + 22020434506.5471*pow(xi1, 22) - 8472208302.94696*pow(xi1, 20) + 2521396724.84906*pow(xi1, 18) - 573689069.79194*pow(xi1, 16) + 98002129.1228823*pow(xi1, 14) - 12242267.5399568*pow(xi1, 12) + 1076619.87856925*pow(xi1, 10) - 63042.4471244913*pow(xi1, 8) + 2255.80251793066*pow(xi1, 6) - 42.626524097941*pow(xi1, 4) + 0.28074549351004*pow(xi1, 2) + 1.45519152283669e-12*pow(xi2, 2)*(1.53441825913517e+20*pow(xi2, 38) - 1.53333692139089e+21*pow(xi2, 36) + 7.08671748796399e+21*pow(xi2, 34) - 2.00969612501745e+22*pow(xi2, 32) + 3.91201343646736e+22*pow(xi2, 30) - 5.54007148389578e+22*pow(xi2, 28) + 5.90265843099501e+22*pow(xi2, 26) - 4.8261678568632e+22*pow(xi2, 24) + 3.06141700279943e+22*pow(xi2, 22) - 1.51323273678928e+22*pow(xi2, 20) + 5.8220572137691e+21*pow(xi2, 18) - 1.73269063575492e+21*pow(xi2, 16) + 3.94236126852647e+20*pow(xi2, 14) - 6.73465503233838e+19*pow(xi2, 12) + 8.41282219407951e+18*pow(xi2, 10) - 7.39847546988545e+17*pow(xi2, 8) + 4.33224397855199e+16*pow(xi2, 6) - 1.55017568651946e+15*pow(xi2, 4) + 29292724310850.0*pow(xi2, 2) - 192926834100.0);
case 25:
return -426211070.808355*pow(xi1, 41) + 4365721614.85918*pow(xi1, 39) - 20723298178.1831*pow(xi1, 37) + 60493571748.5145*pow(xi1, 35) - 121519831214.533*pow(xi1, 33) + 178111895896.725*pow(xi1, 31) - 197066396253.507*pow(xi1, 29) + 167976778695.129*pow(xi1, 27) - 111594197200.571*pow(xi1, 25) + 58084613149.5716*pow(xi1, 23) - 23687115110.1917*pow(xi1, 21) + 7532016460.0326*pow(xi1, 19) - 1849367958.92472*pow(xi1, 17) + 345268929.319048*pow(xi1, 15) - 47924000.009509*pow(xi1, 13) + 4789415.46284829*pow(xi1, 11) - 329068.299702693*pow(xi1, 9) + 14508.7363759144*pow(xi1, 7) - 367.62686556828*pow(xi1, 5) + 4.30476423382061*pow(xi1, 3) + 5.82076609134674e-11*pow(xi2, 3)*(7.32225044126009e+18*pow(xi2, 38) - 7.50025262370419e+19*pow(xi2, 36) + 3.56023551762212e+20*pow(xi2, 34) - 1.0392716491124e+21*pow(xi2, 32) + 2.08769480352744e+21*pow(xi2, 30) - 3.05993907161996e+21*pow(xi2, 28) + 3.38557490819755e+21*pow(xi2, 26) - 2.88581908393203e+21*pow(xi2, 24) + 1.91717370959931e+21*pow(xi2, 22) - 9.97886055512886e+20*pow(xi2, 20) + 4.06941538939444e+20*pow(xi2, 18) - 1.29399057475095e+20*pow(xi2, 16) + 3.17718996074078e+19*pow(xi2, 14) - 5.93167503900098e+18*pow(xi2, 12) + 8.2332805093738e+17*pow(xi2, 10) - 8.22815311195605e+16*pow(xi2, 8) + 5.65335034149357e+15*pow(xi2, 6) - 249258192963351.0*pow(xi2, 4) + 6315781458987.0*pow(xi2, 2) - 73955286405.0);
case 26:
return -814790410.166368*pow(xi1, 42) + 8549783317.50976*pow(xi1, 40) - 41653476712.0875*pow(xi1, 38) + 125058682142.194*pow(xi1, 36) - 259003421118.796*pow(xi1, 34) + 392457703405.874*pow(xi1, 32) - 450317176392.393*pow(xi1, 30) + 399522176450.682*pow(xi1, 28) - 277437040157.331*pow(xi1, 26) + 151702743338.496*pow(xi1, 24) - 65381671352.4093*pow(xi1, 22) + 22131888579.5098*pow(xi1, 20) - 5836813063.12121*pow(xi1, 18) + 1183677533.4723*pow(xi1, 16) - 181066218.998149*pow(xi1, 14) + 20329839.01153*pow(xi1, 12) - 1611743.59518819*pow(xi1, 10) + 85277.0028051157*pow(xi1, 8) - 2761.75736724289*pow(xi1, 6) + 47.1730413956175*pow(xi1, 4) - 0.269047764613788*pow(xi1, 2) + 5.19711258155959e-13*pow(xi2, 2)*(1.56777517781202e+21*pow(xi2, 40) - 1.64510258019927e+22*pow(xi2, 38) + 8.01473434689148e+22*pow(xi2, 36) - 2.40631081546949e+23*pow(xi2, 34) + 4.98360228019291e+23*pow(xi2, 32) - 7.55145664533791e+23*pow(xi2, 30) + 8.6647570035371e+23*pow(xi2, 28) - 7.68738737483324e+23*pow(xi2, 26) + 5.33829190350299e+23*pow(xi2, 24) - 2.9189812796584e+23*pow(xi2, 22) + 1.25803838816955e+23*pow(xi2, 20) - 4.25849704661743e+22*pow(xi2, 18) + 1.12308767060991e+22*pow(xi2, 16) - 2.27756762028251e+21*pow(xi2, 14) + 3.48397723075326e+20*pow(xi2, 12) - 3.9117565171985e+19*pow(xi2, 10) + 3.10122894183009e+18*pow(xi2, 8) - 1.64085348290695e+17*pow(xi2, 6) + 5.31402259216429e+15*pow(xi2, 4) - 90767788181070.0*pow(xi2, 2) + 517687004835.0);
case 27:
return -1559849920.11385*pow(xi1, 43) + 16758016581.4581*pow(xi1, 41) - 83738552891.7078*pow(xi1, 39) + 258384653060.602*pow(xi1, 37) - 551216342688.762*pow(xi1, 35) + 862566527590.693*pow(xi1, 33) - 1025137419153.52*pow(xi1, 31) + 945245017769.346*pow(xi1, 29) - 684894432229.456*pow(xi1, 27) + 392574311178.262*pow(xi1, 25) - 178337649002.54*pow(xi1, 23) + 64052489187.5357*pow(xi1, 21) - 18068776057.7848*pow(xi1, 19) + 3958930149.3731*pow(xi1, 17) - 662688642.100233*pow(xi1, 15) + 82788410.2822969*pow(xi1, 13) - 7469672.88666969*pow(xi1, 11) + 464477.057046165*pow(xi1, 9) - 18568.1392978458*pow(xi1, 7) + 426.889119853877*pow(xi1, 5) - 4.4841294102298*pow(xi1, 3) + 7.27595761418343e-12*pow(xi2, 3)*(2.1438414059383e+20*pow(xi2, 40) - 2.30320426122203e+21*pow(xi2, 38) + 1.1508939074696e+22*pow(xi2, 36) - 3.55121163098749e+22*pow(xi2, 34) + 7.57585972758068e+22*pow(xi2, 32) - 1.18550240852042e+23*pow(xi2, 30) + 1.40893814053447e+23*pow(xi2, 28) - 1.29913486016841e+23*pow(xi2, 26) + 9.4131174004416e+22*pow(xi2, 24) - 5.39550024883316e+22*pow(xi2, 22) + 2.4510539843566e+22*pow(xi2, 20) - 8.80330708121151e+21*pow(xi2, 18) + 2.48335367190187e+21*pow(xi2, 16) - 5.44111216598588e+20*pow(xi2, 14) + 9.10792334480368e+19*pow(xi2, 12) - 1.13783524688094e+19*pow(xi2, 10) + 1.02662402432205e+18*pow(xi2, 8) - 6.38372406321793e+16*pow(xi2, 6) + 2.55198563301825e+15*pow(xi2, 4) - 58671193881300.0*pow(xi2, 2) + 616294053375.0);
case 28:
return -2990166848.60985*pow(xi1, 44) + 32872291760.5344*pow(xi1, 42) - 168370927902.997*pow(xi1, 40) + 533545185426.962*pow(xi1, 38) - 1171446565841.26*pow(xi1, 36) + 1891235717065.74*pow(xi1, 34) - 2325370700007.72*pow(xi1, 32) + 2225327260993.79*pow(xi1, 30) - 1679622467988.24*pow(xi1, 28) + 1007198702447.56*pow(xi1, 26) - 481108506863.906*pow(xi1, 24) + 182797439097.335*pow(xi1, 22) - 54951131326.4392*pow(xi1, 20) + 12946492132.2885*pow(xi1, 18) - 2356797655.27788*pow(xi1, 16) + 324895309.523393*pow(xi1, 14) - 32978968.5669253*pow(xi1, 12) + 2369734.10762014*pow(xi1, 10) - 113866.472549779*pow(xi1, 8) + 3353.33545287931*pow(xi1, 6) - 51.9555378781433*pow(xi1, 4) + 0.258699773667104*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(3.28772321903685e+21*pow(xi2, 42) - 3.61434670223528e+22*pow(xi2, 40) + 1.85125793008779e+23*pow(xi2, 38) - 5.86639135320847e+23*pow(xi2, 36) + 1.28801912046072e+24*pow(xi2, 34) - 2.07943566177906e+24*pow(xi2, 32) + 2.5567721235481e+24*pow(xi2, 30) - 2.44677319906959e+24*pow(xi2, 28) + 1.84676443382689e+24*pow(xi2, 26) - 1.10742668482199e+24*pow(xi2, 24) + 5.28984397518814e+23*pow(xi2, 22) - 2.00987909815195e+23*pow(xi2, 20) + 6.04194078528659e+22*pow(xi2, 18) - 1.42348186383617e+22*pow(xi2, 16) + 2.59132642629324e+21*pow(xi2, 14) - 3.57226170630853e+20*pow(xi2, 12) + 3.62607594113936e+19*pow(xi2, 10) - 2.60555020606573e+18*pow(xi2, 8) + 1.25197510582319e+17*pow(xi2, 6) - 3.6870313222743e+15*pow(xi2, 4) + 57125718024375.0*pow(xi2, 2) - 284443409250.0);
case 29:
return -5739151515.19191*pow(xi1, 45) + 64528538905.8027*pow(xi1, 43) - 338582125411.19*pow(xi1, 41) + 1101111962091.26*pow(xi1, 39) - 2486172256125.54*pow(xi1, 37) + 4137157284655.27*pow(xi1, 35) - 5256914464518.41*pow(xi1, 33) + 5214493554143.21*pow(xi1, 31) - 4093581718892.25*pow(xi1, 29) + 2563396026608.8*pow(xi1, 27) - 1284656774810.01*pow(xi1, 25) + 514956083882.467*pow(xi1, 23) - 164410684836.72*pow(xi1, 21) + 41475494866.957*pow(xi1, 19) - 8166473938.34107*pow(xi1, 17) + 1233384913.79123*pow(xi1, 15) - 139478936.421598*pow(xi1, 13) + 11421836.7765192*pow(xi1, 11) - 645954.797160119*pow(xi1, 9) + 23522.5504032993*pow(xi1, 7) - 492.667848971632*pow(xi1, 5) + 4.65659592600787*pow(xi1, 3) + 7.27595761418343e-13*pow(xi2, 3)*(7.88782978065219e+21*pow(xi2, 42) - 8.86873485629076e+22*pow(xi2, 40) + 4.65343729808394e+23*pow(xi2, 38) - 1.51335675725323e+24*pow(xi2, 36) + 3.41696913033015e+24*pow(xi2, 34) - 5.68606567552082e+24*pow(xi2, 32) + 7.22504822495229e+24*pow(xi2, 30) - 7.16674536967933e+24*pow(xi2, 28) + 5.62617587396662e+24*pow(xi2, 26) - 3.52310467231396e+24*pow(xi2, 24) + 1.76561882700603e+24*pow(xi2, 22) - 7.07750252528458e+23*pow(xi2, 20) + 2.25964324635736e+23*pow(xi2, 18) - 5.70034860924788e+22*pow(xi2, 16) + 1.12239163164196e+22*pow(xi2, 14) - 1.6951513177962e+21*pow(xi2, 12) + 1.9169839053172e+20*pow(xi2, 10) - 1.5698052932928e+19*pow(xi2, 8) + 8.87793513119048e+17*pow(xi2, 6) - 3.23291471042182e+16*pow(xi2, 4) + 677117535719625.0*pow(xi2, 2) - 6399976708125.0);
default:
return 0.;
}
case 20:
switch(j) {
case 0:
return 1.9073486328125e-6*y1t*(-1361270295.0*pow(xi1, 20) + 6611884290.0*pow(xi1, 18) - 13524308775.0*pow(xi1, 16) + 15123958200.0*pow(xi1, 14) - 10039179150.0*pow(xi1, 12) + 4015671660.0*pow(xi1, 10) - 936990054.0*pow(xi1, 8) + 116396280.0*pow(xi1, 6) - 6235515.0*pow(xi1, 4) + 72930.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-453756765.0*pow(xi2, 18) + 2203961430.0*pow(xi2, 16) - 4508102925.0*pow(xi2, 14) + 5041319400.0*pow(xi2, 12) - 3346393050.0*pow(xi2, 10) + 1338557220.0*pow(xi2, 8) - 312330018.0*pow(xi2, 6) + 38798760.0*pow(xi2, 4) - 2078505.0*pow(xi2, 2) + 24310.0));
case 1:
return 9.5367431640625e-7*y1r*(-1361270295.0*pow(xi1, 20) + 477638700.0*pow(xi1, 19) + 6611884290.0*pow(xi1, 18) - 2333606220.0*pow(xi1, 17) - 13524308775.0*pow(xi1, 16) + 4808643120.0*pow(xi1, 15) + 15123958200.0*pow(xi1, 14) - 5429113200.0*pow(xi1, 13) - 10039179150.0*pow(xi1, 12) + 3650610600.0*pow(xi1, 11) + 4015671660.0*pow(xi1, 10) - 1487285800.0*pow(xi1, 9) - 936990054.0*pow(xi1, 8) + 356948592.0*pow(xi1, 7) + 116396280.0*pow(xi1, 6) - 46558512.0*pow(xi1, 5) - 6235515.0*pow(xi1, 4) + 2771340.0*pow(xi1, 3) + 72930.0*pow(xi1, 2) - 48620.0*xi1 + xi2*(1361270295.0*pow(xi2, 19) - 477638700.0*pow(xi2, 18) - 6611884290.0*pow(xi2, 17) + 2333606220.0*pow(xi2, 16) + 13524308775.0*pow(xi2, 15) - 4808643120.0*pow(xi2, 14) - 15123958200.0*pow(xi2, 13) + 5429113200.0*pow(xi2, 12) + 10039179150.0*pow(xi2, 11) - 3650610600.0*pow(xi2, 10) - 4015671660.0*pow(xi2, 9) + 1487285800.0*pow(xi2, 8) + 936990054.0*pow(xi2, 7) - 356948592.0*pow(xi2, 6) - 116396280.0*pow(xi2, 5) + 46558512.0*pow(xi2, 4) + 6235515.0*pow(xi2, 3) - 2771340.0*pow(xi2, 2) - 72930.0*xi2 + 48620.0));
case 2:
return 1.9073486328125e-6*y2t*(1361270295.0*pow(xi1, 20) - 6611884290.0*pow(xi1, 18) + 13524308775.0*pow(xi1, 16) - 15123958200.0*pow(xi1, 14) + 10039179150.0*pow(xi1, 12) - 4015671660.0*pow(xi1, 10) + 936990054.0*pow(xi1, 8) - 116396280.0*pow(xi1, 6) + 6235515.0*pow(xi1, 4) - 72930.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-453756765.0*pow(xi2, 18) + 2203961430.0*pow(xi2, 16) - 4508102925.0*pow(xi2, 14) + 5041319400.0*pow(xi2, 12) - 3346393050.0*pow(xi2, 10) + 1338557220.0*pow(xi2, 8) - 312330018.0*pow(xi2, 6) + 38798760.0*pow(xi2, 4) - 2078505.0*pow(xi2, 2) + 24310.0));
case 3:
return 9.5367431640625e-7*y2r*(-1361270295.0*pow(xi1, 20) - 477638700.0*pow(xi1, 19) + 6611884290.0*pow(xi1, 18) + 2333606220.0*pow(xi1, 17) - 13524308775.0*pow(xi1, 16) - 4808643120.0*pow(xi1, 15) + 15123958200.0*pow(xi1, 14) + 5429113200.0*pow(xi1, 13) - 10039179150.0*pow(xi1, 12) - 3650610600.0*pow(xi1, 11) + 4015671660.0*pow(xi1, 10) + 1487285800.0*pow(xi1, 9) - 936990054.0*pow(xi1, 8) - 356948592.0*pow(xi1, 7) + 116396280.0*pow(xi1, 6) + 46558512.0*pow(xi1, 5) - 6235515.0*pow(xi1, 4) - 2771340.0*pow(xi1, 3) + 72930.0*pow(xi1, 2) + 48620.0*xi1 + xi2*(1361270295.0*pow(xi2, 19) + 477638700.0*pow(xi2, 18) - 6611884290.0*pow(xi2, 17) - 2333606220.0*pow(xi2, 16) + 13524308775.0*pow(xi2, 15) + 4808643120.0*pow(xi2, 14) - 15123958200.0*pow(xi2, 13) - 5429113200.0*pow(xi2, 12) + 10039179150.0*pow(xi2, 11) + 3650610600.0*pow(xi2, 10) - 4015671660.0*pow(xi2, 9) - 1487285800.0*pow(xi2, 8) + 936990054.0*pow(xi2, 7) + 356948592.0*pow(xi2, 6) - 116396280.0*pow(xi2, 5) - 46558512.0*pow(xi2, 4) + 6235515.0*pow(xi2, 3) + 2771340.0*pow(xi2, 2) - 72930.0*xi2 - 48620.0));
case 4:
return -2472.77812957764*pow(xi1, 21) + 12858.4462738037*pow(xi1, 19) - 28729.1859054565*pow(xi1, 17) + 36095.3091430664*pow(xi1, 15) - 28030.4866790771*pow(xi1, 13) + 13925.9742736816*pow(xi1, 11) - 4425.36515808105*pow(xi1, 9) + 871.118225097656*pow(xi1, 7) - 98.3179550170898*pow(xi1, 5) + 5.37864685058594*pow(xi1, 3) - 0.0927352905273438*xi1 + 2472.77812957764*pow(xi2, 21) - 12858.4462738037*pow(xi2, 19) + 28729.1859054565*pow(xi2, 17) - 36095.3091430664*pow(xi2, 15) + 28030.4866790771*pow(xi2, 13) - 13925.9742736816*pow(xi2, 11) + 4425.36515808105*pow(xi2, 9) - 871.118225097656*pow(xi2, 7) + 98.3179550170898*pow(xi2, 5) - 5.37864685058594*pow(xi2, 3) + 0.0927352905273438*xi2;
case 5:
return -3933.96520614624*pow(xi1, 22) + 21513.1697273254*pow(xi1, 20) - 50826.8304634094*pow(xi1, 18) + 67863.6191368103*pow(xi1, 16) - 56201.2533187866*pow(xi1, 14) + 29786.1116409302*pow(xi1, 12) - 10042.1747817993*pow(xi1, 10) + 2064.67705535889*pow(xi1, 8) - 235.223064422607*pow(xi1, 6) + 12.009220123291*pow(xi1, 4) - 0.139102935791016*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(1031265375.0*pow(xi2, 20) - 5639548365.0*pow(xi2, 18) + 13323948645.0*pow(xi2, 16) - 17790040575.0*pow(xi2, 14) + 14732821350.0*pow(xi2, 12) - 7808250450.0*pow(xi2, 10) + 2632495866.0*pow(xi2, 8) - 541242702.0*pow(xi2, 6) + 61662315.0*pow(xi2, 4) - 3148145.0*pow(xi2, 2) + 36465.0);
case 6:
return -6585.11567115784*pow(xi1, 23) + 37709.866476059*pow(xi1, 21) - 93909.3694210052*pow(xi1, 19) + 133322.262125015*pow(xi1, 17) - 118866.862277985*pow(xi1, 15) + 69138.8915061951*pow(xi1, 13) - 26420.6678581238*pow(xi1, 11) + 6530.74373245239*pow(xi1, 9) - 1006.17326545715*pow(xi1, 7) + 90.5513744354248*pow(xi1, 5) - 4.1962718963623*pow(xi1, 3) + 0.0695514678955078*xi1 + 6585.11567115784*pow(xi2, 23) - 37709.866476059*pow(xi2, 21) + 93909.3694210052*pow(xi2, 19) - 133322.262125015*pow(xi2, 17) + 118866.862277985*pow(xi2, 15) - 69138.8915061951*pow(xi2, 13) + 26420.6678581238*pow(xi2, 11) - 6530.74373245239*pow(xi2, 9) + 1006.17326545715*pow(xi2, 7) - 90.5513744354248*pow(xi2, 5) + 4.1962718963623*pow(xi2, 3) - 0.0695514678955078*xi2;
case 7:
return -11359.3245327473*pow(xi1, 24) + 67939.5791101456*pow(xi1, 22) - 177795.557491779*pow(xi1, 20) + 267309.309983253*pow(xi1, 18) - 254878.725403547*pow(xi1, 16) + 160521.721315384*pow(xi1, 14) - 67422.9912786484*pow(xi1, 12) + 18613.5446720123*pow(xi1, 10) - 3236.46453738213*pow(xi1, 8) + 324.005513191223*pow(xi1, 6) - 15.2723431587219*pow(xi1, 4) + 0.17387866973877*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(47644460325.0*pow(xi2, 22) - 284959248420.0*pow(xi2, 20) + 745728617970.0*pow(xi2, 18) - 1121176508100.0*pow(xi2, 16) + 1069038857475.0*pow(xi2, 14) - 673276897800.0*pow(xi2, 12) + 282792522012.0*pow(xi2, 10) - 78070864872.0*pow(xi2, 8) + 13574716155.0*pow(xi2, 6) - 1358977620.0*pow(xi2, 4) + 64056850.0*pow(xi2, 2) - 729300.0);
case 8:
return -19992.4111776352*pow(xi1, 25) + 124628.017730713*pow(xi1, 23) - 341861.576414108*pow(xi1, 21) + 542531.872558594*pow(xi1, 19) - 550892.626976967*pow(xi1, 17) + 373726.219482422*pow(xi1, 15) - 171716.18970108*pow(xi1, 13) + 53039.797668457*pow(xi1, 11) - 10716.5249490738*pow(xi1, 9) + 1347.62924194336*pow(xi1, 7) - 97.8589153289795*pow(xi1, 5) + 3.70941162109375*pow(xi1, 3) - 0.0579595565795898*xi1 + 19992.4111776352*pow(xi2, 25) - 124628.017730713*pow(xi2, 23) + 341861.576414108*pow(xi2, 21) - 542531.872558594*pow(xi2, 19) + 550892.626976967*pow(xi2, 17) - 373726.219482422*pow(xi2, 15) + 171716.18970108*pow(xi2, 13) - 53039.797668457*pow(xi2, 11) + 10716.5249490738*pow(xi2, 9) - 1347.62924194336*pow(xi2, 7) + 97.8589153289795*pow(xi2, 5) - 3.70941162109375*pow(xi2, 3) + 0.0579595565795898*xi2;
case 9:
return -35700.7342457771*pow(xi1, 26) + 231544.762108326*pow(xi1, 24) - 664261.264958382*pow(xi1, 22) + 1109577.42443562*pow(xi1, 20) - 1195370.44476271*pow(xi1, 18) + 869151.521766186*pow(xi1, 16) - 433712.863775253*pow(xi1, 14) + 148085.07665062*pow(xi1, 12) - 33866.3728480339*pow(xi1, 10) + 4964.00997877121*pow(xi1, 8) - 429.167332649231*pow(xi1, 6) + 18.2572603225708*pow(xi1, 4) - 0.202858448028564*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(74869866225.0*pow(xi2, 24) - 485584560945.0*pow(xi2, 22) + 1393056840330.0*pow(xi2, 20) - 2326952514810.0*pow(xi2, 18) + 2506873518975.0*pow(xi2, 16) - 1822742852175.0*pow(xi2, 14) + 909561799692.0*pow(xi2, 12) - 310556914668.0*pow(xi2, 10) + 71022931551.0*pow(xi2, 8) - 10410283455.0*pow(xi2, 6) + 900029130.0*pow(xi2, 4) - 38288250.0*pow(xi2, 2) + 425425.0);
case 10:
return -64459.6590548754*pow(xi1, 27) + 434273.931575418*pow(xi1, 25) - 1300387.65375495*pow(xi1, 23) + 2280517.13728309*pow(xi1, 21) - 2598070.78379095*pow(xi1, 19) + 2015827.85172164*pow(xi1, 17) - 1086007.95365381*pow(xi1, 15) + 406552.760191441*pow(xi1, 13) - 104136.594859958*pow(xi1, 11) + 17650.3092950583*pow(xi1, 9) - 1868.9087998867*pow(xi1, 7) + 113.012441396713*pow(xi1, 5) - 3.49930822849274*pow(xi1, 3) + 0.0507146120071411*xi1 + 64459.6590548754*pow(xi2, 27) - 434273.931575418*pow(xi2, 25) + 1300387.65375495*pow(xi2, 23) - 2280517.13728309*pow(xi2, 21) + 2598070.78379095*pow(xi2, 19) - 2015827.85172164*pow(xi2, 17) + 1086007.95365381*pow(xi2, 15) - 406552.760191441*pow(xi2, 13) + 104136.594859958*pow(xi2, 11) - 17650.3092950583*pow(xi2, 9) + 1868.9087998867*pow(xi2, 7) - 113.012441396713*pow(xi2, 5) + 3.49930822849274*pow(xi2, 3) - 0.0507146120071411*xi2;
case 11:
return -117408.664707094*pow(xi1, 28) + 820479.374541342*pow(xi1, 26) - 2559760.03214344*pow(xi1, 24) + 4702295.96284211*pow(xi1, 22) - 5648384.72818986*pow(xi1, 20) + 4658688.84687275*pow(xi1, 18) - 2695718.21505412*pow(xi1, 16) + 1098603.18051696*pow(xi1, 14) - 311941.764789551*pow(xi1, 12) + 60108.9683331847*pow(xi1, 10) - 7501.34424760938*pow(xi1, 8) + 559.372027516365*pow(xi1, 6) - 21.1860291659832*pow(xi1, 4) + 0.228215754032135*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(3939581056125.0*pow(xi2, 26) - 27530719380450.0*pow(xi2, 24) + 85891293934875.0*pow(xi2, 22) - 157782870129060.0*pow(xi2, 20) + 189528341271885.0*pow(xi2, 18) - 156319658121550.0*pow(xi2, 16) + 90453293538195.0*pow(xi2, 14) - 36863005715640.0*pow(xi2, 12) + 10467028734591.0*pow(xi2, 10) - 2016922290526.0*pow(xi2, 8) + 251703345465.0*pow(xi2, 6) - 18769410660.0*pow(xi2, 4) + 710885175.0*pow(xi2, 2) - 7657650.0);
case 12:
return -215384.171117842*pow(xi1, 29) + 1559187.06731021*pow(xi1, 27) - 5059848.83704752*pow(xi1, 25) + 9716260.68171859*pow(xi1, 23) - 12273352.074565*pow(xi1, 21) + 10723903.6297828*pow(xi1, 19) - 6634823.52170509*pow(xi1, 17) + 2925596.79840517*pow(xi1, 15) - 912995.348572433*pow(xi1, 13) + 197547.517040372*pow(xi1, 11) - 28554.2153170705*pow(xi1, 9) + 2592.99522185326*pow(xi1, 7) - 133.913961589336*pow(xi1, 5) + 3.43845069408417*pow(xi1, 3) - 0.045643150806427*xi1 + 215384.171117842*pow(xi2, 29) - 1559187.06731021*pow(xi2, 27) + 5059848.83704752*pow(xi2, 25) - 9716260.68171859*pow(xi2, 23) + 12273352.074565*pow(xi2, 21) - 10723903.6297828*pow(xi2, 19) + 6634823.52170509*pow(xi2, 17) - 2925596.79840517*pow(xi2, 15) + 912995.348572433*pow(xi2, 13) - 197547.517040372*pow(xi2, 11) + 28554.2153170705*pow(xi2, 9) - 2592.99522185326*pow(xi2, 7) + 133.913961589336*pow(xi2, 5) - 3.43845069408417*pow(xi2, 3) + 0.045643150806427*xi2;
case 13:
return -397481.697608382*pow(xi1, 30) + 2977056.79637298*pow(xi1, 28) - 10034074.3945129*pow(xi1, 26) + 20103395.1400928*pow(xi1, 24) - 26640716.4326794*pow(xi1, 22) + 24584156.7905514*pow(xi1, 20) - 16197959.5438677*pow(xi1, 18) + 7686806.28355846*pow(xi1, 16) - 2617221.91839382*pow(xi1, 14) + 629291.577356607*pow(xi1, 12) - 103705.850256771*pow(xi1, 10) + 11150.8845161498*pow(xi1, 8) - 721.564963907003*pow(xi1, 6) + 24.1832627356052*pow(xi1, 4) - 0.251037329435349*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(13337272593645.0*pow(xi2, 28) - 99893449834035.0*pow(xi2, 26) + 336687666953625.0*pow(xi2, 24) - 674558005197375.0*pow(xi2, 22) + 893914107971625.0*pow(xi2, 20) - 824907417305895.0*pow(xi2, 18) + 543513332053461.0*pow(xi2, 16) - 257926418738835.0*pow(xi2, 14) + 87819394889655.0*pow(xi2, 12) - 21115521440585.0*pow(xi2, 10) + 3479790900443.0*pow(xi2, 8) - 374161596237.0*pow(xi2, 6) + 24211702515.0*pow(xi2, 4) - 811455645.0*pow(xi2, 2) + 8423415.0);
case 14:
return -737264.439112321*pow(xi1, 31) + 5706701.51566319*pow(xi1, 29) - 19948935.3299687*pow(xi1, 27) + 41628441.8250643*pow(xi1, 25) - 57747885.7514877*pow(xi1, 23) + 56126414.4955482*pow(xi1, 21) - 39242329.4288853*pow(xi1, 19) + 19948317.2103351*pow(xi1, 17) - 7363716.27477591*pow(xi1, 15) + 1950274.42433514*pow(xi1, 13) - 361784.81152229*pow(xi1, 11) + 45172.5006237179*pow(xi1, 9) - 3562.3404416889*pow(xi1, 7) + 159.835467651486*pow(xi1, 5) - 3.47268305718899*pow(xi1, 3) + 0.0418395549058914*xi1 + 737264.439112321*pow(xi2, 31) - 5706701.51566319*pow(xi2, 29) + 19948935.3299687*pow(xi2, 27) - 41628441.8250643*pow(xi2, 25) + 57747885.7514877*pow(xi2, 23) - 56126414.4955482*pow(xi2, 21) + 39242329.4288853*pow(xi2, 19) - 19948317.2103351*pow(xi2, 17) + 7363716.27477591*pow(xi2, 15) - 1950274.42433514*pow(xi2, 13) + 361784.81152229*pow(xi2, 11) - 45172.5006237179*pow(xi2, 9) + 3562.3404416889*pow(xi2, 7) - 159.835467651486*pow(xi2, 5) + 3.47268305718899*pow(xi2, 3) - 0.0418395549058914*xi2;
case 15:
return -1373509.47190396*pow(xi1, 32) + 10975517.9743457*pow(xi1, 30) - 39741270.4156874*pow(xi1, 28) + 86237891.5732345*pow(xi1, 26) - 124983372.13927*pow(xi1, 24) + 127620687.931434*pow(xi1, 22) - 94385785.032511*pow(xi1, 20) + 51182880.666102*pow(xi1, 18) - 20371444.2763663*pow(xi1, 16) + 5898530.05603891*pow(xi1, 14) - 1218646.21992296*pow(xi1, 12) + 173911.651316531*pow(xi1, 10) - 16287.4470273647*pow(xi1, 8) + 922.206549458206*pow(xi1, 6) - 27.3316892422736*pow(xi1, 4) + 0.271957106888294*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.94958913128688e+15*pow(xi2, 30) - 2.35697453782375e+16*pow(xi2, 28) + 8.53437283684348e+16*pow(xi2, 26) - 1.85194461991518e+17*pow(xi2, 24) + 2.6839974794098e+17*pow(xi2, 22) - 2.74063340479266e+17*pow(xi2, 20) + 2.0269192996096e+17*pow(xi2, 18) - 1.09914399287989e+17*pow(xi2, 16) + 4.37473434696398e+16*pow(xi2, 14) - 1.26669968425801e+16*pow(xi2, 12) + 2.61702282998156e+15*pow(xi2, 10) - 373472427398928.0*pow(xi2, 8) + 34977026158932.0*pow(xi2, 6) - 1980423485040.0*pow(xi2, 4) + 58694355720.0*pow(xi2, 2) - 584023440.0);
case 16:
return -2568641.0903139*pow(xi1, 33) + 21168864.3506505*pow(xi1, 31) - 79300066.27011*pow(xi1, 29) + 178680095.728121*pow(xi1, 27) - 270052767.826836*pow(xi1, 25) + 289047535.62412*pow(xi1, 23) - 225479030.866805*pow(xi1, 21) + 129953892.378422*pow(xi1, 19) - 55500176.6003122*pow(xi1, 17) + 17455090.6417334*pow(xi1, 15) - 3980427.21410811*pow(xi1, 13) + 640853.077293187*pow(xi1, 11) - 69867.2311975062*pow(xi1, 9) + 4832.35144087672*pow(xi1, 7) - 190.587540507317*pow(xi1, 5) + 3.57429340481758*pow(xi1, 3) - 0.0388510152697563*xi1 + 2568641.0903139*pow(xi2, 33) - 21168864.3506505*pow(xi2, 31) + 79300066.27011*pow(xi2, 29) - 178680095.728121*pow(xi2, 27) + 270052767.826836*pow(xi2, 25) - 289047535.62412*pow(xi2, 23) + 225479030.866805*pow(xi2, 21) - 129953892.378422*pow(xi2, 19) + 55500176.6003122*pow(xi2, 17) - 17455090.6417334*pow(xi2, 15) + 3980427.21410811*pow(xi2, 13) - 640853.077293187*pow(xi2, 11) + 69867.2311975062*pow(xi2, 9) - 4832.35144087672*pow(xi2, 7) + 190.587540507317*pow(xi2, 5) - 3.57429340481758*pow(xi2, 3) + 0.0388510152697563*xi2;
case 17:
return -4819979.45770668*pow(xi1, 34) + 40929461.0305161*pow(xi1, 32) - 158446829.516417*pow(xi1, 30) + 370202602.281114*pow(xi1, 28) - 582509869.76183*pow(xi1, 26) + 652191998.055786*pow(xi1, 24) - 535223944.487169*pow(xi1, 22) + 326775381.698712*pow(xi1, 20) - 149109899.969673*pow(xi1, 18) + 50650699.779417*pow(xi1, 16) - 12651109.289059*pow(xi1, 14) + 2273137.20335324*pow(xi1, 12) - 283886.523512423*pow(xi1, 10) + 23376.3450796902*pow(xi1, 8) - 1167.78381697834*pow(xi1, 6) + 30.6923020631075*pow(xi1, 4) - 0.291382614523172*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.29385338364013e+15*pow(xi2, 32) - 1.09869185355608e+16*pow(xi2, 30) + 4.25327469329937e+16*pow(xi2, 28) - 9.93755043557175e+16*pow(xi2, 26) + 1.56366302514017e+17*pow(xi2, 24) - 1.75071456397656e+17*pow(xi2, 22) + 1.43673083600532e+17*pow(xi2, 20) - 8.77180985958677e+16*pow(xi2, 18) + 4.00263839924734e+16*pow(xi2, 16) - 1.35964436920069e+16*pow(xi2, 14) + 3.39600629091438e+15*pow(xi2, 12) - 610190621732692.0*pow(xi2, 10) + 76205208391312.0*pow(xi2, 8) - 6275039851080.0*pow(xi2, 6) + 313474581420.0*pow(xi2, 4) - 8238902100.0*pow(xi2, 2) + 78217425.0);
case 18:
return -9071889.90789793*pow(xi1, 35) + 79305876.2916238*pow(xi1, 33) - 316933615.672017*pow(xi1, 31) + 766877990.533416*pow(xi1, 29) - 1254324985.64334*pow(xi1, 27) + 1466251586.22142*pow(xi1, 25) - 1262891657.42003*pow(xi1, 23) + 814364974.334062*pow(xi1, 21) - 395526919.443841*pow(xi1, 19) + 144394456.337024*pow(xi1, 17) - 39241570.1076733*pow(xi1, 15) + 7797068.97306965*pow(xi1, 13) - 1100827.15933084*pow(xi1, 11) + 105759.79021824*pow(xi1, 9) - 6469.68474330381*pow(xi1, 7) + 226.248887423426*pow(xi1, 5) - 3.72726927744225*pow(xi1, 3) + 0.0364228268153965*xi1 + 9071889.90789793*pow(xi2, 35) - 79305876.2916238*pow(xi2, 33) + 316933615.672017*pow(xi2, 31) - 766877990.533416*pow(xi2, 29) + 1254324985.64334*pow(xi2, 27) - 1466251586.22142*pow(xi2, 25) + 1262891657.42003*pow(xi2, 23) - 814364974.334062*pow(xi2, 21) + 395526919.443841*pow(xi2, 19) - 144394456.337024*pow(xi2, 17) + 39241570.1076733*pow(xi2, 15) - 7797068.97306965*pow(xi2, 13) + 1100827.15933084*pow(xi2, 11) - 105759.79021824*pow(xi2, 9) + 6469.68474330381*pow(xi2, 7) - 226.248887423426*pow(xi2, 5) + 3.72726927744225*pow(xi2, 3) - 0.0364228268153965*xi2;
case 19:
return -17120968.6987289*pow(xi1, 36) + 153955308.142856*pow(xi1, 34) - 634520170.735474*pow(xi1, 32) + 1588150421.7811*pow(xi1, 30) - 2696332621.91209*pow(xi1, 28) + 3285026390.1665*pow(xi1, 26) - 2963177684.40006*pow(xi1, 24) + 2012710576.66574*pow(xi1, 22) - 1036951472.45552*pow(xi1, 20) + 405061899.334431*pow(xi1, 18) - 119085133.628048*pow(xi1, 16) + 25961307.0176306*pow(xi1, 14) - 4098248.04843586*pow(xi1, 12) + 451955.890922382*pow(xi1, 10) - 32990.2157787024*pow(xi1, 8) + 1465.08149857633*pow(xi1, 6) - 34.3133380956715*pow(xi1, 4) + 0.309594027930871*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(1.47068001273761e+17*pow(xi2, 34) - 1.32246602703834e+18*pow(xi2, 32) + 5.45048676392239e+18*pow(xi2, 30) - 1.36421082453568e+19*pow(xi2, 28) + 2.31613208605008e+19*pow(xi2, 26) - 2.82181618245241e+19*pow(xi2, 24) + 2.54535024934705e+19*pow(xi2, 22) - 1.72890522061853e+19*pow(xi2, 20) + 8.90734532347098e+18*pow(xi2, 18) - 3.47945522099405e+18*pow(xi2, 16) + 1.02293350874451e+18*pow(xi2, 14) - 2.23005929204278e+17*pow(xi2, 12) + 3.52036826778557e+16*pow(xi2, 10) - 3.88227154149234e+15*pow(xi2, 8) + 283383795715020.0*pow(xi2, 6) - 12584954244720.0*pow(xi2, 4) + 294749329875.0*pow(xi2, 2) - 2659392450.0);
case 20:
return -32391021.8624601*pow(xi1, 37) + 299372366.960632*pow(xi1, 35) - 1271301663.00224*pow(xi1, 33) + 3287781287.3285*pow(xi1, 31) - 5786354059.01691*pow(xi1, 29) + 7335615603.83088*pow(xi1, 27) - 6916058175.64479*pow(xi1, 25) + 4936178217.59385*pow(xi1, 23) - 2689402980.3072*pow(xi1, 21) + 1119719858.36565*pow(xi1, 19) - 354306119.977473*pow(xi1, 17) + 84176447.4670211*pow(xi1, 15) - 14719728.3050917*pow(xi1, 13) + 1838582.02332172*pow(xi1, 11) - 156904.37235449*pow(xi1, 9) + 8552.06031074747*pow(xi1, 7) - 267.055808493169*pow(xi1, 5) + 3.92152435379103*pow(xi1, 3) - 0.0343993364367634*xi1 + 32391021.8624601*pow(xi2, 37) - 299372366.960632*pow(xi2, 35) + 1271301663.00224*pow(xi2, 33) - 3287781287.3285*pow(xi2, 31) + 5786354059.01691*pow(xi2, 29) - 7335615603.83088*pow(xi2, 27) + 6916058175.64479*pow(xi2, 25) - 4936178217.59385*pow(xi2, 23) + 2689402980.3072*pow(xi2, 21) - 1119719858.36565*pow(xi2, 19) + 354306119.977473*pow(xi2, 17) - 84176447.4670211*pow(xi2, 15) + 14719728.3050917*pow(xi2, 13) - 1838582.02332172*pow(xi2, 11) + 156904.37235449*pow(xi2, 9) - 8552.06031074747*pow(xi2, 7) + 267.055808493169*pow(xi2, 5) - 3.92152435379103*pow(xi2, 3) + 0.0343993364367634*xi2;
case 21:
return -61417325.3874071*pow(xi1, 38) + 583014039.372506*pow(xi1, 36) - 2548730617.81604*pow(xi1, 34) + 6803567031.10103*pow(xi1, 32) - 12397121286.1174*pow(xi1, 30) + 16329382762.539*pow(xi1, 28) - 16062239196.4967*pow(xi1, 26) + 12019255313.2307*pow(xi1, 24) - 6905979674.78069*pow(xi1, 22) + 3053856817.14484*pow(xi1, 20) - 1035376037.57364*pow(xi1, 18) + 266494890.885114*pow(xi1, 16) - 51212175.5007219*pow(xi1, 14) + 7164580.97348283*pow(xi1, 12) - 703164.296631967*pow(xi1, 10) + 45826.1492935312*pow(xi1, 8) - 1821.35198611824*pow(xi1, 6) + 38.2348624494625*pow(xi1, 4) - 0.326793696149252*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(5.27570807893408e+17*pow(xi2, 36) - 5.00805246442754e+18*pow(xi2, 34) + 2.18934292996676e+19*pow(xi2, 32) - 5.84421957894454e+19*pow(xi2, 30) + 1.0649046097684e+20*pow(xi2, 28) - 1.40268329857942e+20*pow(xi2, 26) + 1.37973584098965e+20*pow(xi2, 24) - 1.032446169852e+20*pow(xi2, 22) + 5.93219137000476e+19*pow(xi2, 20) - 2.62324303126074e+19*pow(xi2, 18) + 8.89381244088173e+18*pow(xi2, 16) - 2.2891736818053e+18*pow(xi2, 14) + 4.39909237865226e+17*pow(xi2, 12) - 6.15432819413052e+16*pow(xi2, 10) + 6.04013531549828e+15*pow(xi2, 8) - 393643625034660.0*pow(xi2, 6) + 15645294429765.0*pow(xi2, 4) - 328434967575.0*pow(xi2, 2) + 2807136475.0);
case 22:
return -116692918.236073*pow(xi1, 39) + 1136922431.95717*pow(xi1, 37) - 5112427747.50414*pow(xi1, 35) + 14072663329.5704*pow(xi1, 33) - 26517959811.2804*pow(xi1, 31) + 36241322522.7774*pow(xi1, 29) - 37130150648.172*pow(xi1, 27) + 29070301213.2304*pow(xi1, 25) - 17570522700.1095*pow(xi1, 23) + 8226381205.98939*pow(xi1, 21) - 2976454861.17552*pow(xi1, 19) + 825687319.603043*pow(xi1, 17) - 173173784.504984*pow(xi1, 15) + 26879987.6421062*pow(xi1, 13) - 2993171.44800321*pow(xi1, 11) + 228491.145845553*pow(xi1, 9) - 11168.7170434363*pow(xi1, 7) + 313.349403489672*pow(xi1, 5) - 4.1502799410955*pow(xi1, 3) + 0.0326793696149252*xi1 + 116692918.236073*pow(xi2, 39) - 1136922431.95717*pow(xi2, 37) + 5112427747.50414*pow(xi2, 35) - 14072663329.5704*pow(xi2, 33) + 26517959811.2804*pow(xi2, 31) - 36241322522.7774*pow(xi2, 29) + 37130150648.172*pow(xi2, 27) - 29070301213.2304*pow(xi2, 25) + 17570522700.1095*pow(xi2, 23) - 8226381205.98939*pow(xi2, 21) + 2976454861.17552*pow(xi2, 19) - 825687319.603043*pow(xi2, 17) + 173173784.504984*pow(xi2, 15) - 26879987.6421062*pow(xi2, 13) + 2993171.44800321*pow(xi2, 11) - 228491.145845553*pow(xi2, 9) + 11168.7170434363*pow(xi2, 7) - 313.349403489672*pow(xi2, 5) + 4.1502799410955*pow(xi2, 3) - 0.0326793696149252*xi2;
case 23:
return -222133305.070811*pow(xi1, 40) + 2219785083.42539*pow(xi1, 38) - 10259396727.5352*pow(xi1, 36) + 29094468214.3189*pow(xi1, 34) - 56634836041.7293*pow(xi1, 32) + 80205087700.4013*pow(xi1, 30) - 85454984888.6874*pow(xi1, 28) + 69870738325.5301*pow(xi1, 26) - 44321915588.4007*pow(xi1, 24) + 21908106656.4077*pow(xi1, 22) - 8429050151.6992*pow(xi1, 20) + 2508569934.62919*pow(xi1, 18) - 570774531.410123*pow(xi1, 16) + 97504906.6443698*pow(xi1, 14) - 12180237.1297037*pow(xi1, 12) + 1071171.86734953*pow(xi1, 10) - 62723.8433239953*pow(xi1, 8) + 2244.43544483787*pow(xi1, 6) - 42.4913503418065*pow(xi1, 4) + 0.343133380956715*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(3.05297689802088e+19*pow(xi2, 38) - 3.05084938798742e+20*pow(xi2, 36) + 1.4100407494865e+21*pow(xi2, 34) - 3.99871326320036e+21*pow(xi2, 32) + 7.78383259563359e+21*pow(xi2, 30) - 1.10233033166731e+22*pow(xi2, 28) + 1.17448436920668e+22*pow(xi2, 26) - 9.60296115377681e+21*pow(xi2, 24) + 6.09155769434411e+21*pow(xi2, 22) - 3.01102725140964e+21*pow(xi2, 20) + 1.15847983161254e+21*pow(xi2, 18) - 3.44775226526759e+20*pow(xi2, 16) + 7.84466542654785e+19*pow(xi2, 14) - 1.34009723275872e+19*pow(xi2, 12) + 1.67403904414727e+18*pow(xi2, 10) - 1.47220740437168e+17*pow(xi2, 8) + 8.62069938419161e+15*pow(xi2, 6) - 308472858673980.0*pow(xi2, 4) + 5839966722590.0*pow(xi2, 2) - 47159892780.0);
case 24:
return -423580138.272501*pow(xi1, 41) + 4338811569.17533*pow(xi1, 39) - 20595743075.9893*pow(xi1, 37) + 60121749251.6231*pow(xi1, 35) - 120773953279.355*pow(xi1, 33) + 177020168578.682*pow(xi1, 31) - 195860136712.149*pow(xi1, 29) + 166949967786.963*pow(xi1, 27) - 110912954589.41*pow(xi1, 25) + 57730496761.096*pow(xi1, 23) - 23542894463.8585*pow(xi1, 21) + 7486216791.89479*pow(xi1, 19) - 1838137033.97982*pow(xi1, 17) + 343174836.118123*pow(xi1, 15) - 47633702.7455318*pow(xi1, 13) + 4760440.11342579*pow(xi1, 11) - 327079.942769009*pow(xi1, 9) + 14421.2061698267*pow(xi1, 7) - 365.547269320057*pow(xi1, 5) + 4.40874404623173*pow(xi1, 3) - 0.0311939437233377*xi1 + 423580138.272501*pow(xi2, 41) - 4338811569.17533*pow(xi2, 39) + 20595743075.9893*pow(xi2, 37) - 60121749251.6231*pow(xi2, 35) + 120773953279.355*pow(xi2, 33) - 177020168578.682*pow(xi2, 31) + 195860136712.149*pow(xi2, 29) - 166949967786.963*pow(xi2, 27) + 110912954589.41*pow(xi2, 25) - 57730496761.096*pow(xi2, 23) + 23542894463.8585*pow(xi2, 21) - 7486216791.89479*pow(xi2, 19) + 1838137033.97982*pow(xi2, 17) - 343174836.118123*pow(xi2, 15) + 47633702.7455318*pow(xi2, 13) - 4760440.11342579*pow(xi2, 11) + 327079.942769009*pow(xi2, 9) - 14421.2061698267*pow(xi2, 7) + 365.547269320057*pow(xi2, 5) - 4.40874404623173*pow(xi2, 3) + 0.0311939437233377*xi2;
case 25:
return -809011754.775118*pow(xi1, 42) + 8489230013.44023*pow(xi1, 40) - 41358870195.9563*pow(xi1, 38) + 124175359033.23*pow(xi1, 36) - 257176448649.812*pow(xi1, 34) + 389693015951.955*pow(xi1, 32) - 447149038103.796*pow(xi1, 30) + 396715033466.757*pow(xi1, 28) - 275490194373.394*pow(xi1, 26) + 150639557207.264*pow(xi1, 24) - 64924029426.9716*pow(xi1, 22) + 21977168312.6472*pow(xi1, 20) - 5796059239.39062*pow(xi1, 18) + 1175422960.42417*pow(xi1, 16) - 179805053.890068*pow(xi1, 14) + 20188407.4579259*pow(xi1, 12) - 1600544.29407977*pow(xi1, 10) + 84685.1976549923*pow(xi1, 8) - 2742.85227764936*pow(xi1, 6) + 47.1132530034811*pow(xi1, 4) - 0.358730352818384*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(5.55948644614192e+19*pow(xi2, 40) - 5.83375444415159e+20*pow(xi2, 38) + 2.84215991825826e+21*pow(xi2, 36) - 8.53326569626849e+21*pow(xi2, 34) + 1.76730309800379e+22*pow(xi2, 32) - 2.67795001438921e+22*pow(xi2, 30) + 3.07278479214986e+22*pow(xi2, 28) - 2.72620495131403e+22*pow(xi2, 26) + 1.89315420032385e+22*pow(xi2, 24) - 1.03518715470259e+22*pow(xi2, 22) + 4.46154532981416e+21*pow(xi2, 20) - 1.51025950658411e+21*pow(xi2, 18) + 3.98302158061782e+20*pow(xi2, 16) - 8.07744507838293e+19*pow(xi2, 14) + 1.23561092178138e+19*pow(xi2, 12) - 1.38733679664182e+18*pow(xi2, 10) + 1.09988566381952e+17*pow(xi2, 8) - 5.8195224701358e+15*pow(xi2, 6) + 188487373284210.0*pow(xi2, 4) - 3237598093730.0*pow(xi2, 2) + 24651762135.0);
case 26:
return -1547470158.8431*pow(xi1, 43) + 16625191560.6287*pow(xi1, 41) - 83075701012.3164*pow(xi1, 39) + 256341987434.563*pow(xi1, 37) - 546864253678.519*pow(xi1, 35) + 855764806225.721*pow(xi1, 33) - 1017063876240.53*pow(xi1, 31) + 937809906938.586*pow(xi1, 29) - 679513807901.221*pow(xi1, 27) + 389493949031.175*pow(xi1, 25) - 176939998576.283*pow(xi1, 23) + 63551103650.6587*pow(xi1, 21) - 17927506260.0493*pow(xi1, 19) + 3928013839.52227*pow(xi1, 17) - 657519566.445603*pow(xi1, 15) + 82143393.9973852*pow(xi1, 13) - 7411542.29891748*pow(xi1, 11) + 460866.585516028*pow(xi1, 9) - 18424.3960454715*pow(xi1, 7) + 424.126896137175*pow(xi1, 5) - 4.69338878270719*pow(xi1, 3) + 0.0298941960681987*xi1 + 1547470158.8431*pow(xi2, 43) - 16625191560.6287*pow(xi2, 41) + 83075701012.3164*pow(xi2, 39) - 256341987434.563*pow(xi2, 37) + 546864253678.519*pow(xi2, 35) - 855764806225.721*pow(xi2, 33) + 1017063876240.53*pow(xi2, 31) - 937809906938.586*pow(xi2, 29) + 679513807901.221*pow(xi2, 27) - 389493949031.175*pow(xi2, 25) + 176939998576.283*pow(xi2, 23) - 63551103650.6587*pow(xi2, 21) + 17927506260.0493*pow(xi2, 19) - 3928013839.52227*pow(xi2, 17) + 657519566.445603*pow(xi2, 15) - 82143393.9973852*pow(xi2, 13) + 7411542.29891748*pow(xi2, 11) - 460866.585516028*pow(xi2, 9) + 18424.3960454715*pow(xi2, 7) - 424.126896137175*pow(xi2, 5) + 4.69338878270719*pow(xi2, 3) - 0.0298941960681987*xi2;
case 27:
return -2964108749.71129*pow(xi1, 44) + 32586184470.587*pow(xi1, 42) - 166907325447.439*pow(xi1, 40) + 528912960881.657*pow(xi1, 38) - 1161288561403.75*pow(xi1, 36) + 1874856086782.63*pow(xi1, 34) - 2305255330325.58*pow(xi1, 32) + 2206100246925.95*pow(xi1, 30) - 1665127529061.39*pow(xi1, 28) + 998516875157.21*pow(xi1, 26) - 476966272244.759*pow(xi1, 24) + 181225405807.216*pow(xi1, 22) - 54479098236.3531*pow(xi1, 20) + 12835406932.7529*pow(xi1, 18) - 2336598245.351*pow(xi1, 16) + 322113828.809707*pow(xi1, 14) - 32696942.1566639*pow(xi1, 12) + 2349491.17916685*pow(xi1, 10) - 112895.628966776*pow(xi1, 8) + 3325.87878356744*pow(xi1, 6) - 52.1280043939214*pow(xi1, 4) + 0.373677450852483*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(3.25907203630014e+21*pow(xi2, 42) - 3.58288887302641e+22*pow(xi2, 40) + 1.83516545090453e+23*pow(xi2, 38) - 5.81545950570815e+23*pow(xi2, 36) + 1.27685027646668e+24*pow(xi2, 34) - 2.06142606782411e+24*pow(xi2, 32) + 2.53465504068558e+24*pow(xi2, 30) - 2.42563287353459e+24*pow(xi2, 28) + 1.83082707993292e+24*pow(xi2, 26) - 1.09788091476591e+24*pow(xi2, 24) + 5.24429962390086e+23*pow(xi2, 22) - 1.99259440933458e+23*pow(xi2, 20) + 5.99004019816212e+22*pow(xi2, 18) - 1.41126791697985e+22*pow(xi2, 16) + 2.56911694020443e+21*pow(xi2, 14) - 3.5416790024372e+20*pow(xi2, 12) + 3.59506680939712e+19*pow(xi2, 10) - 2.5832928708511e+18*pow(xi2, 8) + 1.24130056774055e+17*pow(xi2, 6) - 3.6568423951059e+15*pow(xi2, 4) + 57315346963875.0*pow(xi2, 2) - 410862702250.0);
case 28:
return -5685008576.36934*pow(xi1, 45) + 63920516598.1696*pow(xi1, 43) - 335395652216.154*pow(xi1, 41) + 1090761466149.57*pow(xi1, 39) - 2462829664359.92*pow(xi1, 37) + 4098358985109.66*pow(xi1, 35) - 5207672102829.33*pow(xi1, 33) + 5165704568093.2*pow(xi1, 31) - 4055323997387.46*pow(xi1, 29) + 2539466092295.99*pow(xi1, 27) - 1272677592880.11*pow(xi1, 25) + 510159539292.741*pow(xi1, 23) - 162880969995.744*pow(xi1, 21) + 41090018295.1226*pow(xi1, 19) - 8090656221.72712*pow(xi1, 17) + 1221946438.94162*pow(xi1, 15) - 138186780.026711*pow(xi1, 13) + 11316135.0824385*pow(xi1, 11) - 639984.608374149*pow(xi1, 9) + 23307.6275589514*pow(xi1, 7) - 489.615191642361*pow(xi1, 5) + 5.00152895756401*pow(xi1, 3) - 0.0287444192963449*xi1 + 5685008576.36934*pow(xi2, 45) - 63920516598.1696*pow(xi2, 43) + 335395652216.154*pow(xi2, 41) - 1090761466149.57*pow(xi2, 39) + 2462829664359.92*pow(xi2, 37) - 4098358985109.66*pow(xi2, 35) + 5207672102829.33*pow(xi2, 33) - 5165704568093.2*pow(xi2, 31) + 4055323997387.46*pow(xi2, 29) - 2539466092295.99*pow(xi2, 27) + 1272677592880.11*pow(xi2, 25) - 510159539292.741*pow(xi2, 23) + 162880969995.744*pow(xi2, 21) - 41090018295.1226*pow(xi2, 19) + 8090656221.72712*pow(xi2, 17) - 1221946438.94162*pow(xi2, 15) + 138186780.026711*pow(xi2, 13) - 11316135.0824385*pow(xi2, 11) + 639984.608374149*pow(xi2, 9) - 23307.6275589514*pow(xi2, 7) + 489.615191642361*pow(xi2, 5) - 5.00152895756401*pow(xi2, 3) + 0.0287444192963449*xi2;
case 29:
return -10916864295.202*pow(xi1, 46) + 125476260721.295*pow(xi1, 44) - 674073073816.212*pow(xi1, 42) + 2248321823144.9*pow(xi1, 40) - 5216544812047.65*pow(xi1, 38) + 8939734579066.18*pow(xi1, 36) - 11727223625887.1*pow(xi1, 34) + 12043084537277.8*pow(xi1, 32) - 9819495279736.75*pow(xi1, 30) + 6410302670942.14*pow(xi1, 28) - 3363668401955.01*pow(xi1, 26) + 1418999123886.7*pow(xi1, 24) - 479709514691.903*pow(xi1, 22) + 129086628714.985*pow(xi1, 20) - 27359365638.4866*pow(xi1, 18) + 4498778446.81622*pow(xi1, 16) - 562063823.082374*pow(xi1, 14) + 51848002.1788295*pow(xi1, 12) - 3393112.46214019*pow(xi1, 10) + 148747.317821576*pow(xi1, 8) - 4003.61182729473*pow(xi1, 6) + 57.5606996409306*pow(xi1, 4) - 0.388049660500656*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(1.20032192314272e+22*pow(xi2, 44) - 1.37962607672917e+23*pow(xi2, 42) + 7.41151182631635e+23*pow(xi2, 40) - 2.47205598753035e+24*pow(xi2, 38) + 5.73565167766096e+24*pow(xi2, 36) - 9.82934211891445e+24*pow(xi2, 34) + 1.28942187381923e+25*pow(xi2, 32) - 1.32415114830263e+25*pow(xi2, 30) + 1.07966492389621e+25*pow(xi2, 28) - 7.04820232426443e+24*pow(xi2, 26) + 3.69839251993225e+24*pow(xi2, 24) - 1.56020603651738e+24*pow(xi2, 22) + 5.27446189358529e+23*pow(xi2, 20) - 1.4193224926253e+23*pow(xi2, 18) + 3.00819406480912e+22*pow(xi2, 16) - 4.94645921306248e+21*pow(xi2, 14) + 6.17995709031303e+20*pow(xi2, 12) - 5.70074812725784e+19*pow(xi2, 10) + 3.73076660647479e+18*pow(xi2, 8) - 1.63549405545315e+17*pow(xi2, 6) + 4.40201775721208e+15*pow(xi2, 4) - 63288658558125.0*pow(xi2, 2) + 426665113875.0);
default:
return 0.;
}
case 21:
switch(j) {
case 0:
return 7.62939453125e-6*y1t*(-631165425.0*pow(xi1, 21) + 3224061225.0*pow(xi1, 19) - 7000818660.0*pow(xi1, 17) + 8415125460.0*pow(xi1, 15) - 6107752350.0*pow(xi1, 13) + 2737957950.0*pow(xi1, 11) - 743642900.0*pow(xi1, 9) + 114733476.0*pow(xi1, 7) - 8729721.0*pow(xi1, 5) + 230945.0*pow(xi1, 3) + pow(xi2, 3)*(631165425.0*pow(xi2, 18) - 3224061225.0*pow(xi2, 16) + 7000818660.0*pow(xi2, 14) - 8415125460.0*pow(xi2, 12) + 6107752350.0*pow(xi2, 10) - 2737957950.0*pow(xi2, 8) + 743642900.0*pow(xi2, 6) - 114733476.0*pow(xi2, 4) + 8729721.0*pow(xi2, 2) - 230945.0));
case 1:
return 9.5367431640625e-7*y1r*(-2524661700.0*pow(xi1, 21) + 883631595.0*pow(xi1, 20) + 12896244900.0*pow(xi1, 19) - 4537567650.0*pow(xi1, 18) - 28003274640.0*pow(xi1, 17) + 9917826435.0*pow(xi1, 16) + 33660501840.0*pow(xi1, 15) - 12021607800.0*pow(xi1, 14) - 24431009400.0*pow(xi1, 13) + 8822308950.0*pow(xi1, 12) + 10951831800.0*pow(xi1, 11) - 4015671660.0*pow(xi1, 10) - 2974571600.0*pow(xi1, 9) + 1115464350.0*pow(xi1, 8) + 458933904.0*pow(xi1, 7) - 178474296.0*pow(xi1, 6) - 34918884.0*pow(xi1, 5) + 14549535.0*pow(xi1, 4) + 923780.0*pow(xi1, 3) - 461890.0*pow(xi1, 2) + pow(xi2, 2)*(2524661700.0*pow(xi2, 19) - 883631595.0*pow(xi2, 18) - 12896244900.0*pow(xi2, 17) + 4537567650.0*pow(xi2, 16) + 28003274640.0*pow(xi2, 15) - 9917826435.0*pow(xi2, 14) - 33660501840.0*pow(xi2, 13) + 12021607800.0*pow(xi2, 12) + 24431009400.0*pow(xi2, 11) - 8822308950.0*pow(xi2, 10) - 10951831800.0*pow(xi2, 9) + 4015671660.0*pow(xi2, 8) + 2974571600.0*pow(xi2, 7) - 1115464350.0*pow(xi2, 6) - 458933904.0*pow(xi2, 5) + 178474296.0*pow(xi2, 4) + 34918884.0*pow(xi2, 3) - 14549535.0*pow(xi2, 2) - 923780.0*xi2 + 461890.0));
case 2:
return 7.62939453125e-6*y2t*(631165425.0*pow(xi1, 21) - 3224061225.0*pow(xi1, 19) + 7000818660.0*pow(xi1, 17) - 8415125460.0*pow(xi1, 15) + 6107752350.0*pow(xi1, 13) - 2737957950.0*pow(xi1, 11) + 743642900.0*pow(xi1, 9) - 114733476.0*pow(xi1, 7) + 8729721.0*pow(xi1, 5) - 230945.0*pow(xi1, 3) + pow(xi2, 3)*(-631165425.0*pow(xi2, 18) + 3224061225.0*pow(xi2, 16) - 7000818660.0*pow(xi2, 14) + 8415125460.0*pow(xi2, 12) - 6107752350.0*pow(xi2, 10) + 2737957950.0*pow(xi2, 8) - 743642900.0*pow(xi2, 6) + 114733476.0*pow(xi2, 4) - 8729721.0*pow(xi2, 2) + 230945.0));
case 3:
return 9.5367431640625e-7*y2r*(-2524661700.0*pow(xi1, 21) - 883631595.0*pow(xi1, 20) + 12896244900.0*pow(xi1, 19) + 4537567650.0*pow(xi1, 18) - 28003274640.0*pow(xi1, 17) - 9917826435.0*pow(xi1, 16) + 33660501840.0*pow(xi1, 15) + 12021607800.0*pow(xi1, 14) - 24431009400.0*pow(xi1, 13) - 8822308950.0*pow(xi1, 12) + 10951831800.0*pow(xi1, 11) + 4015671660.0*pow(xi1, 10) - 2974571600.0*pow(xi1, 9) - 1115464350.0*pow(xi1, 8) + 458933904.0*pow(xi1, 7) + 178474296.0*pow(xi1, 6) - 34918884.0*pow(xi1, 5) - 14549535.0*pow(xi1, 4) + 923780.0*pow(xi1, 3) + 461890.0*pow(xi1, 2) + pow(xi2, 2)*(2524661700.0*pow(xi2, 19) + 883631595.0*pow(xi2, 18) - 12896244900.0*pow(xi2, 17) - 4537567650.0*pow(xi2, 16) + 28003274640.0*pow(xi2, 15) + 9917826435.0*pow(xi2, 14) - 33660501840.0*pow(xi2, 13) - 12021607800.0*pow(xi2, 12) + 24431009400.0*pow(xi2, 11) + 8822308950.0*pow(xi2, 10) - 10951831800.0*pow(xi2, 9) - 4015671660.0*pow(xi2, 8) + 2974571600.0*pow(xi2, 7) + 1115464350.0*pow(xi2, 6) - 458933904.0*pow(xi2, 5) - 178474296.0*pow(xi2, 4) + 34918884.0*pow(xi2, 3) + 14549535.0*pow(xi2, 2) - 923780.0*xi2 - 461890.0));
case 4:
return -4596.5277671814*pow(xi1, 22) + 25053.1468391418*pow(xi1, 20) - 59099.3972969055*pow(xi1, 18) + 79106.4203453064*pow(xi1, 16) - 66199.3886947632*pow(xi1, 14) + 35975.4335403442*pow(xi1, 12) - 12765.4764175415*pow(xi1, 10) + 2893.50798797607*pow(xi1, 8) - 395.914775848389*pow(xi1, 6) + 29.0725135803223*pow(xi1, 4) - 0.880985260009766*pow(xi1, 2) + 3.814697265625e-6*pow(xi2, 2)*(1204952175.0*pow(xi2, 20) - 6567532125.0*pow(xi2, 18) + 15492552405.0*pow(xi2, 16) - 20737273455.0*pow(xi2, 14) + 17353772550.0*pow(xi2, 12) - 9430744050.0*pow(xi2, 10) + 3346393050.0*pow(xi2, 8) - 758515758.0*pow(xi2, 6) + 103786683.0*pow(xi2, 4) - 7621185.0*pow(xi2, 2) + 230945.0);
case 5:
return -7327.79788970947*pow(xi1, 23) + 41907.0819854736*pow(xi1, 21) - 104247.120094299*pow(xi1, 19) + 147827.172546387*pow(xi1, 17) - 131511.187820435*pow(xi1, 15) + 76057.2441101074*pow(xi1, 13) - 28625.61378479*pow(xi1, 11) + 6808.25408935547*pow(xi1, 9) - 954.635627746582*pow(xi1, 7) + 68.3644561767578*pow(xi1, 5) - 1.76197052001953*pow(xi1, 3) + 7.62939453125e-6*pow(xi2, 3)*(960469125.0*pow(xi2, 20) - 5492845050.0*pow(xi2, 18) + 13663878525.0*pow(xi2, 16) - 19376003160.0*pow(xi2, 14) + 17237434410.0*pow(xi2, 12) - 9968975100.0*pow(xi2, 10) + 3752016450.0*pow(xi2, 8) - 892371480.0*pow(xi2, 6) + 125126001.0*pow(xi2, 4) - 8960666.0*pow(xi2, 2) + 230945.0);
case 6:
return -12289.3277108669*pow(xi1, 24) + 73451.2714147568*pow(xi1, 22) - 192100.697286129*pow(xi1, 20) + 288650.013709068*pow(xi1, 18) - 275090.35777688*pow(xi1, 16) + 173242.563199997*pow(xi1, 14) - 72901.8306016922*pow(xi1, 12) + 20297.107503891*pow(xi1, 10) - 3631.91679596901*pow(xi1, 8) + 396.634247144063*pow(xi1, 6) - 24.1169714927673*pow(xi1, 4) + 0.660738945007324*pow(xi1, 2) + 7.94728597005208e-8*pow(xi2, 2)*(154635529125.0*pow(xi2, 22) - 924230884500.0*pow(xi2, 20) + 2417186169090.0*pow(xi2, 18) - 3632057721300.0*pow(xi2, 16) + 3461437763955.0*pow(xi2, 14) - 2179895927400.0*pow(xi2, 12) + 917317319100.0*pow(xi2, 10) - 255396717576.0*pow(xi2, 8) + 45700089435.0*pow(xi2, 6) - 4990813828.0*pow(xi2, 4) + 303461730.0*pow(xi2, 2) - 8314020.0);
case 7:
return -21235.9582843781*pow(xi1, 25) + 132326.16648674*pow(xi1, 23) - 362841.146650314*pow(xi1, 21) + 575621.929979324*pow(xi1, 19) - 584297.167682648*pow(xi1, 17) + 396256.456432343*pow(xi1, 15) - 181974.990749359*pow(xi1, 13) + 56113.9396705627*pow(xi1, 11) - 11257.6701450348*pow(xi1, 9) + 1375.65848350525*pow(xi1, 7) - 89.4200038909912*pow(xi1, 5) + 2.20246315002441*pow(xi1, 3) + 1.9073486328125e-6*pow(xi2, 3)*(11133758097.0*pow(xi2, 22) - 69377021175.0*pow(xi2, 20) + 190233259095.0*pow(xi2, 18) - 301791670425.0*pow(xi2, 16) + 306339993450.0*pow(xi2, 14) - 207752505030.0*pow(xi2, 12) + 95407303950.0*pow(xi2, 10) - 29419865202.0*pow(xi2, 8) + 5902261365.0*pow(xi2, 6) - 721241235.0*pow(xi2, 4) + 46881835.0*pow(xi2, 2) - 1154725.0);
case 8:
return -37435.1828731023*pow(xi1, 26) + 242730.829489231*pow(xi1, 24) - 696181.399483681*pow(xi1, 22) + 1162625.44245243*pow(xi1, 20) - 1252241.40361547*pow(xi1, 18) + 910307.749307156*pow(xi1, 16) - 454159.560728073*pow(xi1, 14) + 155054.118558884*pow(xi1, 12) - 35489.4119925499*pow(xi1, 10) + 5233.38281393051*pow(xi1, 8) - 467.142434120178*pow(xi1, 6) + 23.1258630752563*pow(xi1, 4) - 0.550615787506104*pow(xi1, 2) + 3.66797814002404e-8*pow(xi2, 2)*(1020594492225.0*pow(xi2, 24) - 6617564778825.0*pow(xi2, 22) + 18979976785770.0*pow(xi2, 20) - 31696629534570.0*pow(xi2, 18) + 34139827332975.0*pow(xi2, 16) - 24817698321975.0*pow(xi2, 14) + 12381741204300.0*pow(xi2, 12) - 4227236712972.0*pow(xi2, 10) + 967546987407.0*pow(xi2, 8) - 142677590055.0*pow(xi2, 6) + 12735692970.0*pow(xi2, 4) - 630479850.0*pow(xi2, 2) + 15011425.0);
case 9:
return -66947.5757201513*pow(xi1, 27) + 450956.643104553*pow(xi1, 25) - 1350117.33681679*pow(xi1, 23) + 2367351.01711273*pow(xi1, 21) - 2696581.86814785*pow(xi1, 19) + 2091952.29377747*pow(xi1, 17) - 1126858.29648972*pow(xi1, 15) + 421785.623886108*pow(xi1, 13) - 108014.851653099*pow(xi1, 11) + 18288.6666742961*pow(xi1, 9) - 1922.75032997131*pow(xi1, 7) + 111.00414276123*pow(xi1, 5) - 2.56954034169515*pow(xi1, 3) + 3.17891438802083e-7*pow(xi2, 3)*(210598863475.0*pow(xi2, 24) - 1418586939000.0*pow(xi2, 22) + 4247101909710.0*pow(xi2, 20) - 7447042380360.0*pow(xi2, 18) + 8482713086925.0*pow(xi2, 16) - 6580712905200.0*pow(xi2, 14) + 3544789695300.0*pow(xi2, 12) - 1326822847056.0*pow(xi2, 10) + 339785343261.0*pow(xi2, 8) - 57531170840.0*pow(xi2, 6) + 6048449550.0*pow(xi2, 4) - 349188840.0*pow(xi2, 2) + 8083075.0);
case 10:
return -121043.607886881*pow(xi1, 28) + 845778.579072654*pow(xi1, 26) - 2638381.56539574*pow(xi1, 24) + 4846179.01085794*pow(xi1, 22) - 5820583.71478423*pow(xi1, 20) + 4800210.0817278*pow(xi1, 18) - 2777324.87994209*pow(xi1, 16) + 1131748.51436734*pow(xi1, 14) - 321322.880017787*pow(xi1, 12) + 61915.3605063558*pow(xi1, 10) - 7733.72222229838*pow(xi1, 8) + 582.193602919579*pow(xi1, 6) - 23.8485462963581*pow(xi1, 4) + 0.481788814067841*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(4061549509875.0*pow(xi2, 26) - 28379619818550.0*pow(xi2, 24) + 88529394826125.0*pow(xi2, 22) - 162610784079660.0*pow(xi2, 20) + 195306380458035.0*pow(xi2, 18) - 161068322773050.0*pow(xi2, 16) + 93191558825925.0*pow(xi2, 14) - 37975178566440.0*pow(xi2, 12) + 10781806727601.0*pow(xi2, 10) - 2077534753866.0*pow(xi2, 8) + 259500656415.0*pow(xi2, 6) - 19535175660.0*pow(xi2, 4) + 800224425.0*pow(xi2, 2) - 16166150.0);
case 11:
return -220753.859594464*pow(xi1, 29) + 1597921.02183402*pow(xi1, 27) - 5185115.58801055*pow(xi1, 25) + 9956002.6088655*pow(xi1, 23) - 12575203.3539766*pow(xi1, 21) + 10986811.2805098*pow(xi1, 19) - 6796979.6032548*pow(xi1, 17) + 2996882.53331995*pow(xi1, 15) - 935175.832545161*pow(xi1, 13) + 202332.507389426*pow(xi1, 11) - 29241.6076886654*pow(xi1, 9) + 2651.71057105064*pow(xi1, 7) - 134.708152413368*pow(xi1, 5) + 2.89073288440704*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(1851817592625.0*pow(xi2, 26) - 13404333067125.0*pow(xi2, 24) + 43495902102510.0*pow(xi2, 22) - 83517003132750.0*pow(xi2, 20) + 105488451456795.0*pow(xi2, 18) - 92164053002175.0*pow(xi2, 16) + 57017197475700.0*pow(xi2, 14) - 25139672794068.0*pow(xi2, 12) + 7844823470295.0*pow(xi2, 10) - 1697288090147.0*pow(xi2, 8) + 245296384190.0*pow(xi2, 6) - 22244160510.0*pow(xi2, 4) + 1130013885.0*pow(xi2, 2) - 24249225.0);
case 12:
return -405451.255455166*pow(xi1, 30) + 3036558.8335298*pow(xi1, 28) - 10234008.0454154*pow(xi1, 26) + 20502764.8258321*pow(xi1, 24) - 27168407.1926661*pow(xi1, 22) + 25069719.7046261*pow(xi1, 20) - 16516991.3616178*pow(xi1, 18) + 7837789.40442404*pow(xi1, 16) - 2668491.02463529*pow(xi1, 14) + 641586.375719259*pow(xi1, 12) - 105726.973603338*pow(xi1, 10) + 11368.8188244402*pow(xi1, 8) - 737.262150615454*pow(xi1, 6) + 25.5829860270023*pow(xi1, 4) - 0.433609932661057*pow(xi1, 2) + 9.9341074625651e-9*pow(xi2, 2)*(40814059741455.0*pow(xi2, 28) - 305670020681025.0*pow(xi2, 26) + 1.03018898114204e+15*pow(xi2, 24) - 2.06387588448113e+15*pow(xi2, 22) + 2.73486141508388e+15*pow(xi2, 20) - 2.52360061526381e+15*pow(xi2, 18) + 1.66265479046398e+15*pow(xi2, 16) - 788977714803201.0*pow(xi2, 14) + 268619101886205.0*pow(xi2, 12) - 64584199248595.0*pow(xi2, 10) + 10642825639017.0*pow(xi2, 8) - 1144422774495.0*pow(xi2, 6) + 74215238097.0*pow(xi2, 4) - 2575267695.0*pow(xi2, 2) + 43648605.0);
case 13:
return -749074.166969955*pow(xi1, 31) + 5797853.33353579*pow(xi1, 29) - 20266690.4669765*pow(xi1, 27) + 42289717.7062619*pow(xi1, 25) - 58662785.4666039*pow(xi1, 23) + 57013311.6029352*pow(xi1, 21) - 39860846.3061646*pow(xi1, 19) + 20261945.3071647*pow(xi1, 17) - 7479204.49236828*pow(xi1, 15) + 1980787.58679807*pow(xi1, 13) - 367431.737764776*pow(xi1, 11) + 45875.8207523823*pow(xi1, 9) - 3617.07494741678*pow(xi1, 7) + 161.534153580666*pow(xi1, 5) - 3.17980617284775*pow(xi1, 3) + 5.96046447753906e-8*pow(xi2, 3)*(12567379099275.0*pow(xi2, 28) - 97271837713050.0*pow(xi2, 26) + 340018643569605.0*pow(xi2, 24) - 709503728536980.0*pow(xi2, 22) + 984198222934875.0*pow(xi2, 20) - 956524643637750.0*pow(xi2, 18) + 668754028421325.0*pow(xi2, 16) - 339939032998488.0*pow(xi2, 14) + 125480229276633.0*pow(xi2, 12) - 33232101193830.0*pow(xi2, 10) + 6164481629735.0*pow(xi2, 8) - 769668553940.0*pow(xi2, 6) + 60684447681.0*pow(xi2, 4) - 2710093386.0*pow(xi2, 2) + 53348295.0);
case 14:
return -1390859.06523328*pow(xi1, 32) + 11113797.4660238*pow(xi1, 30) - 40240699.1092844*pow(xi1, 28) + 87318955.0707993*pow(xi1, 26) - 126546331.339768*pow(xi1, 24) + 129212818.351678*pow(xi1, 22) - 95560534.0450485*pow(xi1, 20) + 51818448.6328783*pow(xi1, 18) - 20623835.859613*pow(xi1, 16) + 5971447.06099082*pow(xi1, 14) - 1233677.99478771*pow(xi1, 12) + 176052.183267586*pow(xi1, 10) - 16487.5533654671*pow(xi1, 8) + 933.829577811062*pow(xi1, 6) - 28.0220418982208*pow(xi1, 4) + 0.397475771605968*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(2.98684709926103e+15*pow(xi2, 30) - 2.386669832547e+16*pow(xi2, 28) + 8.64162433212764e+16*pow(xi2, 26) - 1.87516028174988e+17*pow(xi2, 24) + 2.71756177266541e+17*pow(xi2, 22) - 2.77482414522222e+17*pow(xi2, 20) + 2.05214684255889e+17*pow(xi2, 18) - 1.11279271103834e+17*pow(xi2, 16) + 4.42893502675548e+16*pow(xi2, 14) - 1.28235849183754e+16*pow(xi2, 12) + 2.64930332070404e+15*pow(xi2, 10) - 378069184761840.0*pow(xi2, 8) + 35406751247868.0*pow(xi2, 6) - 2005383748368.0*pow(xi2, 4) + 60176876760.0*pow(xi2, 2) - 853572720.0);
case 15:
return -2593676.57852359*pow(xi1, 33) + 21374698.9817139*pow(xi1, 31) - 80069343.0678237*pow(xi1, 29) + 180409482.926837*pow(xi1, 27) - 272660658.817659*pow(xi1, 25) + 291832705.291657*pow(xi1, 23) - 227646965.371663*pow(xi1, 21) + 131200707.86478*pow(xi1, 19) - 56031543.8303474*pow(xi1, 17) + 17621862.9742209*pow(xi1, 15) - 4018380.24838351*pow(xi1, 13) + 646951.29511781*pow(xi1, 11) - 70530.7633705189*pow(xi1, 9) + 4878.1179368645*pow(xi1, 7) - 192.219283148646*pow(xi1, 5) + 3.44479002058506*pow(xi1, 3) + 4.96705373128255e-9*pow(xi2, 3)*(522176066304375.0*pow(xi2, 30) - 4.30329530101433e+15*pow(xi2, 28) + 1.61200879635238e+16*pow(xi2, 26) - 3.63212263621424e+16*pow(xi2, 24) + 5.48938412122341e+16*pow(xi2, 22) - 5.87536839905096e+16*pow(xi2, 20) + 4.58313877174189e+16*pow(xi2, 18) - 2.64141913824038e+16*pow(xi2, 16) + 1.12806397638625e+16*pow(xi2, 14) - 3.54774961729088e+15*pow(xi2, 12) + 809006800767165.0*pow(xi2, 10) - 130248499436055.0*pow(xi2, 8) + 14199718220545.0*pow(xi2, 6) - 982094859603.0*pow(xi2, 4) + 38698853193.0*pow(xi2, 2) - 693527835.0);
case 16:
return -4854970.23416916*pow(xi1, 34) + 41225938.4348919*pow(xi1, 32) - 159592087.223465*pow(xi1, 30) + 372872774.309806*pow(xi1, 28) - 586702614.054534*pow(xi1, 26) + 656876682.631329*pow(xi1, 24) - 539060699.397119*pow(xi1, 22) + 329113221.379803*pow(xi1, 20) - 150174585.707234*pow(xi1, 18) + 51011662.3364239*pow(xi1, 16) - 12741096.0830762*pow(xi1, 14) + 2289275.60617186*pow(xi1, 12) - 285898.280884445*pow(xi1, 10) + 23541.6950006783*pow(xi1, 8) - 1176.05131302774*pow(xi1, 6) + 31.0031101852655*pow(xi1, 4) - 0.369084645062685*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.30324614867563e+15*pow(xi2, 32) - 1.10665035827981e+16*pow(xi2, 30) + 4.28401747078226e+16*pow(xi2, 28) - 1.00092273201838e+17*pow(xi2, 26) + 1.57491783740121e+17*pow(xi2, 24) - 1.76328991837908e+17*pow(xi2, 22) + 1.44703004654344e+17*pow(xi2, 20) - 8.83456576567164e+16*pow(xi2, 18) + 4.03121833939324e+16*pow(xi2, 16) - 1.3693338840596e+16*pow(xi2, 14) + 3.42016193700038e+15*pow(xi2, 12) - 614522741252420.0*pow(xi2, 10) + 76745235398832.0*pow(xi2, 8) - 6319425632520.0*pow(xi2, 6) + 315693870492.0*pow(xi2, 4) - 8322334020.0*pow(xi2, 2) + 99075405.0);
case 17:
return -9118096.47788722*pow(xi1, 35) + 79708988.7815304*pow(xi1, 33) - 318541366.112857*pow(xi1, 31) + 770760565.57494*pow(xi1, 29) - 1260663100.10732*pow(xi1, 27) + 1473646404.52689*pow(xi1, 25) - 1269248861.795*pow(xi1, 23) + 818456749.903348*pow(xi1, 21) - 397510603.618273*pow(xi1, 19) + 145117328.453817*pow(xi1, 17) - 39437672.1525126*pow(xi1, 15) + 7835964.69822362*pow(xi1, 13) - 1106309.09639171*pow(xi1, 11) + 106285.551295131*pow(xi1, 9) - 6501.79510742426*pow(xi1, 7) + 227.356141358614*pow(xi1, 5) - 3.69084645062685*pow(xi1, 3) + 7.45058059692383e-9*pow(xi2, 3)*(1.22381019294683e+15*pow(xi2, 32) - 1.06983593754345e+16*pow(xi2, 30) + 4.27538984336838e+16*pow(xi2, 28) - 1.03449731943463e+17*pow(xi2, 26) + 1.6920333706984e+17*pow(xi2, 24) - 1.97789472290969e+17*pow(xi2, 22) + 1.70355698496711e+17*pow(xi2, 20) - 1.09851405438292e+17*pow(xi2, 18) + 5.33529700735531e+16*pow(xi2, 16) - 1.94773181185011e+16*pow(xi2, 14) + 5.29323475391911e+15*pow(xi2, 12) - 1.05172537848378e+15*pow(xi2, 10) + 148486293383428.0*pow(xi2, 8) - 14265405214060.0*pow(xi2, 6) + 872656167240.0*pow(xi2, 4) - 30515224740.0*pow(xi2, 2) + 495377025.0);
case 18:
return -17175581.0390758*pow(xi1, 36) + 154445460.189213*pow(xi1, 34) - 636536529.850006*pow(xi1, 32) + 1593187891.04673*pow(xi1, 30) - 2704869598.21416*pow(xi1, 28) + 3295408612.9558*pow(xi1, 26) - 2972526156.78936*pow(xi1, 24) + 2019049360.76173*pow(xi1, 22) - 1040211599.82845*pow(xi1, 20) + 406333229.98651*pow(xi1, 18) - 119458267.623672*pow(xi1, 16) + 26042517.6376345*pow(xi1, 14) - 4111046.93219014*pow(xi1, 12) + 453365.068400052*pow(xi1, 10) - 33092.9135811911*pow(xi1, 8) + 1469.6335425321*pow(xi1, 6) - 34.4286770472536*pow(xi1, 4) + 0.346016854746267*pow(xi1, 2) + 3.88051072756449e-11*pow(xi2, 2)*(4.42611353115768e+17*pow(xi2, 34) - 3.98002920317004e+18*pow(xi2, 32) + 1.64034214704906e+19*pow(xi2, 30) - 4.10561393305735e+19*pow(xi2, 28) + 6.97039587856468e+19*pow(xi2, 26) - 8.49220333176112e+19*pow(xi2, 24) + 7.66014157794892e+19*pow(xi2, 22) - 5.2030505840888e+19*pow(xi2, 20) + 2.68060488130982e+19*pow(xi2, 18) - 1.04711276044206e+19*pow(xi2, 16) + 3.07841611608293e+18*pow(xi2, 14) - 6.7111056935486e+17*pow(xi2, 12) + 1.05940872756467e+17*pow(xi2, 10) - 1.16831288515622e+16*pow(xi2, 8) + 852797889363420.0*pow(xi2, 6) - 37872168013680.0*pow(xi2, 4) + 887220251775.0*pow(xi2, 2) - 8916786450.0);
case 19:
return -32439730.1660127*pow(xi1, 37) + 299821748.504057*pow(xi1, 35) - 1273206633.86498*pow(xi1, 33) + 3292699297.39704*pow(xi1, 31) - 5794994748.83702*pow(xi1, 29) + 7346551305.36478*pow(xi1, 27) - 6926351242.32454*pow(xi1, 25) + 4943512575.58459*pow(xi1, 23) - 2693392503.79356*pow(xi1, 21) + 1121378210.87288*pow(xi1, 19) - 354830029.912586*pow(xi1, 17) + 84300723.3929026*pow(xi1, 15) - 14741426.4360987*pow(xi1, 13) + 1841288.09378052*pow(xi1, 11) - 157134.957986493*pow(xi1, 9) + 8564.60918867961*pow(xi1, 7) - 267.447960928548*pow(xi1, 5) + 3.92152435379103*pow(xi1, 3) + 4.65661287307739e-10*pow(xi2, 3)*(6.96637900770446e+16*pow(xi2, 34) - 6.43862302227231e+17*pow(xi2, 32) + 2.73419042675017e+18*pow(xi2, 30) - 7.07101789894123e+18*pow(xi2, 28) + 1.24446564633734e+19*pow(xi2, 26) - 1.57765987974639e+19*pow(xi2, 24) + 1.48742260331964e+19*pow(xi2, 22) - 1.06161124197503e+19*pow(xi2, 20) + 5.78401635954245e+18*pow(xi2, 18) - 2.40814137107302e+18*pow(xi2, 16) + 7.61991687056628e+17*pow(xi2, 14) - 1.81034425000829e+17*pow(xi2, 12) + 3.16569722197168e+16*pow(xi2, 10) - 3.95413607265076e+15*pow(xi2, 8) + 337444752805160.0*pow(xi2, 6) - 18392358184200.0*pow(xi2, 4) + 574340122785.0*pow(xi2, 2) - 8421409425.0);
case 20:
return -61417325.3874071*pow(xi1, 38) + 583014039.372506*pow(xi1, 36) - 2548730617.81604*pow(xi1, 34) + 6803567031.10103*pow(xi1, 32) - 12397121286.1174*pow(xi1, 30) + 16329382762.539*pow(xi1, 28) - 16062239196.4967*pow(xi1, 26) + 12019255313.2307*pow(xi1, 24) - 6905979674.78069*pow(xi1, 22) + 3053856817.14484*pow(xi1, 20) - 1035376037.57364*pow(xi1, 18) + 266494890.885114*pow(xi1, 16) - 51212175.5007219*pow(xi1, 14) + 7164580.97348283*pow(xi1, 12) - 703164.296631967*pow(xi1, 10) + 45826.1492935312*pow(xi1, 8) - 1821.35198611824*pow(xi1, 6) + 38.2348624494625*pow(xi1, 4) - 0.326793696149252*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(5.27570807893408e+17*pow(xi2, 36) - 5.00805246442754e+18*pow(xi2, 34) + 2.18934292996676e+19*pow(xi2, 32) - 5.84421957894454e+19*pow(xi2, 30) + 1.0649046097684e+20*pow(xi2, 28) - 1.40268329857942e+20*pow(xi2, 26) + 1.37973584098965e+20*pow(xi2, 24) - 1.032446169852e+20*pow(xi2, 22) + 5.93219137000476e+19*pow(xi2, 20) - 2.62324303126074e+19*pow(xi2, 18) + 8.89381244088173e+18*pow(xi2, 16) - 2.2891736818053e+18*pow(xi2, 14) + 4.39909237865226e+17*pow(xi2, 12) - 6.15432819413052e+16*pow(xi2, 10) + 6.04013531549828e+15*pow(xi2, 8) - 393643625034660.0*pow(xi2, 6) + 15645294429765.0*pow(xi2, 4) - 328434967575.0*pow(xi2, 2) + 2807136475.0);
case 21:
return -116535437.914567*pow(xi1, 39) + 1135390555.81044*pow(xi1, 37) - 5105550103.41374*pow(xi1, 35) + 14053760933.5557*pow(xi1, 33) - 26482395306.5159*pow(xi1, 31) + 36192790927.193*pow(xi1, 29) - 37080503004.7506*pow(xi1, 27) + 29031487951.9893*pow(xi1, 25) - 17547097623.7151*pow(xi1, 23) + 8215429601.80738*pow(xi1, 21) - 2972498030.86585*pow(xi1, 19) + 824591221.539438*pow(xi1, 17) - 172944218.334939*pow(xi1, 15) + 26844403.798678*pow(xi1, 13) - 2989214.50871948*pow(xi1, 11) + 228189.49347776*pow(xi1, 9) - 11153.9917194878*pow(xi1, 7) + 312.937643432524*pow(xi1, 5) - 4.13938681789053*pow(xi1, 3) + 5.97001650394537e-12*pow(xi2, 3)*(1.95201198920561e+19*pow(xi2, 36) - 1.90182146910332e+20*pow(xi2, 34) + 8.55198658167806e+20*pow(xi2, 32) - 2.35405730022154e+21*pow(xi2, 30) + 4.43589984868797e+21*pow(xi2, 28) - 6.06242728194711e+21*pow(xi2, 26) + 6.21112236126071e+21*pow(xi2, 24) - 4.86288236101246e+21*pow(xi2, 22) + 2.93920420690945e+21*pow(xi2, 20) - 1.37611505703177e+21*pow(xi2, 18) + 4.97904491369736e+20*pow(xi2, 16) - 1.38122100834143e+20*pow(xi2, 14) + 2.8968800709453e+19*pow(xi2, 12) - 4.49653761944167e+18*pow(xi2, 10) + 5.00704563671476e+17*pow(xi2, 8) - 3.82225900593337e+16*pow(xi2, 6) + 1.86833515654715e+15*pow(xi2, 4) - 52418220824970.0*pow(xi2, 2) + 693362709325.0);
case 22:
return -221563001.335071*pow(xi1, 40) + 2214094580.21603*pow(xi1, 38) - 10233135408.4591*pow(xi1, 36) + 29020103383.2284*pow(xi1, 34) - 56490288563.2613*pow(xi1, 32) + 80000676119.5703*pow(xi1, 30) - 85237502310.1306*pow(xi1, 28) + 69693167146.6517*pow(xi1, 26) - 44209431231.8868*pow(xi1, 24) + 21852582608.9513*pow(xi1, 22) - 8407716578.46659*pow(xi1, 20) + 2502229402.03009*pow(xi1, 18) - 569333795.484418*pow(xi1, 16) + 97259112.1754349*pow(xi1, 14) - 12149572.8591448*pow(xi1, 12) + 1068478.64285384*pow(xi1, 10) - 62566.3402002307*pow(xi1, 8) + 2238.80805739018*pow(xi1, 6) - 42.3769725481543*pow(xi1, 4) + 0.31045401134179*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(3.04513870316075e+19*pow(xi2, 38) - 3.04302841992918e+20*pow(xi2, 36) + 1.40643142127589e+21*pow(xi2, 34) - 3.98849263864016e+21*pow(xi2, 32) + 7.76396614146592e+21*pow(xi2, 30) - 1.09952092029262e+22*pow(xi2, 28) + 1.17149531140715e+22*pow(xi2, 26) - 9.57855595678498e+21*pow(xi2, 24) + 6.07609796210287e+21*pow(xi2, 22) - 3.00339608443469e+21*pow(xi2, 20) + 1.15554776763363e+21*pow(xi2, 18) - 3.43903790361884e+20*pow(xi2, 16) + 7.82486410276201e+19*pow(xi2, 14) - 1.33671905930076e+19*pow(xi2, 12) + 1.66982457889267e+18*pow(xi2, 10) - 1.46850586481014e+17*pow(xi2, 8) + 8.59905231969284e+15*pow(xi2, 6) - 307699436432388.0*pow(xi2, 4) + 5824246758330.0*pow(xi2, 2) - 42668474420.0);
case 23:
return -422024764.447755*pow(xi1, 41) + 4322902316.91078*pow(xi1, 39) - 20520330597.4072*pow(xi1, 37) + 59901917263.415*pow(xi1, 35) - 120332959323.442*pow(xi1, 33) + 176374680057.007*pow(xi1, 31) - 195146915254.19*pow(xi1, 29) + 166342835627.683*pow(xi1, 27) - 110510141539.374*pow(xi1, 25) + 57521106460.0063*pow(xi1, 23) - 23457614573.9268*pow(xi1, 21) + 7459134211.59708*pow(xi1, 19) - 1831495756.75403*pow(xi1, 17) + 341936494.88629*pow(xi1, 15) - 47462032.3602766*pow(xi1, 13) + 4743304.91553402*pow(xi1, 11) - 325904.065670225*pow(xi1, 9) + 14369.426005757*pow(xi1, 7) - 364.224646106188*pow(xi1, 5) + 4.34635615878506*pow(xi1, 3) + 5.82076609134674e-11*pow(xi2, 3)*(7.25033024562084e+18*pow(xi2, 38) - 7.42668962997378e+19*pow(xi2, 36) + 3.52536595275888e+20*pow(xi2, 34) - 1.02910710245626e+21*pow(xi2, 32) + 2.06730449970033e+21*pow(xi2, 30) - 3.03009393074923e+21*pow(xi2, 28) + 3.35259847572812e+21*pow(xi2, 26) - 2.8577481557792e+21*pow(xi2, 24) + 1.89854977515177e+21*pow(xi2, 22) - 9.88205084301845e+20*pow(xi2, 20) + 4.02998749748754e+20*pow(xi2, 18) - 1.28146949981137e+20*pow(xi2, 16) + 3.14648575120853e+19*pow(xi2, 14) - 5.87442425138195e+18*pow(xi2, 12) + 8.15391507156326e+17*pow(xi2, 10) - 8.14893579486987e+16*pow(xi2, 8) + 5.59898921474822e+15*pow(xi2, 6) - 246864859028073.0*pow(xi2, 4) + 6257331773693.0*pow(xi2, 2) - 74669830235.0);
case 24:
return -805226904.46038*pow(xi1, 42) + 8449568302.93278*pow(xi1, 40) - 41165901262.5445*pow(xi1, 38) + 123596762437.165*pow(xi1, 36) - 255979710020.842*pow(xi1, 34) + 387881992088.781*pow(xi1, 32) - 445073680723.189*pow(xi1, 30) + 394876109613.793*pow(xi1, 28) - 274214810169.403*pow(xi1, 26) + 149943044753.442*pow(xi1, 24) - 64624213069.4037*pow(xi1, 22) + 21875803667.7972*pow(xi1, 20) - 5769358869.07719*pow(xi1, 18) + 1170014757.05802*pow(xi1, 16) - 178978750.223936*pow(xi1, 14) + 20095740.8543639*pow(xi1, 12) - 1593206.31097129*pow(xi1, 10) + 84297.3998941569*pow(xi1, 8) - 2730.2887435151*pow(xi1, 6) + 46.8221095287299*pow(xi1, 4) - 0.296342465371708*pow(xi1, 2) + 4.85063840945562e-12*pow(xi2, 2)*(1.66004314584799e+20*pow(xi2, 40) - 1.7419497372679e+21*pow(xi2, 38) + 8.4866975823837e+21*pow(xi2, 36) - 2.5480514522837e+22*pow(xi2, 34) + 5.27723751829958e+22*pow(xi2, 32) - 7.99651425949749e+22*pow(xi2, 30) + 9.17556913447892e+22*pow(xi2, 28) - 8.14070388846216e+22*pow(xi2, 26) + 5.65316948043089e+22*pow(xi2, 24) - 3.09120227269774e+22*pow(xi2, 22) + 1.33228263198156e+22*pow(xi2, 20) - 4.50988134369148e+21*pow(xi2, 18) + 1.18940196775556e+21*pow(xi2, 16) - 2.41208405635275e+20*pow(xi2, 14) + 3.68979781867565e+19*pow(xi2, 12) - 4.14290638840244e+18*pow(xi2, 10) + 3.28452912067319e+17*pow(xi2, 8) - 1.73786196327954e+16*pow(xi2, 6) + 562872041377646.0*pow(xi2, 4) - 9652772599470.0*pow(xi2, 2) + 61093497465.0);
case 25:
return -1538805712.26503*pow(xi1, 43) + 16532226174.7729*pow(xi1, 41) - 82611751780.2235*pow(xi1, 39) + 254912225915.977*pow(xi1, 37) - 543817928726.357*pow(xi1, 35) + 851003685212.995*pow(xi1, 33) - 1011412343303.2*pow(xi1, 31) + 932605142497.08*pow(xi1, 29) - 675747137296.369*pow(xi1, 27) + 387337506400.648*pow(xi1, 25) - 175961532717.34*pow(xi1, 23) + 63200085370.9558*pow(xi1, 21) - 17828601337.3*pow(xi1, 19) + 3906368383.90736*pow(xi1, 17) - 653900452.039292*pow(xi1, 15) + 81691776.9779117*pow(xi1, 13) - 7370840.43279175*pow(xi1, 11) + 458338.497413532*pow(xi1, 9) - 18323.4134511531*pow(xi1, 7) + 421.675572059583*pow(xi1, 5) - 4.5439178023662*pow(xi1, 3) + 2.91038304567337e-11*pow(xi2, 3)*(5.28729616726104e+19*pow(xi2, 40) - 5.68042966005799e+20*pow(xi2, 38) + 2.83851817729064e+21*pow(xi2, 36) - 8.75871738927749e+21*pow(xi2, 34) + 1.86854417508653e+22*pow(xi2, 32) - 2.92402639741223e+22*pow(xi2, 30) + 3.47518634980638e+22*pow(xi2, 28) - 3.2044068696851e+22*pow(xi2, 26) + 2.32184948404282e+22*pow(xi2, 24) - 1.33088153800398e+22*pow(xi2, 22) + 6.04599222700007e+21*pow(xi2, 20) - 2.17153839818131e+21*pow(xi2, 18) + 6.12586077417003e+20*pow(xi2, 16) - 1.34221795640084e+20*pow(xi2, 14) + 2.2467848450787e+19*pow(xi2, 12) - 2.80690808377805e+18*pow(xi2, 10) + 2.53260148823e+17*pow(xi2, 8) - 1.57483908551112e+16*pow(xi2, 6) + 629587692190314.0*pow(xi2, 4) - 14488662332144.0*pow(xi2, 2) + 156127826855.0);
case 26:
return -2945006008.03753*pow(xi1, 44) + 32376437528.27*pow(xi1, 42) - 165834316512.342*pow(xi1, 40) + 525516840538.759*pow(xi1, 38) - 1153840986172.26*pow(xi1, 36) + 1862846628678.5*pow(xi1, 34) - 2290506419752.75*pow(xi1, 32) + 2192002290170.17*pow(xi1, 30) - 1654499005685.08*pow(xi1, 28) + 992150683496.898*pow(xi1, 26) - 473928780505.806*pow(xi1, 24) + 180072606201.234*pow(xi1, 22) - 54132938919.5742*pow(xi1, 20) + 12753941922.5462*pow(xi1, 18) - 2321784503.34649*pow(xi1, 16) + 320073908.647654*pow(xi1, 14) - 32490100.6234645*pow(xi1, 12) + 2334644.31637217*pow(xi1, 10) - 112182.940656012*pow(xi1, 8) + 3304.67781971587*pow(xi1, 6) - 51.5450675705915*pow(xi1, 4) + 0.283994862647887*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(3.23806834970745e+21*pow(xi2, 42) - 3.55982695282961e+22*pow(xi2, 40) + 1.82336759289605e+23*pow(xi2, 38) - 5.77811876764472e+23*pow(xi2, 36) + 1.26866158090092e+24*pow(xi2, 34) - 2.04822152899533e+24*pow(xi2, 32) + 2.51843844201372e+24*pow(xi2, 30) - 2.41013200615372e+24*pow(xi2, 28) + 1.81914089489458e+24*pow(xi2, 26) - 1.09088121301074e+24*pow(xi2, 24) + 5.21090204903833e+23*pow(xi2, 22) - 1.97991924362186e+23*pow(xi2, 20) + 5.95197957877598e+22*pow(xi2, 18) - 1.40231074438193e+22*pow(xi2, 16) + 2.55282905861959e+21*pow(xi2, 14) - 3.51924984305808e+20*pow(xi2, 12) + 3.57232434231115e+19*pow(xi2, 10) - 2.56696857257235e+18*pow(xi2, 8) + 1.2334644768939e+17*pow(xi2, 6) - 3.63353168883104e+15*pow(xi2, 4) + 56674401148365.0*pow(xi2, 2) - 312255653710.0);
case 27:
return -5643940402.95904*pow(xi1, 45) + 63459307840.2206*pow(xi1, 43) - 332978508214.796*pow(xi1, 41) + 1082909699230.21*pow(xi1, 39) - 2445121682401.35*pow(xi1, 37) + 4068925192581.16*pow(xi1, 35) - 5170313921043.63*pow(xi1, 33) + 5128689225764.81*pow(xi1, 31) - 4026297675831.58*pow(xi1, 29) + 2521309801100.88*pow(xi1, 27) - 1263588399544.35*pow(xi1, 25) + 506520061817.221*pow(xi1, 23) - 161720234605.989*pow(xi1, 21) + 40797513653.6727*pow(xi1, 19) - 8033123179.43023*pow(xi1, 17) + 1213266304.17716*pow(xi1, 15) - 137206195.642171*pow(xi1, 13) + 11235918.5064705*pow(xi1, 11) - 635452.569682131*pow(xi1, 9) + 23142.3356502297*pow(xi1, 7) - 485.631215127887*pow(xi1, 5) + 4.73324771079812*pow(xi1, 3) + 1.2126596023639e-12*pow(xi2, 3)*(4.65418357464617e+21*pow(xi2, 42) - 5.23306851457044e+22*pow(xi2, 40) + 2.74585306186256e+23*pow(xi2, 38) - 8.93003854601274e+23*pow(xi2, 36) + 2.01632979084563e+24*pow(xi2, 34) - 3.35537292134527e+24*pow(xi2, 32) + 4.2636152065797e+24*pow(xi2, 30) - 4.22929007923342e+24*pow(xi2, 28) + 3.32022083359823e+24*pow(xi2, 26) - 2.07915708265201e+24*pow(xi2, 24) + 1.04199760351641e+24*pow(xi2, 22) - 4.1769352325239e+23*pow(xi2, 20) + 1.33359958796961e+23*pow(xi2, 18) - 3.36430054849224e+22*pow(xi2, 16) + 6.62438425735534e+21*pow(xi2, 14) - 1.0005003067737e+21*pow(xi2, 12) + 1.13144855633607e+20*pow(xi2, 10) - 9.26551728495589e+18*pow(xi2, 8) + 5.24015616949231e+17*pow(xi2, 6) - 1.90839503559919e+16*pow(xi2, 4) + 400467875883075.0*pow(xi2, 2) - 3903195671375.0);
case 28:
return -10830136475.5778*pow(xi1, 46) + 124480567047.592*pow(xi1, 44) - 668730146595.075*pow(xi1, 42) + 2230520873347.34*pow(xi1, 40) - 5175289082189.45*pow(xi1, 38) + 8869111491786.76*pow(xi1, 36) - 11634680954177.8*pow(xi1, 34) + 11948152405933.1*pow(xi1, 32) - 9742174333567.36*pow(xi1, 30) + 6359880357274.0*pow(xi1, 28) - 3337238393035.54*pow(xi1, 26) + 1407861058998.53*pow(xi1, 24) - 475948085093.87*pow(xi1, 22) + 128075500365.761*pow(xi1, 20) - 27145281328.444*pow(xi1, 18) + 4463611836.62049*pow(xi1, 16) - 557674658.619336*pow(xi1, 14) + 51443527.1447734*pow(xi1, 12) - 3366668.49452746*pow(xi1, 10) + 147588.470953531*pow(xi1, 8) - 3971.39508214739*pow(xi1, 6) + 56.5259005462622*pow(xi1, 4) - 0.273071983315276*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(1.19078609852987e+22*pow(xi2, 44) - 1.36867830900977e+23*pow(xi2, 42) + 7.35276572025634e+23*pow(xi2, 40) - 2.45248363624248e+24*pow(xi2, 38) + 5.69029052296948e+24*pow(xi2, 36) - 9.75169121326128e+24*pow(xi2, 34) + 1.27924669945824e+25*pow(xi2, 32) - 1.31371325007633e+25*pow(xi2, 30) + 1.07116339595782e+25*pow(xi2, 28) - 6.99276240408694e+24*pow(xi2, 26) + 3.66933241780307e+24*pow(xi2, 24) - 1.54795960466192e+24*pow(xi2, 22) + 5.23310453778431e+23*pow(xi2, 20) - 1.40820501885384e+23*pow(xi2, 18) + 2.98465524598749e+22*pow(xi2, 16) - 4.90779311624281e+21*pow(xi2, 14) + 6.13169771667971e+20*pow(xi2, 12) - 5.65627562694886e+19*pow(xi2, 10) + 3.70169115660006e+18*pow(xi2, 8) - 1.62275239939087e+17*pow(xi2, 6) + 4.36659507131348e+15*pow(xi2, 4) - 62150884921125.0*pow(xi2, 2) + 300245820875.0);
case 29:
return -20806834300.5978*pow(xi1, 47) + 244355631791.314*pow(xi1, 45) - 1343273740298.02*pow(xi1, 43) + 4592284861114.13*pow(xi1, 41) - 10941218087890.8*pow(xi1, 39) + 19293765550349.6*pow(xi1, 37) - 26104144978494.4*pow(xi1, 35) + 27721880835822.7*pow(xi1, 33) - 23445377187979.1*pow(xi1, 31) + 15930895144025.1*pow(xi1, 29) - 8736178307237.03*pow(xi1, 27) + 3869824780370.31*pow(xi1, 25) - 1381408154889.13*pow(xi1, 23) + 395166275983.381*pow(xi1, 21) - 89767193240.2531*pow(xi1, 19) + 15982098655.2556*pow(xi1, 17) - 2190045568.70281*pow(xi1, 15) + 225338397.125726*pow(xi1, 13) - 16827632.97963*pow(xi1, 11) + 869437.913538747*pow(xi1, 9) - 28967.2419283845*pow(xi1, 7) + 556.411473203207*pow(xi1, 5) - 4.91529569967497*pow(xi1, 3) + 1.81898940354586e-12*pow(xi2, 3)*(1.14386781253579e+22*pow(xi2, 44) - 1.3433592923355e+23*pow(xi2, 42) + 7.38472548371917e+23*pow(xi2, 40) - 2.52463530142734e+24*pow(xi2, 38) + 6.0149982548345e+24*pow(xi2, 36) - 1.06068597830967e+25*pow(xi2, 34) + 1.43509054685025e+25*pow(xi2, 32) - 1.52402651614039e+25*pow(xi2, 30) + 1.28892324178886e+25*pow(xi2, 28) - 8.75810222586789e+24*pow(xi2, 26) + 4.80276481556578e+24*pow(xi2, 24) - 2.12745867173643e+24*pow(xi2, 22) + 7.59437164502595e+23*pow(xi2, 20) - 2.17244957674334e+23*pow(xi2, 18) + 4.93500363802367e+22*pow(xi2, 16) - 8.78625165385837e+21*pow(xi2, 14) + 1.20399028407402e+21*pow(xi2, 12) - 1.23881093912071e+20*pow(xi2, 10) + 9.25108906452505e+18*pow(xi2, 8) - 4.77978547782579e+17*pow(xi2, 6) + 1.59249096624296e+16*pow(xi2, 4) - 305890442307450.0*pow(xi2, 2) + 2702212387875.0);
default:
return 0.;
}
case 22:
switch(j) {
case 0:
return 9.5367431640625e-7*y1t*(-9398626965.0*pow(xi1, 22) + 50367000915.0*pow(xi1, 20) - 115707975075.0*pow(xi1, 18) + 148767396525.0*pow(xi1, 16) - 117210676050.0*pow(xi1, 14) + 58227239070.0*pow(xi1, 12) - 18070522470.0*pow(xi1, 10) + 3346393050.0*pow(xi1, 8) - 334639305.0*pow(xi1, 6) + 14549535.0*pow(xi1, 4) - 138567.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-3132875655.0*pow(xi2, 20) + 16789000305.0*pow(xi2, 18) - 38569325025.0*pow(xi2, 16) + 49589132175.0*pow(xi2, 14) - 39070225350.0*pow(xi2, 12) + 19409079690.0*pow(xi2, 10) - 6023507490.0*pow(xi2, 8) + 1115464350.0*pow(xi2, 6) - 111546435.0*pow(xi2, 4) + 4849845.0*pow(xi2, 2) - 46189.0));
case 1:
return 4.76837158203125e-7*y1r*(-9398626965.0*pow(xi1, 22) + 3282060210.0*pow(xi1, 21) + 50367000915.0*pow(xi1, 20) - 17672631900.0*pow(xi1, 19) - 115707975075.0*pow(xi1, 18) + 40838108850.0*pow(xi1, 17) + 148767396525.0*pow(xi1, 16) - 52895074320.0*pow(xi1, 15) - 117210676050.0*pow(xi1, 14) + 42075627300.0*pow(xi1, 13) + 58227239070.0*pow(xi1, 12) - 21173541480.0*pow(xi1, 11) - 18070522470.0*pow(xi1, 10) + 6692786100.0*pow(xi1, 9) + 3346393050.0*pow(xi1, 8) - 1274816400.0*pow(xi1, 7) - 334639305.0*pow(xi1, 6) + 133855722.0*pow(xi1, 5) + 14549535.0*pow(xi1, 4) - 6466460.0*pow(xi1, 3) - 138567.0*pow(xi1, 2) + 92378.0*xi1 + xi2*(9398626965.0*pow(xi2, 21) - 3282060210.0*pow(xi2, 20) - 50367000915.0*pow(xi2, 19) + 17672631900.0*pow(xi2, 18) + 115707975075.0*pow(xi2, 17) - 40838108850.0*pow(xi2, 16) - 148767396525.0*pow(xi2, 15) + 52895074320.0*pow(xi2, 14) + 117210676050.0*pow(xi2, 13) - 42075627300.0*pow(xi2, 12) - 58227239070.0*pow(xi2, 11) + 21173541480.0*pow(xi2, 10) + 18070522470.0*pow(xi2, 9) - 6692786100.0*pow(xi2, 8) - 3346393050.0*pow(xi2, 7) + 1274816400.0*pow(xi2, 6) + 334639305.0*pow(xi2, 5) - 133855722.0*pow(xi2, 4) - 14549535.0*pow(xi2, 3) + 6466460.0*pow(xi2, 2) + 138567.0*xi2 - 92378.0));
case 2:
return 9.5367431640625e-7*y2t*(9398626965.0*pow(xi1, 22) - 50367000915.0*pow(xi1, 20) + 115707975075.0*pow(xi1, 18) - 148767396525.0*pow(xi1, 16) + 117210676050.0*pow(xi1, 14) - 58227239070.0*pow(xi1, 12) + 18070522470.0*pow(xi1, 10) - 3346393050.0*pow(xi1, 8) + 334639305.0*pow(xi1, 6) - 14549535.0*pow(xi1, 4) + 138567.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-3132875655.0*pow(xi2, 20) + 16789000305.0*pow(xi2, 18) - 38569325025.0*pow(xi2, 16) + 49589132175.0*pow(xi2, 14) - 39070225350.0*pow(xi2, 12) + 19409079690.0*pow(xi2, 10) - 6023507490.0*pow(xi2, 8) + 1115464350.0*pow(xi2, 6) - 111546435.0*pow(xi2, 4) + 4849845.0*pow(xi2, 2) - 46189.0));
case 3:
return 4.76837158203125e-7*y2r*(-9398626965.0*pow(xi1, 22) - 3282060210.0*pow(xi1, 21) + 50367000915.0*pow(xi1, 20) + 17672631900.0*pow(xi1, 19) - 115707975075.0*pow(xi1, 18) - 40838108850.0*pow(xi1, 17) + 148767396525.0*pow(xi1, 16) + 52895074320.0*pow(xi1, 15) - 117210676050.0*pow(xi1, 14) - 42075627300.0*pow(xi1, 13) + 58227239070.0*pow(xi1, 12) + 21173541480.0*pow(xi1, 11) - 18070522470.0*pow(xi1, 10) - 6692786100.0*pow(xi1, 9) + 3346393050.0*pow(xi1, 8) + 1274816400.0*pow(xi1, 7) - 334639305.0*pow(xi1, 6) - 133855722.0*pow(xi1, 5) + 14549535.0*pow(xi1, 4) + 6466460.0*pow(xi1, 3) - 138567.0*pow(xi1, 2) - 92378.0*xi1 + xi2*(9398626965.0*pow(xi2, 21) + 3282060210.0*pow(xi2, 20) - 50367000915.0*pow(xi2, 19) - 17672631900.0*pow(xi2, 18) + 115707975075.0*pow(xi2, 17) + 40838108850.0*pow(xi2, 16) - 148767396525.0*pow(xi2, 15) - 52895074320.0*pow(xi2, 14) + 117210676050.0*pow(xi2, 13) + 42075627300.0*pow(xi2, 12) - 58227239070.0*pow(xi2, 11) - 21173541480.0*pow(xi2, 10) + 18070522470.0*pow(xi2, 9) + 6692786100.0*pow(xi2, 8) - 3346393050.0*pow(xi2, 7) - 1274816400.0*pow(xi2, 6) + 334639305.0*pow(xi2, 5) + 133855722.0*pow(xi2, 4) - 14549535.0*pow(xi2, 3) - 6466460.0*pow(xi2, 2) + 138567.0*xi2 + 92378.0));
case 4:
return -8573.52353096008*pow(xi1, 23) + 48876.4119243622*pow(xi1, 21) - 121393.88422966*pow(xi1, 19) + 172476.27453804*pow(xi1, 17) - 154773.431110382*pow(xi1, 15) + 91384.7427177429*pow(xi1, 13) - 35859.3837547302*pow(xi1, 11) + 9219.5107460022*pow(xi1, 9) - 1489.30558204651*pow(xi1, 7) + 138.755178451538*pow(xi1, 5) - 6.25499534606934*pow(xi1, 3) + 0.0880985260009766*xi1 + 8573.52353096008*pow(xi2, 23) - 48876.4119243622*pow(xi2, 21) + 121393.88422966*pow(xi2, 19) - 172476.27453804*pow(xi2, 17) + 154773.431110382*pow(xi2, 15) - 91384.7427177429*pow(xi2, 13) + 35859.3837547302*pow(xi2, 11) - 9219.5107460022*pow(xi2, 9) + 1489.30558204651*pow(xi2, 7) - 138.755178451538*pow(xi2, 5) + 6.25499534606934*pow(xi2, 3) - 0.0880985260009766*xi2;
case 5:
return -13693.8223063946*pow(xi1, 24) + 81741.5854597092*pow(xi1, 22) - 213555.301215649*pow(xi1, 20) + 320533.865046501*pow(xi1, 18) - 304889.328414202*pow(xi1, 16) + 191109.129095078*pow(xi1, 14) - 79465.0906991959*pow(xi1, 12) + 21488.5519695282*pow(xi1, 10) - 3590.29024243355*pow(xi1, 8) + 334.554152488708*pow(xi1, 6) - 13.985641002655*pow(xi1, 4) + 0.132147789001465*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(57436053675.0*pow(xi2, 22) - 342849058860.0*pow(xi2, 20) + 895715854110.0*pow(xi2, 18) - 1344416472300.0*pow(xi2, 16) + 1278798529725.0*pow(xi2, 14) - 801569784600.0*pow(xi2, 12) + 333300747780.0*pow(xi2, 10) - 90129519480.0*pow(xi2, 8) + 15058768725.0*pow(xi2, 6) - 1403221820.0*pow(xi2, 4) + 58660030.0*pow(xi2, 2) - 554268.0);
case 6:
return -23005.6214747429*pow(xi1, 25) + 143258.44874382*pow(xi1, 23) - 392582.810969353*pow(xi1, 21) + 622456.821012497*pow(xi1, 19) - 631527.864468098*pow(xi1, 17) + 428224.98418808*pow(xi1, 15) - 196905.242013931*pow(xi1, 13) + 61080.8704948425*pow(xi1, 11) - 12499.5289921761*pow(xi1, 9) + 1618.81041526794*pow(xi1, 7) - 123.646281242371*pow(xi1, 5) + 4.84541893005371*pow(xi1, 3) - 0.0660738945007324*xi1 + 23005.6214747429*pow(xi2, 25) - 143258.44874382*pow(xi2, 23) + 392582.810969353*pow(xi2, 21) - 622456.821012497*pow(xi2, 19) + 631527.864468098*pow(xi2, 17) - 428224.98418808*pow(xi2, 15) + 196905.242013931*pow(xi2, 13) - 61080.8704948425*pow(xi2, 11) + 12499.5289921761*pow(xi2, 9) - 1618.81041526794*pow(xi2, 7) + 123.646281242371*pow(xi2, 5) - 4.84541893005371*pow(xi2, 3) + 0.0660738945007324*xi2;
case 7:
return -39817.4217832088*pow(xi1, 26) + 258075.881928205*pow(xi1, 24) - 739921.916306019*pow(xi1, 22) + 1235245.40490389*pow(xi1, 20) - 1330024.46163297*pow(xi1, 18) + 966541.123548746*pow(xi1, 16) - 482000.350642204*pow(xi1, 14) + 164355.508875847*pow(xi1, 12) - 37440.0785429478*pow(xi1, 10) + 5421.85859799385*pow(xi1, 8) - 453.112743854523*pow(xi1, 6) + 17.7298283576965*pow(xi1, 4) - 0.165184736251831*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(167006371455.0*pow(xi2, 24) - 1082448703875.0*pow(xi2, 22) + 3103457453250.0*pow(xi2, 20) - 5180994742770.0*pow(xi2, 18) + 5578526919525.0*pow(xi2, 16) - 4053967300665.0*pow(xi2, 14) + 2021655998700.0*pow(xi2, 12) - 689356968300.0*pow(xi2, 10) + 157035071193.0*pow(xi2, 8) - 22740923205.0*pow(xi2, 6) + 1900492594.0*pow(xi2, 4) - 74364290.0*pow(xi2, 2) + 692835.0);
case 8:
return -70294.9545061588*pow(xi1, 27) + 473384.903422594*pow(xi1, 25) - 1416926.27066374*pow(xi1, 23) + 2483930.03357649*pow(xi1, 21) - 2828756.50350451*pow(xi1, 19) + 2194030.45318007*pow(xi1, 17) - 1181610.30903339*pow(xi1, 15) + 442227.793622017*pow(xi1, 13) - 113300.856317282*pow(xi1, 11) + 19251.8955790997*pow(xi1, 9) - 2061.04299116135*pow(xi1, 7) + 129.04231595993*pow(xi1, 5) - 4.239741563797*pow(xi1, 3) + 0.0550615787506104*xi1 + 70294.9545061588*pow(xi2, 27) - 473384.903422594*pow(xi2, 25) + 1416926.27066374*pow(xi2, 23) - 2483930.03357649*pow(xi2, 21) + 2828756.50350451*pow(xi2, 19) - 2194030.45318007*pow(xi2, 17) + 1181610.30903339*pow(xi2, 15) - 442227.793622017*pow(xi2, 13) + 113300.856317282*pow(xi2, 11) - 19251.8955790997*pow(xi2, 9) + 2061.04299116135*pow(xi2, 7) - 129.04231595993*pow(xi2, 5) + 4.239741563797*pow(xi2, 3) - 0.0550615787506104*xi2;
case 9:
return -125885.352202356*pow(xi1, 28) + 879459.403354526*pow(xi1, 26) - 2742999.29717928*pow(xi1, 24) + 5037549.29947257*pow(xi1, 22) - 6049516.46395773*pow(xi1, 20) + 4988280.7302314*pow(xi1, 18) - 2885731.76894814*pow(xi1, 16) + 1175760.47526598*pow(xi1, 14) - 333757.370148003*pow(xi1, 12) + 64269.6642190218*pow(xi1, 10) - 7996.5022303462*pow(xi1, 8) + 588.090698003769*pow(xi1, 6) - 21.1023500561714*pow(xi1, 4) + 0.192715525627136*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2112005745135.0*pow(xi2, 26) - 14754880373310.0*pow(xi2, 24) + 46019891696625.0*pow(xi2, 22) - 84516052707900.0*pow(xi2, 20) + 101494044411375.0*pow(xi2, 18) - 83689463279730.0*pow(xi2, 16) + 48414545205705.0*pow(xi2, 14) - 19725987457800.0*pow(xi2, 12) + 5599519490565.0*pow(xi2, 10) - 1078266038850.0*pow(xi2, 8) + 134159045163.0*pow(xi2, 6) - 9866524668.0*pow(xi2, 4) + 354038685.0*pow(xi2, 2) - 3233230.0);
case 10:
return -227895.896228403*pow(xi1, 29) + 1649420.89680523*pow(xi1, 27) - 5351610.52541748*pow(xi1, 25) + 10274545.6434935*pow(xi1, 23) - 12976146.7507325*pow(xi1, 21) + 11335923.7640038*pow(xi1, 19) - 7012244.4740881*pow(xi1, 17) + 3091489.85211968*pow(xi1, 15) - 964606.306213886*pow(xi1, 13) + 208688.813287318*pow(xi1, 11) - 30172.9123489559*pow(xi1, 9) + 2748.55838191509*pow(xi1, 7) - 144.565551549196*pow(xi1, 5) + 3.95066827535629*pow(xi1, 3) - 0.0481788814067841*xi1 + 227895.896228403*pow(xi2, 29) - 1649420.89680523*pow(xi2, 27) + 5351610.52541748*pow(xi2, 25) - 10274545.6434935*pow(xi2, 23) + 12976146.7507325*pow(xi2, 21) - 11335923.7640038*pow(xi2, 19) + 7012244.4740881*pow(xi2, 17) - 3091489.85211968*pow(xi2, 15) + 964606.306213886*pow(xi2, 13) - 208688.813287318*pow(xi2, 11) + 30172.9123489559*pow(xi2, 9) - 2748.55838191509*pow(xi2, 7) + 144.565551549196*pow(xi2, 5) - 3.95066827535629*pow(xi2, 3) + 0.0481788814067841*xi2;
case 11:
return -416121.025335565*pow(xi1, 30) + 3116200.43859892*pow(xi1, 28) - 10501547.1333341*pow(xi1, 26) + 21037051.9058537*pow(xi1, 24) - 27874207.4076701*pow(xi1, 22) + 25719033.3889248*pow(xi1, 20) - 16943525.1738567*pow(xi1, 18) + 8039608.18552695*pow(xi1, 16) - 2737009.26113538*pow(xi1, 14) + 658014.033508673*pow(xi1, 12) - 108422.541410133*pow(xi1, 10) + 11650.7581970841*pow(xi1, 8) - 750.30417381227*pow(xi1, 6) + 24.3544245511293*pow(xi1, 4) - 0.216804966330528*pow(xi1, 2) + 1.49011611938477e-8*pow(xi2, 2)*(27925409296785.0*pow(xi2, 28) - 209124671430675.0*pow(xi2, 26) + 704746898360505.0*pow(xi2, 24) - 1.41177265531088e+15*pow(xi2, 22) + 1.87060639402913e+15*pow(xi2, 20) - 1.72597511390882e+15*pow(xi2, 18) + 1.13706072657293e+15*pow(xi2, 16) - 539528972335815.0*pow(xi2, 14) + 183677582272275.0*pow(xi2, 12) - 44158574284825.0*pow(xi2, 10) + 7276113586027.0*pow(xi2, 8) - 781869147345.0*pow(xi2, 6) + 50352060759.0*pow(xi2, 4) - 1634397765.0*pow(xi2, 2) + 14549535.0);
case 12:
return -765125.756262168*pow(xi1, 31) + 5921722.2836215*pow(xi1, 29) - 20698420.5992248*pow(xi1, 27) + 43188032.1491528*pow(xi1, 25) - 59905433.2374316*pow(xi1, 23) + 58217735.3508566*pow(xi1, 21) - 40700676.7005455*pow(xi1, 19) + 20687731.1349157*pow(xi1, 17) - 7635970.62332113*pow(xi1, 15) + 2022201.05743848*pow(xi1, 13) - 375095.230757907*pow(xi1, 11) + 46832.4571802467*pow(xi1, 9) - 3695.62648393214*pow(xi1, 7) + 167.127721711993*pow(xi1, 5) - 3.83022107183933*pow(xi1, 3) + 0.0433609932661057*xi1 + 765125.756262168*pow(xi2, 31) - 5921722.2836215*pow(xi2, 29) + 20698420.5992248*pow(xi2, 27) - 43188032.1491528*pow(xi2, 25) + 59905433.2374316*pow(xi2, 23) - 58217735.3508566*pow(xi2, 21) + 40700676.7005455*pow(xi2, 19) - 20687731.1349157*pow(xi2, 17) + 7635970.62332113*pow(xi2, 15) - 2022201.05743848*pow(xi2, 13) + 375095.230757907*pow(xi2, 11) - 46832.4571802467*pow(xi2, 9) + 3695.62648393214*pow(xi2, 7) - 167.127721711993*pow(xi2, 5) + 3.83022107183933*pow(xi2, 3) - 0.0433609932661057*xi2;
case 13:
return -1415047.91854168*pow(xi1, 32) + 11306561.1464429*pow(xi1, 30) - 40936820.1382083*pow(xi1, 28) + 88825591.3740283*pow(xi1, 26) - 128724305.723804*pow(xi1, 24) + 131431185.617418*pow(xi1, 22) - 97197166.7331937*pow(xi1, 20) + 52703810.8407026*pow(xi1, 18) - 20975386.6819913*pow(xi1, 16) + 6073001.20285492*pow(xi1, 14) - 1254611.22974331*pow(xi1, 12) + 179032.623164363*pow(xi1, 10) - 16764.9744193722*pow(xi1, 8) + 947.979715280235*pow(xi1, 6) - 27.6245661266148*pow(xi1, 4) + 0.238485462963581*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.0387922662047e+15*pow(xi2, 30) - 2.42806551770983e+16*pow(xi2, 28) + 8.79111518479194e+16*pow(xi2, 26) - 1.90751504999656e+17*pow(xi2, 24) + 2.76433341642022e+17*pow(xi2, 22) - 2.82246321950658e+17*pow(xi2, 20) + 2.08729326191463e+17*pow(xi2, 18) - 1.13180571967694e+17*pow(xi2, 16) + 4.50442999100533e+16*pow(xi2, 14) - 1.30416707774153e+16*pow(xi2, 12) + 2.69425710047094e+15*pow(xi2, 10) - 384469630704016.0*pow(xi2, 8) + 36002508424740.0*pow(xi2, 6) - 2035770937200.0*pow(xi2, 4) + 59323304040.0*pow(xi2, 2) - 512143632.0);
case 14:
return -2629988.05062292*pow(xi1, 33) + 21673212.5643307*pow(xi1, 31) - 81184889.5904638*pow(xi1, 29) + 182917081.974193*pow(xi1, 27) - 276441752.001857*pow(xi1, 25) + 295870487.432912*pow(xi1, 23) - 230789656.99729*pow(xi1, 21) + 133007978.589758*pow(xi1, 19) - 56801705.9862845*pow(xi1, 17) + 17863564.1120404*pow(xi1, 15) - 4073381.09373626*pow(xi1, 13) + 655788.077647805*pow(xi1, 11) - 71492.3014260083*pow(xi1, 9) + 4945.05285680294*pow(xi1, 7) - 195.558079630136*pow(xi1, 5) + 3.8157674074173*pow(xi1, 3) - 0.0397475771605968*xi1 + 2629988.05062292*pow(xi2, 33) - 21673212.5643307*pow(xi2, 31) + 81184889.5904638*pow(xi2, 29) - 182917081.974193*pow(xi2, 27) + 276441752.001857*pow(xi2, 25) - 295870487.432912*pow(xi2, 23) + 230789656.99729*pow(xi2, 21) - 133007978.589758*pow(xi2, 19) + 56801705.9862845*pow(xi2, 17) - 17863564.1120404*pow(xi2, 15) + 4073381.09373626*pow(xi2, 13) - 655788.077647805*pow(xi2, 11) + 71492.3014260083*pow(xi2, 9) - 4945.05285680294*pow(xi2, 7) + 195.558079630136*pow(xi2, 5) - 3.8157674074173*pow(xi2, 3) + 0.0397475771605968*xi2;
case 15:
return -4908914.34788215*pow(xi1, 34) + 41682976.2934526*pow(xi1, 32) - 161357453.758476*pow(xi1, 30) + 376988466.755545*pow(xi1, 28) - 593164732.277684*pow(xi1, 26) + 664096571.54609*pow(xi1, 24) - 544973436.806207*pow(xi1, 22) + 332715807.100391*pow(xi1, 20) - 151815163.18702*pow(xi1, 18) + 51567840.3122956*pow(xi1, 16) - 12879742.0744171*pow(xi1, 14) + 2314139.34894989*pow(xi1, 12) - 288997.558465965*pow(xi1, 10) + 23796.3634057716*pow(xi1, 8) - 1188.45255710185*pow(xi1, 6) + 31.0031101852655*pow(xi1, 4) - 0.25835925154388*pow(xi1, 2) + 1.86264514923096e-9*pow(xi2, 2)*(2.63545332287738e+15*pow(xi2, 32) - 2.23783774975403e+16*pow(xi2, 30) + 8.66281233573109e+16*pow(xi2, 28) - 2.02394141960531e+17*pow(xi2, 26) + 3.18452890784156e+17*pow(xi2, 24) - 3.56534132022022e+17*pow(xi2, 22) + 2.92580386033923e+17*pow(xi2, 20) - 1.78625438794803e+17*pow(xi2, 18) + 8.15051451156442e+16*pow(xi2, 16) - 2.76852734583325e+16*pow(xi2, 14) + 6.91475887381708e+15*pow(xi2, 12) - 1.24239410276582e+15*pow(xi2, 10) + 155154382779396.0*pow(xi2, 8) - 12775575323940.0*pow(xi2, 6) + 638045608200.0*pow(xi2, 4) - 16644668040.0*pow(xi2, 2) + 138705567.0);
case 16:
return -9196700.75786901*pow(xi1, 35) + 80394710.8035937*pow(xi1, 33) - 321276134.119334*pow(xi1, 31) + 777364493.20886*pow(xi1, 29) - 1271443221.77745*pow(xi1, 27) + 1486223279.32134*pow(xi1, 25) - 1280060550.32711*pow(xi1, 23) + 825415347.600242*pow(xi1, 21) - 400883985.039707*pow(xi1, 19) + 146346571.587733*pow(xi1, 17) - 39771130.9808454*pow(xi1, 15) + 7902101.94451205*pow(xi1, 13) - 1115630.10317823*pow(xi1, 11) + 107179.474305473*pow(xi1, 9) - 6556.41963489354*pow(xi1, 7) + 229.423015370965*pow(xi1, 5) - 3.87538877315819*pow(xi1, 3) + 0.0369084645062685*xi1 + 9196700.75786901*pow(xi2, 35) - 80394710.8035937*pow(xi2, 33) + 321276134.119334*pow(xi2, 31) - 777364493.20886*pow(xi2, 29) + 1271443221.77745*pow(xi2, 27) - 1486223279.32134*pow(xi2, 25) + 1280060550.32711*pow(xi2, 23) - 825415347.600242*pow(xi2, 21) + 400883985.039707*pow(xi2, 19) - 146346571.587733*pow(xi2, 17) + 39771130.9808454*pow(xi2, 15) - 7902101.94451205*pow(xi2, 13) + 1115630.10317823*pow(xi2, 11) - 107179.474305473*pow(xi2, 9) + 6556.41963489354*pow(xi2, 7) - 229.423015370965*pow(xi2, 5) + 3.87538877315819*pow(xi2, 3) - 0.0369084645062685*xi2;
case 17:
return -17286391.2393279*pow(xi1, 36) + 155439963.663983*pow(xi1, 34) - 640627537.401558*pow(xi1, 32) + 1603408154.14936*pow(xi1, 30) - 2722189337.19028*pow(xi1, 28) + 3316471384.76167*pow(xi1, 26) - 2991491208.6324*pow(xi1, 24) + 2031908379.46927*pow(xi1, 22) - 1046825005.81663*pow(xi1, 20) + 408912151.540302*pow(xi1, 18) - 120215159.194258*pow(xi1, 16) + 26207247.0460324*pow(xi1, 14) - 4137007.85298576*pow(xi1, 12) + 456223.339859758*pow(xi1, 10) - 33301.2157277483*pow(xi1, 8) + 1478.84835583717*pow(xi1, 6) - 34.5555498939939*pow(xi1, 4) + 0.276813483797014*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.7122242519387e+16*pow(xi2, 34) - 3.33804780214117e+17*pow(xi2, 32) + 1.37573716102836e+18*pow(xi2, 30) - 3.44329279210561e+18*pow(xi2, 28) + 5.84585708837608e+18*pow(xi2, 26) - 7.12206806783559e+18*pow(xi2, 24) + 6.42417845367384e+18*pow(xi2, 22) - 4.36349001914444e+18*pow(xi2, 20) + 2.24803958230871e+18*pow(xi2, 18) - 8.78132158901297e+17*pow(xi2, 16) + 2.58160088611386e+17*pow(xi2, 14) - 5.62796344904508e+16*pow(xi2, 12) + 8.8841567159345e+15*pow(xi2, 10) - 979732162184776.0*pow(xi2, 8) + 71513816233860.0*pow(xi2, 6) - 3175802662032.0*pow(xi2, 4) + 74207478345.0*pow(xi2, 2) - 594452430.0);
case 18:
return -32587183.4849491*pow(xi1, 37) + 301182124.285212*pow(xi1, 35) - 1278973293.46615*pow(xi1, 33) + 3307586664.76692*pow(xi1, 31) - 5821150644.88581*pow(xi1, 29) + 7379653798.46706*pow(xi1, 27) - 6957507972.42003*pow(xi1, 25) + 4965713056.14373*pow(xi1, 23) - 2705468268.15591*pow(xi1, 21) + 1126397750.97304*pow(xi1, 19) - 356415789.394206*pow(xi1, 17) + 84676873.7027844*pow(xi1, 15) - 14807100.0023584*pow(xi1, 13) + 1849478.42261893*pow(xi1, 11) - 157832.850914726*pow(xi1, 9) + 8602.58799865656*pow(xi1, 7) - 268.64517924597*pow(xi1, 5) + 3.99072772474028*pow(xi1, 3) - 0.0346016854746267*xi1 + 32587183.4849491*pow(xi2, 37) - 301182124.285212*pow(xi2, 35) + 1278973293.46615*pow(xi2, 33) - 3307586664.76692*pow(xi2, 31) + 5821150644.88581*pow(xi2, 29) - 7379653798.46706*pow(xi2, 27) + 6957507972.42003*pow(xi2, 25) - 4965713056.14373*pow(xi2, 23) + 2705468268.15591*pow(xi2, 21) - 1126397750.97304*pow(xi2, 19) + 356415789.394206*pow(xi2, 17) - 84676873.7027844*pow(xi2, 15) + 14807100.0023584*pow(xi2, 13) - 1849478.42261893*pow(xi2, 11) + 157832.850914726*pow(xi2, 9) - 8602.58799865656*pow(xi2, 7) + 268.64517924597*pow(xi2, 5) - 3.99072772474028*pow(xi2, 3) + 0.0346016854746267*xi2;
case 19:
return -61592803.4599426*pow(xi1, 38) + 584676985.136067*pow(xi1, 36) - 2555988333.59488*pow(xi1, 34) + 6822908928.68779*pow(xi1, 32) - 12432308002.2498*pow(xi1, 30) + 16375656213.2256*pow(xi1, 28) - 16107683650.0167*pow(xi1, 26) + 12053207925.8038*pow(xi1, 24) - 6925457912.8482*pow(xi1, 22) + 3062457034.47476*pow(xi1, 20) - 1038287442.79005*pow(xi1, 18) + 267243136.899296*pow(xi1, 16) - 51355753.1063992*pow(xi1, 14) + 7184638.11364675*pow(xi1, 12) - 705129.947642557*pow(xi1, 10) + 45954.0694179519*pow(xi1, 8) - 1826.4303601564*pow(xi1, 6) + 38.3329005583073*pow(xi1, 4) - 0.294114326534327*pow(xi1, 2) + 5.82076609134674e-11*pow(xi2, 2)*(1.05815630611764e+18*pow(xi2, 36) - 1.00446741195331e+19*pow(xi2, 34) + 4.39115452069901e+19*pow(xi2, 32) - 1.17216682849202e+20*pow(xi2, 30) + 2.13585425133848e+20*pow(xi2, 28) - 2.81331631545373e+20*pow(xi2, 26) + 2.76727897964542e+20*pow(xi2, 24) - 2.07072535412861e+20*pow(xi2, 22) + 1.1897846098203e+20*pow(xi2, 20) - 5.2612611233897e+19*pow(xi2, 18) + 1.7837642442523e+19*pow(xi2, 16) - 4.5912021322517e+18*pow(xi2, 14) + 8.8228512021374e+17*pow(xi2, 12) - 1.23431142926832e+17*pow(xi2, 10) + 1.21140402582199e+16*pow(xi2, 8) - 789484901072868.0*pow(xi2, 6) + 31377834661173.0*pow(xi2, 4) - 658554217035.0*pow(xi2, 2) + 5052845655.0);
case 20:
return -116692918.236073*pow(xi1, 39) + 1136922431.95717*pow(xi1, 37) - 5112427747.50414*pow(xi1, 35) + 14072663329.5704*pow(xi1, 33) - 26517959811.2804*pow(xi1, 31) + 36241322522.7774*pow(xi1, 29) - 37130150648.172*pow(xi1, 27) + 29070301213.2304*pow(xi1, 25) - 17570522700.1095*pow(xi1, 23) + 8226381205.98939*pow(xi1, 21) - 2976454861.17552*pow(xi1, 19) + 825687319.603043*pow(xi1, 17) - 173173784.504984*pow(xi1, 15) + 26879987.6421062*pow(xi1, 13) - 2993171.44800321*pow(xi1, 11) + 228491.145845553*pow(xi1, 9) - 11168.7170434363*pow(xi1, 7) + 313.349403489672*pow(xi1, 5) - 4.1502799410955*pow(xi1, 3) + 0.0326793696149252*xi1 + 116692918.236073*pow(xi2, 39) - 1136922431.95717*pow(xi2, 37) + 5112427747.50414*pow(xi2, 35) - 14072663329.5704*pow(xi2, 33) + 26517959811.2804*pow(xi2, 31) - 36241322522.7774*pow(xi2, 29) + 37130150648.172*pow(xi2, 27) - 29070301213.2304*pow(xi2, 25) + 17570522700.1095*pow(xi2, 23) - 8226381205.98939*pow(xi2, 21) + 2976454861.17552*pow(xi2, 19) - 825687319.603043*pow(xi2, 17) + 173173784.504984*pow(xi2, 15) - 26879987.6421062*pow(xi2, 13) + 2993171.44800321*pow(xi2, 11) - 228491.145845553*pow(xi2, 9) + 11168.7170434363*pow(xi2, 7) - 313.349403489672*pow(xi2, 5) + 4.1502799410955*pow(xi2, 3) - 0.0326793696149252*xi2;
case 21:
return -221563001.335071*pow(xi1, 40) + 2214094580.21603*pow(xi1, 38) - 10233135408.4591*pow(xi1, 36) + 29020103383.2284*pow(xi1, 34) - 56490288563.2613*pow(xi1, 32) + 80000676119.5703*pow(xi1, 30) - 85237502310.1306*pow(xi1, 28) + 69693167146.6517*pow(xi1, 26) - 44209431231.8868*pow(xi1, 24) + 21852582608.9513*pow(xi1, 22) - 8407716578.46659*pow(xi1, 20) + 2502229402.03009*pow(xi1, 18) - 569333795.484418*pow(xi1, 16) + 97259112.1754349*pow(xi1, 14) - 12149572.8591448*pow(xi1, 12) + 1068478.64285384*pow(xi1, 10) - 62566.3402002307*pow(xi1, 8) + 2238.80805739018*pow(xi1, 6) - 42.3769725481543*pow(xi1, 4) + 0.31045401134179*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(3.04513870316075e+19*pow(xi2, 38) - 3.04302841992918e+20*pow(xi2, 36) + 1.40643142127589e+21*pow(xi2, 34) - 3.98849263864016e+21*pow(xi2, 32) + 7.76396614146592e+21*pow(xi2, 30) - 1.09952092029262e+22*pow(xi2, 28) + 1.17149531140715e+22*pow(xi2, 26) - 9.57855595678498e+21*pow(xi2, 24) + 6.07609796210287e+21*pow(xi2, 22) - 3.00339608443469e+21*pow(xi2, 20) + 1.15554776763363e+21*pow(xi2, 18) - 3.43903790361884e+20*pow(xi2, 16) + 7.82486410276201e+19*pow(xi2, 14) - 1.33671905930076e+19*pow(xi2, 12) + 1.66982457889267e+18*pow(xi2, 10) - 1.46850586481014e+17*pow(xi2, 8) + 8.59905231969284e+15*pow(xi2, 6) - 307699436432388.0*pow(xi2, 4) + 5824246758330.0*pow(xi2, 2) - 42668474420.0);
case 22:
return -421510100.100867*pow(xi1, 41) + 4317637974.73472*pow(xi1, 39) - 20495376463.706*pow(xi1, 37) + 59829173626.0731*pow(xi1, 35) - 120187030355.44*pow(xi1, 33) + 176161079659.26*pow(xi1, 31) - 194910898677.091*pow(xi1, 29) + 166141923646.698*pow(xi1, 27) - 110376841418.661*pow(xi1, 25) + 57451813692.2349*pow(xi1, 23) - 23429392934.2707*pow(xi1, 21) + 7450171697.65655*pow(xi1, 19) - 1829297919.45312*pow(xi1, 17) + 341526679.439026*pow(xi1, 15) - 47405219.4064614*pow(xi1, 13) + 4737634.10611667*pow(xi1, 11) - 325514.911567008*pow(xi1, 9) + 14352.2889443309*pow(xi1, 7) - 363.790010490309*pow(xi1, 5) + 4.34635615878506*pow(xi1, 3) - 0.031045401134179*xi1 + 421510100.100867*pow(xi2, 41) - 4317637974.73472*pow(xi2, 39) + 20495376463.706*pow(xi2, 37) - 59829173626.0731*pow(xi2, 35) + 120187030355.44*pow(xi2, 33) - 176161079659.26*pow(xi2, 31) + 194910898677.091*pow(xi2, 29) - 166141923646.698*pow(xi2, 27) + 110376841418.661*pow(xi2, 25) - 57451813692.2349*pow(xi2, 23) + 23429392934.2707*pow(xi2, 21) - 7450171697.65655*pow(xi2, 19) + 1829297919.45312*pow(xi2, 17) - 341526679.439026*pow(xi2, 15) + 47405219.4064614*pow(xi2, 13) - 4737634.10611667*pow(xi2, 11) + 325514.911567008*pow(xi2, 9) - 14352.2889443309*pow(xi2, 7) + 363.790010490309*pow(xi2, 5) - 4.34635615878506*pow(xi2, 3) + 0.031045401134179*xi2;
case 23:
return -803354283.752333*pow(xi1, 42) + 8429944669.8439*pow(xi1, 40) - 41070423529.3311*pow(xi1, 38) + 123310478369.716*pow(xi1, 36) - 255387566346.647*pow(xi1, 34) + 386985888284.832*pow(xi1, 32) - 444046768569.53*pow(xi1, 30) + 393966174779.878*pow(xi1, 28) - 273583716795.579*pow(xi1, 26) + 149598387506.117*pow(xi1, 24) - 64475852087.3283*pow(xi1, 22) + 21825643771.0978*pow(xi1, 20) - 5756146123.25306*pow(xi1, 18) + 1167338459.55362*pow(xi1, 16) - 178569841.335938*pow(xi1, 14) + 20049882.8097356*pow(xi1, 12) - 1589574.9092333*pow(xi1, 10) + 84105.4842801184*pow(xi1, 8) - 2724.07872251853*pow(xi1, 6) + 46.7233287069394*pow(xi1, 4) - 0.325976711908879*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(1.10412172026169e+20*pow(xi2, 40) - 1.15860277325021e+21*pow(xi2, 38) + 5.64467602852308e+21*pow(xi2, 36) - 1.69476630992655e+22*pow(xi2, 34) + 3.51001998484442e+22*pow(xi2, 32) - 5.31869354942996e+22*pow(xi2, 30) + 6.10293231648196e+22*pow(xi2, 28) - 5.41462987651134e+22*pow(xi2, 26) + 3.76010597233645e+22*pow(xi2, 24) - 2.05606458199395e+22*pow(xi2, 22) + 8.86149363509787e+21*pow(xi2, 20) - 2.99969363875236e+21*pow(xi2, 18) + 7.9111869921181e+20*pow(xi2, 16) - 1.60437776228666e+20*pow(xi2, 14) + 2.45424521148724e+19*pow(xi2, 12) - 2.7556349106063e+18*pow(xi2, 10) + 2.18469511990375e+17*pow(xi2, 8) - 1.15593697407152e+16*pow(xi2, 6) + 374394528798290.0*pow(xi2, 4) - 6421605400210.0*pow(xi2, 2) + 44801898141.0);
case 24:
return -1533676359.89082*pow(xi1, 43) + 16477189610.109*pow(xi1, 41) - 82337083389.5511*pow(xi1, 39) + 254065759248.919*pow(xi1, 37) - 542014369628.522*pow(xi1, 35) + 848184840655.991*pow(xi1, 33) - 1008066267320.93*pow(xi1, 31) + 929523529356.303*pow(xi1, 29) - 673516946271.272*pow(xi1, 27) + 386060686638.382*pow(xi1, 25) - 175382178039.451*pow(xi1, 23) + 62992242266.5747*pow(xi1, 21) - 17770037336.7532*pow(xi1, 19) + 3893551383.46965*pow(xi1, 17) - 651757419.719781*pow(xi1, 15) + 81424351.1461102*pow(xi1, 13) - 7346738.38629451*pow(xi1, 11) + 456841.438780431*pow(xi1, 9) - 18263.6284754963*pow(xi1, 7) + 420.312396718873*pow(xi1, 5) - 4.57355204890337*pow(xi1, 3) + 0.0296342465371708*xi1 + 1533676359.89082*pow(xi2, 43) - 16477189610.109*pow(xi2, 41) + 82337083389.5511*pow(xi2, 39) - 254065759248.919*pow(xi2, 37) + 542014369628.522*pow(xi2, 35) - 848184840655.991*pow(xi2, 33) + 1008066267320.93*pow(xi2, 31) - 929523529356.303*pow(xi2, 29) + 673516946271.272*pow(xi2, 27) - 386060686638.382*pow(xi2, 25) + 175382178039.451*pow(xi2, 23) - 62992242266.5747*pow(xi2, 21) + 17770037336.7532*pow(xi2, 19) - 3893551383.46965*pow(xi2, 17) + 651757419.719781*pow(xi2, 15) - 81424351.1461102*pow(xi2, 13) + 7346738.38629451*pow(xi2, 11) - 456841.438780431*pow(xi2, 9) + 18263.6284754963*pow(xi2, 7) - 420.312396718873*pow(xi2, 5) + 4.57355204890337*pow(xi2, 3) - 0.0296342465371708*xi2;
case 25:
return -2932474067.5778*pow(xi1, 44) + 32238834564.0148*pow(xi1, 42) - 165130361584.918*pow(xi1, 40) + 523288745102.942*pow(xi1, 38) - 1148954747625.29*pow(xi1, 36) + 1854967248083.68*pow(xi1, 34) - 2280829494925.56*pow(xi1, 32) + 2182752279805.6*pow(xi1, 30) - 1647525238173.91*pow(xi1, 28) + 987973509155.938*pow(xi1, 26) - 471935693612.43*pow(xi1, 24) + 179316168680.198*pow(xi1, 22) - 53905793874.3631*pow(xi1, 20) + 12700484717.7838*pow(xi1, 18) - 2312063576.2873*pow(xi1, 16) + 318735268.794855*pow(xi1, 14) - 32354364.3586448*pow(xi1, 12) + 2324901.14233653*pow(xi1, 10) - 111715.261973273*pow(xi1, 8) + 3290.93246836372*pow(xi1, 6) - 51.4030701392676*pow(xi1, 4) + 0.340793835177465*pow(xi1, 2) + 1.81898940354586e-12*pow(xi2, 2)*(1.61214466772669e+21*pow(xi2, 42) - 1.77234867345406e+22*pow(xi2, 40) + 9.07813763307364e+22*pow(xi2, 38) - 2.87681029962498e+23*pow(xi2, 36) + 6.31644552401221e+23*pow(xi2, 34) - 1.01977902920583e+24*pow(xi2, 32) + 1.25389927532256e+24*pow(xi2, 30) - 1.19998075610042e+24*pow(xi2, 28) + 9.05736578213321e+23*pow(xi2, 26) - 5.43144180625806e+23*pow(xi2, 24) + 2.59449391344699e+23*pow(xi2, 22) - 9.85801062560599e+22*pow(xi2, 20) + 2.96350235846792e+22*pow(xi2, 18) - 6.98216531279734e+21*pow(xi2, 16) + 1.27107039314262e+21*pow(xi2, 14) - 1.75226567111126e+20*pow(xi2, 12) + 1.77869999108157e+19*pow(xi2, 10) - 1.27812791971436e+18*pow(xi2, 8) + 6.14161147698277e+16*pow(xi2, 6) - 1.80920925759574e+15*pow(xi2, 4) + 28259136660755.0*pow(xi2, 2) - 187353392226.0);
case 26:
return -5615144788.65823*pow(xi1, 45) + 63135916036.1408*pow(xi1, 43) - 331283607298.759*pow(xi1, 41) + 1077403912985.34*pow(xi1, 39) - 2432704272638.31*pow(xi1, 37) + 4048284797605.57*pow(xi1, 35) - 5144115977810.54*pow(xi1, 33) + 5102731133233.49*pow(xi1, 31) - 4005941677467.71*pow(xi1, 29) + 2508576623183.67*pow(xi1, 27) - 1257213928686.48*pow(xi1, 25) + 503967555431.51*pow(xi1, 23) - 160906149318.764*pow(xi1, 21) + 40592360498.6979*pow(xi1, 19) - 7992770588.98206*pow(xi1, 17) + 1207178101.86205*pow(xi1, 15) - 136518405.419752*pow(xi1, 13) + 11179652.8357223*pow(xi1, 11) - 632273.686710647*pow(xi1, 9) + 23026.7091704373*pow(xi1, 7) - 483.330856740439*pow(xi1, 5) + 4.82791266501408*pow(xi1, 3) - 0.0283994862647887*xi1 + 5615144788.65823*pow(xi2, 45) - 63135916036.1408*pow(xi2, 43) + 331283607298.759*pow(xi2, 41) - 1077403912985.34*pow(xi2, 39) + 2432704272638.31*pow(xi2, 37) - 4048284797605.57*pow(xi2, 35) + 5144115977810.54*pow(xi2, 33) - 5102731133233.49*pow(xi2, 31) + 4005941677467.71*pow(xi2, 29) - 2508576623183.67*pow(xi2, 27) + 1257213928686.48*pow(xi2, 25) - 503967555431.51*pow(xi2, 23) + 160906149318.764*pow(xi2, 21) - 40592360498.6979*pow(xi2, 19) + 7992770588.98206*pow(xi2, 17) - 1207178101.86205*pow(xi2, 15) + 136518405.419752*pow(xi2, 13) - 11179652.8357223*pow(xi2, 11) + 632273.686710647*pow(xi2, 9) - 23026.7091704373*pow(xi2, 7) + 483.330856740439*pow(xi2, 5) - 4.82791266501408*pow(xi2, 3) + 0.0283994862647887*xi2;
case 27:
return -10766429790.4273*pow(xi1, 46) + 123749152457.737*pow(xi1, 44) - 664805249813.08*pow(xi1, 42) + 2217444024836.51*pow(xi1, 40) - 5144981244028.56*pow(xi1, 38) + 8817228144268.68*pow(xi1, 36) - 11566692718301.1*pow(xi1, 34) + 11878407054355.6*pow(xi1, 32) - 9685366353522.19*pow(xi1, 30) + 6322834046464.09*pow(xi1, 28) - 3317819280545.0*pow(xi1, 26) + 1399677324153.45*pow(xi1, 24) - 473184299476.64*pow(xi1, 22) + 127332537367.964*pow(xi1, 20) - 26987971774.8993*pow(xi1, 18) + 4437770795.40733*pow(xi1, 16) - 554449355.907009*pow(xi1, 14) + 51146299.3791467*pow(xi1, 12) - 3347235.88000065*pow(xi1, 10) + 146737.457721642*pow(xi1, 8) - 3948.73556897189*pow(xi1, 6) + 56.4439789512676*pow(xi1, 4) - 0.354993578309859*pow(xi1, 2) + 4.54747350886464e-13*pow(xi2, 2)*(2.36756294884175e+22*pow(xi2, 44) - 2.72127264109414e+23*pow(xi2, 42) + 1.46192220475202e+24*pow(xi2, 40) - 4.87621097850032e+24*pow(xi2, 38) + 1.13139334049977e+25*pow(xi2, 36) - 1.93892897387544e+25*pow(xi2, 34) + 2.54354262773681e+25*pow(xi2, 32) - 2.6120893351441e+25*pow(xi2, 30) + 2.12983458499362e+25*pow(xi2, 28) - 1.39040591091705e+25*pow(xi2, 26) + 7.29596175563726e+24*pow(xi2, 24) - 3.07792298608224e+24*pow(xi2, 22) + 1.04054327871121e+24*pow(xi2, 20) - 2.80007210860597e+23*pow(xi2, 18) + 5.93471775531844e+22*pow(xi2, 16) - 9.75876118191021e+21*pow(xi2, 14) + 1.21924702766534e+21*pow(xi2, 12) - 1.12471901770168e+20*pow(xi2, 10) + 7.36064954193949e+18*pow(xi2, 8) - 3.22679081990469e+17*pow(xi2, 6) + 8.68336134619454e+15*pow(xi2, 4) - 124121622349725.0*pow(xi2, 2) + 780639134275.0);
case 28:
return -20669430677.858*pow(xi1, 47) + 242743705984.959*pow(xi1, 45) - 1334422142073.76*pow(xi1, 43) + 4562055823778.34*pow(xi1, 41) - 10869272649002.0*pow(xi1, 39) + 19167029443937.3*pow(xi1, 37) - 25932850957625.2*pow(xi1, 35) + 27540158501634.1*pow(xi1, 33) - 23291845098194.7*pow(xi1, 31) + 15826677366730.5*pow(xi1, 29) - 8679084881270.15*pow(xi1, 27) + 3844559615681.35*pow(xi1, 25) - 1372398208003.19*pow(xi1, 23) + 392591422175.228*pow(xi1, 21) - 89182852887.1235*pow(xi1, 19) + 15878163957.8501*pow(xi1, 17) - 2175816995.68173*pow(xi1, 15) + 223875789.885968*pow(xi1, 13) - 16718513.386797*pow(xi1, 11) + 863805.394274895*pow(xi1, 9) - 28780.1493897359*pow(xi1, 7) + 553.314836912411*pow(xi1, 5) - 5.10644608799566*pow(xi1, 3) + 0.0273071983315276*xi1 + 20669430677.858*pow(xi2, 47) - 242743705984.959*pow(xi2, 45) + 1334422142073.76*pow(xi2, 43) - 4562055823778.34*pow(xi2, 41) + 10869272649002.0*pow(xi2, 39) - 19167029443937.3*pow(xi2, 37) + 25932850957625.2*pow(xi2, 35) - 27540158501634.1*pow(xi2, 33) + 23291845098194.7*pow(xi2, 31) - 15826677366730.5*pow(xi2, 29) + 8679084881270.15*pow(xi2, 27) - 3844559615681.35*pow(xi2, 25) + 1372398208003.19*pow(xi2, 23) - 392591422175.228*pow(xi2, 21) + 89182852887.1235*pow(xi2, 19) - 15878163957.8501*pow(xi2, 17) + 2175816995.68173*pow(xi2, 15) - 223875789.885968*pow(xi2, 13) + 16718513.386797*pow(xi2, 11) - 863805.394274895*pow(xi2, 9) + 28780.1493897359*pow(xi2, 7) - 553.314836912411*pow(xi2, 5) + 5.10644608799566*pow(xi2, 3) - 0.0273071983315276*xi2;
case 29:
return -39728049242.7039*pow(xi1, 48) + 476505949117.133*pow(xi1, 46) - 2679054791412.26*pow(xi1, 44) + 9382111673603.37*pow(xi1, 42) - 22937896621590.0*pow(xi1, 40) + 41588485583490.6*pow(xi1, 38) - 57981856038508.5*pow(xi1, 36) + 63608598673568.9*pow(xi1, 34) - 55730713154580.7*pow(xi1, 32) + 39358257862237.2*pow(xi1, 30) - 22516922818681.8*pow(xi1, 28) + 10451406445051.6*pow(xi1, 26) - 3929555657141.43*pow(xi1, 24) + 1191272175390.01*pow(xi1, 22) - 288926022756.805*pow(xi1, 20) + 55425095713.3247*pow(xi1, 18) - 8277516579.76024*pow(xi1, 16) + 941984086.723766*pow(xi1, 14) - 79334996.0209767*pow(xi1, 12) + 4749320.37729368*pow(xi1, 10) - 190735.308470803*pow(xi1, 8) + 4707.5998798852*pow(xi1, 6) - 61.8712846196587*pow(xi1, 4) + 0.368647177475623*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(1.39780646691873e+24*pow(xi2, 46) - 1.67655626162793e+25*pow(xi2, 44) + 9.4260860627417e+25*pow(xi2, 42) - 3.30103708103035e+26*pow(xi2, 40) + 8.07055489669184e+26*pow(xi2, 38) - 1.46326475138056e+27*pow(xi2, 36) + 2.04005519725997e+27*pow(xi2, 34) - 2.23802860378003e+27*pow(xi2, 32) + 1.96085014840673e+27*pow(xi2, 30) - 1.38479558939315e+27*pow(xi2, 28) + 7.92243790748012e+26*pow(xi2, 26) - 3.67726173214312e+26*pow(xi2, 24) + 1.38258948384639e+26*pow(xi2, 22) - 4.19141634779945e+25*pow(xi2, 20) + 1.01656806908218e+25*pow(xi2, 18) - 1.95009719063674e+24*pow(xi2, 16) + 2.9123922331376e+23*pow(xi2, 14) - 3.31431186090476e+22*pow(xi2, 12) + 2.79135201966805e+21*pow(xi2, 10) - 1.67101855323773e+20*pow(xi2, 8) + 6.71090206371489e+18*pow(xi2, 6) - 1.65633945819222e+17*pow(xi2, 4) + 2.1769022996721e+15*pow(xi2, 2) - 12970619461800.0);
default:
return 0.;
}
case 23:
switch(j) {
case 0:
return 1.9073486328125e-6*y1t*(-8775943605.0*pow(xi1, 23) + 49230903150.0*pow(xi1, 21) - 119290265325.0*pow(xi1, 19) + 163352435400.0*pow(xi1, 17) - 138849570090.0*pow(xi1, 15) + 75736129140.0*pow(xi1, 13) - 26466926850.0*pow(xi1, 11) + 5736673800.0*pow(xi1, 9) - 717084225.0*pow(xi1, 7) + 44618574.0*pow(xi1, 5) - 969969.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-2925314535.0*pow(xi2, 20) + 16410301050.0*pow(xi2, 18) - 39763421775.0*pow(xi2, 16) + 54450811800.0*pow(xi2, 14) - 46283190030.0*pow(xi2, 12) + 25245376380.0*pow(xi2, 10) - 8822308950.0*pow(xi2, 8) + 1912224600.0*pow(xi2, 6) - 239028075.0*pow(xi2, 4) + 14872858.0*pow(xi2, 2) - 323323.0));
case 1:
return 4.76837158203125e-7*y1r*(-17551887210.0*pow(xi1, 23) + 6116566755.0*pow(xi1, 22) + 98461806300.0*pow(xi1, 21) - 34461632205.0*pow(xi1, 20) - 238580530650.0*pow(xi1, 19) + 83945001525.0*pow(xi1, 18) + 326704870800.0*pow(xi1, 17) - 115707975075.0*pow(xi1, 16) - 277699140180.0*pow(xi1, 15) + 99178264350.0*pow(xi1, 14) + 151472258280.0*pow(xi1, 13) - 54698315490.0*pow(xi1, 12) - 52933853700.0*pow(xi1, 11) + 19409079690.0*pow(xi1, 10) + 11473347600.0*pow(xi1, 9) - 4302505350.0*pow(xi1, 8) - 1434168450.0*pow(xi1, 7) + 557732175.0*pow(xi1, 6) + 89237148.0*pow(xi1, 5) - 37182145.0*pow(xi1, 4) - 1939938.0*pow(xi1, 3) + 969969.0*pow(xi1, 2) + pow(xi2, 2)*(17551887210.0*pow(xi2, 21) - 6116566755.0*pow(xi2, 20) - 98461806300.0*pow(xi2, 19) + 34461632205.0*pow(xi2, 18) + 238580530650.0*pow(xi2, 17) - 83945001525.0*pow(xi2, 16) - 326704870800.0*pow(xi2, 15) + 115707975075.0*pow(xi2, 14) + 277699140180.0*pow(xi2, 13) - 99178264350.0*pow(xi2, 12) - 151472258280.0*pow(xi2, 11) + 54698315490.0*pow(xi2, 10) + 52933853700.0*pow(xi2, 9) - 19409079690.0*pow(xi2, 8) - 11473347600.0*pow(xi2, 7) + 4302505350.0*pow(xi2, 6) + 1434168450.0*pow(xi2, 5) - 557732175.0*pow(xi2, 4) - 89237148.0*pow(xi2, 3) + 37182145.0*pow(xi2, 2) + 1939938.0*xi2 - 969969.0));
case 2:
return 1.9073486328125e-6*y2t*(8775943605.0*pow(xi1, 23) - 49230903150.0*pow(xi1, 21) + 119290265325.0*pow(xi1, 19) - 163352435400.0*pow(xi1, 17) + 138849570090.0*pow(xi1, 15) - 75736129140.0*pow(xi1, 13) + 26466926850.0*pow(xi1, 11) - 5736673800.0*pow(xi1, 9) + 717084225.0*pow(xi1, 7) - 44618574.0*pow(xi1, 5) + 969969.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-2925314535.0*pow(xi2, 20) + 16410301050.0*pow(xi2, 18) - 39763421775.0*pow(xi2, 16) + 54450811800.0*pow(xi2, 14) - 46283190030.0*pow(xi2, 12) + 25245376380.0*pow(xi2, 10) - 8822308950.0*pow(xi2, 8) + 1912224600.0*pow(xi2, 6) - 239028075.0*pow(xi2, 4) + 14872858.0*pow(xi2, 2) - 323323.0));
case 3:
return 4.76837158203125e-7*y2r*(-17551887210.0*pow(xi1, 23) - 6116566755.0*pow(xi1, 22) + 98461806300.0*pow(xi1, 21) + 34461632205.0*pow(xi1, 20) - 238580530650.0*pow(xi1, 19) - 83945001525.0*pow(xi1, 18) + 326704870800.0*pow(xi1, 17) + 115707975075.0*pow(xi1, 16) - 277699140180.0*pow(xi1, 15) - 99178264350.0*pow(xi1, 14) + 151472258280.0*pow(xi1, 13) + 54698315490.0*pow(xi1, 12) - 52933853700.0*pow(xi1, 11) - 19409079690.0*pow(xi1, 10) + 11473347600.0*pow(xi1, 9) + 4302505350.0*pow(xi1, 8) - 1434168450.0*pow(xi1, 7) - 557732175.0*pow(xi1, 6) + 89237148.0*pow(xi1, 5) + 37182145.0*pow(xi1, 4) - 1939938.0*pow(xi1, 3) - 969969.0*pow(xi1, 2) + pow(xi2, 2)*(17551887210.0*pow(xi2, 21) + 6116566755.0*pow(xi2, 20) - 98461806300.0*pow(xi2, 19) - 34461632205.0*pow(xi2, 18) + 238580530650.0*pow(xi2, 17) + 83945001525.0*pow(xi2, 16) - 326704870800.0*pow(xi2, 15) - 115707975075.0*pow(xi2, 14) + 277699140180.0*pow(xi2, 13) + 99178264350.0*pow(xi2, 12) - 151472258280.0*pow(xi2, 11) - 54698315490.0*pow(xi2, 10) + 52933853700.0*pow(xi2, 9) + 19409079690.0*pow(xi2, 8) - 11473347600.0*pow(xi2, 7) - 4302505350.0*pow(xi2, 6) + 1434168450.0*pow(xi2, 5) + 557732175.0*pow(xi2, 4) - 89237148.0*pow(xi2, 3) - 37182145.0*pow(xi2, 2) + 1939938.0*xi2 + 969969.0));
case 4:
return -16041.3347017765*pow(xi1, 24) + 95465.5040788651*pow(xi1, 22) - 249016.891787052*pow(xi1, 20) + 374316.789364815*pow(xi1, 18) - 358630.103105307*pow(xi1, 16) + 228720.737085342*pow(xi1, 14) - 98439.2306470871*pow(xi1, 12) + 28357.5940418243*pow(xi1, 10) - 5299.95226264*pow(xi1, 8) + 602.814164161682*pow(xi1, 6) - 36.8472084999084*pow(xi1, 4) + 0.925034523010254*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(67282234305.0*pow(xi2, 22) - 400411345620.0*pow(xi2, 20) + 1044452545290.0*pow(xi2, 18) - 1569998406900.0*pow(xi2, 16) + 1504203675975.0*pow(xi2, 14) - 959324302440.0*pow(xi2, 12) + 412884058860.0*pow(xi2, 10) - 118940370120.0*pow(xi2, 8) + 22229610975.0*pow(xi2, 6) - 2528385860.0*pow(xi2, 4) + 154548394.0*pow(xi2, 2) - 3879876.0);
case 5:
return -25666.1355228424*pow(xi1, 25) + 159630.842885971*pow(xi1, 23) - 436998.461294174*pow(xi1, 21) + 692150.120401382*pow(xi1, 19) - 701032.59973526*pow(xi1, 17) + 473492.052211761*pow(xi1, 15) - 215647.282390594*pow(xi1, 13) + 65402.3434638977*pow(xi1, 11) - 12714.8197650909*pow(xi1, 9) + 1469.04292106628*pow(xi1, 7) - 86.9532451629639*pow(xi1, 5) + 1.85006904602051*pow(xi1, 3) + 1.9073486328125e-6*pow(xi2, 3)*(13456446861.0*pow(xi2, 22) - 83692535355.0*pow(xi2, 20) + 229113049275.0*pow(xi2, 18) - 362886002325.0*pow(xi2, 16) + 367542979650.0*pow(xi2, 14) - 248246201070.0*pow(xi2, 12) + 113061282390.0*pow(xi2, 10) - 34289663850.0*pow(xi2, 8) + 6666227425.0*pow(xi2, 6) - 770201575.0*pow(xi2, 4) + 45588543.0*pow(xi2, 2) - 969969.0);
case 6:
return -43188.2088124752*pow(xi1, 26) + 279745.227116346*pow(xi1, 24) - 801585.194084644*pow(xi1, 22) + 1337462.24400759*pow(xi1, 20) - 1439388.69436383*pow(xi1, 18) + 1045795.4754889*pow(xi1, 16) - 521967.386698723*pow(xi1, 14) + 178745.682291985*pow(xi1, 12) - 41294.0366613865*pow(xi1, 10) + 6224.43616986275*pow(xi1, 8) - 578.917438983917*pow(xi1, 6) + 30.0636219978333*pow(xi1, 4) - 0.69377589225769*pow(xi1, 2) + 2.38418579101563e-7*pow(xi2, 2)*(181144476975.0*pow(xi2, 24) - 1173336525075.0*pow(xi2, 22) + 3362091985890.0*pow(xi2, 20) - 5609723239890.0*pow(xi2, 18) + 6037233758325.0*pow(xi2, 16) - 4386384146025.0*pow(xi2, 14) + 2189289897900.0*pow(xi2, 12) - 749713730220.0*pow(xi2, 10) + 173199743145.0*pow(xi2, 8) - 26107177525.0*pow(xi2, 6) + 2428155730.0*pow(xi2, 4) - 126095970.0*pow(xi2, 2) + 2909907.0);
case 7:
return -74859.5619416237*pow(xi1, 27) + 503932.66087532*pow(xi1, 25) - 1507825.26934147*pow(xi1, 23) + 2642391.18733406*pow(xi1, 21) - 3008256.60670996*pow(xi1, 19) + 2332526.65002823*pow(xi1, 17) - 1255698.85142326*pow(xi1, 15) + 469510.651874542*pow(xi1, 13) - 119893.934762478*pow(xi1, 11) + 20130.9536838531*pow(xi1, 9) - 2068.42124271393*pow(xi1, 7) + 112.854211807251*pow(xi1, 5) - 2.31258630752563*pow(xi1, 3) + 4.76837158203125e-7*pow(xi2, 3)*(156991880045.0*pow(xi2, 24) - 1056823387620.0*pow(xi2, 22) + 3162138779250.0*pow(xi2, 20) - 5541495963300.0*pow(xi2, 18) + 6308771359275.0*pow(xi2, 16) - 4891662929160.0*pow(xi2, 14) + 2633391357660.0*pow(xi2, 12) - 984635202600.0*pow(xi2, 10) + 251435805075.0*pow(xi2, 8) - 42217669780.0*pow(xi2, 6) + 4337793746.0*pow(xi2, 4) - 236672436.0*pow(xi2, 2) + 4849845.0);
case 8:
return -132341.011289656*pow(xi1, 28) + 924333.005681634*pow(xi1, 26) - 2882286.2527594*pow(xi1, 24) + 5292172.23957181*pow(xi1, 22) - 6353932.12669283*pow(xi1, 20) + 5238217.27822244*pow(xi1, 18) - 3029728.63045782*pow(xi1, 16) + 1234258.81294012*pow(xi1, 14) - 350443.153385818*pow(xi1, 12) + 67627.7707961798*pow(xi1, 10) - 8505.12255173922*pow(xi1, 8) + 654.847356081009*pow(xi1, 6) - 28.2328245043755*pow(xi1, 4) + 0.578146576881409*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2220313732065.0*pow(xi2, 26) - 15507734492250.0*pow(xi2, 24) + 48356739036375.0*pow(xi2, 22) - 88787916772500.0*pow(xi2, 20) + 106601291738865.0*pow(xi2, 18) - 87882702731670.0*pow(xi2, 16) + 50830411654575.0*pow(xi2, 14) - 20707426704600.0*pow(xi2, 12) + 5879460480075.0*pow(xi2, 10) - 1134605718246.0*pow(xi2, 8) + 142692278157.0*pow(xi2, 6) - 10986515540.0*pow(xi2, 4) + 473668195.0*pow(xi2, 2) - 9699690.0);
case 9:
return -237301.123691797*pow(xi1, 29) + 1717205.31722188*pow(xi1, 27) - 5570646.91424131*pow(xi1, 25) + 10693423.2775569*pow(xi1, 23) - 13503154.0309131*pow(xi1, 21) + 11794617.2651803*pow(xi1, 19) - 7294968.68435383*pow(xi1, 17) + 3215695.24364948*pow(xi1, 15) - 1003197.3931253*pow(xi1, 13) + 216942.985686064*pow(xi1, 11) - 31295.3054652214*pow(xi1, 9) + 2815.34257078171*pow(xi1, 7) - 138.678092241287*pow(xi1, 5) + 2.69801735877991*pow(xi1, 3) + 2.38418579101563e-7*pow(xi2, 3)*(995313052305.0*pow(xi2, 26) - 7202481130845.0*pow(xi2, 24) + 23364986634990.0*pow(xi2, 22) - 44851468026750.0*pow(xi2, 20) + 56636332964475.0*pow(xi2, 18) - 49470210373815.0*pow(xi2, 16) + 30597316332660.0*pow(xi2, 14) - 13487603423220.0*pow(xi2, 12) + 4207714838775.0*pow(xi2, 10) - 909924832635.0*pow(xi2, 8) + 131262024894.0*pow(xi2, 6) - 11808402606.0*pow(xi2, 4) + 581658077.0*pow(xi2, 2) - 11316305.0);
case 10:
return -430108.286691383*pow(xi1, 30) + 3220566.92717694*pow(xi1, 28) - 10852024.9993969*pow(xi1, 26) + 21736745.4230245*pow(xi1, 24) - 28798227.5263164*pow(xi1, 22) + 26568852.6144587*pow(xi1, 20) - 17501613.8303212*pow(xi1, 18) + 8303601.8471282*pow(xi1, 16) - 2826614.7797104*pow(xi1, 14) + 679508.515860513*pow(xi1, 12) - 111985.127419218*pow(xi1, 10) + 12060.9036379606*pow(xi1, 8) - 789.675955697894*pow(xi1, 6) + 28.4978083521128*pow(xi1, 4) - 0.505878254771233*pow(xi1, 2) + 1.49011611938477e-8*pow(xi2, 2)*(28864078516845.0*pow(xi2, 28) - 216128587918815.0*pow(xi2, 26) + 728267069809125.0*pow(xi2, 24) - 1.45872829239638e+15*pow(xi2, 22) + 1.93261633450463e+15*pow(xi2, 20) - 1.78300551673976e+15*pow(xi2, 18) + 1.17451342231955e+15*pow(xi2, 16) - 557245287069075.0*pow(xi2, 14) + 189690906831975.0*pow(xi2, 12) - 45601044577725.0*pow(xi2, 10) + 7515194685999.0*pow(xi2, 8) - 809393541957.0*pow(xi2, 6) + 52994256315.0*pow(xi2, 4) - 1912455545.0*pow(xi2, 2) + 33948915.0);
case 11:
return -786219.448790699*pow(xi1, 31) + 6084458.68978053*pow(xi1, 29) - 21265479.0051578*pow(xi1, 27) + 44367651.1797434*pow(xi1, 25) - 61536845.3039266*pow(xi1, 23) + 59798623.1011078*pow(xi1, 21) - 41802781.6162907*pow(xi1, 19) + 21246375.4476535*pow(xi1, 17) - 7841612.93932602*pow(xi1, 15) + 2076515.09504765*pow(xi1, 13) - 385135.903046876*pow(xi1, 11) + 48068.4554105997*pow(xi1, 9) - 3781.04970547557*pow(xi1, 7) + 166.332770168781*pow(xi1, 5) - 3.0352695286274*pow(xi1, 3) + 2.98023223876953e-8*pow(xi2, 3)*(26381147031525.0*pow(xi2, 28) - 204160555363050.0*pow(xi2, 26) + 713551069225995.0*pow(xi2, 24) - 1.48873133451042e+15*pow(xi2, 22) + 2.06483389124513e+15*pow(xi2, 20) - 2.00650883253975e+15*pow(xi2, 18) + 1.40266859315468e+15*pow(xi2, 16) - 712910060204760.0*pow(xi2, 14) + 263120868142935.0*pow(xi2, 12) - 69676284553750.0*pow(xi2, 10) + 12923016469545.0*pow(xi2, 8) - 1612909718420.0*pow(xi2, 6) + 126870975231.0*pow(xi2, 4) - 5581201626.0*pow(xi2, 2) + 101846745.0);
case 12:
return -1447135.17293038*pow(xi1, 32) + 11562219.9182525*pow(xi1, 30) - 41859905.6974805*pow(xi1, 28) + 90823108.3086038*pow(xi1, 26) - 131611410.038288*pow(xi1, 24) + 134371362.125239*pow(xi1, 22) - 99365988.1704175*pow(xi1, 20) + 53876892.8339118*pow(xi1, 18) - 21441114.7105898*pow(xi1, 16) + 6207519.21943057*pow(xi1, 14) - 1282336.02874777*pow(xi1, 12) + 182983.673429422*pow(xi1, 10) - 17140.8084095176*pow(xi1, 8) + 974.068579562008*pow(xi1, 6) - 29.9732865951955*pow(xi1, 4) + 0.455290429294109*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.10769912031365e+15*pow(xi2, 30) - 2.48296782090271e+16*pow(xi2, 28) + 8.98934629921614e+16*pow(xi2, 26) - 1.9504113995326e+17*pow(xi2, 24) + 2.82633350947447e+17*pow(xi2, 22) - 2.88560302923438e+17*pow(xi2, 20) + 2.13386834763333e+17*pow(xi2, 18) - 1.15699746365874e+17*pow(xi2, 16) + 4.60444432358839e+16*pow(xi2, 14) - 1.33305460183729e+16*pow(xi2, 12) + 2.7537956529771e+15*pow(xi2, 10) - 392954446540656.0*pow(xi2, 8) + 36809605772940.0*pow(xi2, 6) - 2091796346640.0*pow(xi2, 4) + 64367142840.0*pow(xi2, 2) - 977728752.0);
case 13:
return -2678994.03914385*pow(xi1, 33) + 22076031.0194258*pow(xi1, 31) - 82690023.7308931*pow(xi1, 29) + 186299988.107375*pow(xi1, 27) - 281542048.924484*pow(xi1, 25) + 301316378.346892*pow(xi1, 23) - 235027817.674493*pow(xi1, 21) + 135444947.360354*pow(xi1, 19) - 57840098.2291941*pow(xi1, 17) + 18189409.6449181*pow(xi1, 15) - 4147521.9692352*pow(xi1, 13) + 667698.518639132*pow(xi1, 11) - 72786.0282803327*pow(xi1, 9) + 5031.24831698835*pow(xi1, 7) - 196.988992407918*pow(xi1, 5) + 3.33879648149014*pow(xi1, 3) + 1.49011611938477e-8*pow(xi2, 3)*(179784246629715.0*pow(xi2, 30) - 1.48149736334243e+15*pow(xi2, 28) + 5.54923355671328e+15*pow(xi2, 26) - 1.25023805650994e+16*pow(xi2, 24) + 1.88939670715546e+16*pow(xi2, 22) - 2.02209998554541e+16*pow(xi2, 20) + 1.57724498525344e+16*pow(xi2, 18) - 9.08955655189312e+15*pow(xi2, 16) + 3.88158328580963e+15*pow(xi2, 14) - 1.2206706181011e+15*pow(xi2, 12) + 278335487770417.0*pow(xi2, 10) - 44808489080355.0*pow(xi2, 8) + 4884587672965.0*pow(xi2, 6) - 337641359055.0*pow(xi2, 4) + 13219707501.0*pow(xi2, 2) - 224062839.0);
case 14:
return -4983716.85223083*pow(xi1, 34) + 42316671.0878179*pow(xi1, 32) - 163804940.004247*pow(xi1, 30) + 382693879.671142*pow(xi1, 28) - 602122074.063587*pow(xi1, 26) + 674103390.262549*pow(xi1, 24) - 553167824.13291*pow(xi1, 22) + 337708164.141526*pow(xi1, 20) - 154088440.688562*pow(xi1, 18) + 52338450.6070863*pow(xi1, 16) - 13071827.5511526*pow(xi1, 14) + 2348583.8959056*pow(xi1, 12) - 293290.932760544*pow(xi1, 10) + 24150.230407007*pow(xi1, 8) - 1207.53139413893*pow(xi1, 6) + 32.2750326544046*pow(xi1, 4) - 0.417349560186267*pow(xi1, 2) + 1.86264514923096e-9*pow(xi2, 2)*(2.67561261160694e+15*pow(xi2, 32) - 2.27185897997208e+16*pow(xi2, 30) + 8.79421075301855e+16*pow(xi2, 28) - 2.05457212195864e+17*pow(xi2, 26) + 3.2326182703785e+17*pow(xi2, 24) - 3.61906501912546e+17*pow(xi2, 22) + 2.96979714231291e+17*pow(xi2, 20) - 1.81305690072507e+17*pow(xi2, 18) + 8.27256016811262e+16*pow(xi2, 16) - 2.80989917100934e+16*pow(xi2, 14) + 7.01788397889401e+15*pow(xi2, 12) - 1.26088637810335e+15*pow(xi2, 10) + 157459370552484.0*pow(xi2, 8) - 12965556223620.0*pow(xi2, 6) + 648288480840.0*pow(xi2, 4) - 17327526216.0*pow(xi2, 2) + 224062839.0);
case 15:
return -9310240.27339825*pow(xi1, 35) + 81385124.7313643*pow(xi1, 33) - 325225778.020873*pow(xi1, 31) + 786901443.045491*pow(xi1, 29) - 1287010097.68695*pow(xi1, 27) + 1504383534.87654*pow(xi1, 25) - 1295670982.26369*pow(xi1, 23) + 835461875.914782*pow(xi1, 21) - 405754033.635682*pow(xi1, 19) + 148121087.247014*pow(xi1, 17) - 40252478.8666085*pow(xi1, 15) + 7997565.65664124*pow(xi1, 13) - 1129083.48007344*pow(xi1, 11) + 108469.548168182*pow(xi1, 9) - 6634.66557964683*pow(xi1, 7) + 231.489889383316*pow(xi1, 5) - 3.61702952161431*pow(xi1, 3) + 3.72529029846191e-9*pow(xi2, 3)*(2.49919859325923e+15*pow(xi2, 32) - 2.18466530688806e+16*pow(xi2, 30) + 8.73021300259878e+16*pow(xi2, 28) - 2.11232247690974e+17*pow(xi2, 26) + 3.45479142449202e+17*pow(xi2, 24) - 4.03829880183475e+17*pow(xi2, 22) + 3.47804030949921e+17*pow(xi2, 20) - 2.242675896318e+17*pow(xi2, 18) + 1.08918769042834e+17*pow(xi2, 16) - 3.9760951598368e+16*pow(xi2, 14) + 1.08051925196884e+16*pow(xi2, 12) - 2.14683018393043e+15*pow(xi2, 10) + 303086038835580.0*pow(xi2, 8) - 29117072624640.0*pow(xi2, 6) + 1780979480280.0*pow(xi2, 4) - 62140094016.0*pow(xi2, 2) + 970938969.0);
case 16:
return -17456700.5126217*pow(xi1, 36) + 156968380.219184*pow(xi1, 34) - 646914534.321435*pow(xi1, 32) + 1619113705.96732*pow(xi1, 30) - 2748803401.56655*pow(xi1, 28) + 3348835568.88779*pow(xi1, 26) - 3020630767.10615*pow(xi1, 24) + 2051665199.17433*pow(xi1, 22) - 1056985506.89965*pow(xi1, 20) + 412874103.839298*pow(xi1, 18) - 121377909.228796*pow(xi1, 16) + 26460296.7336268*pow(xi1, 14) - 4176886.19847074*pow(xi1, 12) + 460613.724740993*pow(xi1, 10) - 33621.2121150177*pow(xi1, 8) + 1493.31647392362*pow(xi1, 6) - 35.2014480228536*pow(xi1, 4) + 0.387538877315819*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.74879788988884e+16*pow(xi2, 34) - 3.37087029773744e+17*pow(xi2, 32) + 1.38923838410882e+18*pow(xi2, 30) - 3.47702020781751e+18*pow(xi2, 28) + 5.90301035643093e+18*pow(xi2, 26) - 7.1915696240273e+18*pow(xi2, 24) + 6.48675517900615e+18*pow(xi2, 22) - 4.40591746639754e+18*pow(xi2, 20) + 2.26985909223999e+18*pow(xi2, 18) - 8.86640386677545e+17*pow(xi2, 16) + 2.60657075297269e+17*pow(xi2, 14) - 5.68230545566913e+16*pow(xi2, 12) + 8.9697948107728e+15*pow(xi2, 10) - 989160441925656.0*pow(xi2, 8) + 72201003242940.0*pow(xi2, 6) - 3206872709040.0*pow(xi2, 4) + 75594534015.0*pow(xi2, 2) - 832233402.0);
case 17:
return -32837469.0723911*pow(xi1, 37) + 303491125.009677*pow(xi1, 35) - 1288760839.34582*pow(xi1, 33) + 3332853573.87662*pow(xi1, 31) - 5865541029.76668*pow(xi1, 29) + 7435831693.49892*pow(xi1, 27) - 7010382002.96711*pow(xi1, 25) + 5003386821.33951*pow(xi1, 23) - 2725959954.0341*pow(xi1, 21) + 1134915281.2323*pow(xi1, 19) - 359106543.713533*pow(xi1, 17) + 85315115.7148456*pow(xi1, 15) - 14918529.9824437*pow(xi1, 13) + 1863374.76427998*pow(xi1, 11) - 159016.920591667*pow(xi1, 9) + 8666.99326921999*pow(xi1, 7) - 270.502136366442*pow(xi1, 5) + 3.87538877315819*pow(xi1, 3) + 1.86264514923096e-9*pow(xi2, 3)*(1.76294819686664e+16*pow(xi2, 34) - 1.62935557067851e+17*pow(xi2, 32) + 6.91898207169477e+17*pow(xi2, 30) - 1.7893121377696e+18*pow(xi2, 28) + 3.14903836202425e+18*pow(xi2, 26) - 3.99208174276727e+18*pow(xi2, 24) + 3.76367017940134e+18*pow(xi2, 22) - 2.68617284586132e+18*pow(xi2, 20) + 1.46348860659777e+18*pow(xi2, 18) - 6.0930300207792e+17*pow(xi2, 16) + 1.92793857628652e+17*pow(xi2, 14) - 4.58032039812147e+16*pow(xi2, 12) + 8.0093247973739e+15*pow(xi2, 10) - 1.00039170909678e+15*pow(xi2, 8) + 85371559181480.0*pow(xi2, 6) - 4653056580744.0*pow(xi2, 4) + 145224728649.0*pow(xi2, 2) - 2080583505.0);
case 18:
return -61948317.4770274*pow(xi1, 38) + 588045987.694992*pow(xi1, 36) - 2570691567.21059*pow(xi1, 34) + 6862092306.58149*pow(xi1, 32) - 12503588653.0115*pow(xi1, 30) + 16469394098.4744*pow(xi1, 28) - 16199740202.3215*pow(xi1, 26) + 12121984061.9096*pow(xi1, 24) - 6964913198.30605*pow(xi1, 22) + 3079877352.23662*pow(xi1, 20) - 1044184571.43626*pow(xi1, 18) + 268758699.305915*pow(xi1, 16) - 51646562.040118*pow(xi1, 14) + 7225262.03304275*pow(xi1, 12) - 709111.122226401*pow(xi1, 10) + 46213.1483845536*pow(xi1, 8) - 1836.73243531171*pow(xi1, 6) + 38.6327818324207*pow(xi1, 4) - 0.363317697483581*pow(xi1, 2) + 5.82076609134674e-11*pow(xi2, 2)*(1.06426399042423e+18*pow(xi2, 36) - 1.0102553142776e+19*pow(xi2, 34) + 4.41641448370898e+19*pow(xi2, 32) - 1.17889848155603e+20*pow(xi2, 30) + 2.14810017389285e+20*pow(xi2, 28) - 2.82942036151532e+20*pow(xi2, 26) + 2.78309417490669e+20*pow(xi2, 24) - 2.0825410043414e+20*pow(xi2, 22) + 1.19656297624813e+20*pow(xi2, 20) - 5.29118900141894e+19*pow(xi2, 18) + 1.7938954341226e+19*pow(xi2, 16) - 4.61723929613762e+18*pow(xi2, 14) + 8.87281179652568e+17*pow(xi2, 12) - 1.24129056547796e+17*pow(xi2, 10) + 1.2182436316769e+16*pow(xi2, 8) - 793935843827412.0*pow(xi2, 6) + 31554822964665.0*pow(xi2, 4) - 663706138095.0*pow(xi2, 2) + 6241750515.0);
case 19:
return -117169215.861527*pow(xi1, 39) + 1141555508.85931*pow(xi1, 37) - 5133228518.34571*pow(xi1, 35) + 14129831014.1259*pow(xi1, 33) - 26625518290.5583*pow(xi1, 31) + 36388095709.5377*pow(xi1, 29) - 37280297135.4758*pow(xi1, 27) + 29187680419.3394*pow(xi1, 25) - 17641364021.031*pow(xi1, 23) + 8259500271.79728*pow(xi1, 21) - 2988420683.98686*pow(xi1, 19) + 829001983.126658*pow(xi1, 17) - 173867997.780774*pow(xi1, 15) + 26987592.7666662*pow(xi1, 13) - 3005137.05266305*pow(xi1, 11) + 229403.31855374*pow(xi1, 9) - 11213.2459524736*pow(xi1, 7) + 314.584683661116*pow(xi1, 5) - 4.11760057148058*pow(xi1, 3) + 1.16415321826935e-10*pow(xi2, 3)*(1.00647590044644e+18*pow(xi2, 36) - 9.80588715423875e+18*pow(xi2, 34) + 4.40940972183787e+19*pow(xi2, 32) - 1.21374324207355e+20*pow(xi2, 30) + 2.28711460593995e+20*pow(xi2, 28) - 3.12571362072365e+20*pow(xi2, 26) + 3.20235313964062e+20*pow(xi2, 24) - 2.50720265694324e+20*pow(xi2, 22) + 1.51538163054319e+20*pow(xi2, 20) - 7.09485670973448e+19*pow(xi2, 18) + 2.5670338208827e+19*pow(xi2, 16) - 7.12107281169628e+18*pow(xi2, 14) + 1.49351472857885e+18*pow(xi2, 12) - 2.31821656661195e+17*pow(xi2, 10) + 2.58139307223712e+16*pow(xi2, 8) - 1.97055950156437e+15*pow(xi2, 6) + 96321049295757.0*pow(xi2, 4) - 2702261856294.0*pow(xi2, 2) + 35369919585.0);
case 20:
return -222133305.070811*pow(xi1, 40) + 2219785083.42539*pow(xi1, 38) - 10259396727.5352*pow(xi1, 36) + 29094468214.3189*pow(xi1, 34) - 56634836041.7293*pow(xi1, 32) + 80205087700.4013*pow(xi1, 30) - 85454984888.6874*pow(xi1, 28) + 69870738325.5301*pow(xi1, 26) - 44321915588.4007*pow(xi1, 24) + 21908106656.4077*pow(xi1, 22) - 8429050151.6992*pow(xi1, 20) + 2508569934.62919*pow(xi1, 18) - 570774531.410123*pow(xi1, 16) + 97504906.6443698*pow(xi1, 14) - 12180237.1297037*pow(xi1, 12) + 1071171.86734953*pow(xi1, 10) - 62723.8433239953*pow(xi1, 8) + 2244.43544483787*pow(xi1, 6) - 42.4913503418065*pow(xi1, 4) + 0.343133380956715*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(3.05297689802088e+19*pow(xi2, 38) - 3.05084938798742e+20*pow(xi2, 36) + 1.4100407494865e+21*pow(xi2, 34) - 3.99871326320036e+21*pow(xi2, 32) + 7.78383259563359e+21*pow(xi2, 30) - 1.10233033166731e+22*pow(xi2, 28) + 1.17448436920668e+22*pow(xi2, 26) - 9.60296115377681e+21*pow(xi2, 24) + 6.09155769434411e+21*pow(xi2, 22) - 3.01102725140964e+21*pow(xi2, 20) + 1.15847983161254e+21*pow(xi2, 18) - 3.44775226526759e+20*pow(xi2, 16) + 7.84466542654785e+19*pow(xi2, 14) - 1.34009723275872e+19*pow(xi2, 12) + 1.67403904414727e+18*pow(xi2, 10) - 1.47220740437168e+17*pow(xi2, 8) + 8.62069938419161e+15*pow(xi2, 6) - 308472858673980.0*pow(xi2, 4) + 5839966722590.0*pow(xi2, 2) - 47159892780.0);
case 21:
return -422024764.447755*pow(xi1, 41) + 4322902316.91078*pow(xi1, 39) - 20520330597.4072*pow(xi1, 37) + 59901917263.415*pow(xi1, 35) - 120332959323.442*pow(xi1, 33) + 176374680057.007*pow(xi1, 31) - 195146915254.19*pow(xi1, 29) + 166342835627.683*pow(xi1, 27) - 110510141539.374*pow(xi1, 25) + 57521106460.0063*pow(xi1, 23) - 23457614573.9268*pow(xi1, 21) + 7459134211.59708*pow(xi1, 19) - 1831495756.75403*pow(xi1, 17) + 341936494.88629*pow(xi1, 15) - 47462032.3602766*pow(xi1, 13) + 4743304.91553402*pow(xi1, 11) - 325904.065670225*pow(xi1, 9) + 14369.426005757*pow(xi1, 7) - 364.224646106188*pow(xi1, 5) + 4.34635615878506*pow(xi1, 3) + 5.82076609134674e-11*pow(xi2, 3)*(7.25033024562084e+18*pow(xi2, 38) - 7.42668962997378e+19*pow(xi2, 36) + 3.52536595275888e+20*pow(xi2, 34) - 1.02910710245626e+21*pow(xi2, 32) + 2.06730449970033e+21*pow(xi2, 30) - 3.03009393074923e+21*pow(xi2, 28) + 3.35259847572812e+21*pow(xi2, 26) - 2.8577481557792e+21*pow(xi2, 24) + 1.89854977515177e+21*pow(xi2, 22) - 9.88205084301845e+20*pow(xi2, 20) + 4.02998749748754e+20*pow(xi2, 18) - 1.28146949981137e+20*pow(xi2, 16) + 3.14648575120853e+19*pow(xi2, 14) - 5.87442425138195e+18*pow(xi2, 12) + 8.15391507156326e+17*pow(xi2, 10) - 8.14893579486987e+16*pow(xi2, 8) + 5.59898921474822e+15*pow(xi2, 6) - 246864859028073.0*pow(xi2, 4) + 6257331773693.0*pow(xi2, 2) - 74669830235.0);
case 22:
return -803354283.752333*pow(xi1, 42) + 8429944669.8439*pow(xi1, 40) - 41070423529.3311*pow(xi1, 38) + 123310478369.716*pow(xi1, 36) - 255387566346.647*pow(xi1, 34) + 386985888284.832*pow(xi1, 32) - 444046768569.53*pow(xi1, 30) + 393966174779.878*pow(xi1, 28) - 273583716795.579*pow(xi1, 26) + 149598387506.117*pow(xi1, 24) - 64475852087.3283*pow(xi1, 22) + 21825643771.0978*pow(xi1, 20) - 5756146123.25306*pow(xi1, 18) + 1167338459.55362*pow(xi1, 16) - 178569841.335938*pow(xi1, 14) + 20049882.8097356*pow(xi1, 12) - 1589574.9092333*pow(xi1, 10) + 84105.4842801184*pow(xi1, 8) - 2724.07872251853*pow(xi1, 6) + 46.7233287069394*pow(xi1, 4) - 0.325976711908879*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(1.10412172026169e+20*pow(xi2, 40) - 1.15860277325021e+21*pow(xi2, 38) + 5.64467602852308e+21*pow(xi2, 36) - 1.69476630992655e+22*pow(xi2, 34) + 3.51001998484442e+22*pow(xi2, 32) - 5.31869354942996e+22*pow(xi2, 30) + 6.10293231648196e+22*pow(xi2, 28) - 5.41462987651134e+22*pow(xi2, 26) + 3.76010597233645e+22*pow(xi2, 24) - 2.05606458199395e+22*pow(xi2, 22) + 8.86149363509787e+21*pow(xi2, 20) - 2.99969363875236e+21*pow(xi2, 18) + 7.9111869921181e+20*pow(xi2, 16) - 1.60437776228666e+20*pow(xi2, 14) + 2.45424521148724e+19*pow(xi2, 12) - 2.7556349106063e+18*pow(xi2, 10) + 2.18469511990375e+17*pow(xi2, 8) - 1.15593697407152e+16*pow(xi2, 6) + 374394528798290.0*pow(xi2, 4) - 6421605400210.0*pow(xi2, 2) + 44801898141.0);
case 23:
return -1531977936.45794*pow(xi1, 43) + 16458965813.4624*pow(xi1, 41) - 82246133902.1835*pow(xi1, 39) + 253785470676.682*pow(xi1, 37) - 541417155879.751*pow(xi1, 35) + 847251426526.943*pow(xi1, 33) - 1006958259563.54*pow(xi1, 31) + 928503086198.243*pow(xi1, 29) - 672778436231.104*pow(xi1, 27) + 385637874429.917*pow(xi1, 25) - 175190326199.53*pow(xi1, 23) + 62923414996.2573*pow(xi1, 21) - 17750643707.6883*pow(xi1, 19) + 3889306965.7242*pow(xi1, 17) - 651047737.754652*pow(xi1, 15) + 81335790.3152447*pow(xi1, 13) - 7338756.68486208*pow(xi1, 11) + 456345.664891637*pow(xi1, 9) - 18243.8299765003*pow(xi1, 7) + 419.858004938636*pow(xi1, 5) - 4.56367396672431*pow(xi1, 3) + 3.38416633217834e-13*pow(xi2, 3)*(4.52689905307292e+21*pow(xi2, 40) - 4.86352152876246e+22*pow(xi2, 38) + 2.43032185268633e+23*pow(xi2, 36) - 7.49920204168347e+23*pow(xi2, 34) + 1.59985385686184e+24*pow(xi2, 32) - 2.50357501187473e+24*pow(xi2, 30) + 2.9754987217646e+24*pow(xi2, 28) - 2.74366858794609e+24*pow(xi2, 26) + 1.98801823017383e+24*pow(xi2, 24) - 1.13953581643751e+24*pow(xi2, 22) + 5.17676464462557e+23*pow(xi2, 20) - 1.85934758578354e+23*pow(xi2, 18) + 5.24520427347391e+22*pow(xi2, 16) - 1.14926590006606e+22*pow(xi2, 14) + 1.92380537435222e+21*pow(xi2, 12) - 2.40342176866023e+20*pow(xi2, 10) + 2.16855673288914e+19*pow(xi2, 8) - 1.3484729179901e+18*pow(xi2, 6) + 5.39093773347629e+16*pow(xi2, 4) - 1.24065416332057e+15*pow(xi2, 2) + 13485371340441.0);
case 24:
return -2926267773.25488*pow(xi1, 44) + 32170687453.9002*pow(xi1, 42) - 164781727359.808*pow(xi1, 40) + 522185265338.526*pow(xi1, 38) - 1146534774301.18*pow(xi1, 36) + 1851064835044.44*pow(xi1, 34) - 2276036756996.6*pow(xi1, 32) + 2178170928315.17*pow(xi1, 30) - 1644071226030.65*pow(xi1, 28) + 985904588081.376*pow(xi1, 26) - 470948522565.186*pow(xi1, 24) + 178941502904.888*pow(xi1, 22) - 53793287029.6419*pow(xi1, 20) + 12674006632.6617*pow(xi1, 18) - 2307248617.22092*pow(xi1, 16) + 318072208.243466*pow(xi1, 14) - 32287130.2272467*pow(xi1, 12) + 2320075.01478208*pow(xi1, 10) - 111483.603306741*pow(xi1, 8) + 3284.11659166017*pow(xi1, 6) - 51.2894721942084*pow(xi1, 4) + 0.311159588640294*pow(xi1, 2) + 1.81898940354586e-12*pow(xi2, 2)*(1.60873272133996e+21*pow(xi2, 42) - 1.76860224645554e+22*pow(xi2, 40) + 9.05897126385615e+22*pow(xi2, 38) - 2.87074385546503e+23*pow(xi2, 36) + 6.30314157996837e+23*pow(xi2, 34) - 1.01763365494931e+24*pow(xi2, 32) + 1.25126443978167e+24*pow(xi2, 30) - 1.19746213148309e+24*pow(xi2, 28) + 9.03837714956322e+23*pow(xi2, 26) - 5.4200677923659e+23*pow(xi2, 24) + 2.58906688322175e+23*pow(xi2, 22) - 9.83741315678188e+22*pow(xi2, 20) + 2.95731722926916e+22*pow(xi2, 18) - 6.96760883156087e+21*pow(xi2, 16) + 1.26842334140225e+21*pow(xi2, 14) - 1.7486204571804e+20*pow(xi2, 12) + 1.77500375561878e+19*pow(xi2, 10) - 1.27547472803273e+18*pow(xi2, 8) + 6.12887590710645e+16*pow(xi2, 6) - 1.80546218975122e+15*pow(xi2, 4) + 28196685530013.0*pow(xi2, 2) - 171061792902.0);
case 25:
return -5598077479.27021*pow(xi1, 45) + 62944237023.0138*pow(xi1, 43) - 330278999375.818*pow(xi1, 41) + 1074140453307.64*pow(xi1, 39) - 2425343957107.78*pow(xi1, 37) + 4036050195832.79*pow(xi1, 35) - 5128586911375.06*pow(xi1, 33) + 5087344019982.91*pow(xi1, 31) - 3993875133123.08*pow(xi1, 29) + 2501028597707.71*pow(xi1, 27) - 1253435191838.01*pow(xi1, 25) + 502454428984.502*pow(xi1, 23) - 160423552908.796*pow(xi1, 21) + 40470742430.8232*pow(xi1, 19) - 7968848617.85145*pow(xi1, 17) + 1203568825.07947*pow(xi1, 15) - 136110656.698573*pow(xi1, 13) + 11146295.9461998*pow(xi1, 11) - 630389.076516768*pow(xi1, 9) + 22958.1446964552*pow(xi1, 7) - 481.882482940935*pow(xi1, 5) + 4.77111369248451*pow(xi1, 3) + 7.27595761418343e-12*pow(xi2, 3)*(7.69393910206069e+20*pow(xi2, 42) - 8.65099006353653e+21*pow(xi2, 40) + 4.53932000279918e+22*pow(xi2, 38) - 1.47628739784542e+23*pow(xi2, 36) + 3.33336735274533e+23*pow(xi2, 34) - 5.54710515075719e+23*pow(xi2, 32) + 7.04867617889585e+23*pow(xi2, 30) - 6.99199238058489e+23*pow(xi2, 28) + 5.48914018594281e+23*pow(xi2, 26) - 3.43738753072491e+23*pow(xi2, 24) + 1.72270821011192e+23*pow(xi2, 22) - 6.90568108870013e+22*pow(xi2, 20) + 2.2048445224045e+22*pow(xi2, 18) - 5.5622564859272e+21*pow(xi2, 16) + 1.0952302144143e+21*pow(xi2, 14) - 1.65417239750448e+20*pow(xi2, 12) + 1.87069062130385e+19*pow(xi2, 10) - 1.5319352499349e+18*pow(xi2, 8) + 8.66400149566451e+16*pow(xi2, 6) - 3.15534338073955e+15*pow(xi2, 4) + 66229424151891.0*pow(xi2, 2) - 655736872791.0);
case 26:
return -10724577779.5802*pow(xi1, 46) + 123268642054.967*pow(xi1, 44) - 662226702259.593*pow(xi1, 42) + 2208852750087.43*pow(xi1, 40) - 5125069148373.14*pow(xi1, 38) + 8783140469058.23*pow(xi1, 36) - 11522023284984.6*pow(xi1, 34) + 11832582409198.7*pow(xi1, 32) - 9648041315255.88*pow(xi1, 30) + 6298492797700.62*pow(xi1, 28) - 3305059766157.57*pow(xi1, 26) + 1394300038521.23*pow(xi1, 24) - 471368271194.802*pow(xi1, 22) + 126844343800.751*pow(xi1, 20) - 26884603684.2252*pow(xi1, 18) + 4420790397.9644*pow(xi1, 16) - 552329947.313166*pow(xi1, 14) + 50950982.4545326*pow(xi1, 12) - 3334465.9698603*pow(xi1, 10) + 146178.190695699*pow(xi1, 8) - 3933.68384125155*pow(xi1, 6) + 56.1599840886197*pow(xi1, 4) - 0.298194605780282*pow(xi1, 2) + 4.54747350886464e-13*pow(xi2, 2)*(2.3583595943273e+22*pow(xi2, 44) - 2.71070610559187e+23*pow(xi2, 42) + 1.45625191871636e+24*pow(xi2, 40) - 4.85731856553224e+24*pow(xi2, 38) + 1.12701462435846e+25*pow(xi2, 36) - 1.9314330148239e+25*pow(xi2, 34) + 2.53371971546929e+25*pow(xi2, 32) - 2.60201238910635e+25*pow(xi2, 30) + 2.12162672227742e+25*pow(xi2, 28) - 1.38505321370704e+25*pow(xi2, 26) + 7.26790328676975e+24*pow(xi2, 24) - 3.06609820992524e+24*pow(xi2, 22) + 1.03654979028671e+24*pow(xi2, 20) - 2.78933661853084e+23*pow(xi2, 18) + 5.91198687179101e+22*pow(xi2, 16) - 9.7214208930447e+21*pow(xi2, 14) + 1.21458639887946e+21*pow(xi2, 12) - 1.12042395310739e+20*pow(xi2, 10) + 7.33256821256954e+18*pow(xi2, 8) - 3.21449240794357e+17*pow(xi2, 6) + 8.65026224690128e+15*pow(xi2, 4) - 123497111042305.0*pow(xi2, 2) + 655736872791.0);
case 27:
return -20572934736.318*pow(xi1, 47) + 241611658620.551*pow(xi1, 45) - 1328205586844.64*pow(xi1, 43) + 4540825293226.5*pow(xi1, 41) - 10818742788273.6*pow(xi1, 39) + 19078016455492.4*pow(xi1, 37) - 25812540522610.2*pow(xi1, 35) + 27412521274463.8*pow(xi1, 33) - 23184006044249.6*pow(xi1, 31) + 15753474773929.5*pow(xi1, 29) - 8638981738369.39*pow(xi1, 27) + 3826812736646.04*pow(xi1, 25) - 1366069288952.07*pow(xi1, 23) + 390782719220.513*pow(xi1, 21) - 88772376837.7726*pow(xi1, 19) + 15805152724.9117*pow(xi1, 17) - 2165821655.69451*pow(xi1, 15) + 222848315.609907*pow(xi1, 13) - 16641856.2001029*pow(xi1, 11) + 859848.405690382*pow(xi1, 9) - 28648.4077618996*pow(xi1, 7) + 550.666038674253*pow(xi1, 5) - 4.96991009633803*pow(xi1, 3) + 9.09494701772928e-13*pow(xi2, 3)*(2.26201809600584e+22*pow(xi2, 44) - 2.65654828059541e+23*pow(xi2, 42) + 1.46037748681273e+24*pow(xi2, 40) - 4.9926902096019e+24*pow(xi2, 38) + 1.18953334936246e+25*pow(xi2, 36) - 2.09765009277157e+25*pow(xi2, 34) + 2.83811884470491e+25*pow(xi2, 32) - 3.01403858879299e+25*pow(xi2, 30) + 2.54910842240815e+25*pow(xi2, 28) - 1.73211286918114e+25*pow(xi2, 26) + 9.49866087348167e+24*pow(xi2, 24) - 4.20762510126362e+24*pow(xi2, 22) + 1.5020090675505e+24*pow(xi2, 20) - 4.29670143716877e+23*pow(xi2, 18) + 9.76062605584438e+22*pow(xi2, 16) - 1.7377949199816e+22*pow(xi2, 14) + 2.38134609412519e+21*pow(xi2, 12) - 2.45024314243389e+20*pow(xi2, 10) + 1.82979143997893e+19*pow(xi2, 8) - 9.4541332018123e+17*pow(xi2, 6) + 3.14992574514768e+16*pow(xi2, 4) - 605463712543690.0*pow(xi2, 2) + 5464473939925.0);
case 28:
return -39513881861.3416*pow(xi1, 48) + 473939816873.48*pow(xi1, 46) - 2664641921512.91*pow(xi1, 44) + 9331688393323.42*pow(xi1, 42) - 22814742457657.3*pow(xi1, 40) + 41365417755535.0*pow(xi1, 38) - 57671165870739.0*pow(xi1, 36) + 63268091738868.2*pow(xi1, 34) - 55432667648218.2*pow(xi1, 32) + 39147974586004.8*pow(xi1, 30) - 22396734632040.0*pow(xi1, 28) + 10395673205955.8*pow(xi1, 26) - 3908620671560.13*pow(xi1, 24) + 1184931540983.06*pow(xi1, 22) - 287389625108.033*pow(xi1, 20) + 55130639039.3158*pow(xi1, 18) - 8233581071.61553*pow(xi1, 16) + 936988776.947738*pow(xi1, 14) - 78914666.8737741*pow(xi1, 12) + 4724180.42568061*pow(xi1, 10) - 189726.537067971*pow(xi1, 8) + 4682.51548749786*pow(xi1, 6) - 61.3114870538624*pow(xi1, 4) + 0.28672558248104*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(1.39027112208359e+24*pow(xi2, 46) - 1.66752748645894e+25*pow(xi2, 44) + 9.37537528500105e+25*pow(xi2, 42) - 3.28329596647726e+26*pow(xi2, 40) + 8.02722387741088e+26*pow(xi2, 38) - 1.45541624992072e+27*pow(xi2, 36) + 2.02912375879283e+27*pow(xi2, 34) - 2.2260480810907e+27*pow(xi2, 32) + 1.95036360441147e+27*pow(xi2, 30) - 1.37739690435813e+27*pow(xi2, 28) + 7.88015044868524e+26*pow(xi2, 26) - 3.6576523419225e+26*pow(xi2, 24) + 1.37522364062272e+26*pow(xi2, 22) - 4.16910722377411e+25*pow(xi2, 20) + 1.0111623504271e+25*pow(xi2, 18) - 1.93973691745437e+24*pow(xi2, 16) + 2.89693380047285e+23*pow(xi2, 14) - 3.29673617711888e+22*pow(xi2, 12) + 2.77656300255309e+21*pow(xi2, 10) - 1.66217321911923e+20*pow(xi2, 8) + 6.67540907532506e+18*pow(xi2, 6) - 1.64751367223843e+17*pow(xi2, 4) + 2.1572061738227e+15*pow(xi2, 2) - 10088259581400.0);
case 29:
return -75981341991.8768*pow(xi1, 49) + 930343104637.766*pow(xi1, 47) - 5347021071237.98*pow(xi1, 45) + 19170777097011.4*pow(xi1, 43) - 48064836289803.9*pow(xi1, 41) + 89534811535571.6*pow(xi1, 39) - 128518154466020.0*pow(xi1, 37) + 145501072157689.0*pow(xi1, 35) - 131912174618258.0*pow(xi1, 33) + 96692459335021.2*pow(xi1, 31) - 57617974678786.9*pow(xi1, 29) + 27969551245737.2*pow(xi1, 27) - 11050657441547.3*pow(xi1, 25) + 3540321435715.92*pow(xi1, 23) - 913580894724.717*pow(xi1, 21) + 188008155558.22*pow(xi1, 19) - 30431272882.66*pow(xi1, 17) + 3802262020.28662*pow(xi1, 15) - 357585352.728971*pow(xi1, 13) + 24455846.7974416*pow(xi1, 11) - 1159047.64875872*pow(xi1, 9) + 35465.8737443918*pow(xi1, 7) - 626.552742837569*pow(xi1, 5) + 5.16106048465872*pow(xi1, 3) + 4.54747350886464e-13*pow(xi2, 3)*(1.67084738028187e+23*pow(xi2, 46) - 2.04584612274089e+24*pow(xi2, 44) + 1.17582236835789e+25*pow(xi2, 42) - 4.21569846633318e+25*pow(xi2, 40) + 1.05695692775578e+26*pow(xi2, 38) - 1.96889132748187e+26*pow(xi2, 36) + 2.82614410431401e+26*pow(xi2, 34) - 3.19960241382507e+26*pow(xi2, 32) + 2.90077939675986e+26*pow(xi2, 30) - 2.12628966714228e+26*pow(xi2, 28) + 1.26703266256459e+26*pow(xi2, 26) - 6.15056936367295e+25*pow(xi2, 24) + 2.43006527031012e+25*pow(xi2, 22) - 7.78524916926856e+24*pow(xi2, 20) + 2.00898563332766e+24*pow(xi2, 18) - 4.13434306305964e+23*pow(xi2, 16) + 6.69190767650184e+22*pow(xi2, 14) - 8.36126260631241e+21*pow(xi2, 12) + 7.86338506495773e+20*pow(xi2, 10) - 5.3778975841791e+19*pow(xi2, 8) + 2.54877273391329e+18*pow(xi2, 6) - 7.79902811423886e+16*pow(xi2, 4) + 1.37780405232971e+15*pow(xi2, 2) - 11349292029075.0);
default:
return 0.;
}
case 24:
switch(j) {
case 0:
return 1.19209289550781e-7*y1t*(-263012370465.0*pow(xi1, 24) + 1541374822260.0*pow(xi1, 22) - 3928626071370.0*pow(xi1, 20) + 5708260103700.0*pow(xi1, 18) - 5206858878375.0*pow(xi1, 16) + 3094361847720.0*pow(xi1, 14) - 1203362940780.0*pow(xi1, 12) + 299454372360.0*pow(xi1, 10) - 45176306175.0*pow(xi1, 8) + 3718214500.0*pow(xi1, 6) - 133855722.0*pow(xi1, 4) + 1058148.0*pow(xi1, 2) + pow(xi2, 2)*(263012370465.0*pow(xi2, 22) - 1541374822260.0*pow(xi2, 20) + 3928626071370.0*pow(xi2, 18) - 5708260103700.0*pow(xi2, 16) + 5206858878375.0*pow(xi2, 14) - 3094361847720.0*pow(xi2, 12) + 1203362940780.0*pow(xi2, 10) - 299454372360.0*pow(xi2, 8) + 45176306175.0*pow(xi2, 6) - 3718214500.0*pow(xi2, 4) + 133855722.0*pow(xi2, 2) - 1058148.0));
case 1:
return 5.96046447753906e-8*y1r*(-263012370465.0*pow(xi1, 24) + 91482563640.0*pow(xi1, 23) + 1541374822260.0*pow(xi1, 22) - 538257874440.0*pow(xi1, 21) - 3928626071370.0*pow(xi1, 20) + 1378465288200.0*pow(xi1, 19) + 5708260103700.0*pow(xi1, 18) - 2014680036600.0*pow(xi1, 17) - 5206858878375.0*pow(xi1, 16) + 1851327601200.0*pow(xi1, 15) + 3094361847720.0*pow(xi1, 14) - 1110796560720.0*pow(xi1, 13) - 1203362940780.0*pow(xi1, 12) + 437586523920.0*pow(xi1, 11) + 299454372360.0*pow(xi1, 10) - 110909026800.0*pow(xi1, 9) - 45176306175.0*pow(xi1, 8) + 17210021400.0*pow(xi1, 7) + 3718214500.0*pow(xi1, 6) - 1487285800.0*pow(xi1, 5) - 133855722.0*pow(xi1, 4) + 59491432.0*pow(xi1, 3) + 1058148.0*pow(xi1, 2) - 705432.0*xi1 + xi2*(263012370465.0*pow(xi2, 23) - 91482563640.0*pow(xi2, 22) - 1541374822260.0*pow(xi2, 21) + 538257874440.0*pow(xi2, 20) + 3928626071370.0*pow(xi2, 19) - 1378465288200.0*pow(xi2, 18) - 5708260103700.0*pow(xi2, 17) + 2014680036600.0*pow(xi2, 16) + 5206858878375.0*pow(xi2, 15) - 1851327601200.0*pow(xi2, 14) - 3094361847720.0*pow(xi2, 13) + 1110796560720.0*pow(xi2, 12) + 1203362940780.0*pow(xi2, 11) - 437586523920.0*pow(xi2, 10) - 299454372360.0*pow(xi2, 9) + 110909026800.0*pow(xi2, 8) + 45176306175.0*pow(xi2, 7) - 17210021400.0*pow(xi2, 6) - 3718214500.0*pow(xi2, 5) + 1487285800.0*pow(xi2, 4) + 133855722.0*pow(xi2, 3) - 59491432.0*pow(xi2, 2) - 1058148.0*xi2 + 705432.0));
case 2:
return 1.19209289550781e-7*y2t*(263012370465.0*pow(xi1, 24) - 1541374822260.0*pow(xi1, 22) + 3928626071370.0*pow(xi1, 20) - 5708260103700.0*pow(xi1, 18) + 5206858878375.0*pow(xi1, 16) - 3094361847720.0*pow(xi1, 14) + 1203362940780.0*pow(xi1, 12) - 299454372360.0*pow(xi1, 10) + 45176306175.0*pow(xi1, 8) - 3718214500.0*pow(xi1, 6) + 133855722.0*pow(xi1, 4) - 1058148.0*pow(xi1, 2) + pow(xi2, 2)*(-263012370465.0*pow(xi2, 22) + 1541374822260.0*pow(xi2, 20) - 3928626071370.0*pow(xi2, 18) + 5708260103700.0*pow(xi2, 16) - 5206858878375.0*pow(xi2, 14) + 3094361847720.0*pow(xi2, 12) - 1203362940780.0*pow(xi2, 10) + 299454372360.0*pow(xi2, 8) - 45176306175.0*pow(xi2, 6) + 3718214500.0*pow(xi2, 4) - 133855722.0*pow(xi2, 2) + 1058148.0));
case 3:
return 5.96046447753906e-8*y2r*(-263012370465.0*pow(xi1, 24) - 91482563640.0*pow(xi1, 23) + 1541374822260.0*pow(xi1, 22) + 538257874440.0*pow(xi1, 21) - 3928626071370.0*pow(xi1, 20) - 1378465288200.0*pow(xi1, 19) + 5708260103700.0*pow(xi1, 18) + 2014680036600.0*pow(xi1, 17) - 5206858878375.0*pow(xi1, 16) - 1851327601200.0*pow(xi1, 15) + 3094361847720.0*pow(xi1, 14) + 1110796560720.0*pow(xi1, 13) - 1203362940780.0*pow(xi1, 12) - 437586523920.0*pow(xi1, 11) + 299454372360.0*pow(xi1, 10) + 110909026800.0*pow(xi1, 9) - 45176306175.0*pow(xi1, 8) - 17210021400.0*pow(xi1, 7) + 3718214500.0*pow(xi1, 6) + 1487285800.0*pow(xi1, 5) - 133855722.0*pow(xi1, 4) - 59491432.0*pow(xi1, 3) + 1058148.0*pow(xi1, 2) + 705432.0*xi1 + xi2*(263012370465.0*pow(xi2, 23) + 91482563640.0*pow(xi2, 22) - 1541374822260.0*pow(xi2, 21) - 538257874440.0*pow(xi2, 20) + 3928626071370.0*pow(xi2, 19) + 1378465288200.0*pow(xi2, 18) - 5708260103700.0*pow(xi2, 17) - 2014680036600.0*pow(xi2, 16) + 5206858878375.0*pow(xi2, 15) + 1851327601200.0*pow(xi2, 14) - 3094361847720.0*pow(xi2, 13) - 1110796560720.0*pow(xi2, 12) + 1203362940780.0*pow(xi2, 11) + 437586523920.0*pow(xi2, 10) - 299454372360.0*pow(xi2, 9) - 110909026800.0*pow(xi2, 8) + 45176306175.0*pow(xi2, 7) + 17210021400.0*pow(xi2, 6) - 3718214500.0*pow(xi2, 5) - 1487285800.0*pow(xi2, 4) + 133855722.0*pow(xi2, 3) + 59491432.0*pow(xi2, 2) - 1058148.0*xi2 - 705432.0));
case 4:
return -30099.3771131516*pow(xi1, 25) + 186662.80380249*pow(xi1, 23) - 510192.693929672*pow(xi1, 21) + 808988.887023926*pow(xi1, 19) - 824362.408947945*pow(xi1, 17) + 564980.347045898*pow(xi1, 15) - 264834.537677765*pow(xi1, 13) + 84616.872253418*pow(xi1, 11) - 18008.4399461746*pow(xi1, 9) + 2431.51931762695*pow(xi1, 7) - 190.063759994507*pow(xi1, 5) + 7.176025390625*pow(xi1, 3) - 0.0840940475463867*xi1 + 30099.3771131516*pow(xi2, 25) - 186662.80380249*pow(xi2, 23) + 510192.693929672*pow(xi2, 21) - 808988.887023926*pow(xi2, 19) + 824362.408947945*pow(xi2, 17) - 564980.347045898*pow(xi2, 15) + 264834.537677765*pow(xi2, 13) - 84616.872253418*pow(xi2, 11) + 18008.4399461746*pow(xi2, 9) - 2431.51931762695*pow(xi2, 7) + 190.063759994507*pow(xi2, 5) - 7.176025390625*pow(xi2, 3) + 0.0840940475463867*xi2;
case 5:
return -48236.1812710762*pow(xi1, 26) + 312076.875107288*pow(xi1, 24) - 893335.171551704*pow(xi1, 22) + 1489045.17017841*pow(xi1, 20) - 1600041.99846983*pow(xi1, 18) + 1158651.10234022*pow(xi1, 16) - 573808.164968491*pow(xi1, 14) + 193032.23982811*pow(xi1, 12) - 42878.3234667778*pow(xi1, 10) + 5939.49249982834*pow(xi1, 8) - 460.97553730011*pow(xi1, 6) + 16.0619630813599*pow(xi1, 4) - 0.12614107131958*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(101158604025.0*pow(xi2, 24) - 654472642785.0*pow(xi2, 22) + 1873459641690.0*pow(xi2, 20) - 3122754056730.0*pow(xi2, 18) + 3355531277175.0*pow(xi2, 16) - 2429867476575.0*pow(xi2, 14) + 1203362940780.0*pow(xi2, 12) - 404817947820.0*pow(xi2, 10) + 89922361815.0*pow(xi2, 8) - 12456018575.0*pow(xi2, 6) + 966735770.0*pow(xi2, 4) - 33684378.0*pow(xi2, 2) + 264537.0);
case 6:
return -81286.8980679247*pow(xi1, 27) + 546863.683015108*pow(xi1, 25) - 1635362.49871016*pow(xi1, 23) + 2864386.47074461*pow(xi1, 21) - 3259442.8732574*pow(xi1, 19) + 2526638.3282125*pow(xi1, 17) - 1360955.26306629*pow(xi1, 15) + 510447.213749886*pow(xi1, 13) - 131678.168796301*pow(xi1, 11) + 22745.5405149195*pow(xi1, 9) - 2515.10279417038*pow(xi1, 7) + 165.034568309784*pow(xi1, 5) - 5.52918362617493*pow(xi1, 3) + 0.06307053565979*xi1 + 81286.8980679247*pow(xi2, 27) - 546863.683015108*pow(xi2, 25) + 1635362.49871016*pow(xi2, 23) - 2864386.47074461*pow(xi2, 21) + 3259442.8732574*pow(xi2, 19) - 2526638.3282125*pow(xi2, 17) + 1360955.26306629*pow(xi2, 15) - 510447.213749886*pow(xi2, 13) + 131678.168796301*pow(xi2, 11) - 22745.5405149195*pow(xi2, 9) + 2515.10279417038*pow(xi2, 7) - 165.034568309784*pow(xi2, 5) + 5.52918362617493*pow(xi2, 3) - 0.06307053565979*xi2;
case 7:
return -141090.830217898*pow(xi1, 28) + 985083.781004548*pow(xi1, 26) - 3070661.81036085*pow(xi1, 24) + 5636204.89152074*pow(xi1, 22) - 6764883.44941288*pow(xi1, 20) + 5575318.75673711*pow(xi1, 18) - 3223532.88829654*pow(xi1, 16) + 1312222.58924246*pow(xi1, 14) - 371694.770376384*pow(xi1, 12) + 71150.4344075918*pow(xi1, 10) - 8712.88090068102*pow(xi1, 8) + 616.332282304764*pow(xi1, 6) - 20.313968360424*pow(xi1, 4) + 0.157676339149475*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2367111334185.0*pow(xi2, 26) - 16526963372010.0*pow(xi2, 24) + 51517156455375.0*pow(xi2, 22) - 94559826885300.0*pow(xi2, 20) + 113495910845625.0*pow(xi2, 18) - 93538327050630.0*pow(xi2, 16) + 54081907550055.0*pow(xi2, 14) - 22015441819800.0*pow(xi2, 12) + 6236003448675.0*pow(xi2, 10) - 1193706206550.0*pow(xi2, 8) + 146177884853.0*pow(xi2, 6) - 10340339828.0*pow(xi2, 4) + 340811835.0*pow(xi2, 2) - 2645370.0);
case 8:
return -249746.986822486*pow(xi1, 29) + 1806837.60868192*pow(xi1, 27) - 5860084.52208102*pow(xi1, 25) + 11246581.6746354*pow(xi1, 23) - 14198689.9865001*pow(xi1, 21) + 12399650.7613456*pow(xi1, 19) - 7667706.33566916*pow(xi1, 17) + 3379488.03859234*pow(xi1, 15) - 1054394.5972234*pow(xi1, 13) + 228315.864676237*pow(xi1, 11) - 33153.3859709501*pow(xi1, 9) + 3064.44115304947*pow(xi1, 7) - 167.322627186775*pow(xi1, 5) + 4.80036854743958*pow(xi1, 3) - 0.0525587797164917*xi1 + 249746.986822486*pow(xi2, 29) - 1806837.60868192*pow(xi2, 27) + 5860084.52208102*pow(xi2, 25) - 11246581.6746354*pow(xi2, 23) + 14198689.9865001*pow(xi2, 21) - 12399650.7613456*pow(xi2, 19) + 7667706.33566916*pow(xi2, 17) - 3379488.03859234*pow(xi2, 15) + 1054394.5972234*pow(xi2, 13) - 228315.864676237*pow(xi2, 11) + 33153.3859709501*pow(xi2, 9) - 3064.44115304947*pow(xi2, 7) + 167.322627186775*pow(xi2, 5) - 4.80036854743958*pow(xi2, 3) + 0.0525587797164917*xi2;
case 9:
return -448355.304914653*pow(xi1, 30) + 3356649.28634673*pow(xi1, 28) - 11308794.1731486*pow(xi1, 26) + 22648233.4607616*pow(xi1, 24) - 30001437.7402291*pow(xi1, 22) + 27674998.2284423*pow(xi1, 20) - 18227758.1421468*pow(xi1, 18) + 8646958.25716048*pow(xi1, 16) - 2943054.94313389*pow(xi1, 14) + 707276.096616685*pow(xi1, 12) - 116399.603186524*pow(xi1, 10) + 12447.9005028605*pow(xi1, 8) - 787.236498335997*pow(xi1, 6) + 24.0982005000114*pow(xi1, 4) - 0.183955729007721*pow(xi1, 2) + 3.97364298502604e-9*pow(xi2, 2)*(112832306929485.0*pow(xi2, 28) - 844728451699275.0*pow(xi2, 26) + 2.84595123813683e+15*pow(xi2, 24) - 5.69961457184438e+15*pow(xi2, 22) + 7.55010901917563e+15*pow(xi2, 20) - 6.9646413461729e+15*pow(xi2, 18) + 4.58716553319833e+15*pow(xi2, 16) - 2.17607829635048e+15*pow(xi2, 14) + 740644027212375.0*pow(xi2, 12) - 177991857668625.0*pow(xi2, 10) + 29292919274619.0*pow(xi2, 8) - 3132616732245.0*pow(xi2, 6) + 198114551635.0*pow(xi2, 4) - 6064510725.0*pow(xi2, 2) + 46293975.0);
case 10:
return -813547.932304814*pow(xi1, 31) + 6295221.28702842*pow(xi1, 29) - 21999639.0535594*pow(xi1, 27) + 45894394.1861918*pow(xi1, 25) - 63647685.3472386*pow(xi1, 23) + 61843493.4318345*pow(xi1, 21) - 43227949.0107802*pow(xi1, 19) + 21968581.144582*pow(xi1, 17) - 8107398.1842526*pow(xi1, 15) + 2146726.9782532*pow(xi1, 13) - 398184.796114191*pow(xi1, 11) + 49755.7135626823*pow(xi1, 9) - 3946.58752410114*pow(xi1, 7) + 182.554599538445*pow(xi1, 5) - 4.43026714026928*pow(xi1, 3) + 0.0459889322519302*xi1 + 813547.932304814*pow(xi2, 31) - 6295221.28702842*pow(xi2, 29) + 21999639.0535594*pow(xi2, 27) - 45894394.1861918*pow(xi2, 25) + 63647685.3472386*pow(xi2, 23) - 61843493.4318345*pow(xi2, 21) + 43227949.0107802*pow(xi2, 19) - 21968581.144582*pow(xi2, 17) + 8107398.1842526*pow(xi2, 15) - 2146726.9782532*pow(xi2, 13) + 398184.796114191*pow(xi2, 11) - 49755.7135626823*pow(xi2, 9) + 3946.58752410114*pow(xi2, 7) - 182.554599538445*pow(xi2, 5) + 4.43026714026928*pow(xi2, 3) - 0.0459889322519302*xi2;
case 11:
return -1488679.72334943*pow(xi1, 32) + 11893145.806239*pow(xi1, 30) - 43054459.3877993*pow(xi1, 28) + 93407464.6031898*pow(xi1, 26) - 135345860.163132*pow(xi1, 24) + 138173637.360835*pow(xi1, 22) - 102170151.372404*pow(xi1, 20) + 55393315.5756378*pow(xi1, 18) - 22043036.0687566*pow(xi1, 16) + 6381339.80813455*pow(xi1, 14) - 1318139.46433848*pow(xi1, 12) + 188051.027000137*pow(xi1, 10) - 17587.6326048765*pow(xi1, 8) + 987.120238535106*pow(xi1, 6) - 27.696834448725*pow(xi1, 4) + 0.206950195133686*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.19691536300208e+15*pow(xi2, 30) - 2.5540336142178e+16*pow(xi2, 28) + 9.24587475087791e+16*pow(xi2, 26) - 2.00591002836489e+17*pow(xi2, 24) + 2.9065302152482e+17*pow(xi2, 22) - 2.96725626817074e+17*pow(xi2, 20) + 2.19408729385923e+17*pow(xi2, 18) - 1.18956239407186e+17*pow(xi2, 16) + 4.73370595099291e+16*pow(xi2, 14) - 1.37038228903004e+16*pow(xi2, 12) + 2.83068294545036e+15*pow(xi2, 10) - 403836505472400.0*pow(xi2, 8) + 37769153426004.0*pow(xi2, 6) - 2119824570864.0*pow(xi2, 4) + 59478499080.0*pow(xi2, 2) - 444422160.0);
case 12:
return -2742779.61150441*pow(xi1, 33) + 22600235.4279654*pow(xi1, 31) - 84648362.5869781*pow(xi1, 29) + 190700740.01478*pow(xi1, 27) - 288175803.705125*pow(xi1, 25) + 308398483.842205*pow(xi1, 23) - 240538465.619668*pow(xi1, 21) + 138613122.14585*pow(xi1, 19) - 59189858.1177827*pow(xi1, 17) + 18612900.9589193*pow(xi1, 15) - 4243868.11019075*pow(xi1, 13) + 683181.726775736*pow(xi1, 11) - 74483.69949465*pow(xi1, 9) + 5159.52458873391*pow(xi1, 7) - 206.398327946663*pow(xi1, 5) + 4.24937734007835*pow(xi1, 3) - 0.0413900390267372*xi1 + 2742779.61150441*pow(xi2, 33) - 22600235.4279654*pow(xi2, 31) + 84648362.5869781*pow(xi2, 29) - 190700740.01478*pow(xi2, 27) + 288175803.705125*pow(xi2, 25) - 308398483.842205*pow(xi2, 23) + 240538465.619668*pow(xi2, 21) - 138613122.14585*pow(xi2, 19) + 59189858.1177827*pow(xi2, 17) - 18612900.9589193*pow(xi2, 15) + 4243868.11019075*pow(xi2, 13) - 683181.726775736*pow(xi2, 11) + 74483.69949465*pow(xi2, 9) - 5159.52458873391*pow(xi2, 7) + 206.398327946663*pow(xi2, 5) - 4.24937734007835*pow(xi2, 3) + 0.0413900390267372*xi2;
case 13:
return -5082209.28014053*pow(xi1, 34) + 43150939.7019241*pow(xi1, 32) - 167026656.234368*pow(xi1, 30) + 390203143.561572*pow(xi1, 28) - 613909922.174896*pow(xi1, 26) + 687270735.359609*pow(xi1, 24) - 563949022.965526*pow(xi1, 22) + 344275754.593978*pow(xi1, 20) - 157078667.432643*pow(xi1, 18) + 53351986.2105718*pow(xi1, 16) - 13324438.7481877*pow(xi1, 14) + 2393876.62580161*pow(xi1, 12) - 298932.017313659*pow(xi1, 10) + 24607.5082151592*pow(xi1, 8) - 1225.7430113107*pow(xi1, 6) + 31.2632761448622*pow(xi1, 4) - 0.227645214647055*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.36424516560196e+15*pow(xi2, 32) - 1.15832421757145e+16*pow(xi2, 30) + 4.48358766304277e+16*pow(xi2, 28) - 1.04744358774584e+17*pow(xi2, 26) + 1.64795189901943e+17*pow(xi2, 24) - 1.84487833241712e+17*pow(xi2, 22) + 1.51383913140505e+17*pow(xi2, 20) - 9.24158191741785e+16*pow(xi2, 18) + 4.21654837201537e+16*pow(xi2, 16) - 1.43215647469406e+16*pow(xi2, 14) + 3.57675179131384e+15*pow(xi2, 12) - 642601363654796.0*pow(xi2, 10) + 80243952380592.0*pow(xi2, 8) - 6605527688760.0*pow(xi2, 6) + 329032884180.0*pow(xi2, 4) - 8392171788.0*pow(xi2, 2) + 61108047.0);
case 14:
return -9462589.65969023*pow(xi1, 35) + 82713940.9585662*pow(xi1, 33) - 330524390.007123*pow(xi1, 31) + 799694402.640513*pow(xi1, 29) - 1307889670.50919*pow(xi1, 27) + 1528739306.45805*pow(xi1, 25) - 1316605152.29215*pow(xi1, 23) + 848933462.981639*pow(xi1, 21) - 412283819.498231*pow(xi1, 19) + 150500168.595666*pow(xi1, 17) - 40897766.306323*pow(xi1, 15) + 8125532.61845206*pow(xi1, 13) - 1147116.31001519*pow(xi1, 11) + 110200.627421848*pow(xi1, 9) - 6743.28486777842*pow(xi1, 7) + 237.135490706563*pow(xi1, 5) - 4.18614255823195*pow(xi1, 3) + 0.0379408691078424*xi1 + 9462589.65969023*pow(xi2, 35) - 82713940.9585662*pow(xi2, 33) + 330524390.007123*pow(xi2, 31) - 799694402.640513*pow(xi2, 29) + 1307889670.50919*pow(xi2, 27) - 1528739306.45805*pow(xi2, 25) + 1316605152.29215*pow(xi2, 23) - 848933462.981639*pow(xi2, 21) + 412283819.498231*pow(xi2, 19) - 150500168.595666*pow(xi2, 17) + 40897766.306323*pow(xi2, 15) - 8125532.61845206*pow(xi2, 13) + 1147116.31001519*pow(xi2, 11) - 110200.627421848*pow(xi2, 9) + 6743.28486777842*pow(xi2, 7) - 237.135490706563*pow(xi2, 5) + 4.18614255823195*pow(xi2, 3) - 0.0379408691078424*xi2;
case 15:
return -17691807.5902328*pow(xi1, 36) + 159078150.8532*pow(xi1, 34) - 655592218.992931*pow(xi1, 32) + 1640789841.43268*pow(xi1, 30) - 2785532373.16041*pow(xi1, 28) + 3393496929.74806*pow(xi1, 26) - 3060839533.17806*pow(xi1, 24) + 2078925210.23867*pow(xi1, 22) - 1071003828.3239*pow(xi1, 20) + 418340016.31884*pow(xi1, 18) - 122981940.948562*pow(xi1, 16) + 26809361.5972113*pow(xi1, 14) - 4231892.43185647*pow(xi1, 12) + 466669.101904269*pow(xi1, 10) - 34061.4965434279*pow(xi1, 8) + 1511.47991221398*pow(xi1, 6) - 34.8961143619381*pow(xi1, 4) + 0.246615649200976*pow(xi1, 2) + 5.17401430341932e-11*pow(xi2, 2)*(3.41935807532285e+17*pow(xi2, 34) - 3.07455954940192e+18*pow(xi2, 32) + 1.26708621303902e+19*pow(xi2, 30) - 3.17121241885307e+19*pow(xi2, 28) + 5.38369670010296e+19*pow(xi2, 26) - 6.55873124955496e+19*pow(xi2, 24) + 5.91579256198666e+19*pow(xi2, 22) - 4.01801210496226e+19*pow(xi2, 20) + 2.06996688744388e+19*pow(xi2, 18) - 8.08540509913887e+18*pow(xi2, 16) + 2.37691536467705e+18*pow(xi2, 14) - 5.18153990789974e+17*pow(xi2, 12) + 8.17912781775606e+16*pow(xi2, 10) - 9.01947838829638e+15*pow(xi2, 8) + 658318561680780.0*pow(xi2, 6) - 29212905561840.0*pow(xi2, 4) + 674449514739.0*pow(xi2, 2) - 4766427666.0);
case 16:
return -33197754.7832167*pow(xi1, 37) + 306814736.282442*pow(xi1, 35) - 1302848393.68207*pow(xi1, 33) + 3369219126.11369*pow(xi1, 31) - 5929426758.38608*pow(xi1, 29) + 7516677563.57637*pow(xi1, 27) - 7086469405.995*pow(xi1, 25) + 5057597873.96622*pow(xi1, 23) - 2755445247.24114*pow(xi1, 21) + 1147170493.78579*pow(xi1, 19) - 362977881.300088*pow(xi1, 17) + 86233348.1594231*pow(xi1, 15) - 15078836.0463731*pow(xi1, 13) + 1883365.51848263*pow(xi1, 11) - 160720.290966164*pow(xi1, 9) + 8760.19049741328*pow(xi1, 7) - 274.036960671656*pow(xi1, 5) + 4.20420963875949*pow(xi1, 3) - 0.0352308070287108*xi1 + 33197754.7832167*pow(xi2, 37) - 306814736.282442*pow(xi2, 35) + 1302848393.68207*pow(xi2, 33) - 3369219126.11369*pow(xi2, 31) + 5929426758.38608*pow(xi2, 29) - 7516677563.57637*pow(xi2, 27) + 7086469405.995*pow(xi2, 25) - 5057597873.96622*pow(xi2, 23) + 2755445247.24114*pow(xi2, 21) - 1147170493.78579*pow(xi2, 19) + 362977881.300088*pow(xi2, 17) - 86233348.1594231*pow(xi2, 15) + 15078836.0463731*pow(xi2, 13) - 1883365.51848263*pow(xi2, 11) + 160720.290966164*pow(xi2, 9) - 8760.19049741328*pow(xi2, 7) + 274.036960671656*pow(xi2, 5) - 4.20420963875949*pow(xi2, 3) + 0.0352308070287108*xi2;
case 17:
return -62493317.3375291*pow(xi1, 38) + 593210422.874364*pow(xi1, 36) - 2593229632.47033*pow(xi1, 34) + 6922152726.01049*pow(xi1, 32) - 12612843638.232*pow(xi1, 30) + 16613064815.6171*pow(xi1, 28) - 16340828722.4991*pow(xi1, 26) + 12227388514.1203*pow(xi1, 24) - 7025379152.49504*pow(xi1, 22) + 3106573380.0222*pow(xi1, 20) - 1053221405.90108*pow(xi1, 18) + 271081088.424279*pow(xi1, 16) - 52092171.7263622*pow(xi1, 14) + 7287508.49415471*pow(xi1, 12) - 715211.134725111*pow(xi1, 10) + 46610.0523653235*pow(xi1, 8) - 1852.21857692627*pow(xi1, 6) + 38.6658107140101*pow(xi1, 4) - 0.264231052715331*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(1.34203377091619e+17*pow(xi2, 36) - 1.27390968294586e+18*pow(xi2, 34) + 5.56891823123908e+18*pow(xi2, 32) - 1.48652097880662e+19*pow(xi2, 30) + 2.70858754678841e+19*pow(xi2, 28) - 3.56762850347018e+19*pow(xi2, 26) + 3.50916624763357e+19*pow(xi2, 24) - 2.62581168918163e+19*pow(xi2, 22) + 1.50868868509832e+19*pow(xi2, 20) - 6.67131553490977e+18*pow(xi2, 18) + 2.26177574689614e+18*pow(xi2, 16) - 5.82142204673181e+17*pow(xi2, 14) + 1.11867086971171e+17*pow(xi2, 12) - 1.56498053258583e+16*pow(xi2, 10) + 1.5359042166897e+15*pow(xi2, 8) - 100094325286956.0*pow(xi2, 6) + 3977609106471.0*pow(xi2, 4) - 83034196245.0*pow(xi2, 2) + 567431865.0);
case 18:
return -117976166.383989*pow(xi1, 39) + 1149404705.7981*pow(xi1, 37) - 5168467444.95001*pow(xi1, 35) + 14226677005.8239*pow(xi1, 33) - 26807724752.4166*pow(xi1, 31) + 36636726077.2706*pow(xi1, 29) - 37534635100.886*pow(xi1, 27) + 29386507704.384*pow(xi1, 25) - 17761358284.0216*pow(xi1, 23) + 8315597465.75811*pow(xi1, 21) - 3008687944.80839*pow(xi1, 19) + 834616101.433694*pow(xi1, 17) - 175043774.437964*pow(xi1, 15) + 27169837.4464822*pow(xi1, 13) - 3025402.05860465*pow(xi1, 11) + 230948.140743281*pow(xi1, 9) - 11288.6844422918*pow(xi1, 7) + 316.841657236393*pow(xi1, 5) - 4.28274497942766*pow(xi1, 3) + 0.0330288815894164*xi1 + 117976166.383989*pow(xi2, 39) - 1149404705.7981*pow(xi2, 37) + 5168467444.95001*pow(xi2, 35) - 14226677005.8239*pow(xi2, 33) + 26807724752.4166*pow(xi2, 31) - 36636726077.2706*pow(xi2, 29) + 37534635100.886*pow(xi2, 27) - 29386507704.384*pow(xi2, 25) + 17761358284.0216*pow(xi2, 23) - 8315597465.75811*pow(xi2, 21) + 3008687944.80839*pow(xi2, 19) - 834616101.433694*pow(xi2, 17) + 175043774.437964*pow(xi2, 15) - 27169837.4464822*pow(xi2, 13) + 3025402.05860465*pow(xi2, 11) - 230948.140743281*pow(xi2, 9) + 11288.6844422918*pow(xi2, 7) - 316.841657236393*pow(xi2, 5) + 4.28274497942766*pow(xi2, 3) - 0.0330288815894164*xi2;
case 19:
return -223287244.317932*pow(xi1, 40) + 2231298889.66052*pow(xi1, 38) - 10312531213.2237*pow(xi1, 36) + 29244927646.0313*pow(xi1, 34) - 56927287899.7051*pow(xi1, 32) + 80618650592.7439*pow(xi1, 30) - 85894985109.8443*pow(xi1, 28) + 70229985530.9422*pow(xi1, 26) - 44549480703.4182*pow(xi1, 24) + 22020434506.5471*pow(xi1, 22) - 8472208302.94696*pow(xi1, 20) + 2521396724.84906*pow(xi1, 18) - 573689069.79194*pow(xi1, 16) + 98002129.1228823*pow(xi1, 14) - 12242267.5399568*pow(xi1, 12) + 1076619.87856925*pow(xi1, 10) - 63042.4471244913*pow(xi1, 8) + 2255.80251793066*pow(xi1, 6) - 42.626524097941*pow(xi1, 4) + 0.28074549351004*pow(xi1, 2) + 1.45519152283669e-12*pow(xi2, 2)*(1.53441825913517e+20*pow(xi2, 38) - 1.53333692139089e+21*pow(xi2, 36) + 7.08671748796399e+21*pow(xi2, 34) - 2.00969612501745e+22*pow(xi2, 32) + 3.91201343646736e+22*pow(xi2, 30) - 5.54007148389578e+22*pow(xi2, 28) + 5.90265843099501e+22*pow(xi2, 26) - 4.8261678568632e+22*pow(xi2, 24) + 3.06141700279943e+22*pow(xi2, 22) - 1.51323273678928e+22*pow(xi2, 20) + 5.8220572137691e+21*pow(xi2, 18) - 1.73269063575492e+21*pow(xi2, 16) + 3.94236126852647e+20*pow(xi2, 14) - 6.73465503233838e+19*pow(xi2, 12) + 8.41282219407951e+18*pow(xi2, 10) - 7.39847546988545e+17*pow(xi2, 8) + 4.33224397855199e+16*pow(xi2, 6) - 1.55017568651946e+15*pow(xi2, 4) + 29292724310850.0*pow(xi2, 2) - 192926834100.0);
case 20:
return -423580138.272501*pow(xi1, 41) + 4338811569.17533*pow(xi1, 39) - 20595743075.9893*pow(xi1, 37) + 60121749251.6231*pow(xi1, 35) - 120773953279.355*pow(xi1, 33) + 177020168578.682*pow(xi1, 31) - 195860136712.149*pow(xi1, 29) + 166949967786.963*pow(xi1, 27) - 110912954589.41*pow(xi1, 25) + 57730496761.096*pow(xi1, 23) - 23542894463.8585*pow(xi1, 21) + 7486216791.89479*pow(xi1, 19) - 1838137033.97982*pow(xi1, 17) + 343174836.118123*pow(xi1, 15) - 47633702.7455318*pow(xi1, 13) + 4760440.11342579*pow(xi1, 11) - 327079.942769009*pow(xi1, 9) + 14421.2061698267*pow(xi1, 7) - 365.547269320057*pow(xi1, 5) + 4.40874404623173*pow(xi1, 3) - 0.0311939437233377*xi1 + 423580138.272501*pow(xi2, 41) - 4338811569.17533*pow(xi2, 39) + 20595743075.9893*pow(xi2, 37) - 60121749251.6231*pow(xi2, 35) + 120773953279.355*pow(xi2, 33) - 177020168578.682*pow(xi2, 31) + 195860136712.149*pow(xi2, 29) - 166949967786.963*pow(xi2, 27) + 110912954589.41*pow(xi2, 25) - 57730496761.096*pow(xi2, 23) + 23542894463.8585*pow(xi2, 21) - 7486216791.89479*pow(xi2, 19) + 1838137033.97982*pow(xi2, 17) - 343174836.118123*pow(xi2, 15) + 47633702.7455318*pow(xi2, 13) - 4760440.11342579*pow(xi2, 11) + 327079.942769009*pow(xi2, 9) - 14421.2061698267*pow(xi2, 7) + 365.547269320057*pow(xi2, 5) - 4.40874404623173*pow(xi2, 3) + 0.0311939437233377*xi2;
case 21:
return -805226904.46038*pow(xi1, 42) + 8449568302.93278*pow(xi1, 40) - 41165901262.5445*pow(xi1, 38) + 123596762437.165*pow(xi1, 36) - 255979710020.842*pow(xi1, 34) + 387881992088.781*pow(xi1, 32) - 445073680723.189*pow(xi1, 30) + 394876109613.793*pow(xi1, 28) - 274214810169.403*pow(xi1, 26) + 149943044753.442*pow(xi1, 24) - 64624213069.4037*pow(xi1, 22) + 21875803667.7972*pow(xi1, 20) - 5769358869.07719*pow(xi1, 18) + 1170014757.05802*pow(xi1, 16) - 178978750.223936*pow(xi1, 14) + 20095740.8543639*pow(xi1, 12) - 1593206.31097129*pow(xi1, 10) + 84297.3998941569*pow(xi1, 8) - 2730.2887435151*pow(xi1, 6) + 46.8221095287299*pow(xi1, 4) - 0.296342465371708*pow(xi1, 2) + 4.85063840945562e-12*pow(xi2, 2)*(1.66004314584799e+20*pow(xi2, 40) - 1.7419497372679e+21*pow(xi2, 38) + 8.4866975823837e+21*pow(xi2, 36) - 2.5480514522837e+22*pow(xi2, 34) + 5.27723751829958e+22*pow(xi2, 32) - 7.99651425949749e+22*pow(xi2, 30) + 9.17556913447892e+22*pow(xi2, 28) - 8.14070388846216e+22*pow(xi2, 26) + 5.65316948043089e+22*pow(xi2, 24) - 3.09120227269774e+22*pow(xi2, 22) + 1.33228263198156e+22*pow(xi2, 20) - 4.50988134369148e+21*pow(xi2, 18) + 1.18940196775556e+21*pow(xi2, 16) - 2.41208405635275e+20*pow(xi2, 14) + 3.68979781867565e+19*pow(xi2, 12) - 4.14290638840244e+18*pow(xi2, 10) + 3.28452912067319e+17*pow(xi2, 8) - 1.73786196327954e+16*pow(xi2, 6) + 562872041377646.0*pow(xi2, 4) - 9652772599470.0*pow(xi2, 2) + 61093497465.0);
case 22:
return -1533676359.89082*pow(xi1, 43) + 16477189610.109*pow(xi1, 41) - 82337083389.5511*pow(xi1, 39) + 254065759248.919*pow(xi1, 37) - 542014369628.522*pow(xi1, 35) + 848184840655.991*pow(xi1, 33) - 1008066267320.93*pow(xi1, 31) + 929523529356.303*pow(xi1, 29) - 673516946271.272*pow(xi1, 27) + 386060686638.382*pow(xi1, 25) - 175382178039.451*pow(xi1, 23) + 62992242266.5747*pow(xi1, 21) - 17770037336.7532*pow(xi1, 19) + 3893551383.46965*pow(xi1, 17) - 651757419.719781*pow(xi1, 15) + 81424351.1461102*pow(xi1, 13) - 7346738.38629451*pow(xi1, 11) + 456841.438780431*pow(xi1, 9) - 18263.6284754963*pow(xi1, 7) + 420.312396718873*pow(xi1, 5) - 4.57355204890337*pow(xi1, 3) + 0.0296342465371708*xi1 + 1533676359.89082*pow(xi2, 43) - 16477189610.109*pow(xi2, 41) + 82337083389.5511*pow(xi2, 39) - 254065759248.919*pow(xi2, 37) + 542014369628.522*pow(xi2, 35) - 848184840655.991*pow(xi2, 33) + 1008066267320.93*pow(xi2, 31) - 929523529356.303*pow(xi2, 29) + 673516946271.272*pow(xi2, 27) - 386060686638.382*pow(xi2, 25) + 175382178039.451*pow(xi2, 23) - 62992242266.5747*pow(xi2, 21) + 17770037336.7532*pow(xi2, 19) - 3893551383.46965*pow(xi2, 17) + 651757419.719781*pow(xi2, 15) - 81424351.1461102*pow(xi2, 13) + 7346738.38629451*pow(xi2, 11) - 456841.438780431*pow(xi2, 9) + 18263.6284754963*pow(xi2, 7) - 420.312396718873*pow(xi2, 5) + 4.57355204890337*pow(xi2, 3) - 0.0296342465371708*xi2;
case 23:
return -2926267773.25488*pow(xi1, 44) + 32170687453.9002*pow(xi1, 42) - 164781727359.808*pow(xi1, 40) + 522185265338.526*pow(xi1, 38) - 1146534774301.18*pow(xi1, 36) + 1851064835044.44*pow(xi1, 34) - 2276036756996.6*pow(xi1, 32) + 2178170928315.17*pow(xi1, 30) - 1644071226030.65*pow(xi1, 28) + 985904588081.376*pow(xi1, 26) - 470948522565.186*pow(xi1, 24) + 178941502904.888*pow(xi1, 22) - 53793287029.6419*pow(xi1, 20) + 12674006632.6617*pow(xi1, 18) - 2307248617.22092*pow(xi1, 16) + 318072208.243466*pow(xi1, 14) - 32287130.2272467*pow(xi1, 12) + 2320075.01478208*pow(xi1, 10) - 111483.603306741*pow(xi1, 8) + 3284.11659166017*pow(xi1, 6) - 51.2894721942084*pow(xi1, 4) + 0.311159588640294*pow(xi1, 2) + 1.81898940354586e-12*pow(xi2, 2)*(1.60873272133996e+21*pow(xi2, 42) - 1.76860224645554e+22*pow(xi2, 40) + 9.05897126385615e+22*pow(xi2, 38) - 2.87074385546503e+23*pow(xi2, 36) + 6.30314157996837e+23*pow(xi2, 34) - 1.01763365494931e+24*pow(xi2, 32) + 1.25126443978167e+24*pow(xi2, 30) - 1.19746213148309e+24*pow(xi2, 28) + 9.03837714956322e+23*pow(xi2, 26) - 5.4200677923659e+23*pow(xi2, 24) + 2.58906688322175e+23*pow(xi2, 22) - 9.83741315678188e+22*pow(xi2, 20) + 2.95731722926916e+22*pow(xi2, 18) - 6.96760883156087e+21*pow(xi2, 16) + 1.26842334140225e+21*pow(xi2, 14) - 1.7486204571804e+20*pow(xi2, 12) + 1.77500375561878e+19*pow(xi2, 10) - 1.27547472803273e+18*pow(xi2, 8) + 6.12887590710645e+16*pow(xi2, 6) - 1.80546218975122e+15*pow(xi2, 4) + 28196685530013.0*pow(xi2, 2) - 171061792902.0);
case 24:
return -5592422855.55377*pow(xi1, 45) + 62880730755.5235*pow(xi1, 43) - 329946154449.194*pow(xi1, 41) + 1073059201467.59*pow(xi1, 39) - 2422905313949.18*pow(xi1, 37) + 4031996559106.4*pow(xi1, 35) - 5123441697247.83*pow(xi1, 33) + 5082245802862.89*pow(xi1, 31) - 3989877093289.8*pow(xi1, 29) + 2498527673418.84*pow(xi1, 27) - 1252183155949.86*pow(xi1, 25) + 501953070634.544*pow(xi1, 23) - 160263648668.943*pow(xi1, 21) + 40430445050.3462*pow(xi1, 19) - 7960922172.58466*pow(xi1, 17) + 1202372898.70999*pow(xi1, 15) - 135975549.161354*pow(xi1, 13) + 11135243.0726873*pow(xi1, 11) - 629764.60336879*pow(xi1, 9) + 22935.4251074434*pow(xi1, 7) - 481.405371571687*pow(xi1, 5) + 4.77111369248451*pow(xi1, 3) - 0.0282872353309358*xi1 + 5592422855.55377*pow(xi2, 45) - 62880730755.5235*pow(xi2, 43) + 329946154449.194*pow(xi2, 41) - 1073059201467.59*pow(xi2, 39) + 2422905313949.18*pow(xi2, 37) - 4031996559106.4*pow(xi2, 35) + 5123441697247.83*pow(xi2, 33) - 5082245802862.89*pow(xi2, 31) + 3989877093289.8*pow(xi2, 29) - 2498527673418.84*pow(xi2, 27) + 1252183155949.86*pow(xi2, 25) - 501953070634.544*pow(xi2, 23) + 160263648668.943*pow(xi2, 21) - 40430445050.3462*pow(xi2, 19) + 7960922172.58466*pow(xi2, 17) - 1202372898.70999*pow(xi2, 15) + 135975549.161354*pow(xi2, 13) - 11135243.0726873*pow(xi2, 11) + 629764.60336879*pow(xi2, 9) - 22935.4251074434*pow(xi2, 7) + 481.405371571687*pow(xi2, 5) - 4.77111369248451*pow(xi2, 3) + 0.0282872353309358*xi2;
case 25:
return -10703833915.403*pow(xi1, 46) + 123030475510.325*pow(xi1, 44) - 660948623360.421*pow(xi1, 42) + 2204594368100.28*pow(xi1, 40) - 5115199347309.37*pow(xi1, 38) + 8766244108501.35*pow(xi1, 36) - 11499881607450.5*pow(xi1, 34) + 11809867896629.5*pow(xi1, 32) - 9629539738306.08*pow(xi1, 30) + 6286427016209.27*pow(xi1, 28) - 3298734907736.02*pow(xi1, 26) + 1391634507284.73*pow(xi1, 24) - 470468054146.476*pow(xi1, 22) + 126602340893.671*pow(xi1, 20) - 26833362532.7568*pow(xi1, 18) + 4412372880.13861*pow(xi1, 16) - 551279305.585031*pow(xi1, 14) + 50854158.3368599*pow(xi1, 12) - 3328135.51137573*pow(xi1, 10) + 145900.940711039*pow(xi1, 8) - 3926.22897610704*pow(xi1, 6) + 56.0605858866929*pow(xi1, 4) - 0.325303206305762*pow(xi1, 2) + 1.81898940354586e-12*pow(xi2, 2)*(5.88449492588436e+21*pow(xi2, 44) - 6.76367191972063e+22*pow(xi2, 42) + 3.63360348373661e+23*pow(xi2, 40) - 1.21198857112787e+24*pow(xi2, 38) + 2.81211058037943e+24*pow(xi2, 36) - 4.81929366461004e+24*pow(xi2, 34) + 6.32212677271958e+24*pow(xi2, 32) - 6.49254353742134e+24*pow(xi2, 30) + 5.2938954561993e+24*pow(xi2, 28) - 3.45599980074364e+24*pow(xi2, 26) + 1.81349869400317e+24*pow(xi2, 24) - 7.65059161186943e+23*pow(xi2, 22) + 2.586425480156e+23*pow(xi2, 20) - 6.96003729581259e+22*pow(xi2, 18) + 1.47517970585475e+22*pow(xi2, 16) - 2.42572764389794e+21*pow(xi2, 14) + 3.0306900332151e+20*pow(xi2, 12) - 2.79573692060696e+19*pow(xi2, 10) + 1.82966184678592e+18*pow(xi2, 8) - 8.0209890407622e+16*pow(xi2, 6) + 2.15846720627038e+15*pow(xi2, 4) - 30819633021177.0*pow(xi2, 2) + 178837328943.0);
case 26:
return -20515681671.1891*pow(xi1, 47) + 240939982417.454*pow(xi1, 45) - 1324517078711.9*pow(xi1, 43) + 4528228288286.7*pow(xi1, 41) - 10788760831208.3*pow(xi1, 39) + 19025199835309.7*pow(xi1, 37) - 25741152427126.8*pow(xi1, 35) + 27336784803967.1*pow(xi1, 33) - 23120016516737.7*pow(xi1, 31) + 15710037319763.9*pow(xi1, 29) - 8615184787726.1*pow(xi1, 27) + 3816281731480.58*pow(xi1, 25) - 1362313663683.21*pow(xi1, 23) + 389709410212.598*pow(xi1, 21) - 88528792082.7051*pow(xi1, 19) + 15761825919.9628*pow(xi1, 17) - 2159890092.02749*pow(xi1, 15) + 222238572.11934*pow(xi1, 13) - 16596364.3474867*pow(xi1, 11) + 857500.123169862*pow(xi1, 9) - 28570.2381759558*pow(xi1, 7) + 549.175065645352*pow(xi1, 5) - 4.99701869686351*pow(xi1, 3) + 0.0271086005254801*xi1 + 20515681671.1891*pow(xi2, 47) - 240939982417.454*pow(xi2, 45) + 1324517078711.9*pow(xi2, 43) - 4528228288286.7*pow(xi2, 41) + 10788760831208.3*pow(xi2, 39) - 19025199835309.7*pow(xi2, 37) + 25741152427126.8*pow(xi2, 35) - 27336784803967.1*pow(xi2, 33) + 23120016516737.7*pow(xi2, 31) - 15710037319763.9*pow(xi2, 29) + 8615184787726.1*pow(xi2, 27) - 3816281731480.58*pow(xi2, 25) + 1362313663683.21*pow(xi2, 23) - 389709410212.598*pow(xi2, 21) + 88528792082.7051*pow(xi2, 19) - 15761825919.9628*pow(xi2, 17) + 2159890092.02749*pow(xi2, 15) - 222238572.11934*pow(xi2, 13) + 16596364.3474867*pow(xi2, 11) - 857500.123169862*pow(xi2, 9) + 28570.2381759558*pow(xi2, 7) - 549.175065645352*pow(xi2, 5) + 4.99701869686351*pow(xi2, 3) - 0.0271086005254801*xi2;
case 27:
return -39373012407.2904*pow(xi1, 48) + 472251907715.73*pow(xi1, 46) - 2655161515440.8*pow(xi1, 44) + 9298520803347.89*pow(xi1, 42) - 22733732541815.3*pow(xi1, 40) + 41218683269644.9*pow(xi1, 38) - 57466790358075.2*pow(xi1, 36) + 63044099317287.5*pow(xi1, 34) - 55236604541920.0*pow(xi1, 32) + 39009642190619.9*pow(xi1, 30) - 22317669184363.2*pow(xi1, 28) + 10359008774601.5*pow(xi1, 26) - 3894848291944.96*pow(xi1, 24) + 1180760210360.19*pow(xi1, 22) - 286378858115.921*pow(xi1, 20) + 54936919123.2888*pow(xi1, 18) - 8204676009.03359*pow(xi1, 16) + 933702334.618827*pow(xi1, 14) - 78638126.6143699*pow(xi1, 12) + 4707640.30819233*pow(xi1, 10) - 189062.861554361*pow(xi1, 8) + 4666.16575761683*pow(xi1, 6) - 61.1637799356146*pow(xi1, 4) + 0.338857506568502*pow(xi1, 2) + 9.473903143468e-15*pow(xi2, 2)*(4.15594415638892e+24*pow(xi2, 46) - 4.9847660522193e+25*pow(xi2, 44) + 2.80260572145649e+26*pow(xi2, 42) - 9.81487847462212e+26*pow(xi2, 40) + 2.39961631415766e+27*pow(xi2, 38) - 4.3507604675127e+27*pow(xi2, 36) + 6.06579880412826e+27*pow(xi2, 34) - 6.65450114515417e+27*pow(xi2, 32) + 5.83039574137974e+27*pow(xi2, 30) - 4.11758929766091e+27*pow(xi2, 28) + 2.35569953021429e+27*pow(xi2, 26) - 1.09342565759117e+27*pow(xi2, 24) + 4.1111337460003e+26*pow(xi2, 22) - 1.24632919767001e+26*pow(xi2, 20) + 3.02281809069761e+25*pow(xi2, 18) - 5.7987630115436e+24*pow(xi2, 16) + 8.66029120710453e+23*pow(xi2, 14) - 9.85551910843198e+22*pow(xi2, 12) + 8.30049932150602e+21*pow(xi2, 10) - 4.96906104791469e+20*pow(xi2, 8) + 1.99561742073239e+19*pow(xi2, 6) - 4.92528336732472e+17*pow(xi2, 4) + 6.4560275748423e+15*pow(xi2, 2) - 35767465788600.0);
case 28:
return -75655521485.9082*pow(xi1, 49) + 926357529840.222*pow(xi1, 47) - 5324136684503.24*pow(xi1, 45) + 19088808068324.2*pow(xi1, 43) - 47859520057032.9*pow(xi1, 41) + 89152712018737.6*pow(xi1, 39) - 127970204724623.0*pow(xi1, 37) + 144881292955948.0*pow(xi1, 35) - 131350799622012.0*pow(xi1, 33) + 96281346590719.7*pow(xi1, 31) - 57373221024004.7*pow(xi1, 29) + 27850848100907.0*pow(xi1, 27) - 11003800602332.3*pow(xi1, 25) + 3525323265287.58*pow(xi1, 23) - 909714057948.449*pow(xi1, 21) + 187213093106.203*pow(xi1, 19) - 30302696016.6417*pow(xi1, 17) + 3786210901.09783*pow(xi1, 15) - 356077128.481597*pow(xi1, 13) + 24352785.8487305*pow(xi1, 11) - 1154167.4155017*pow(xi1, 9) + 35316.6945199066*pow(xi1, 7) - 624.033033173341*pow(xi1, 5) + 5.24794702480449*pow(xi1, 3) - 0.0260659620437309*xi1 + 75655521485.9082*pow(xi2, 49) - 926357529840.222*pow(xi2, 47) + 5324136684503.24*pow(xi2, 45) - 19088808068324.2*pow(xi2, 43) + 47859520057032.9*pow(xi2, 41) - 89152712018737.6*pow(xi2, 39) + 127970204724623.0*pow(xi2, 37) - 144881292955948.0*pow(xi2, 35) + 131350799622012.0*pow(xi2, 33) - 96281346590719.7*pow(xi2, 31) + 57373221024004.7*pow(xi2, 29) - 27850848100907.0*pow(xi2, 27) + 11003800602332.3*pow(xi2, 25) - 3525323265287.58*pow(xi2, 23) + 909714057948.449*pow(xi2, 21) - 187213093106.203*pow(xi2, 19) + 30302696016.6417*pow(xi2, 17) - 3786210901.09783*pow(xi2, 15) + 356077128.481597*pow(xi2, 13) - 24352785.8487305*pow(xi2, 11) + 1154167.4155017*pow(xi2, 9) - 35316.6945199066*pow(xi2, 7) + 624.033033173341*pow(xi2, 5) - 5.24794702480449*pow(xi2, 3) + 0.0260659620437309*xi2;
case 29:
return -145538806888.077*pow(xi1, 50) + 1818436825861.34*pow(xi1, 48) - 10678646758589.6*pow(xi1, 46) + 39175840371527.9*pow(xi1, 44) - 100663775838791.0*pow(xi1, 42) + 192520127394647.0*pow(xi1, 40) - 284282290970171.0*pow(xi1, 38) + 331835096922265.0*pow(xi1, 36) - 310962453524380.0*pow(xi1, 34) + 236281374337303.0*pow(xi1, 32) - 146432298299480.0*pow(xi1, 30) + 74208765606632.7*pow(xi1, 28) - 30744623546611.0*pow(xi1, 26) + 10382337028640.8*pow(xi1, 24) - 2841593580509.51*pow(xi1, 22) + 624889983293.009*pow(xi1, 20) - 109080673375.912*pow(xi1, 18) + 14868478903.0804*pow(xi1, 16) - 1548160823.61131*pow(xi1, 14) + 119545585.350288*pow(xi1, 12) - 6572312.36046044*pow(xi1, 10) + 242720.226250891*pow(xi1, 8) - 5514.13958011828*pow(xi1, 6) + 66.6245989837762*pow(xi1, 4) - 0.351890487590367*pow(xi1, 2) + 2.27373675443232e-14*pow(xi2, 2)*(6.40086441864344e+24*pow(xi2, 48) - 7.99756973764248e+25*pow(xi2, 46) + 4.69651851199269e+26*pow(xi2, 44) - 1.72297168065566e+27*pow(xi2, 42) + 4.42723968122348e+27*pow(xi2, 40) - 8.46712474605324e+27*pow(xi2, 38) + 1.25028673797001e+28*pow(xi2, 36) - 1.45942619028083e+28*pow(xi2, 34) + 1.36762733380724e+28*pow(xi2, 32) - 1.03917647404303e+28*pow(xi2, 30) + 6.44016058648968e+27*pow(xi2, 28) - 3.26373602669586e+27*pow(xi2, 26) + 1.35216284324378e+27*pow(xi2, 24) - 4.56620011459194e+26*pow(xi2, 22) + 1.24974607327354e+26*pow(xi2, 20) - 2.74829521084565e+25*pow(xi2, 18) + 4.79741874969806e+24*pow(xi2, 16) - 6.53922617651163e+23*pow(xi2, 14) + 6.8088833089116e+22*pow(xi2, 12) - 5.25767044567719e+21*pow(xi2, 10) + 2.89053354468087e+20*pow(xi2, 8) - 1.06749484423711e+19*pow(xi2, 6) + 2.42514423420797e+17*pow(xi2, 4) - 2.930180851143e+15*pow(xi2, 2) + 15476307312375.0);
default:
return 0.;
}
case 25:
switch(j) {
case 0:
return 9.5367431640625e-7*y1t*(-61750730457.0*pow(xi1, 25) + 377365575015.0*pow(xi1, 23) - 1009233514575.0*pow(xi1, 21) + 1550773449225.0*pow(xi1, 19) - 1511010027450.0*pow(xi1, 17) + 971946990630.0*pow(xi1, 15) - 416548710270.0*pow(xi1, 13) + 117210676050.0*pow(xi1, 11) - 20795442525.0*pow(xi1, 9) + 2151252675.0*pow(xi1, 7) - 111546435.0*pow(xi1, 5) + 2028117.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-20583576819.0*pow(xi2, 22) + 125788525005.0*pow(xi2, 20) - 336411171525.0*pow(xi2, 18) + 516924483075.0*pow(xi2, 16) - 503670009150.0*pow(xi2, 14) + 323982330210.0*pow(xi2, 12) - 138849570090.0*pow(xi2, 10) + 39070225350.0*pow(xi2, 8) - 6931814175.0*pow(xi2, 6) + 717084225.0*pow(xi2, 4) - 37182145.0*pow(xi2, 2) + 676039.0));
case 1:
return 5.96046447753906e-8*y1r*(-494005843656.0*pow(xi1, 25) + 171529806825.0*pow(xi1, 24) + 3018924600120.0*pow(xi1, 23) - 1052049481860.0*pow(xi1, 22) - 8073868116600.0*pow(xi1, 21) + 2825853840810.0*pow(xi1, 20) + 12406187593800.0*pow(xi1, 19) - 4365140079300.0*pow(xi1, 18) - 12088080219600.0*pow(xi1, 17) + 4281195077775.0*pow(xi1, 16) + 7775575925040.0*pow(xi1, 15) - 2776991401800.0*pow(xi1, 14) - 3332389682160.0*pow(xi1, 13) + 1203362940780.0*pow(xi1, 12) + 937685408400.0*pow(xi1, 11) - 343817983080.0*pow(xi1, 10) - 166363540200.0*pow(xi1, 9) + 62386327575.0*pow(xi1, 8) + 17210021400.0*pow(xi1, 7) - 6692786100.0*pow(xi1, 6) - 892371480.0*pow(xi1, 5) + 371821450.0*pow(xi1, 4) + 16224936.0*pow(xi1, 3) - 8112468.0*pow(xi1, 2) + pow(xi2, 2)*(494005843656.0*pow(xi2, 23) - 171529806825.0*pow(xi2, 22) - 3018924600120.0*pow(xi2, 21) + 1052049481860.0*pow(xi2, 20) + 8073868116600.0*pow(xi2, 19) - 2825853840810.0*pow(xi2, 18) - 12406187593800.0*pow(xi2, 17) + 4365140079300.0*pow(xi2, 16) + 12088080219600.0*pow(xi2, 15) - 4281195077775.0*pow(xi2, 14) - 7775575925040.0*pow(xi2, 13) + 2776991401800.0*pow(xi2, 12) + 3332389682160.0*pow(xi2, 11) - 1203362940780.0*pow(xi2, 10) - 937685408400.0*pow(xi2, 9) + 343817983080.0*pow(xi2, 8) + 166363540200.0*pow(xi2, 7) - 62386327575.0*pow(xi2, 6) - 17210021400.0*pow(xi2, 5) + 6692786100.0*pow(xi2, 4) + 892371480.0*pow(xi2, 3) - 371821450.0*pow(xi2, 2) - 16224936.0*xi2 + 8112468.0));
case 2:
return 9.5367431640625e-7*y2t*(61750730457.0*pow(xi1, 25) - 377365575015.0*pow(xi1, 23) + 1009233514575.0*pow(xi1, 21) - 1550773449225.0*pow(xi1, 19) + 1511010027450.0*pow(xi1, 17) - 971946990630.0*pow(xi1, 15) + 416548710270.0*pow(xi1, 13) - 117210676050.0*pow(xi1, 11) + 20795442525.0*pow(xi1, 9) - 2151252675.0*pow(xi1, 7) + 111546435.0*pow(xi1, 5) - 2028117.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-20583576819.0*pow(xi2, 22) + 125788525005.0*pow(xi2, 20) - 336411171525.0*pow(xi2, 18) + 516924483075.0*pow(xi2, 16) - 503670009150.0*pow(xi2, 14) + 323982330210.0*pow(xi2, 12) - 138849570090.0*pow(xi2, 10) + 39070225350.0*pow(xi2, 8) - 6931814175.0*pow(xi2, 6) + 717084225.0*pow(xi2, 4) - 37182145.0*pow(xi2, 2) + 676039.0));
case 3:
return 5.96046447753906e-8*y2r*(-494005843656.0*pow(xi1, 25) - 171529806825.0*pow(xi1, 24) + 3018924600120.0*pow(xi1, 23) + 1052049481860.0*pow(xi1, 22) - 8073868116600.0*pow(xi1, 21) - 2825853840810.0*pow(xi1, 20) + 12406187593800.0*pow(xi1, 19) + 4365140079300.0*pow(xi1, 18) - 12088080219600.0*pow(xi1, 17) - 4281195077775.0*pow(xi1, 16) + 7775575925040.0*pow(xi1, 15) + 2776991401800.0*pow(xi1, 14) - 3332389682160.0*pow(xi1, 13) - 1203362940780.0*pow(xi1, 12) + 937685408400.0*pow(xi1, 11) + 343817983080.0*pow(xi1, 10) - 166363540200.0*pow(xi1, 9) - 62386327575.0*pow(xi1, 8) + 17210021400.0*pow(xi1, 7) + 6692786100.0*pow(xi1, 6) - 892371480.0*pow(xi1, 5) - 371821450.0*pow(xi1, 4) + 16224936.0*pow(xi1, 3) + 8112468.0*pow(xi1, 2) + pow(xi2, 2)*(494005843656.0*pow(xi2, 23) + 171529806825.0*pow(xi2, 22) - 3018924600120.0*pow(xi2, 21) - 1052049481860.0*pow(xi2, 20) + 8073868116600.0*pow(xi2, 19) + 2825853840810.0*pow(xi2, 18) - 12406187593800.0*pow(xi2, 17) - 4365140079300.0*pow(xi2, 16) + 12088080219600.0*pow(xi2, 15) + 4281195077775.0*pow(xi2, 14) - 7775575925040.0*pow(xi2, 13) - 2776991401800.0*pow(xi2, 12) + 3332389682160.0*pow(xi2, 11) + 1203362940780.0*pow(xi2, 10) - 937685408400.0*pow(xi2, 9) - 343817983080.0*pow(xi2, 8) + 166363540200.0*pow(xi2, 7) + 62386327575.0*pow(xi2, 6) - 17210021400.0*pow(xi2, 5) - 6692786100.0*pow(xi2, 4) + 892371480.0*pow(xi2, 3) + 371821450.0*pow(xi2, 2) - 16224936.0*xi2 - 8112468.0));
case 4:
return -56625.0823616982*pow(xi1, 26) + 365336.642496586*pow(xi1, 24) - 1044145.05877018*pow(xi1, 22) + 1741854.19737339*pow(xi1, 20) - 1881320.51070929*pow(xi1, 18) + 1379346.55040503*pow(xi1, 16) - 699919.84957695*pow(xi1, 14) + 245917.784986496*pow(xi1, 12) - 58835.1689887047*pow(xi1, 10) + 9232.17490911484*pow(xi1, 8) - 886.491417884827*pow(xi1, 6) + 45.7751932144165*pow(xi1, 4) - 0.967081546783447*pow(xi1, 2) + 4.76837158203125e-7*pow(xi2, 2)*(118751404725.0*pow(xi2, 24) - 766166470485.0*pow(xi2, 22) + 2189730898290.0*pow(xi2, 20) - 3652933013730.0*pow(xi2, 18) + 3945415071675.0*pow(xi2, 16) - 2892699376875.0*pow(xi2, 14) + 1467838312380.0*pow(xi2, 12) - 515726974620.0*pow(xi2, 10) + 123386292315.0*pow(xi2, 8) - 19361274075.0*pow(xi2, 6) + 1859107250.0*pow(xi2, 4) - 95997538.0*pow(xi2, 2) + 2028117.0);
case 5:
return -90879.7618150711*pow(xi1, 27) + 610711.999397278*pow(xi1, 25) - 1824527.45999336*pow(xi1, 23) + 3192616.85771942*pow(xi1, 21) - 3627809.54024792*pow(xi1, 19) + 2804130.39894104*pow(xi1, 17) - 1500729.04684067*pow(xi1, 15) + 554891.412277222*pow(xi1, 13) - 138824.556040764*pow(xi1, 11) + 22491.5536880493*pow(xi1, 9) - 2178.23605537415*pow(xi1, 7) + 108.313133239746*pow(xi1, 5) - 1.93416309356689*pow(xi1, 3) + 9.5367431640625e-7*pow(xi2, 3)*(95294337125.0*pow(xi2, 24) - 640377945480.0*pow(xi2, 22) + 1913155705890.0*pow(xi2, 20) - 3347701414200.0*pow(xi2, 18) + 3804034016475.0*pow(xi2, 16) - 2940343837200.0*pow(xi2, 14) + 1573628461020.0*pow(xi2, 12) - 581845817520.0*pow(xi2, 10) + 145568097675.0*pow(xi2, 8) - 23584103400.0*pow(xi2, 6) + 2284046050.0*pow(xi2, 4) - 113574552.0*pow(xi2, 2) + 2028117.0);
case 6:
return -153359.598062932*pow(xi1, 28) + 1070109.19537246*pow(xi1, 26) - 3333887.07623631*pow(xi1, 24) + 6116230.13594985*pow(xi1, 22) - 7337624.0086922*pow(xi1, 20) + 6045594.79239285*pow(xi1, 18) - 3496643.50527674*pow(xi1, 16) + 1426638.4321332*pow(xi1, 14) - 407136.064055264*pow(xi1, 12) + 79550.5738002062*pow(xi1, 10) - 10259.5551416278*pow(xi1, 8) + 822.825216054916*pow(xi1, 6) - 36.8699839711189*pow(xi1, 4) + 0.725311160087585*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(2572947102375.0*pow(xi2, 26) - 17953453114350.0*pow(xi2, 24) + 55933343597625.0*pow(xi2, 22) - 102613314096540.0*pow(xi2, 20) + 123104902920615.0*pow(xi2, 18) - 101428249680450.0*pow(xi2, 16) + 58663943363025.0*pow(xi2, 14) - 23935021129800.0*pow(xi2, 12) + 6830609688045.0*pow(xi2, 10) - 1334637159570.0*pow(xi2, 8) + 172126772675.0*pow(xi2, 6) - 13804716380.0*pow(xi2, 4) + 618575685.0*pow(xi2, 2) - 12168702.0);
case 7:
return -266528.404909372*pow(xi1, 29) + 1927559.74809766*pow(xi1, 27) - 6249526.46725416*pow(xi1, 25) + 11990174.723804*pow(xi1, 23) - 15132877.5010765*pow(xi1, 21) + 13211577.6992261*pow(xi1, 19) - 8167029.78691578*pow(xi1, 17) + 3597335.80345631*pow(xi1, 15) - 1120385.35932899*pow(xi1, 13) + 241233.31105113*pow(xi1, 11) - 34408.5311770439*pow(xi1, 9) + 3012.09060621262*pow(xi1, 7) - 139.743283510208*pow(xi1, 5) + 2.41770386695862*pow(xi1, 3) + 2.38418579101563e-7*pow(xi2, 3)*(1117901154825.0*pow(xi2, 26) - 8084771561685.0*pow(xi2, 24) + 26212413859710.0*pow(xi2, 22) - 50290437804750.0*pow(xi2, 20) + 63471888634275.0*pow(xi2, 18) - 55413373190175.0*pow(xi2, 16) + 34255005703380.0*pow(xi2, 14) - 15088319949780.0*pow(xi2, 12) + 4699236794175.0*pow(xi2, 10) - 1011805841475.0*pow(xi2, 8) + 144319839950.0*pow(xi2, 6) - 12633623678.0*pow(xi2, 4) + 586125813.0*pow(xi2, 2) - 10140585.0);
case 8:
return -472347.562033832*pow(xi1, 30) + 3535449.9340108*pow(xi1, 28) - 11908551.1147007*pow(xi1, 26) + 23844310.0991026*pow(xi1, 24) - 31579394.0735087*pow(xi1, 22) + 29124851.166729*pow(xi1, 20) - 19179056.4950797*pow(xi1, 18) + 9096790.49992114*pow(xi1, 16) - 3096188.05515915*pow(xi1, 14) + 744686.034451425*pow(xi1, 12) - 123066.221275628*pow(xi1, 10) + 13381.5246321559*pow(xi1, 8) - 899.184363186359*pow(xi1, 6) + 34.0493294596672*pow(xi1, 4) - 0.604425966739655*pow(xi1, 2) + 5.96046447753906e-8*pow(xi2, 2)*(7924677075315.0*pow(xi2, 28) - 59315007200085.0*pow(xi2, 26) + 199792334298375.0*pow(xi2, 24) - 400041140903625.0*pow(xi2, 22) + 529814315520375.0*pow(xi2, 20) - 488633918992065.0*pow(xi2, 18) + 321771173494155.0*pow(xi2, 16) - 152618819123925.0*pow(xi2, 14) + 51945415778025.0*pow(xi2, 12) - 12493758452175.0*pow(xi2, 10) + 2064708576645.0*pow(xi2, 8) - 224504729163.0*pow(xi2, 6) + 15085810285.0*pow(xi2, 4) - 571252955.0*pow(xi2, 2) + 10140585.0);
case 9:
return -848919.581535459*pow(xi1, 31) + 6567880.38637519*pow(xi1, 29) - 22948968.0209559*pow(xi1, 27) + 47867735.5486178*pow(xi1, 25) - 66374849.7944623*pow(xi1, 23) + 64484380.0577223*pow(xi1, 21) - 45067812.6132363*pow(xi1, 19) + 22900583.7163782*pow(xi1, 17) - 8450156.6509527*pow(xi1, 15) + 2236934.93848443*pow(xi1, 13) - 414545.549288392*pow(xi1, 11) + 51583.1626238823*pow(xi1, 9) - 4013.14664876461*pow(xi1, 7) + 170.367532491684*pow(xi1, 5) - 2.82065451145172*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(7121253593025.0*pow(xi2, 28) - 55095373952190.0*pow(xi2, 26) + 192509896732335.0*pow(xi2, 24) - 401543669365020.0*pow(xi2, 22) + 556792595984625.0*pow(xi2, 20) - 540934186427250.0*pow(xi2, 18) + 378056213429895.0*pow(xi2, 16) - 192104019767880.0*pow(xi2, 14) + 70885051683435.0*pow(xi2, 12) - 18764770320450.0*pow(xi2, 10) + 3477460111125.0*pow(xi2, 8) - 432710930652.0*pow(xi2, 6) + 33664714083.0*pow(xi2, 4) - 1429146446.0*pow(xi2, 2) + 23661365.0);
case 10:
return -1541982.83364839*pow(xi1, 32) + 12317587.3170846*pow(xi1, 30) - 44586072.4801485*pow(xi1, 28) + 96719986.2192655*pow(xi1, 26) - 140131079.561139*pow(xi1, 24) + 143044354.576721*pow(xi1, 22) - 105761285.988215*pow(xi1, 20) + 57334791.4309478*pow(xi1, 18) - 22813482.6754338*pow(xi1, 16) + 6603828.05723269*pow(xi1, 14) - 1364100.44298442*pow(xi1, 12) + 194729.530543976*pow(xi1, 10) - 18292.9027737658*pow(xi1, 8) + 1052.98558730632*pow(xi1, 6) - 33.7597086839378*pow(xi1, 4) + 0.528872720897198*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.31138292075663e+15*pow(xi2, 30) - 2.64518173462514e+16*pow(xi2, 28) + 9.57478615796617e+16*pow(xi2, 26) - 2.07704588840658e+17*pow(xi2, 24) + 3.00929201934133e+17*pow(xi2, 22) - 3.07185412392222e+17*pow(xi2, 20) + 2.27120632251143e+17*pow(xi2, 18) - 1.23125527059451e+17*pow(xi2, 16) + 4.89915809994253e+16*pow(xi2, 14) - 1.41816127671108e+16*pow(xi2, 12) + 2.9293833955386e+15*pow(xi2, 10) - 418178482625904.0*pow(xi2, 8) + 39283709581116.0*pow(xi2, 6) - 2261269330320.0*pow(xi2, 4) + 72498422360.0*pow(xi2, 2) - 1135745520.0);
case 11:
return -2824372.59765901*pow(xi1, 33) + 23270615.010516*pow(xi1, 31) - 87152179.1195009*pow(xi1, 29) + 196325971.199349*pow(xi1, 27) - 296653455.869637*pow(xi1, 25) + 317447154.463163*pow(xi1, 23) - 247577847.014235*pow(xi1, 21) + 142659378.333813*pow(xi1, 19) - 60913376.9486629*pow(xi1, 17) + 19153554.6350793*pow(xi1, 15) - 4366818.15360002*pow(xi1, 13) + 702868.975049034*pow(xi1, 11) - 76565.7097055763*pow(xi1, 9) + 5272.0752735883*pow(xi1, 7) - 202.452477559447*pow(xi1, 5) + 3.17323632538319*pow(xi1, 3) + 1.49011611938477e-8*pow(xi2, 3)*(189540436541625.0*pow(xi2, 30) - 1.56166453793708e+15*pow(xi2, 28) + 5.84868373583423e+15*pow(xi2, 26) - 1.3175212900885e+16*pow(xi2, 24) + 1.99080764250855e+16*pow(xi2, 22) - 2.13035179160554e+16*pow(xi2, 20) + 1.66146680646911e+16*pow(xi2, 18) - 9.57370881892837e+15*pow(xi2, 16) + 4.08782752942856e+15*pow(xi2, 14) - 1.28537329312211e+15*pow(xi2, 12) + 293052205582675.0*pow(xi2, 10) - 47168738456385.0*pow(xi2, 8) + 5138237799695.0*pow(xi2, 6) - 353802982533.0*pow(xi2, 4) + 13586355783.0*pow(xi2, 2) - 212952285.0);
case 12:
return -5208475.34921234*pow(xi1, 34) + 44220260.3040145*pow(xi1, 32) - 171155330.901526*pow(xi1, 30) + 399824691.036655*pow(xi1, 28) - 629011031.974561*pow(xi1, 26) + 704136332.023367*pow(xi1, 24) - 577756105.294866*pow(xi1, 22) + 352685335.281925*pow(xi1, 20) - 160906983.145731*pow(xi1, 18) + 54649403.6016254*pow(xi1, 16) - 13647760.1367895*pow(xi1, 14) + 2451853.86356305*pow(xi1, 12) - 306183.941086113*pow(xi1, 10) + 25228.4376387298*pow(xi1, 8) - 1268.23678471148*pow(xi1, 6) + 34.905599579215*pow(xi1, 4) - 0.475985448807478*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.39813945543058e+15*pow(xi2, 32) - 1.18702857391468e+16*pow(xi2, 30) + 4.59441592973821e+16*pow(xi2, 28) - 1.07327123258484e+17*pow(xi2, 26) + 1.68848863197122e+17*pow(xi2, 24) - 1.8901515737286e+17*pow(xi2, 22) + 1.55090223581611e+17*pow(xi2, 20) - 9.46732488009165e+16*pow(xi2, 18) + 4.31931393943087e+16*pow(xi2, 16) - 1.46698375759304e+16*pow(xi2, 14) + 3.6635427156977e+15*pow(xi2, 12) - 658164509910908.0*pow(xi2, 10) + 82190625845328.0*pow(xi2, 8) - 6772207161720.0*pow(xi2, 6) + 340439719620.0*pow(xi2, 4) - 9369900540.0*pow(xi2, 2) + 127771371.0);
case 13:
return -9659354.2839938*pow(xi1, 35) + 84429911.5193532*pow(xi1, 33) - 337365833.200063*pow(xi1, 31) + 816210188.947362*pow(xi1, 29) - 1334841870.98294*pow(xi1, 27) + 1560174819.29886*pow(xi1, 25) - 1343621210.16899*pow(xi1, 23) + 866316834.161896*pow(xi1, 21) - 420708715.370866*pow(xi1, 19) + 153569378.028978*pow(xi1, 17) - 41730149.5483515*pow(xi1, 15) + 8290584.15095028*pow(xi1, 13) - 1170365.41226014*pow(xi1, 11) + 112417.084816247*pow(xi1, 9) - 6868.09226006269*pow(xi1, 7) + 237.358077138662*pow(xi1, 5) - 3.4905599579215*pow(xi1, 3) + 7.45058059692383e-9*pow(xi2, 3)*(1.29645658594472e+15*pow(xi2, 32) - 1.13319908993686e+16*pow(xi2, 30) + 4.52804756369394e+16*pow(xi2, 28) - 1.09549877130966e+17*pow(xi2, 26) + 1.791594431626e+17*pow(xi2, 24) - 2.09403119529103e+17*pow(xi2, 22) + 1.80337786121493e+17*pow(xi2, 20) - 1.16275077209362e+17*pow(xi2, 18) + 5.64665679268762e+16*pow(xi2, 16) - 2.06117330094225e+16*pow(xi2, 14) + 5.60092586147996e+15*pow(xi2, 12) - 1.11274336853336e+15*pow(xi2, 10) + 157083786563340.0*pow(xi2, 8) - 15088365712420.0*pow(xi2, 6) + 921819738840.0*pow(xi2, 4) - 31857661836.0*pow(xi2, 2) + 468495027.0);
case 14:
return -17999491.2004977*pow(xi1, 36) + 161838903.489692*pow(xi1, 34) - 666946277.861088*pow(xi1, 32) + 1669148486.73721*pow(xi1, 30) - 2833579781.90386*pow(xi1, 28) + 3451915628.97939*pow(xi1, 26) - 3113429207.75544*pow(xi1, 24) + 2114575789.32407*pow(xi1, 22) - 1089335343.24622*pow(xi1, 20) + 425487080.889746*pow(xi1, 18) - 125079149.104517*pow(xi1, 16) + 27265712.6321411*pow(xi1, 14) - 4303799.71730652*pow(xi1, 12) + 474588.083970297*pow(xi1, 10) - 34644.4308966491*pow(xi1, 8) + 1541.66398141533*pow(xi1, 6) - 37.0144795537926*pow(xi1, 4) + 0.436319994740188*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.86536130253887e+16*pow(xi2, 34) - 3.47546398854365e+17*pow(xi2, 32) + 1.43225622580115e+18*pow(xi2, 30) - 3.5844690813521e+18*pow(xi2, 28) + 6.08506624694195e+18*pow(xi2, 26) - 7.41293236750887e+18*pow(xi2, 24) + 6.68603831286041e+18*pow(xi2, 22) - 4.54101693003013e+18*pow(xi2, 20) + 2.33932983680972e+18*pow(xi2, 18) - 9.13726548645982e+17*pow(xi2, 16) + 2.68605427407705e+17*pow(xi2, 14) - 5.85526720285901e+16*pow(xi2, 12) + 9.24233951718277e+15*pow(xi2, 10) - 1.01917014986186e+15*pow(xi2, 8) + 74398348844820.0*pow(xi2, 6) - 3310698190800.0*pow(xi2, 4) + 79487989581.0*pow(xi2, 2) - 936990054.0);
case 15:
return -33678881.6641329*pow(xi1, 37) + 311252740.143991*pow(xi1, 35) - 1321657965.61896*pow(xi1, 33) + 3417770359.80975*pow(xi1, 31) - 6014713509.51296*pow(xi1, 29) + 7624598077.02301*pow(xi1, 27) - 7188030678.28592*pow(xi1, 25) + 5129953639.24709*pow(xi1, 23) - 2794796753.96302*pow(xi1, 21) + 1163525398.80544*pow(xi1, 19) - 368143949.138997*pow(xi1, 17) + 87458596.6151419*pow(xi1, 15) - 15292728.0635515*pow(xi1, 13) + 1910036.75112527*pow(xi1, 11) - 162990.86614944*pow(xi1, 9) + 8880.98183579743*pow(xi1, 7) - 276.045116672292*pow(xi1, 5) + 3.78143995441496*pow(xi1, 3) + 1.86264514923096e-9*pow(xi2, 3)*(1.80812119141631e+16*pow(xi2, 34) - 1.67102542463604e+17*pow(xi2, 32) + 7.09559717353916e+17*pow(xi2, 30) - 1.83490149007763e+18*pow(xi2, 28) + 3.22912472727094e+18*pow(xi2, 26) - 4.09342492324479e+18*pow(xi2, 24) + 3.85904458573534e+18*pow(xi2, 22) - 2.7541228888203e+18*pow(xi2, 20) + 1.50044508215477e+18*pow(xi2, 18) - 6.24662941991839e+17*pow(xi2, 16) + 1.97645777721535e+17*pow(xi2, 14) - 4.69539765270113e+16*pow(xi2, 12) + 8.21022086244688e+15*pow(xi2, 10) - 1.02544317253014e+15*pow(xi2, 8) + 87505054957320.0*pow(xi2, 6) - 4767940817640.0*pow(xi2, 4) + 148200593541.0*pow(xi2, 2) - 2030145117.0);
case 16:
return -63242862.3730616*pow(xi1, 38) + 600312701.027588*pow(xi1, 36) - 2624222778.80029*pow(xi1, 34) + 7004739827.56913*pow(xi1, 32) - 12763068066.1337*pow(xi1, 30) + 16810599588.6806*pow(xi1, 28) - 16534802720.9836*pow(xi1, 26) + 12372295008.3099*pow(xi1, 24) - 7108501413.12895*pow(xi1, 22) + 3143270424.39716*pow(xi1, 20) - 1065643053.90079*pow(xi1, 18) + 274273190.369964*pow(xi1, 16) - 52704628.8232462*pow(xi1, 14) + 7373057.56538108*pow(xi1, 12) - 723594.509931805*pow(xi1, 10) + 47156.4855376538*pow(xi1, 8) - 1875.18906310899*pow(xi1, 6) + 39.8401709483005*pow(xi1, 4) - 0.405154280830175*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(1.35813012798864e+17*pow(xi2, 36) - 1.28916170914346e+18*pow(xi2, 34) + 5.63547550618275e+18*pow(xi2, 32) - 1.50425642381991e+19*pow(xi2, 30) + 2.74084799703331e+19*pow(xi2, 28) - 3.6100487729767e+19*pow(xi2, 26) + 3.55082184662182e+19*pow(xi2, 24) - 2.65693012185776e+19*pow(xi2, 22) + 1.52653905464793e+19*pow(xi2, 20) - 6.75012183763493e+18*pow(xi2, 18) + 2.28845103285674e+18*pow(xi2, 16) - 5.8899719140429e+17*pow(xi2, 14) + 1.13182328571831e+17*pow(xi2, 12) - 1.58335205574186e+16*pow(xi2, 10) + 1.55390737786112e+15*pow(xi2, 8) - 101267781589260.0*pow(xi2, 6) + 4026937849935.0*pow(xi2, 4) - 85556115645.0*pow(xi2, 2) + 870062193.0);
case 17:
return -119134417.666861*pow(xi1, 39) + 1160670487.5222*pow(xi1, 37) - 5219042862.03361*pow(xi1, 35) + 14365665737.576*pow(xi1, 33) - 27069207642.3522*pow(xi1, 31) + 36993518507.7491*pow(xi1, 29) - 37899603270.9539*pow(xi1, 27) + 29671808168.4901*pow(xi1, 25) - 17933533256.272*pow(xi1, 23) + 8396086005.76344*pow(xi1, 21) - 3037766421.81916*pow(xi1, 19) + 842670667.555862*pow(xi1, 17) - 176730598.184079*pow(xi1, 15) + 27431284.8221486*pow(xi1, 13) - 3054473.13668797*pow(xi1, 11) + 233164.102070853*pow(xi1, 9) - 11396.3725418011*pow(xi1, 7) + 319.261573294178*pow(xi1, 5) - 4.05154280830175*pow(xi1, 3) + 9.31322574615479e-10*pow(xi2, 3)*(1.27919606926794e+17*pow(xi2, 36) - 1.24626044633506e+18*pow(xi2, 34) + 5.60390460221414e+18*pow(xi2, 32) - 1.54250161320391e+19*pow(xi2, 30) + 2.9065340388134e+19*pow(xi2, 28) - 3.97214880386883e+19*pow(xi2, 26) + 4.06943891450304e+19*pow(xi2, 24) - 3.18598614242127e+19*pow(xi2, 22) + 1.92559847093541e+19*pow(xi2, 20) - 9.01522870228931e+18*pow(xi2, 18) + 3.26177685865006e+18*pow(xi2, 16) - 9.04810739612729e+17*pow(xi2, 14) + 1.89763034850784e+17*pow(xi2, 12) - 2.94541177995974e+16*pow(xi2, 10) + 3.27971555714634e+15*pow(xi2, 8) - 250358048248880.0*pow(xi2, 6) + 12236761840017.0*pow(xi2, 4) - 342804504042.0*pow(xi2, 2) + 4350310965.0);
case 18:
return -225052360.873805*pow(xi1, 40) + 2248910330.16548*pow(xi1, 38) - 10393802715.0371*pow(xi1, 36) + 29475054534.4272*pow(xi1, 34) - 57374577463.9329*pow(xi1, 32) + 81251153683.8055*pow(xi1, 30) - 86567901261.2371*pow(xi1, 28) + 70779385557.1236*pow(xi1, 26) - 44897488059.1497*pow(xi1, 24) + 22192208682.0584*pow(xi1, 22) - 8538204843.03323*pow(xi1, 20) + 2541010647.06651*pow(xi1, 18) - 578145679.079641*pow(xi1, 16) + 98762409.9830697*pow(xi1, 14) - 12337113.0280166*pow(xi1, 12) + 1084949.75604712*pow(xi1, 10) - 63529.6180163226*pow(xi1, 8) + 2273.46416187924*pow(xi1, 6) - 43.2375584073452*pow(xi1, 4) + 0.379832138278289*pow(xi1, 2) + 7.27595761418343e-12*pow(xi2, 2)*(3.09309609548987e+19*pow(xi2, 38) - 3.09087882230314e+20*pow(xi2, 36) + 1.42851336774913e+21*pow(xi2, 34) - 4.0510206487418e+21*pow(xi2, 32) + 7.88550188254113e+21*pow(xi2, 30) - 1.11670735306949e+22*pow(xi2, 28) + 1.18978017536119e+22*pow(xi2, 26) - 9.72784467836226e+21*pow(xi2, 24) + 6.17066377237116e+21*pow(xi2, 22) - 3.05007393649434e+21*pow(xi2, 20) + 1.17348193815605e+21*pow(xi2, 18) - 3.4923384409403e+20*pow(xi2, 16) + 7.94597370870647e+19*pow(xi2, 14) - 1.35738022704457e+19*pow(xi2, 12) + 1.69559990343638e+18*pow(xi2, 10) - 1.49114359040817e+17*pow(xi2, 8) + 8.73144421463929e+15*pow(xi2, 6) - 312462535164780.0*pow(xi2, 4) + 5942524778190.0*pow(xi2, 2) - 52203731580.0);
case 19:
return -426211070.808355*pow(xi1, 41) + 4365721614.85918*pow(xi1, 39) - 20723298178.1831*pow(xi1, 37) + 60493571748.5145*pow(xi1, 35) - 121519831214.533*pow(xi1, 33) + 178111895896.725*pow(xi1, 31) - 197066396253.507*pow(xi1, 29) + 167976778695.129*pow(xi1, 27) - 111594197200.571*pow(xi1, 25) + 58084613149.5716*pow(xi1, 23) - 23687115110.1917*pow(xi1, 21) + 7532016460.0326*pow(xi1, 19) - 1849367958.92472*pow(xi1, 17) + 345268929.319048*pow(xi1, 15) - 47924000.009509*pow(xi1, 13) + 4789415.46284829*pow(xi1, 11) - 329068.299702693*pow(xi1, 9) + 14508.7363759144*pow(xi1, 7) - 367.62686556828*pow(xi1, 5) + 4.30476423382061*pow(xi1, 3) + 5.82076609134674e-11*pow(xi2, 3)*(7.32225044126009e+18*pow(xi2, 38) - 7.50025262370419e+19*pow(xi2, 36) + 3.56023551762212e+20*pow(xi2, 34) - 1.0392716491124e+21*pow(xi2, 32) + 2.08769480352744e+21*pow(xi2, 30) - 3.05993907161996e+21*pow(xi2, 28) + 3.38557490819755e+21*pow(xi2, 26) - 2.88581908393203e+21*pow(xi2, 24) + 1.91717370959931e+21*pow(xi2, 22) - 9.97886055512886e+20*pow(xi2, 20) + 4.06941538939444e+20*pow(xi2, 18) - 1.29399057475095e+20*pow(xi2, 16) + 3.17718996074078e+19*pow(xi2, 14) - 5.93167503900098e+18*pow(xi2, 12) + 8.2332805093738e+17*pow(xi2, 10) - 8.22815311195605e+16*pow(xi2, 8) + 5.65335034149357e+15*pow(xi2, 6) - 249258192963351.0*pow(xi2, 4) + 6315781458987.0*pow(xi2, 2) - 73955286405.0);
case 20:
return -809011754.775118*pow(xi1, 42) + 8489230013.44023*pow(xi1, 40) - 41358870195.9563*pow(xi1, 38) + 124175359033.23*pow(xi1, 36) - 257176448649.812*pow(xi1, 34) + 389693015951.955*pow(xi1, 32) - 447149038103.796*pow(xi1, 30) + 396715033466.757*pow(xi1, 28) - 275490194373.394*pow(xi1, 26) + 150639557207.264*pow(xi1, 24) - 64924029426.9716*pow(xi1, 22) + 21977168312.6472*pow(xi1, 20) - 5796059239.39062*pow(xi1, 18) + 1175422960.42417*pow(xi1, 16) - 179805053.890068*pow(xi1, 14) + 20188407.4579259*pow(xi1, 12) - 1600544.29407977*pow(xi1, 10) + 84685.1976549923*pow(xi1, 8) - 2742.85227764936*pow(xi1, 6) + 47.1132530034811*pow(xi1, 4) - 0.358730352818384*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(5.55948644614192e+19*pow(xi2, 40) - 5.83375444415159e+20*pow(xi2, 38) + 2.84215991825826e+21*pow(xi2, 36) - 8.53326569626849e+21*pow(xi2, 34) + 1.76730309800379e+22*pow(xi2, 32) - 2.67795001438921e+22*pow(xi2, 30) + 3.07278479214986e+22*pow(xi2, 28) - 2.72620495131403e+22*pow(xi2, 26) + 1.89315420032385e+22*pow(xi2, 24) - 1.03518715470259e+22*pow(xi2, 22) + 4.46154532981416e+21*pow(xi2, 20) - 1.51025950658411e+21*pow(xi2, 18) + 3.98302158061782e+20*pow(xi2, 16) - 8.07744507838293e+19*pow(xi2, 14) + 1.23561092178138e+19*pow(xi2, 12) - 1.38733679664182e+18*pow(xi2, 10) + 1.09988566381952e+17*pow(xi2, 8) - 5.8195224701358e+15*pow(xi2, 6) + 188487373284210.0*pow(xi2, 4) - 3237598093730.0*pow(xi2, 2) + 24651762135.0);
case 21:
return -1538805712.26503*pow(xi1, 43) + 16532226174.7729*pow(xi1, 41) - 82611751780.2235*pow(xi1, 39) + 254912225915.977*pow(xi1, 37) - 543817928726.357*pow(xi1, 35) + 851003685212.995*pow(xi1, 33) - 1011412343303.2*pow(xi1, 31) + 932605142497.08*pow(xi1, 29) - 675747137296.369*pow(xi1, 27) + 387337506400.648*pow(xi1, 25) - 175961532717.34*pow(xi1, 23) + 63200085370.9558*pow(xi1, 21) - 17828601337.3*pow(xi1, 19) + 3906368383.90736*pow(xi1, 17) - 653900452.039292*pow(xi1, 15) + 81691776.9779117*pow(xi1, 13) - 7370840.43279175*pow(xi1, 11) + 458338.497413532*pow(xi1, 9) - 18323.4134511531*pow(xi1, 7) + 421.675572059583*pow(xi1, 5) - 4.5439178023662*pow(xi1, 3) + 2.91038304567337e-11*pow(xi2, 3)*(5.28729616726104e+19*pow(xi2, 40) - 5.68042966005799e+20*pow(xi2, 38) + 2.83851817729064e+21*pow(xi2, 36) - 8.75871738927749e+21*pow(xi2, 34) + 1.86854417508653e+22*pow(xi2, 32) - 2.92402639741223e+22*pow(xi2, 30) + 3.47518634980638e+22*pow(xi2, 28) - 3.2044068696851e+22*pow(xi2, 26) + 2.32184948404282e+22*pow(xi2, 24) - 1.33088153800398e+22*pow(xi2, 22) + 6.04599222700007e+21*pow(xi2, 20) - 2.17153839818131e+21*pow(xi2, 18) + 6.12586077417003e+20*pow(xi2, 16) - 1.34221795640084e+20*pow(xi2, 14) + 2.2467848450787e+19*pow(xi2, 12) - 2.80690808377805e+18*pow(xi2, 10) + 2.53260148823e+17*pow(xi2, 8) - 1.57483908551112e+16*pow(xi2, 6) + 629587692190314.0*pow(xi2, 4) - 14488662332144.0*pow(xi2, 2) + 156127826855.0);
case 22:
return -2932474067.5778*pow(xi1, 44) + 32238834564.0148*pow(xi1, 42) - 165130361584.918*pow(xi1, 40) + 523288745102.942*pow(xi1, 38) - 1148954747625.29*pow(xi1, 36) + 1854967248083.68*pow(xi1, 34) - 2280829494925.56*pow(xi1, 32) + 2182752279805.6*pow(xi1, 30) - 1647525238173.91*pow(xi1, 28) + 987973509155.938*pow(xi1, 26) - 471935693612.43*pow(xi1, 24) + 179316168680.198*pow(xi1, 22) - 53905793874.3631*pow(xi1, 20) + 12700484717.7838*pow(xi1, 18) - 2312063576.2873*pow(xi1, 16) + 318735268.794855*pow(xi1, 14) - 32354364.3586448*pow(xi1, 12) + 2324901.14233653*pow(xi1, 10) - 111715.261973273*pow(xi1, 8) + 3290.93246836372*pow(xi1, 6) - 51.4030701392676*pow(xi1, 4) + 0.340793835177465*pow(xi1, 2) + 1.81898940354586e-12*pow(xi2, 2)*(1.61214466772669e+21*pow(xi2, 42) - 1.77234867345406e+22*pow(xi2, 40) + 9.07813763307364e+22*pow(xi2, 38) - 2.87681029962498e+23*pow(xi2, 36) + 6.31644552401221e+23*pow(xi2, 34) - 1.01977902920583e+24*pow(xi2, 32) + 1.25389927532256e+24*pow(xi2, 30) - 1.19998075610042e+24*pow(xi2, 28) + 9.05736578213321e+23*pow(xi2, 26) - 5.43144180625806e+23*pow(xi2, 24) + 2.59449391344699e+23*pow(xi2, 22) - 9.85801062560599e+22*pow(xi2, 20) + 2.96350235846792e+22*pow(xi2, 18) - 6.98216531279734e+21*pow(xi2, 16) + 1.27107039314262e+21*pow(xi2, 14) - 1.75226567111126e+20*pow(xi2, 12) + 1.77869999108157e+19*pow(xi2, 10) - 1.27812791971436e+18*pow(xi2, 8) + 6.14161147698277e+16*pow(xi2, 6) - 1.80920925759574e+15*pow(xi2, 4) + 28259136660755.0*pow(xi2, 2) - 187353392226.0);
case 23:
return -5598077479.27021*pow(xi1, 45) + 62944237023.0138*pow(xi1, 43) - 330278999375.818*pow(xi1, 41) + 1074140453307.64*pow(xi1, 39) - 2425343957107.78*pow(xi1, 37) + 4036050195832.79*pow(xi1, 35) - 5128586911375.06*pow(xi1, 33) + 5087344019982.91*pow(xi1, 31) - 3993875133123.08*pow(xi1, 29) + 2501028597707.71*pow(xi1, 27) - 1253435191838.01*pow(xi1, 25) + 502454428984.502*pow(xi1, 23) - 160423552908.796*pow(xi1, 21) + 40470742430.8232*pow(xi1, 19) - 7968848617.85145*pow(xi1, 17) + 1203568825.07947*pow(xi1, 15) - 136110656.698573*pow(xi1, 13) + 11146295.9461998*pow(xi1, 11) - 630389.076516768*pow(xi1, 9) + 22958.1446964552*pow(xi1, 7) - 481.882482940935*pow(xi1, 5) + 4.77111369248451*pow(xi1, 3) + 7.27595761418343e-12*pow(xi2, 3)*(7.69393910206069e+20*pow(xi2, 42) - 8.65099006353653e+21*pow(xi2, 40) + 4.53932000279918e+22*pow(xi2, 38) - 1.47628739784542e+23*pow(xi2, 36) + 3.33336735274533e+23*pow(xi2, 34) - 5.54710515075719e+23*pow(xi2, 32) + 7.04867617889585e+23*pow(xi2, 30) - 6.99199238058489e+23*pow(xi2, 28) + 5.48914018594281e+23*pow(xi2, 26) - 3.43738753072491e+23*pow(xi2, 24) + 1.72270821011192e+23*pow(xi2, 22) - 6.90568108870013e+22*pow(xi2, 20) + 2.2048445224045e+22*pow(xi2, 18) - 5.5622564859272e+21*pow(xi2, 16) + 1.0952302144143e+21*pow(xi2, 14) - 1.65417239750448e+20*pow(xi2, 12) + 1.87069062130385e+19*pow(xi2, 10) - 1.5319352499349e+18*pow(xi2, 8) + 8.66400149566451e+16*pow(xi2, 6) - 3.15534338073955e+15*pow(xi2, 4) + 66229424151891.0*pow(xi2, 2) - 655736872791.0);
case 24:
return -10703833915.403*pow(xi1, 46) + 123030475510.325*pow(xi1, 44) - 660948623360.421*pow(xi1, 42) + 2204594368100.28*pow(xi1, 40) - 5115199347309.37*pow(xi1, 38) + 8766244108501.35*pow(xi1, 36) - 11499881607450.5*pow(xi1, 34) + 11809867896629.5*pow(xi1, 32) - 9629539738306.08*pow(xi1, 30) + 6286427016209.27*pow(xi1, 28) - 3298734907736.02*pow(xi1, 26) + 1391634507284.73*pow(xi1, 24) - 470468054146.476*pow(xi1, 22) + 126602340893.671*pow(xi1, 20) - 26833362532.7568*pow(xi1, 18) + 4412372880.13861*pow(xi1, 16) - 551279305.585031*pow(xi1, 14) + 50854158.3368599*pow(xi1, 12) - 3328135.51137573*pow(xi1, 10) + 145900.940711039*pow(xi1, 8) - 3926.22897610704*pow(xi1, 6) + 56.0605858866929*pow(xi1, 4) - 0.325303206305762*pow(xi1, 2) + 1.81898940354586e-12*pow(xi2, 2)*(5.88449492588436e+21*pow(xi2, 44) - 6.76367191972063e+22*pow(xi2, 42) + 3.63360348373661e+23*pow(xi2, 40) - 1.21198857112787e+24*pow(xi2, 38) + 2.81211058037943e+24*pow(xi2, 36) - 4.81929366461004e+24*pow(xi2, 34) + 6.32212677271958e+24*pow(xi2, 32) - 6.49254353742134e+24*pow(xi2, 30) + 5.2938954561993e+24*pow(xi2, 28) - 3.45599980074364e+24*pow(xi2, 26) + 1.81349869400317e+24*pow(xi2, 24) - 7.65059161186943e+23*pow(xi2, 22) + 2.586425480156e+23*pow(xi2, 20) - 6.96003729581259e+22*pow(xi2, 18) + 1.47517970585475e+22*pow(xi2, 16) - 2.42572764389794e+21*pow(xi2, 14) + 3.0306900332151e+20*pow(xi2, 12) - 2.79573692060696e+19*pow(xi2, 10) + 1.82966184678592e+18*pow(xi2, 8) - 8.0209890407622e+16*pow(xi2, 6) + 2.15846720627038e+15*pow(xi2, 4) - 30819633021177.0*pow(xi2, 2) + 178837328943.0);
case 25:
return -20496703242.2611*pow(xi1, 47) + 240717331608.619*pow(xi1, 45) - 1323294384605.63*pow(xi1, 43) + 4524052513274.11*pow(xi1, 41) - 10778822065593.1*pow(xi1, 39) + 19007691465167.9*pow(xi1, 37) - 25717487590298.7*pow(xi1, 35) + 27311678351521.5*pow(xi1, 33) - 23098804022919.4*pow(xi1, 31) + 15695637744162.2*pow(xi1, 29) - 8607296021078.13*pow(xi1, 27) + 3812790649353.76*pow(xi1, 25) - 1361068647771.59*pow(xi1, 23) + 389353598857.489*pow(xi1, 21) - 88448041161.5952*pow(xi1, 19) + 15747462549.2999*pow(xi1, 17) - 2157923695.05738*pow(xi1, 15) + 222036432.500656*pow(xi1, 13) - 16581283.000393*pow(xi1, 11) + 856721.622252628*pow(xi1, 9) - 28544.3236447391*pow(xi1, 7) + 548.678074635718*pow(xi1, 5) - 4.98798249668835*pow(xi1, 3) + 7.74038044062067e-14*pow(xi2, 3)*(2.64802271664796e+23*pow(xi2, 44) - 3.10989018505293e+24*pow(xi2, 42) + 1.70959863634238e+25*pow(xi2, 40) - 5.8447418030416e+25*pow(xi2, 38) + 1.39254422289465e+26*pow(xi2, 36) - 2.45565338951787e+26*pow(xi2, 34) + 3.32250950551942e+26*pow(xi2, 32) - 3.52846718078518e+26*pow(xi2, 30) + 2.98419492428298e+26*pow(xi2, 28) - 2.02776050409528e+26*pow(xi2, 26) + 1.11199909191905e+26*pow(xi2, 24) - 4.92584399255708e+25*pow(xi2, 22) + 1.7584001952008e+25*pow(xi2, 20) - 5.03016100880784e+24*pow(xi2, 18) + 1.14268338410641e+24*pow(xi2, 16) - 2.03445588625837e+23*pow(xi2, 14) + 2.7878780786185e+22*pow(xi2, 12) - 2.86854676206137e+21*pow(xi2, 10) + 2.14217933182926e+20*pow(xi2, 8) - 1.10682107788481e+19*pow(xi2, 6) + 3.68771585114107e+17*pow(xi2, 4) - 7.08851559487071e+15*pow(xi2, 2) + 64441050862461.0);
case 26:
return -39303140158.1204*pow(xi1, 48) + 471414685357.541*pow(xi1, 46) - 2650459083811.01*pow(xi1, 44) + 9282069011156.13*pow(xi1, 42) - 22693549650921.2*pow(xi1, 40) + 41145898780126.6*pow(xi1, 38) - 57365413435046.9*pow(xi1, 36) + 62932990858132.5*pow(xi1, 34) - 55139349262126.3*pow(xi1, 32) + 38941023145450.4*pow(xi1, 30) - 22278448882718.6*pow(xi1, 28) + 10340821294578.2*pow(xi1, 26) - 3888016417121.97*pow(xi1, 24) + 1178690980057.69*pow(xi1, 22) - 285877453267.485*pow(xi1, 20) + 54840820984.8424*pow(xi1, 18) - 8190337044.02725*pow(xi1, 16) + 932072013.857978*pow(xi1, 14) - 78500941.0145018*pow(xi1, 12) + 4699435.057622*pow(xi1, 10) - 188733.622760158*pow(xi1, 8) + 4658.04823779281*pow(xi1, 6) - 61.0508274334251*pow(xi1, 4) + 0.311748906043022*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(1.38285630758283e+24*pow(xi2, 46) - 1.65864296977594e+25*pow(xi2, 44) + 9.32547386110312e+25*pow(xi2, 42) - 3.26583769842734e+26*pow(xi2, 40) + 7.98458294934394e+26*pow(xi2, 38) - 1.44769261260939e+27*pow(xi2, 36) + 2.01836605132837e+27*pow(xi2, 34) - 2.2142577670156e+27*pow(xi2, 32) + 1.94004338117471e+27*pow(xi2, 30) - 1.37011544786935e+27*pow(xi2, 28) + 7.83853235051596e+26*pow(xi2, 26) - 3.63835304132558e+26*pow(xi2, 24) + 1.36797416307507e+26*pow(xi2, 22) - 4.14715020200997e+25*pow(xi2, 20) + 1.00584186875709e+25*pow(xi2, 18) - 1.92953985118772e+24*pow(xi2, 16) + 2.88171866089999e+23*pow(xi2, 14) - 3.27943685491661e+22*pow(xi2, 12) + 2.76200631797769e+21*pow(xi2, 10) - 1.65346671674674e+20*pow(xi2, 8) + 6.64047400886665e+18*pow(xi2, 6) - 1.63890502406231e+17*pow(xi2, 4) + 2.1480350287487e+15*pow(xi2, 2) - 10968689508504.0);
case 27:
return -75462029103.5913*pow(xi1, 49) + 923990623023.973*pow(xi1, 47) - 5310546224741.19*pow(xi1, 45) + 19040128213834.7*pow(xi1, 43) - 47737585354992.4*pow(xi1, 41) + 88925785622554.7*pow(xi1, 39) - 127644777643775.0*pow(xi1, 37) + 144513202680571.0*pow(xi1, 35) - 131017392602932.0*pow(xi1, 33) + 96037179634663.5*pow(xi1, 31) - 57227856189002.6*pow(xi1, 29) + 27780346890298.2*pow(xi1, 27) - 10975970713836.3*pow(xi1, 25) + 3516415252299.31*pow(xi1, 23) - 907417367669.162*pow(xi1, 21) + 186740865006.986*pow(xi1, 19) - 30226326970.8981*pow(xi1, 17) + 3776677151.27261*pow(xi1, 15) - 355181293.097636*pow(xi1, 13) + 24291570.510322*pow(xi1, 11) - 1151268.66901578*pow(xi1, 9) + 35228.0717384415*pow(xi1, 7) - 622.4586490659*pow(xi1, 5) + 5.19581510071703*pow(xi1, 3) + 4.54747350886464e-13*pow(xi2, 3)*(1.65942756909939e+23*pow(xi2, 46) - 2.0318768679417e+24*pow(xi2, 44) + 1.16780146478898e+25*pow(xi2, 42) - 4.18696847309143e+25*pow(xi2, 40) + 1.04976060359527e+26*pow(xi2, 38) - 1.95549870602229e+26*pow(xi2, 36) + 2.80693834488425e+26*pow(xi2, 34) - 3.17787893428876e+26*pow(xi2, 32) + 2.88110293215634e+26*pow(xi2, 30) - 2.1118799141425e+26*pow(xi2, 28) + 1.25845386625002e+26*pow(xi2, 26) - 6.10896288590674e+25*pow(xi2, 24) + 2.41364148519837e+25*pow(xi2, 22) - 7.73267891598393e+24*pow(xi2, 20) + 1.99543189399627e+24*pow(xi2, 18) - 4.10647504912259e+23*pow(xi2, 16) + 6.64683959389236e+22*pow(xi2, 14) - 8.30500088436035e+21*pow(xi2, 12) + 7.81051923458733e+20*pow(xi2, 10) - 5.34177284660791e+19*pow(xi2, 8) + 2.53166657655409e+18*pow(xi2, 6) - 7.7467349001087e+16*pow(xi2, 4) + 1.3688010449154e+15*pow(xi2, 2) - 11425718238025.0);
case 28:
return -145061239022.98*pow(xi1, 50) + 1812475393892.79*pow(xi1, 48) - 10643670964834.6*pow(xi1, 46) + 39047645249241.0*pow(xi1, 44) - 100334673478941.0*pow(xi1, 42) + 191891285821329.0*pow(xi1, 40) - 283354553901745.0*pow(xi1, 38) + 330753139825173.0*pow(xi1, 36) - 309949450203787.0*pow(xi1, 34) + 235512332226087.0*pow(xi1, 32) - 145956111105926.0*pow(xi1, 30) + 73967653689345.7*pow(xi1, 28) - 30644817310084.5*pow(xi1, 26) + 10348661764776.1*pow(xi1, 24) - 2832384684974.48*pow(xi1, 22) + 622866586202.908*pow(xi1, 20) - 108727766937.923*pow(xi1, 18) + 14820415476.7655*pow(xi1, 16) - 1543160445.53304*pow(xi1, 14) + 119159786.412311*pow(xi1, 12) - 6551119.55186054*pow(xi1, 10) + 241938.202705073*pow(xi1, 8) - 5496.37302038927*pow(xi1, 6) + 66.3465620553097*pow(xi1, 4) - 0.299758563502905*pow(xi1, 2) + 1.13686837721616e-13*pow(xi2, 2)*(1.27597215236289e+24*pow(xi2, 48) - 1.59427021651441e+25*pow(xi2, 46) + 9.36227199044597e+25*pow(xi2, 44) - 3.43466719910502e+26*pow(xi2, 42) + 8.82553121273627e+26*pow(xi2, 40) - 1.68789360023551e+27*pow(xi2, 38) + 2.492413014386e+27*pow(xi2, 36) - 2.90933538528959e+27*pow(xi2, 34) + 2.72634419617473e+27*pow(xi2, 32) - 2.07158838213781e+27*pow(xi2, 30) + 1.28384353044746e+27*pow(xi2, 28) - 6.50626362485951e+26*pow(xi2, 26) + 2.69554663708074e+26*pow(xi2, 24) - 9.10277915383376e+25*pow(xi2, 22) + 2.49139191637128e+25*pow(xi2, 20) - 5.47879243266592e+24*pow(xi2, 18) + 9.56379552082918e+23*pow(xi2, 16) - 1.303617531614e+23*pow(xi2, 14) + 1.35737828271005e+22*pow(xi2, 12) - 1.04814056578913e+21*pow(xi2, 10) + 5.76242569777709e+19*pow(xi2, 8) - 2.12811093661964e+18*pow(xi2, 6) + 4.83466083720984e+16*pow(xi2, 4) - 583590531542200.0*pow(xi2, 2) + 2636704208775.0);
case 29:
return -279166509376.106*pow(xi1, 51) + 3557880594966.93*pow(xi1, 49) - 21338365920884.2*pow(xi1, 47) + 80059627822368.0*pow(xi1, 45) - 210707878128500.0*pow(xi1, 43) + 413457806621174.0*pow(xi1, 41) - 627584822582511.0*pow(xi1, 39) + 754625892772514.0*pow(xi1, 37) - 730196744663009.0*pow(xi1, 35) + 574457730986261.0*pow(xi1, 33) - 369744544138545.0*pow(xi1, 31) + 195297320104083.0*pow(xi1, 29) - 84678136859102.6*pow(xi1, 27) + 30070931450057.4*pow(xi1, 25) - 8704310569332.09*pow(xi1, 23) + 2038251259475.21*pow(xi1, 21) - 382020033084.267*pow(xi1, 19) + 56487470251.4904*pow(xi1, 17) - 6464022566.86872*pow(xi1, 15) + 557939889.530573*pow(xi1, 13) - 35082432.7556841*pow(xi1, 11) + 1530776.40533598*pow(xi1, 9) - 43171.1940575669*pow(xi1, 7) + 703.59330025402*pow(xi1, 5) - 5.3956541430523*pow(xi1, 3) + 2.27373675443232e-13*pow(xi2, 3)*(1.22778729257867e+24*pow(xi2, 48) - 1.56477243376189e+25*pow(xi2, 46) + 9.38471257910054e+25*pow(xi2, 44) - 3.5210596682445e+26*pow(xi2, 42) + 9.26703048265178e+26*pow(xi2, 40) - 1.81840666389897e+27*pow(xi2, 38) + 2.76014723938084e+27*pow(xi2, 36) - 3.3188797748969e+27*pow(xi2, 34) + 3.21143924528464e+27*pow(xi2, 32) - 2.52649181954084e+27*pow(xi2, 30) + 1.62615370234826e+27*pow(xi2, 28) - 8.58926697311723e+26*pow(xi2, 26) + 3.72418384379963e+26*pow(xi2, 24) - 1.32253355149573e+26*pow(xi2, 22) + 3.82819627310167e+25*pow(xi2, 20) - 8.96432384048829e+24*pow(xi2, 18) + 1.6801418736781e+24*pow(xi2, 16) - 2.48434521460659e+23*pow(xi2, 14) + 2.84290718979145e+22*pow(xi2, 12) - 2.45384558455569e+21*pow(xi2, 10) + 1.54294170982177e+20*pow(xi2, 8) - 6.73242582876822e+18*pow(xi2, 6) + 1.89868919405076e+17*pow(xi2, 4) - 3.09443605941834e+15*pow(xi2, 2) + 23730337878975.0);
default:
return 0.;
}
case 26:
switch(j) {
case 0:
return 5.96046447753906e-8*y1t*(-1860438674025.0*pow(xi1, 26) + 11835556670925.0*pow(xi1, 24) - 33139558678590.0*pow(xi1, 22) + 53691222975390.0*pow(xi1, 20) - 55655536011075.0*pow(xi1, 18) + 38530755699975.0*pow(xi1, 16) - 18050444111700.0*pow(xi1, 14) + 5672996720820.0*pow(xi1, 12) - 1160385692895.0*pow(xi1, 10) + 145568097675.0*pow(xi1, 8) - 10039179150.0*pow(xi1, 6) + 304217550.0*pow(xi1, 4) - 2028117.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-620146224675.0*pow(xi2, 24) + 3945185556975.0*pow(xi2, 22) - 11046519559530.0*pow(xi2, 20) + 17897074325130.0*pow(xi2, 18) - 18551845337025.0*pow(xi2, 16) + 12843585233325.0*pow(xi2, 14) - 6016814703900.0*pow(xi2, 12) + 1890998906940.0*pow(xi2, 10) - 386795230965.0*pow(xi2, 8) + 48522699225.0*pow(xi2, 6) - 3346393050.0*pow(xi2, 4) + 101405850.0*pow(xi2, 2) - 676039.0));
case 1:
return 2.98023223876953e-8*y1r*(-1860438674025.0*pow(xi1, 26) + 644952073662.0*pow(xi1, 25) + 11835556670925.0*pow(xi1, 24) - 4116715363800.0*pow(xi1, 23) - 33139558678590.0*pow(xi1, 22) + 11572544300460.0*pow(xi1, 21) + 53691222975390.0*pow(xi1, 20) - 18839025605400.0*pow(xi1, 19) - 55655536011075.0*pow(xi1, 18) + 19643130356850.0*pow(xi1, 17) + 38530755699975.0*pow(xi1, 16) - 13699824248880.0*pow(xi1, 15) - 18050444111700.0*pow(xi1, 14) + 6479646604200.0*pow(xi1, 13) + 5672996720820.0*pow(xi1, 12) - 2062907898480.0*pow(xi1, 11) - 1160385692895.0*pow(xi1, 10) + 429772478850.0*pow(xi1, 9) + 145568097675.0*pow(xi1, 8) - 55454513400.0*pow(xi1, 7) - 10039179150.0*pow(xi1, 6) + 4015671660.0*pow(xi1, 5) + 304217550.0*pow(xi1, 4) - 135207800.0*pow(xi1, 3) - 2028117.0*pow(xi1, 2) + 1352078.0*xi1 + xi2*(1860438674025.0*pow(xi2, 25) - 644952073662.0*pow(xi2, 24) - 11835556670925.0*pow(xi2, 23) + 4116715363800.0*pow(xi2, 22) + 33139558678590.0*pow(xi2, 21) - 11572544300460.0*pow(xi2, 20) - 53691222975390.0*pow(xi2, 19) + 18839025605400.0*pow(xi2, 18) + 55655536011075.0*pow(xi2, 17) - 19643130356850.0*pow(xi2, 16) - 38530755699975.0*pow(xi2, 15) + 13699824248880.0*pow(xi2, 14) + 18050444111700.0*pow(xi2, 13) - 6479646604200.0*pow(xi2, 12) - 5672996720820.0*pow(xi2, 11) + 2062907898480.0*pow(xi2, 10) + 1160385692895.0*pow(xi2, 9) - 429772478850.0*pow(xi2, 8) - 145568097675.0*pow(xi2, 7) + 55454513400.0*pow(xi2, 6) + 10039179150.0*pow(xi2, 5) - 4015671660.0*pow(xi2, 4) - 304217550.0*pow(xi2, 3) + 135207800.0*pow(xi2, 2) + 2028117.0*xi2 - 1352078.0));
case 2:
return 5.96046447753906e-8*y2t*(1860438674025.0*pow(xi1, 26) - 11835556670925.0*pow(xi1, 24) + 33139558678590.0*pow(xi1, 22) - 53691222975390.0*pow(xi1, 20) + 55655536011075.0*pow(xi1, 18) - 38530755699975.0*pow(xi1, 16) + 18050444111700.0*pow(xi1, 14) - 5672996720820.0*pow(xi1, 12) + 1160385692895.0*pow(xi1, 10) - 145568097675.0*pow(xi1, 8) + 10039179150.0*pow(xi1, 6) - 304217550.0*pow(xi1, 4) + 2028117.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-620146224675.0*pow(xi2, 24) + 3945185556975.0*pow(xi2, 22) - 11046519559530.0*pow(xi2, 20) + 17897074325130.0*pow(xi2, 18) - 18551845337025.0*pow(xi2, 16) + 12843585233325.0*pow(xi2, 14) - 6016814703900.0*pow(xi2, 12) + 1890998906940.0*pow(xi2, 10) - 386795230965.0*pow(xi2, 8) + 48522699225.0*pow(xi2, 6) - 3346393050.0*pow(xi2, 4) + 101405850.0*pow(xi2, 2) - 676039.0));
case 3:
return 2.98023223876953e-8*y2r*(-1860438674025.0*pow(xi1, 26) - 644952073662.0*pow(xi1, 25) + 11835556670925.0*pow(xi1, 24) + 4116715363800.0*pow(xi1, 23) - 33139558678590.0*pow(xi1, 22) - 11572544300460.0*pow(xi1, 21) + 53691222975390.0*pow(xi1, 20) + 18839025605400.0*pow(xi1, 19) - 55655536011075.0*pow(xi1, 18) - 19643130356850.0*pow(xi1, 17) + 38530755699975.0*pow(xi1, 16) + 13699824248880.0*pow(xi1, 15) - 18050444111700.0*pow(xi1, 14) - 6479646604200.0*pow(xi1, 13) + 5672996720820.0*pow(xi1, 12) + 2062907898480.0*pow(xi1, 11) - 1160385692895.0*pow(xi1, 10) - 429772478850.0*pow(xi1, 9) + 145568097675.0*pow(xi1, 8) + 55454513400.0*pow(xi1, 7) - 10039179150.0*pow(xi1, 6) - 4015671660.0*pow(xi1, 5) + 304217550.0*pow(xi1, 4) + 135207800.0*pow(xi1, 3) - 2028117.0*pow(xi1, 2) - 1352078.0*xi1 + xi2*(1860438674025.0*pow(xi2, 25) + 644952073662.0*pow(xi2, 24) - 11835556670925.0*pow(xi2, 23) - 4116715363800.0*pow(xi2, 22) + 33139558678590.0*pow(xi2, 21) + 11572544300460.0*pow(xi2, 20) - 53691222975390.0*pow(xi2, 19) - 18839025605400.0*pow(xi2, 18) + 55655536011075.0*pow(xi2, 17) + 19643130356850.0*pow(xi2, 16) - 38530755699975.0*pow(xi2, 15) - 13699824248880.0*pow(xi2, 14) + 18050444111700.0*pow(xi2, 13) + 6479646604200.0*pow(xi2, 12) - 5672996720820.0*pow(xi2, 11) - 2062907898480.0*pow(xi2, 10) + 1160385692895.0*pow(xi2, 9) + 429772478850.0*pow(xi2, 8) - 145568097675.0*pow(xi2, 7) - 55454513400.0*pow(xi2, 6) + 10039179150.0*pow(xi2, 5) + 4015671660.0*pow(xi2, 4) - 304217550.0*pow(xi2, 3) - 135207800.0*pow(xi2, 2) + 2028117.0*xi2 + 1352078.0));
case 4:
return -106783.720132709*pow(xi1, 27) + 715678.124293685*pow(xi1, 25) - 2134765.60503602*pow(xi1, 23) + 3737630.98551393*pow(xi1, 21) - 4265625.64844191*pow(xi1, 19) + 3332338.98971379*pow(xi1, 17) - 1820737.44653463*pow(xi1, 15) + 698343.453519344*pow(xi1, 13) - 185835.598881841*pow(xi1, 11) + 33328.9112716913*pow(xi1, 9) - 3818.24517846107*pow(xi1, 7) + 253.858906030655*pow(xi1, 5) - 8.13960301876068*pow(xi1, 3) + 0.0805901288986206*xi1 + 106783.720132709*pow(xi2, 27) - 715678.124293685*pow(xi2, 25) + 2134765.60503602*pow(xi2, 23) - 3737630.98551393*pow(xi2, 21) + 4265625.64844191*pow(xi2, 19) - 3332338.98971379*pow(xi2, 17) + 1820737.44653463*pow(xi2, 15) - 698343.453519344*pow(xi2, 13) + 185835.598881841*pow(xi2, 11) - 33328.9112716913*pow(xi2, 9) + 3818.24517846107*pow(xi2, 7) - 253.858906030655*pow(xi2, 5) + 8.13960301876068*pow(xi2, 3) - 0.0805901288986206*xi2;
case 5:
return -171616.693070424*pow(xi1, 28) + 1196204.86489087*pow(xi1, 26) - 3723230.24186119*pow(xi1, 24) + 6824129.6124512*pow(xi1, 22) - 8176238.95359054*pow(xi1, 20) + 6719716.61138982*pow(xi1, 18) - 3865618.70751008*pow(xi1, 16) + 1558943.10125368*pow(xi1, 14) - 434198.589116782*pow(xi1, 12) + 80733.090030849*pow(xi1, 10) - 9424.51188638806*pow(xi1, 8) + 618.529239296913*pow(xi1, 6) - 18.2335166633129*pow(xi1, 4) + 0.120885193347931*pow(xi1, 2) + 4.25747462681362e-9*pow(xi2, 2)*(40309504603875.0*pow(xi2, 26) - 280965823579350.0*pow(xi2, 24) + 874516131796125.0*pow(xi2, 22) - 1.60285855128126e+15*pow(xi2, 20) + 1.92044337788804e+15*pow(xi2, 18) - 1.57833391867305e+15*pow(xi2, 16) + 907960480413525.0*pow(xi2, 14) - 366166151980200.0*pow(xi2, 12) + 101985009231105.0*pow(xi2, 10) - 18962670857130.0*pow(xi2, 8) + 2213639002575.0*pow(xi2, 6) - 145280781100.0*pow(xi2, 4) + 4282707065.0*pow(xi2, 2) - 28393638.0);
case 6:
return -289973.033118993*pow(xi1, 29) + 2095914.50686008*pow(xi1, 27) - 6791785.39954707*pow(xi1, 25) + 13024073.7724453*pow(xi1, 23) - 16430288.1617863*pow(xi1, 21) + 14339802.0394251*pow(xi1, 19) - 8866155.64289019*pow(xi1, 17) + 3911826.81694865*pow(xi1, 15) - 1225155.31102046*pow(xi1, 13) + 267815.70602864*pow(xi1, 11) - 39657.0352770388*pow(xi1, 9) + 3791.47774279118*pow(xi1, 7) - 215.921102851629*pow(xi1, 5) + 6.2457349896431*pow(xi1, 3) - 0.0604425966739655*xi1 + 289973.033118993*pow(xi2, 29) - 2095914.50686008*pow(xi2, 27) + 6791785.39954707*pow(xi2, 25) - 13024073.7724453*pow(xi2, 23) + 16430288.1617863*pow(xi2, 21) - 14339802.0394251*pow(xi2, 19) + 8866155.64289019*pow(xi2, 17) - 3911826.81694865*pow(xi2, 15) + 1225155.31102046*pow(xi2, 13) - 267815.70602864*pow(xi2, 11) + 39657.0352770388*pow(xi2, 9) - 3791.47774279118*pow(xi2, 7) + 215.921102851629*pow(xi2, 5) - 6.2457349896431*pow(xi2, 3) + 0.0604425966739655*xi2;
case 7:
return -504553.077627048*pow(xi1, 30) + 3775202.10564919*pow(xi1, 28) - 12711977.0834365*pow(xi1, 26) + 25445111.4509571*pow(xi1, 24) - 33689526.0770302*pow(xi1, 22) + 31062052.6502893*pow(xi1, 20) - 20448237.8820252*pow(xi1, 18) + 9693702.71960892*pow(xi1, 16) - 3294914.07228*pow(xi1, 14) + 789254.786240682*pow(xi1, 12) - 128830.869173482*pow(xi1, 10) + 13511.1869540066*pow(xi1, 8) - 818.705045714974*pow(xi1, 6) + 23.0185555666685*pow(xi1, 4) - 0.151106491684914*pow(xi1, 2) + 1.49011611938477e-8*pow(xi2, 2)*(33859983867255.0*pow(xi2, 28) - 253349524680525.0*pow(xi2, 26) + 853086341263455.0*pow(xi2, 24) - 1.70759252382713e+15*pow(xi2, 22) + 2.26086582372788e+15*pow(xi2, 20) - 2.08453906686911e+15*pow(xi2, 18) + 1.37225801506448e+15*pow(xi2, 16) - 650533377466665.0*pow(xi2, 14) + 221117940368325.0*pow(xi2, 12) - 52965992111175.0*pow(xi2, 10) + 8645693278365.0*pow(xi2, 8) - 906720407775.0*pow(xi2, 6) + 54942365569.0*pow(xi2, 4) - 1544749115.0*pow(xi2, 2) + 10140585.0);
case 8:
return -895174.815144762*pow(xi1, 31) + 6924185.8525414*pow(xi1, 29) - 24188727.8042527*pow(xi1, 27) + 50443217.3199738*pow(xi1, 25) - 69932128.9454531*pow(xi1, 23) + 67927236.8258033*pow(xi1, 21) - 47465195.5647927*pow(xi1, 19) + 24114852.0421258*pow(xi1, 17) - 8897819.76002522*pow(xi1, 15) + 2356624.70512949*pow(xi1, 13) - 437897.870313004*pow(xi1, 11) + 55065.7599892467*pow(xi1, 9) - 4446.10128606856*pow(xi1, 7) + 213.694800540805*pow(xi1, 5) - 5.38946487009525*pow(xi1, 3) + 0.0503688305616379*xi1 + 895174.815144762*pow(xi2, 31) - 6924185.8525414*pow(xi2, 29) + 24188727.8042527*pow(xi2, 27) - 50443217.3199738*pow(xi2, 25) + 69932128.9454531*pow(xi2, 23) - 67927236.8258033*pow(xi2, 21) + 47465195.5647927*pow(xi2, 19) - 24114852.0421258*pow(xi2, 17) + 8897819.76002522*pow(xi2, 15) - 2356624.70512949*pow(xi2, 13) + 437897.870313004*pow(xi2, 11) - 55065.7599892467*pow(xi2, 9) + 4446.10128606856*pow(xi2, 7) - 213.694800540805*pow(xi2, 5) + 5.38946487009525*pow(xi2, 3) - 0.0503688305616379*xi2;
case 9:
return -1610515.40403276*pow(xi1, 32) + 12863036.2875285*pow(xi1, 30) - 46553456.1889886*pow(xi1, 28) + 100973154.142899*pow(xi1, 26) - 146272634.545407*pow(xi1, 24) + 149293201.91956*pow(xi1, 22) - 110366783.018132*pow(xi1, 20) + 59823745.9727661*pow(xi1, 18) - 23800627.8061373*pow(xi1, 16) + 6888187.31875923*pow(xi1, 14) - 1421973.09600106*pow(xi1, 12) + 202464.943845011*pow(xi1, 10) - 18805.9319790099*pow(xi1, 8) + 1032.46532573551*pow(xi1, 6) - 27.2369451262057*pow(xi1, 4) + 0.176290906965733*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.45855549501248e+15*pow(xi2, 30) - 2.7623160091098e+16*pow(xi2, 28) + 9.99727859237375e+16*pow(xi2, 26) - 2.16838197408858e+17*pow(xi2, 24) + 3.1411809083614e+17*pow(xi2, 22) - 3.20604709879818e+17*pow(xi2, 20) + 2.37010861813803e+17*pow(xi2, 18) - 1.28470516238621e+17*pow(xi2, 16) + 5.11114590258139e+16*pow(xi2, 14) - 1.47922696313964e+16*pow(xi2, 12) + 3.0536639715582e+15*pow(xi2, 10) - 434790156200400.0*pow(xi2, 8) + 40385431410324.0*pow(xi2, 6) - 2217202404144.0*pow(xi2, 4) + 58490894280.0*pow(xi2, 2) - 378581840.0);
case 10:
return -2928209.82551412*pow(xi1, 33) + 24123464.7752993*pow(xi1, 31) - 90336471.2389704*pow(xi1, 29) + 203477776.253399*pow(xi1, 27) - 307428557.336709*pow(xi1, 25) + 328944724.965613*pow(xi1, 23) - 256519873.326385*pow(xi1, 21) + 147797910.676081*pow(xi1, 19) - 63101603.4300435*pow(xi1, 17) + 19839920.0978507*pow(xi1, 15) - 4523153.89852859*pow(xi1, 13) + 728271.336259693*pow(xi1, 11) - 79525.7599556074*pow(xi1, 9) + 5549.65789881349*pow(xi1, 7) - 227.838368162513*pow(xi1, 5) + 4.93614539504051*pow(xi1, 3) - 0.0440727267414331*xi1 + 2928209.82551412*pow(xi2, 33) - 24123464.7752993*pow(xi2, 31) + 90336471.2389704*pow(xi2, 29) - 203477776.253399*pow(xi2, 27) + 307428557.336709*pow(xi2, 25) - 328944724.965613*pow(xi2, 23) + 256519873.326385*pow(xi2, 21) - 147797910.676081*pow(xi2, 19) + 63101603.4300435*pow(xi2, 17) - 19839920.0978507*pow(xi2, 15) + 4523153.89852859*pow(xi2, 13) - 728271.336259693*pow(xi2, 11) + 79525.7599556074*pow(xi2, 9) - 5549.65789881349*pow(xi2, 7) + 227.838368162513*pow(xi2, 5) - 4.93614539504051*pow(xi2, 3) + 0.0440727267414331*xi2;
case 11:
return -5368384.68010921*pow(xi1, 34) + 45574159.305608*pow(xi1, 32) - 176381514.925256*pow(xi1, 30) + 412001085.264459*pow(xi1, 28) - 648117747.563351*pow(xi1, 26) + 725470987.473485*pow(xi1, 24) - 595218173.30991*pow(xi1, 22) + 363318946.840418*pow(xi1, 20) - 165746807.477536*pow(xi1, 18) + 56289305.4453993*pow(xi1, 16) - 14056301.5180623*pow(xi1, 14) + 2524964.4175617*pow(xi1, 12) - 315162.630897876*pow(xi1, 10) + 25888.73523077*pow(xi1, 8) - 1276.3814246133*pow(xi1, 6) + 31.2034905329347*pow(xi1, 4) - 0.198327270336449*pow(xi1, 2) + 9.31322574615479e-10*pow(xi2, 2)*(5.76425915835413e+15*pow(xi2, 32) - 4.89348809400701e+16*pow(xi2, 30) + 1.89388209555728e+17*pow(xi2, 28) - 4.4238279678184e+17*pow(xi2, 26) + 6.95911132435444e+17*pow(xi2, 24) - 7.78968541348861e+17*pow(xi2, 22) + 6.39110647087731e+17*pow(xi2, 20) - 3.90110748674189e+17*pow(xi2, 18) + 1.77969279383107e+17*pow(xi2, 16) - 6.04401815006362e+16*pow(xi2, 14) + 1.50928388306982e+16*pow(xi2, 12) - 2.7111598992478e+15*pow(xi2, 10) + 338403298156924.0*pow(xi2, 8) - 27797817787740.0*pow(xi2, 6) + 1370504118984.0*pow(xi2, 4) - 33504492840.0*pow(xi2, 2) + 212952285.0);
case 12:
return -9908504.29528729*pow(xi1, 35) + 86602324.7757193*pow(xi1, 33) - 346025516.708725*pow(xi1, 31) + 837111711.565737*pow(xi1, 29) - 1368945433.05878*pow(xi1, 27) + 1599944782.75468*pow(xi1, 25) - 1377794584.83228*pow(xi1, 23) + 888302170.752598*pow(xi1, 21) - 431362373.068038*pow(xi1, 19) + 157449965.765871*pow(xi1, 17) - 42782436.1134295*pow(xi1, 15) + 8499237.64101472*pow(xi1, 13) - 1199816.01963915*pow(xi1, 11) + 115296.38123868*pow(xi1, 9) - 7073.37042901665*pow(xi1, 7) + 252.483836956322*pow(xi1, 5) - 4.69374539796263*pow(xi1, 3) + 0.0396654540672898*xi1 + 9908504.29528729*pow(xi2, 35) - 86602324.7757193*pow(xi2, 33) + 346025516.708725*pow(xi2, 31) - 837111711.565737*pow(xi2, 29) + 1368945433.05878*pow(xi2, 27) - 1599944782.75468*pow(xi2, 25) + 1377794584.83228*pow(xi2, 23) - 888302170.752598*pow(xi2, 21) + 431362373.068038*pow(xi2, 19) - 157449965.765871*pow(xi2, 17) + 42782436.1134295*pow(xi2, 15) - 8499237.64101472*pow(xi2, 13) + 1199816.01963915*pow(xi2, 11) - 115296.38123868*pow(xi2, 9) + 7073.37042901665*pow(xi2, 7) - 252.483836956322*pow(xi2, 5) + 4.69374539796263*pow(xi2, 3) - 0.0396654540672898*xi2;
case 13:
return -18390784.4874651*pow(xi1, 36) + 165349363.264199*pow(xi1, 34) - 681381654.418109*pow(xi1, 32) + 1705198444.91246*pow(xi1, 30) - 2894650533.82591*pow(xi1, 28) + 3526159529.0653*pow(xi1, 26) - 3180256899.49859*pow(xi1, 24) + 2159872956.32263*pow(xi1, 22) - 1112624437.37378*pow(xi1, 20) + 434565975.375618*pow(xi1, 18) - 127742933.221558*pow(xi1, 16) + 27845286.2891282*pow(xi1, 14) - 4395100.23215187*pow(xi1, 12) + 484611.628580892*pow(xi1, 10) - 35350.9576309891*pow(xi1, 8) + 1562.02558116987*pow(xi1, 6) - 35.0873995770235*pow(xi1, 4) + 0.218159997370094*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(7.89878179214465e+16*pow(xi2, 34) - 7.10170107634161e+17*pow(xi2, 32) + 2.92651192182015e+18*pow(xi2, 30) - 7.32377155408906e+18*pow(xi2, 28) + 1.24324293761312e+19*pow(xi2, 26) - 1.51447398578142e+19*pow(xi2, 24) + 1.36590993762248e+19*pow(xi2, 22) - 9.27658371092053e+18*pow(xi2, 20) + 4.77868557125077e+18*pow(xi2, 18) - 1.86644665219262e+18*pow(xi2, 16) + 5.48651720481703e+17*pow(xi2, 14) - 1.19594593959563e+17*pow(xi2, 12) + 1.88768117597343e+16*pow(xi2, 10) - 2.08139109601623e+15*pow(xi2, 8) + 151831206907380.0*pow(xi2, 6) - 6708848786640.0*pow(xi2, 4) + 150699233685.0*pow(xi2, 2) - 936990054.0);
case 14:
return -34296327.8279754*pow(xi1, 37) + 316947562.443547*pow(xi1, 35) - 1345791771.57908*pow(xi1, 33) + 3480058140.28836*pow(xi1, 31) - 6124119482.10734*pow(xi1, 29) + 7763025283.9491*pow(xi1, 27) - 7318288745.93586*pow(xi1, 25) + 5222745456.02108*pow(xi1, 23) - 2845258105.69757*pow(xi1, 21) + 1184495832.35406*pow(xi1, 19) - 374767367.763486*pow(xi1, 17) + 89029356.3545286*pow(xi1, 15) - 15566914.4021732*pow(xi1, 13) + 1944230.40113592*pow(xi1, 11) - 165915.906914179*pow(xi1, 9) + 9050.10777661577*pow(xi1, 7) - 285.244196561398*pow(xi1, 5) + 4.58135994477198*pow(xi1, 3) - 0.0363599995616823*xi1 + 34296327.8279754*pow(xi2, 37) - 316947562.443547*pow(xi2, 35) + 1345791771.57908*pow(xi2, 33) - 3480058140.28836*pow(xi2, 31) + 6124119482.10734*pow(xi2, 29) - 7763025283.9491*pow(xi2, 27) + 7318288745.93586*pow(xi2, 25) - 5222745456.02108*pow(xi2, 23) + 2845258105.69757*pow(xi2, 21) - 1184495832.35406*pow(xi2, 19) + 374767367.763486*pow(xi2, 17) - 89029356.3545286*pow(xi2, 15) + 15566914.4021732*pow(xi2, 13) - 1944230.40113592*pow(xi2, 11) + 165915.906914179*pow(xi2, 9) - 9050.10777661577*pow(xi2, 7) + 285.244196561398*pow(xi2, 5) - 4.58135994477198*pow(xi2, 3) + 0.0363599995616823*xi2;
case 15:
return -64218832.4714114*pow(xi1, 38) + 609559692.386086*pow(xi1, 36) - 2664571836.57134*pow(xi1, 34) + 7112249072.16354*pow(xi1, 32) - 12958610422.2982*pow(xi1, 30) + 17067705071.5141*pow(xi1, 28) - 16787255145.7937*pow(xi1, 26) + 12560873795.7298*pow(xi1, 24) - 7216667713.14824*pow(xi1, 22) + 3191020712.83802*pow(xi1, 20) - 1081805051.19921*pow(xi1, 18) + 278426210.632151*pow(xi1, 16) - 53501402.6224166*pow(xi1, 14) + 7484344.83168108*pow(xi1, 12) - 734495.95757998*pow(xi1, 10) + 47860.1999373338*pow(xi1, 8) - 1898.99187710776*pow(xi1, 6) + 38.9960995299043*pow(xi1, 4) - 0.236339997150935*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(5.51635570504029e+17*pow(xi2, 36) - 5.23607788751612e+18*pow(xi2, 34) + 2.28884977918331e+19*pow(xi2, 32) - 6.10937543318975e+19*pow(xi2, 30) + 1.11313615930751e+20*pow(xi2, 28) - 1.46610470199853e+20*pow(xi2, 26) + 1.44201423681584e+20*pow(xi2, 24) - 1.07897084323686e+20*pow(xi2, 22) + 6.19907036281416e+19*pow(xi2, 20) - 2.74106592049958e+19*pow(xi2, 18) + 9.29263463109642e+18*pow(xi2, 16) - 2.39166293802859e+18*pow(xi2, 14) + 4.59573549106816e+17*pow(xi2, 12) - 6.42900325681137e+16*pow(xi2, 10) + 6.30927223370044e+15*pow(xi2, 8) - 411115987021740.0*pow(xi2, 6) + 16312216015095.0*pow(xi2, 4) - 334973944305.0*pow(xi2, 2) + 2030145117.0);
case 16:
return -120674948.929795*pow(xi1, 39) + 1175653580.47207*pow(xi1, 37) - 5286302218.13123*pow(xi1, 35) + 14550493221.5513*pow(xi1, 33) - 27416907540.5478*pow(xi1, 31) + 37467926302.5102*pow(xi1, 29) - 38384854462.9983*pow(xi1, 27) + 30051114463.0346*pow(xi1, 25) - 18162427058.8831*pow(xi1, 23) + 8503083836.0135*pow(xi1, 21) - 3076420020.57996*pow(xi1, 19) + 853376938.104283*pow(xi1, 17) - 178972641.335269*pow(xi1, 15) + 27778770.6562195*pow(xi1, 13) - 3093109.45395475*pow(xi1, 11) + 236110.827741453*pow(xi1, 9) - 11542.8213445254*pow(xi1, 7) + 325.035021796008*pow(xi1, 5) - 4.55798565933947*pow(xi1, 3) + 0.0337628567358479*xi1 + 120674948.929795*pow(xi2, 39) - 1175653580.47207*pow(xi2, 37) + 5286302218.13123*pow(xi2, 35) - 14550493221.5513*pow(xi2, 33) + 27416907540.5478*pow(xi2, 31) - 37467926302.5102*pow(xi2, 29) + 38384854462.9983*pow(xi2, 27) - 30051114463.0346*pow(xi2, 25) + 18162427058.8831*pow(xi2, 23) - 8503083836.0135*pow(xi2, 21) + 3076420020.57996*pow(xi2, 19) - 853376938.104283*pow(xi2, 17) + 178972641.335269*pow(xi2, 15) - 27778770.6562195*pow(xi2, 13) + 3093109.45395475*pow(xi2, 11) - 236110.827741453*pow(xi2, 9) + 11542.8213445254*pow(xi2, 7) - 325.035021796008*pow(xi2, 5) + 4.55798565933947*pow(xi2, 3) - 0.0337628567358479*xi2;
case 17:
return -227472278.732664*pow(xi1, 40) + 2273053878.45846*pow(xi1, 38) - 10505212659.9366*pow(xi1, 36) + 29790506288.6914*pow(xi1, 34) - 57987682215.1704*pow(xi1, 32) + 82118094217.2808*pow(xi1, 30) - 87490193887.0504*pow(xi1, 28) + 71532356048.1256*pow(xi1, 26) - 45374423454.5563*pow(xi1, 24) + 22427611247.8239*pow(xi1, 22) - 8628644103.11401*pow(xi1, 20) + 2567887790.32449*pow(xi1, 18) - 584252375.676849*pow(xi1, 16) + 99804149.7685162*pow(xi1, 14) - 12467065.8196333*pow(xi1, 12) + 1096362.40067811*pow(xi1, 10) - 64196.1260493338*pow(xi1, 8) + 2296.0599537497*pow(xi1, 6) - 43.0054387672863*pow(xi1, 4) + 0.253221425518859*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(1.56317759664542e+19*pow(xi2, 38) - 1.56203073120401e+20*pow(xi2, 36) + 7.21912716991248e+20*pow(xi2, 34) - 2.04718800385939e+21*pow(xi2, 32) + 3.98488317895996e+21*pow(xi2, 30) - 5.64311246516908e+21*pow(xi2, 28) + 6.01228034344929e+21*pow(xi2, 26) - 4.91566607732043e+21*pow(xi2, 24) + 3.11810663699479e+21*pow(xi2, 22) - 1.54121370938888e+21*pow(xi2, 20) + 5.92955907707167e+20*pow(xi2, 18) - 1.76463905267862e+20*pow(xi2, 16) + 4.0149517538278e+19*pow(xi2, 14) - 6.85848894817381e+18*pow(xi2, 12) + 8.56730239558468e+17*pow(xi2, 10) - 7.53414504876245e+16*pow(xi2, 8) + 4.41152419058852e+15*pow(xi2, 6) - 157784038576164.0*pow(xi2, 4) + 2955311248890.0*pow(xi2, 2) - 17401243860.0);
case 18:
return -429978087.848327*pow(xi1, 41) + 4404250503.12178*pow(xi1, 39) - 20905920719.0056*pow(xi1, 37) + 61025896951.4279*pow(xi1, 35) - 122587641860.07*pow(xi1, 33) + 179674777476.665*pow(xi1, 31) - 198793181542.137*pow(xi1, 29) + 169446632019.221*pow(xi1, 27) - 112569347434.57*pow(xi1, 25) + 58591489691.1156*pow(xi1, 23) - 23893543905.5802*pow(xi1, 21) + 7597569384.4288*pow(xi1, 19) - 1865442270.4129*pow(xi1, 17) + 348266022.083215*pow(xi1, 15) - 48339465.2060883*pow(xi1, 13) + 4830882.97791334*pow(xi1, 11) - 331913.895870354*pow(xi1, 9) + 14634.4945765412*pow(xi1, 7) - 371.378763023051*pow(xi1, 5) + 4.60018923025928*pow(xi1, 3) - 0.0316526781898574*xi1 + 429978087.848327*pow(xi2, 41) - 4404250503.12178*pow(xi2, 39) + 20905920719.0056*pow(xi2, 37) - 61025896951.4279*pow(xi2, 35) + 122587641860.07*pow(xi2, 33) - 179674777476.665*pow(xi2, 31) + 198793181542.137*pow(xi2, 29) - 169446632019.221*pow(xi2, 27) + 112569347434.57*pow(xi2, 25) - 58591489691.1156*pow(xi2, 23) + 23893543905.5802*pow(xi2, 21) - 7597569384.4288*pow(xi2, 19) + 1865442270.4129*pow(xi2, 17) - 348266022.083215*pow(xi2, 15) + 48339465.2060883*pow(xi2, 13) - 4830882.97791334*pow(xi2, 11) + 331913.895870354*pow(xi2, 9) - 14634.4945765412*pow(xi2, 7) + 371.378763023051*pow(xi2, 5) - 4.60018923025928*pow(xi2, 3) + 0.0316526781898574*xi2;
case 19:
return -814790410.166368*pow(xi1, 42) + 8549783317.50976*pow(xi1, 40) - 41653476712.0875*pow(xi1, 38) + 125058682142.194*pow(xi1, 36) - 259003421118.796*pow(xi1, 34) + 392457703405.874*pow(xi1, 32) - 450317176392.393*pow(xi1, 30) + 399522176450.682*pow(xi1, 28) - 277437040157.331*pow(xi1, 26) + 151702743338.496*pow(xi1, 24) - 65381671352.4093*pow(xi1, 22) + 22131888579.5098*pow(xi1, 20) - 5836813063.12121*pow(xi1, 18) + 1183677533.4723*pow(xi1, 16) - 181066218.998149*pow(xi1, 14) + 20329839.01153*pow(xi1, 12) - 1611743.59518819*pow(xi1, 10) + 85277.0028051157*pow(xi1, 8) - 2761.75736724289*pow(xi1, 6) + 47.1730413956175*pow(xi1, 4) - 0.269047764613788*pow(xi1, 2) + 5.19711258155959e-13*pow(xi2, 2)*(1.56777517781202e+21*pow(xi2, 40) - 1.64510258019927e+22*pow(xi2, 38) + 8.01473434689148e+22*pow(xi2, 36) - 2.40631081546949e+23*pow(xi2, 34) + 4.98360228019291e+23*pow(xi2, 32) - 7.55145664533791e+23*pow(xi2, 30) + 8.6647570035371e+23*pow(xi2, 28) - 7.68738737483324e+23*pow(xi2, 26) + 5.33829190350299e+23*pow(xi2, 24) - 2.9189812796584e+23*pow(xi2, 22) + 1.25803838816955e+23*pow(xi2, 20) - 4.25849704661743e+22*pow(xi2, 18) + 1.12308767060991e+22*pow(xi2, 16) - 2.27756762028251e+21*pow(xi2, 14) + 3.48397723075326e+20*pow(xi2, 12) - 3.9117565171985e+19*pow(xi2, 10) + 3.10122894183009e+18*pow(xi2, 8) - 1.64085348290695e+17*pow(xi2, 6) + 5.31402259216429e+15*pow(xi2, 4) - 90767788181070.0*pow(xi2, 2) + 517687004835.0);
case 20:
return -1547470158.8431*pow(xi1, 43) + 16625191560.6287*pow(xi1, 41) - 83075701012.3164*pow(xi1, 39) + 256341987434.563*pow(xi1, 37) - 546864253678.519*pow(xi1, 35) + 855764806225.721*pow(xi1, 33) - 1017063876240.53*pow(xi1, 31) + 937809906938.586*pow(xi1, 29) - 679513807901.221*pow(xi1, 27) + 389493949031.175*pow(xi1, 25) - 176939998576.283*pow(xi1, 23) + 63551103650.6587*pow(xi1, 21) - 17927506260.0493*pow(xi1, 19) + 3928013839.52227*pow(xi1, 17) - 657519566.445603*pow(xi1, 15) + 82143393.9973852*pow(xi1, 13) - 7411542.29891748*pow(xi1, 11) + 460866.585516028*pow(xi1, 9) - 18424.3960454715*pow(xi1, 7) + 424.126896137175*pow(xi1, 5) - 4.69338878270719*pow(xi1, 3) + 0.0298941960681987*xi1 + 1547470158.8431*pow(xi2, 43) - 16625191560.6287*pow(xi2, 41) + 83075701012.3164*pow(xi2, 39) - 256341987434.563*pow(xi2, 37) + 546864253678.519*pow(xi2, 35) - 855764806225.721*pow(xi2, 33) + 1017063876240.53*pow(xi2, 31) - 937809906938.586*pow(xi2, 29) + 679513807901.221*pow(xi2, 27) - 389493949031.175*pow(xi2, 25) + 176939998576.283*pow(xi2, 23) - 63551103650.6587*pow(xi2, 21) + 17927506260.0493*pow(xi2, 19) - 3928013839.52227*pow(xi2, 17) + 657519566.445603*pow(xi2, 15) - 82143393.9973852*pow(xi2, 13) + 7411542.29891748*pow(xi2, 11) - 460866.585516028*pow(xi2, 9) + 18424.3960454715*pow(xi2, 7) - 424.126896137175*pow(xi2, 5) + 4.69338878270719*pow(xi2, 3) - 0.0298941960681987*xi2;
case 21:
return -2945006008.03753*pow(xi1, 44) + 32376437528.27*pow(xi1, 42) - 165834316512.342*pow(xi1, 40) + 525516840538.759*pow(xi1, 38) - 1153840986172.26*pow(xi1, 36) + 1862846628678.5*pow(xi1, 34) - 2290506419752.75*pow(xi1, 32) + 2192002290170.17*pow(xi1, 30) - 1654499005685.08*pow(xi1, 28) + 992150683496.898*pow(xi1, 26) - 473928780505.806*pow(xi1, 24) + 180072606201.234*pow(xi1, 22) - 54132938919.5742*pow(xi1, 20) + 12753941922.5462*pow(xi1, 18) - 2321784503.34649*pow(xi1, 16) + 320073908.647654*pow(xi1, 14) - 32490100.6234645*pow(xi1, 12) + 2334644.31637217*pow(xi1, 10) - 112182.940656012*pow(xi1, 8) + 3304.67781971587*pow(xi1, 6) - 51.5450675705915*pow(xi1, 4) + 0.283994862647887*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(3.23806834970745e+21*pow(xi2, 42) - 3.55982695282961e+22*pow(xi2, 40) + 1.82336759289605e+23*pow(xi2, 38) - 5.77811876764472e+23*pow(xi2, 36) + 1.26866158090092e+24*pow(xi2, 34) - 2.04822152899533e+24*pow(xi2, 32) + 2.51843844201372e+24*pow(xi2, 30) - 2.41013200615372e+24*pow(xi2, 28) + 1.81914089489458e+24*pow(xi2, 26) - 1.09088121301074e+24*pow(xi2, 24) + 5.21090204903833e+23*pow(xi2, 22) - 1.97991924362186e+23*pow(xi2, 20) + 5.95197957877598e+22*pow(xi2, 18) - 1.40231074438193e+22*pow(xi2, 16) + 2.55282905861959e+21*pow(xi2, 14) - 3.51924984305808e+20*pow(xi2, 12) + 3.57232434231115e+19*pow(xi2, 10) - 2.56696857257235e+18*pow(xi2, 8) + 1.2334644768939e+17*pow(xi2, 6) - 3.63353168883104e+15*pow(xi2, 4) + 56674401148365.0*pow(xi2, 2) - 312255653710.0);
case 22:
return -5615144788.65823*pow(xi1, 45) + 63135916036.1408*pow(xi1, 43) - 331283607298.759*pow(xi1, 41) + 1077403912985.34*pow(xi1, 39) - 2432704272638.31*pow(xi1, 37) + 4048284797605.57*pow(xi1, 35) - 5144115977810.54*pow(xi1, 33) + 5102731133233.49*pow(xi1, 31) - 4005941677467.71*pow(xi1, 29) + 2508576623183.67*pow(xi1, 27) - 1257213928686.48*pow(xi1, 25) + 503967555431.51*pow(xi1, 23) - 160906149318.764*pow(xi1, 21) + 40592360498.6979*pow(xi1, 19) - 7992770588.98206*pow(xi1, 17) + 1207178101.86205*pow(xi1, 15) - 136518405.419752*pow(xi1, 13) + 11179652.8357223*pow(xi1, 11) - 632273.686710647*pow(xi1, 9) + 23026.7091704373*pow(xi1, 7) - 483.330856740439*pow(xi1, 5) + 4.82791266501408*pow(xi1, 3) - 0.0283994862647887*xi1 + 5615144788.65823*pow(xi2, 45) - 63135916036.1408*pow(xi2, 43) + 331283607298.759*pow(xi2, 41) - 1077403912985.34*pow(xi2, 39) + 2432704272638.31*pow(xi2, 37) - 4048284797605.57*pow(xi2, 35) + 5144115977810.54*pow(xi2, 33) - 5102731133233.49*pow(xi2, 31) + 4005941677467.71*pow(xi2, 29) - 2508576623183.67*pow(xi2, 27) + 1257213928686.48*pow(xi2, 25) - 503967555431.51*pow(xi2, 23) + 160906149318.764*pow(xi2, 21) - 40592360498.6979*pow(xi2, 19) + 7992770588.98206*pow(xi2, 17) - 1207178101.86205*pow(xi2, 15) + 136518405.419752*pow(xi2, 13) - 11179652.8357223*pow(xi2, 11) + 632273.686710647*pow(xi2, 9) - 23026.7091704373*pow(xi2, 7) + 483.330856740439*pow(xi2, 5) - 4.82791266501408*pow(xi2, 3) + 0.0283994862647887*xi2;
case 23:
return -10724577779.5802*pow(xi1, 46) + 123268642054.967*pow(xi1, 44) - 662226702259.593*pow(xi1, 42) + 2208852750087.43*pow(xi1, 40) - 5125069148373.14*pow(xi1, 38) + 8783140469058.23*pow(xi1, 36) - 11522023284984.6*pow(xi1, 34) + 11832582409198.7*pow(xi1, 32) - 9648041315255.88*pow(xi1, 30) + 6298492797700.62*pow(xi1, 28) - 3305059766157.57*pow(xi1, 26) + 1394300038521.23*pow(xi1, 24) - 471368271194.802*pow(xi1, 22) + 126844343800.751*pow(xi1, 20) - 26884603684.2252*pow(xi1, 18) + 4420790397.9644*pow(xi1, 16) - 552329947.313166*pow(xi1, 14) + 50950982.4545326*pow(xi1, 12) - 3334465.9698603*pow(xi1, 10) + 146178.190695699*pow(xi1, 8) - 3933.68384125155*pow(xi1, 6) + 56.1599840886197*pow(xi1, 4) - 0.298194605780282*pow(xi1, 2) + 4.54747350886464e-13*pow(xi2, 2)*(2.3583595943273e+22*pow(xi2, 44) - 2.71070610559187e+23*pow(xi2, 42) + 1.45625191871636e+24*pow(xi2, 40) - 4.85731856553224e+24*pow(xi2, 38) + 1.12701462435846e+25*pow(xi2, 36) - 1.9314330148239e+25*pow(xi2, 34) + 2.53371971546929e+25*pow(xi2, 32) - 2.60201238910635e+25*pow(xi2, 30) + 2.12162672227742e+25*pow(xi2, 28) - 1.38505321370704e+25*pow(xi2, 26) + 7.26790328676975e+24*pow(xi2, 24) - 3.06609820992524e+24*pow(xi2, 22) + 1.03654979028671e+24*pow(xi2, 20) - 2.78933661853084e+23*pow(xi2, 18) + 5.91198687179101e+22*pow(xi2, 16) - 9.7214208930447e+21*pow(xi2, 14) + 1.21458639887946e+21*pow(xi2, 12) - 1.12042395310739e+20*pow(xi2, 10) + 7.33256821256954e+18*pow(xi2, 8) - 3.21449240794357e+17*pow(xi2, 6) + 8.65026224690128e+15*pow(xi2, 4) - 123497111042305.0*pow(xi2, 2) + 655736872791.0);
case 24:
return -20515681671.1891*pow(xi1, 47) + 240939982417.454*pow(xi1, 45) - 1324517078711.9*pow(xi1, 43) + 4528228288286.7*pow(xi1, 41) - 10788760831208.3*pow(xi1, 39) + 19025199835309.7*pow(xi1, 37) - 25741152427126.8*pow(xi1, 35) + 27336784803967.1*pow(xi1, 33) - 23120016516737.7*pow(xi1, 31) + 15710037319763.9*pow(xi1, 29) - 8615184787726.1*pow(xi1, 27) + 3816281731480.58*pow(xi1, 25) - 1362313663683.21*pow(xi1, 23) + 389709410212.598*pow(xi1, 21) - 88528792082.7051*pow(xi1, 19) + 15761825919.9628*pow(xi1, 17) - 2159890092.02749*pow(xi1, 15) + 222238572.11934*pow(xi1, 13) - 16596364.3474867*pow(xi1, 11) + 857500.123169862*pow(xi1, 9) - 28570.2381759558*pow(xi1, 7) + 549.175065645352*pow(xi1, 5) - 4.99701869686351*pow(xi1, 3) + 0.0271086005254801*xi1 + 20515681671.1891*pow(xi2, 47) - 240939982417.454*pow(xi2, 45) + 1324517078711.9*pow(xi2, 43) - 4528228288286.7*pow(xi2, 41) + 10788760831208.3*pow(xi2, 39) - 19025199835309.7*pow(xi2, 37) + 25741152427126.8*pow(xi2, 35) - 27336784803967.1*pow(xi2, 33) + 23120016516737.7*pow(xi2, 31) - 15710037319763.9*pow(xi2, 29) + 8615184787726.1*pow(xi2, 27) - 3816281731480.58*pow(xi2, 25) + 1362313663683.21*pow(xi2, 23) - 389709410212.598*pow(xi2, 21) + 88528792082.7051*pow(xi2, 19) - 15761825919.9628*pow(xi2, 17) + 2159890092.02749*pow(xi2, 15) - 222238572.11934*pow(xi2, 13) + 16596364.3474867*pow(xi2, 11) - 857500.123169862*pow(xi2, 9) + 28570.2381759558*pow(xi2, 7) - 549.175065645352*pow(xi2, 5) + 4.99701869686351*pow(xi2, 3) - 0.0271086005254801*xi2;
case 25:
return -39303140158.1204*pow(xi1, 48) + 471414685357.541*pow(xi1, 46) - 2650459083811.01*pow(xi1, 44) + 9282069011156.13*pow(xi1, 42) - 22693549650921.2*pow(xi1, 40) + 41145898780126.6*pow(xi1, 38) - 57365413435046.9*pow(xi1, 36) + 62932990858132.5*pow(xi1, 34) - 55139349262126.3*pow(xi1, 32) + 38941023145450.4*pow(xi1, 30) - 22278448882718.6*pow(xi1, 28) + 10340821294578.2*pow(xi1, 26) - 3888016417121.97*pow(xi1, 24) + 1178690980057.69*pow(xi1, 22) - 285877453267.485*pow(xi1, 20) + 54840820984.8424*pow(xi1, 18) - 8190337044.02725*pow(xi1, 16) + 932072013.857978*pow(xi1, 14) - 78500941.0145018*pow(xi1, 12) + 4699435.057622*pow(xi1, 10) - 188733.622760158*pow(xi1, 8) + 4658.04823779281*pow(xi1, 6) - 61.0508274334251*pow(xi1, 4) + 0.311748906043022*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(1.38285630758283e+24*pow(xi2, 46) - 1.65864296977594e+25*pow(xi2, 44) + 9.32547386110312e+25*pow(xi2, 42) - 3.26583769842734e+26*pow(xi2, 40) + 7.98458294934394e+26*pow(xi2, 38) - 1.44769261260939e+27*pow(xi2, 36) + 2.01836605132837e+27*pow(xi2, 34) - 2.2142577670156e+27*pow(xi2, 32) + 1.94004338117471e+27*pow(xi2, 30) - 1.37011544786935e+27*pow(xi2, 28) + 7.83853235051596e+26*pow(xi2, 26) - 3.63835304132558e+26*pow(xi2, 24) + 1.36797416307507e+26*pow(xi2, 22) - 4.14715020200997e+25*pow(xi2, 20) + 1.00584186875709e+25*pow(xi2, 18) - 1.92953985118772e+24*pow(xi2, 16) + 2.88171866089999e+23*pow(xi2, 14) - 3.27943685491661e+22*pow(xi2, 12) + 2.76200631797769e+21*pow(xi2, 10) - 1.65346671674674e+20*pow(xi2, 8) + 6.64047400886665e+18*pow(xi2, 6) - 1.63890502406231e+17*pow(xi2, 4) + 2.1480350287487e+15*pow(xi2, 2) - 10968689508504.0);
case 26:
return -75397860711.4964*pow(xi1, 49) + 923205675203.51*pow(xi1, 47) - 5306039136225.21*pow(xi1, 45) + 19023984126810.3*pow(xi1, 43) - 47697146971124.2*pow(xi1, 41) + 88850527443269.1*pow(xi1, 39) - 127536852017959.0*pow(xi1, 37) + 144391127494206.0*pow(xi1, 35) - 130906819389456.0*pow(xi1, 33) + 95956202166020.2*pow(xi1, 31) - 57179646008534.8*pow(xi1, 29) + 27756965085111.9*pow(xi1, 27) - 10966740856858.2*pow(xi1, 25) + 3513460872224.75*pow(xi1, 23) - 906655657151.034*pow(xi1, 21) + 186584247134.471*pow(xi1, 19) - 30200998509.3479*pow(xi1, 17) + 3773515185.74454*pow(xi1, 15) - 354884178.83289*pow(xi1, 13) + 24271267.6401381*pow(xi1, 11) - 1150307.25765732*pow(xi1, 9) + 35198.6782701574*pow(xi1, 7) - 621.939067555828*pow(xi1, 5) + 5.19581510071703*pow(xi1, 3) - 0.0259790755035851*xi1 + 75397860711.4964*pow(xi2, 49) - 923205675203.51*pow(xi2, 47) + 5306039136225.21*pow(xi2, 45) - 19023984126810.3*pow(xi2, 43) + 47697146971124.2*pow(xi2, 41) - 88850527443269.1*pow(xi2, 39) + 127536852017959.0*pow(xi2, 37) - 144391127494206.0*pow(xi2, 35) + 130906819389456.0*pow(xi2, 33) - 95956202166020.2*pow(xi2, 31) + 57179646008534.8*pow(xi2, 29) - 27756965085111.9*pow(xi2, 27) + 10966740856858.2*pow(xi2, 25) - 3513460872224.75*pow(xi2, 23) + 906655657151.034*pow(xi2, 21) - 186584247134.471*pow(xi2, 19) + 30200998509.3479*pow(xi2, 17) - 3773515185.74454*pow(xi2, 15) + 354884178.83289*pow(xi2, 13) - 24271267.6401381*pow(xi2, 11) + 1150307.25765732*pow(xi2, 9) - 35198.6782701574*pow(xi2, 7) + 621.939067555828*pow(xi2, 5) - 5.19581510071703*pow(xi2, 3) + 0.0259790755035851*xi2;
case 27:
return -144824210854.642*pow(xi1, 50) + 1809516572879.87*pow(xi1, 48) - 10626311398270.7*pow(xi1, 46) + 38984017588812.6*pow(xi1, 44) - 100171327455461.0*pow(xi1, 42) + 191579165608972.0*pow(xi1, 40) - 282894076206354.0*pow(xi1, 38) + 330216112067159.0*pow(xi1, 36) - 309446644109395.0*pow(xi1, 34) + 235130614154372.0*pow(xi1, 32) - 145719751523803.0*pow(xi1, 30) + 73847974938271.3*pow(xi1, 28) - 30595276980720.1*pow(xi1, 26) + 10331946432099.3*pow(xi1, 24) - 2827813652143.41*pow(xi1, 22) + 621862223301.171*pow(xi1, 20) - 108552592052.753*pow(xi1, 18) + 14796557716.0717*pow(xi1, 16) - 1540678338.77952*pow(xi1, 14) + 118968280.900703*pow(xi1, 12) - 6540599.65782463*pow(xi1, 10) + 241550.011083072*pow(xi1, 8) - 5487.56011862229*pow(xi1, 6) + 66.2466425341421*pow(xi1, 4) - 0.324738443794814*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(5.09554892218119e+24*pow(xi2, 48) - 6.36667044011133e+25*pow(xi2, 46) + 3.73880094168553e+26*pow(xi2, 44) - 1.37162818036235e+27*pow(xi2, 42) + 3.52446525782516e+27*pow(xi2, 40) - 6.74059264725402e+27*pow(xi2, 38) + 9.95345043897074e+27*pow(xi2, 36) - 1.16184465566984e+28*pow(xi2, 34) + 1.08876858679853e+28*pow(xi2, 32) - 8.27292301788302e+27*pow(xi2, 30) + 5.12705795830563e+27*pow(xi2, 28) - 2.59829462823488e+27*pow(xi2, 26) + 1.07647560945053e+27*pow(xi2, 24) - 3.6352304766886e+26*pow(xi2, 22) + 9.94948477348925e+25*pow(xi2, 20) - 2.18798318526167e+25*pow(xi2, 18) + 3.81935478999124e+24*pow(xi2, 16) - 5.20607592316147e+23*pow(xi2, 14) + 5.42077999408221e+22*pow(xi2, 12) - 4.18582426197903e+21*pow(xi2, 10) + 2.30126892044989e+20*pow(xi2, 8) - 8.49878546800829e+18*pow(xi2, 6) + 1.93076357073442e+17*pow(xi2, 4) - 2.3308465205571e+15*pow(xi2, 2) + 11425718238025.0);
case 28:
return -278508097797.389*pow(xi1, 51) + 3549496820864.59*pow(xi1, 49) - 21288128648696.6*pow(xi1, 47) + 79871307262862.2*pow(xi1, 45) - 210212671150195.0*pow(xi1, 43) + 412486935729554.0*pow(xi1, 41) - 626112410202269.0*pow(xi1, 39) + 752856933338791.0*pow(xi1, 37) - 728486502684749.0*pow(xi1, 35) + 573113389622653.0*pow(xi1, 33) - 368879995670080.0*pow(xi1, 31) + 194841049824986.0*pow(xi1, 29) - 84480468246275.5*pow(xi1, 27) + 30000793028347.5*pow(xi1, 25) - 8684024948552.07*pow(xi1, 23) + 2033504922658.4*pow(xi1, 21) - 381131167800.204*pow(xi1, 19) + 56356143580.967*pow(xi1, 17) - 6449006483.44302*pow(xi1, 15) + 556644810.745324*pow(xi1, 13) - 35001064.4284215*pow(xi1, 11) + 1527228.79271278*pow(xi1, 9) - 43071.2202943735*pow(xi1, 7) + 701.974604011104*pow(xi1, 5) - 5.42063402334421*pow(xi1, 3) + 0.0249798802919088*xi1 + 278508097797.389*pow(xi2, 51) - 3549496820864.59*pow(xi2, 49) + 21288128648696.6*pow(xi2, 47) - 79871307262862.2*pow(xi2, 45) + 210212671150195.0*pow(xi2, 43) - 412486935729554.0*pow(xi2, 41) + 626112410202269.0*pow(xi2, 39) - 752856933338791.0*pow(xi2, 37) + 728486502684749.0*pow(xi2, 35) - 573113389622653.0*pow(xi2, 33) + 368879995670080.0*pow(xi2, 31) - 194841049824986.0*pow(xi2, 29) + 84480468246275.5*pow(xi2, 27) - 30000793028347.5*pow(xi2, 25) + 8684024948552.07*pow(xi2, 23) - 2033504922658.4*pow(xi2, 21) + 381131167800.204*pow(xi2, 19) - 56356143580.967*pow(xi2, 17) + 6449006483.44302*pow(xi2, 15) - 556644810.745324*pow(xi2, 13) + 35001064.4284215*pow(xi2, 11) - 1527228.79271278*pow(xi2, 9) + 43071.2202943735*pow(xi2, 7) - 701.974604011104*pow(xi2, 5) + 5.42063402334421*pow(xi2, 3) - 0.0249798802919088*xi2;
case 29:
return -536187598537.281*pow(xi1, 52) + 6967640531775.1*pow(xi1, 50) - 42659726193562.7*pow(xi1, 48) + 163608805357696.0*pow(xi1, 46) - 440801678175839.0*pow(xi1, 44) + 886879365892137.0*pow(xi1, 42) - 1.38279322603835e+15*pow(xi1, 40) + 1.71135652394663e+15*pow(xi1, 38) - 1.70825590882209e+15*pow(xi1, 36) + 1.38989776889186e+15*pow(xi1, 34) - 927891786877753.0*pow(xi1, 32) + 510039629345147.0*pow(xi1, 30) - 231022322507251.0*pow(xi1, 28) + 86087547010722.5*pow(xi1, 26) - 26285433620239.1*pow(xi1, 24) + 6533333986439.11*pow(xi1, 22) - 1309569337206.32*pow(xi1, 20) + 209011313677.242*pow(xi1, 18) - 26116500380.1459*pow(xi1, 16) + 2498241243.17268*pow(xi1, 14) - 177542358.650584*pow(xi1, 12) + 8996459.42651258*pow(xi1, 10) - 306582.523307831*pow(xi1, 8) + 6432.6089417779*pow(xi1, 6) - 71.7734410487269*pow(xi1, 4) + 0.337228383940769*pow(xi1, 2) + 7.105427357601e-15*pow(xi2, 2)*(7.54616959054118e+25*pow(xi2, 50) - 9.8060822820481e+26*pow(xi2, 48) + 6.00382271840801e+27*pow(xi2, 46) - 2.30258923388578e+28*pow(xi2, 44) + 6.20373210492811e+28*pow(xi2, 42) - 1.24817174429825e+29*pow(xi2, 40) + 1.94610845547399e+29*pow(xi2, 38) - 2.40852018860754e+29*pow(xi2, 36) + 2.40415646075769e+29*pow(xi2, 34) - 1.95610721064514e+29*pow(xi2, 32) + 1.30589159550712e+29*pow(xi2, 30) - 7.17816963957185e+28*pow(xi2, 28) + 3.25135014236851e+28*pow(xi2, 26) - 1.21157451449603e+28*pow(xi2, 24) + 3.69934590804314e+27*pow(xi2, 22) - 9.19485015837942e+26*pow(xi2, 20) + 1.84305499345569e+26*pow(xi2, 18) - 2.94157273247826e+25*pow(xi2, 16) + 3.67557066813271e+24*pow(xi2, 14) - 3.51596197869815e+23*pow(xi2, 12) + 2.4986865633164e+22*pow(xi2, 10) - 1.266139103778e+21*pow(xi2, 8) + 4.31476543039829e+19*pow(xi2, 6) - 9.05309226037846e+17*pow(xi2, 4) + 1.0101213823817e+16*pow(xi2, 2) - 47460675757950.0);
default:
return 0.;
}
case 27:
switch(j) {
case 0:
return 1.19209289550781e-7*y1t*(-1755702867191.0*pow(xi1, 27) + 11609137325916.0*pow(xi1, 25) - 33962901751350.0*pow(xi1, 23) + 57862721502300.0*pow(xi1, 21) - 63581711418225.0*pow(xi1, 19) + 47143512856440.0*pow(xi1, 17) - 23974692435540.0*pow(xi1, 15) + 8330974205400.0*pow(xi1, 13) - 1933976154825.0*pow(xi1, 11) + 286514985900.0*pow(xi1, 9) - 24954531030.0*pow(xi1, 7) + 1095183180.0*pow(xi1, 5) - 16900975.0*pow(xi1, 3) + pow(xi2, 3)*(1755702867191.0*pow(xi2, 24) - 11609137325916.0*pow(xi2, 22) + 33962901751350.0*pow(xi2, 20) - 57862721502300.0*pow(xi2, 18) + 63581711418225.0*pow(xi2, 16) - 47143512856440.0*pow(xi2, 14) + 23974692435540.0*pow(xi2, 12) - 8330974205400.0*pow(xi2, 10) + 1933976154825.0*pow(xi2, 8) - 286514985900.0*pow(xi2, 6) + 24954531030.0*pow(xi2, 4) - 1095183180.0*pow(xi2, 2) + 16900975.0));
case 1:
return 2.98023223876953e-8*y1r*(-3511405734382.0*pow(xi1, 27) + 1215486600363.0*pow(xi1, 26) + 23218274651832.0*pow(xi1, 25) - 8061900920775.0*pow(xi1, 24) - 67925803502700.0*pow(xi1, 23) + 23671113341850.0*pow(xi1, 22) + 115725443004600.0*pow(xi1, 21) - 40503905051610.0*pow(xi1, 20) - 127163422836450.0*pow(xi1, 19) + 44742685812825.0*pow(xi1, 18) + 94287025712880.0*pow(xi1, 17) - 33393321606645.0*pow(xi1, 16) - 47949384871080.0*pow(xi1, 15) + 17124780311100.0*pow(xi1, 14) + 16661948410800.0*pow(xi1, 13) - 6016814703900.0*pow(xi1, 12) - 3867952309650.0*pow(xi1, 11) + 1418249180205.0*pow(xi1, 10) + 573029971800.0*pow(xi1, 9) - 214886239425.0*pow(xi1, 8) - 49909062060.0*pow(xi1, 7) + 19409079690.0*pow(xi1, 6) + 2190366360.0*pow(xi1, 5) - 912652650.0*pow(xi1, 4) - 33801950.0*pow(xi1, 3) + 16900975.0*pow(xi1, 2) + pow(xi2, 2)*(3511405734382.0*pow(xi2, 25) - 1215486600363.0*pow(xi2, 24) - 23218274651832.0*pow(xi2, 23) + 8061900920775.0*pow(xi2, 22) + 67925803502700.0*pow(xi2, 21) - 23671113341850.0*pow(xi2, 20) - 115725443004600.0*pow(xi2, 19) + 40503905051610.0*pow(xi2, 18) + 127163422836450.0*pow(xi2, 17) - 44742685812825.0*pow(xi2, 16) - 94287025712880.0*pow(xi2, 15) + 33393321606645.0*pow(xi2, 14) + 47949384871080.0*pow(xi2, 13) - 17124780311100.0*pow(xi2, 12) - 16661948410800.0*pow(xi2, 11) + 6016814703900.0*pow(xi2, 10) + 3867952309650.0*pow(xi2, 9) - 1418249180205.0*pow(xi2, 8) - 573029971800.0*pow(xi2, 7) + 214886239425.0*pow(xi2, 6) + 49909062060.0*pow(xi2, 5) - 19409079690.0*pow(xi2, 4) - 2190366360.0*pow(xi2, 3) + 912652650.0*pow(xi2, 2) + 33801950.0*xi2 - 16900975.0));
case 2:
return 1.19209289550781e-7*y2t*(1755702867191.0*pow(xi1, 27) - 11609137325916.0*pow(xi1, 25) + 33962901751350.0*pow(xi1, 23) - 57862721502300.0*pow(xi1, 21) + 63581711418225.0*pow(xi1, 19) - 47143512856440.0*pow(xi1, 17) + 23974692435540.0*pow(xi1, 15) - 8330974205400.0*pow(xi1, 13) + 1933976154825.0*pow(xi1, 11) - 286514985900.0*pow(xi1, 9) + 24954531030.0*pow(xi1, 7) - 1095183180.0*pow(xi1, 5) + 16900975.0*pow(xi1, 3) + pow(xi2, 3)*(-1755702867191.0*pow(xi2, 24) + 11609137325916.0*pow(xi2, 22) - 33962901751350.0*pow(xi2, 20) + 57862721502300.0*pow(xi2, 18) - 63581711418225.0*pow(xi2, 16) + 47143512856440.0*pow(xi2, 14) - 23974692435540.0*pow(xi2, 12) + 8330974205400.0*pow(xi2, 10) - 1933976154825.0*pow(xi2, 8) + 286514985900.0*pow(xi2, 6) - 24954531030.0*pow(xi2, 4) + 1095183180.0*pow(xi2, 2) - 16900975.0));
case 3:
return 2.98023223876953e-8*y2r*(-3511405734382.0*pow(xi1, 27) - 1215486600363.0*pow(xi1, 26) + 23218274651832.0*pow(xi1, 25) + 8061900920775.0*pow(xi1, 24) - 67925803502700.0*pow(xi1, 23) - 23671113341850.0*pow(xi1, 22) + 115725443004600.0*pow(xi1, 21) + 40503905051610.0*pow(xi1, 20) - 127163422836450.0*pow(xi1, 19) - 44742685812825.0*pow(xi1, 18) + 94287025712880.0*pow(xi1, 17) + 33393321606645.0*pow(xi1, 16) - 47949384871080.0*pow(xi1, 15) - 17124780311100.0*pow(xi1, 14) + 16661948410800.0*pow(xi1, 13) + 6016814703900.0*pow(xi1, 12) - 3867952309650.0*pow(xi1, 11) - 1418249180205.0*pow(xi1, 10) + 573029971800.0*pow(xi1, 9) + 214886239425.0*pow(xi1, 8) - 49909062060.0*pow(xi1, 7) - 19409079690.0*pow(xi1, 6) + 2190366360.0*pow(xi1, 5) + 912652650.0*pow(xi1, 4) - 33801950.0*pow(xi1, 3) - 16900975.0*pow(xi1, 2) + pow(xi2, 2)*(3511405734382.0*pow(xi2, 25) + 1215486600363.0*pow(xi2, 24) - 23218274651832.0*pow(xi2, 23) - 8061900920775.0*pow(xi2, 22) + 67925803502700.0*pow(xi2, 21) + 23671113341850.0*pow(xi2, 20) - 115725443004600.0*pow(xi2, 19) - 40503905051610.0*pow(xi2, 18) + 127163422836450.0*pow(xi2, 17) + 44742685812825.0*pow(xi2, 16) - 94287025712880.0*pow(xi2, 15) - 33393321606645.0*pow(xi2, 14) + 47949384871080.0*pow(xi2, 13) + 17124780311100.0*pow(xi2, 12) - 16661948410800.0*pow(xi2, 11) - 6016814703900.0*pow(xi2, 10) + 3867952309650.0*pow(xi2, 9) + 1418249180205.0*pow(xi2, 8) - 573029971800.0*pow(xi2, 7) - 214886239425.0*pow(xi2, 6) + 49909062060.0*pow(xi2, 5) + 19409079690.0*pow(xi2, 4) - 2190366360.0*pow(xi2, 3) - 912652650.0*pow(xi2, 2) + 33801950.0*xi2 + 16900975.0));
case 4:
return -201821.231050819*pow(xi1, 28) + 1403138.08254379*pow(xi1, 26) - 4360524.57158938*pow(xi1, 24) + 7995147.04568088*pow(xi1, 22) - 9614774.98687729*pow(xi1, 20) + 7974597.42012888*pow(xi1, 18) - 4669777.74639621*pow(xi1, 16) + 1942908.14099908*pow(xi1, 14) - 569965.699578077*pow(xi1, 12) + 115273.96171242*pow(xi1, 10) - 15411.178393811*pow(xi1, 8) + 1265.66797435284*pow(xi1, 6) - 55.909401923418*pow(xi1, 4) + 1.00737661123276*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(6771996773451.0*pow(xi2, 26) - 47081501377326.0*pow(xi2, 24) + 146314925221725.0*pow(xi2, 22) - 268272617874300.0*pow(xi2, 20) + 322618313492475.0*pow(xi2, 18) - 267583086861090.0*pow(xi2, 16) + 156691739846565.0*pow(xi2, 14) - 65193179099400.0*pow(xi2, 12) + 19124875308825.0*pow(xi2, 10) - 3867952309650.0*pow(xi2, 8) + 517113337455.0*pow(xi2, 6) - 42468769980.0*pow(xi2, 4) + 1876008225.0*pow(xi2, 2) - 33801950.0);
case 5:
return -324769.797093272*pow(xi1, 29) + 2344970.49411428*pow(xi1, 27) - 7591913.54250741*pow(xi1, 25) + 14545305.8785021*pow(xi1, 23) - 18327224.8967797*pow(xi1, 21) + 15960149.8981029*pow(xi1, 19) - 9822894.75166082*pow(xi1, 17) + 4292526.46486044*pow(xi1, 15) - 1318261.2031728*pow(xi1, 13) + 277123.261490464*pow(xi1, 11) - 38011.4855825901*pow(xi1, 9) + 3130.23573517799*pow(xi1, 7) - 132.570762038231*pow(xi1, 5) + 2.01475322246552*pow(xi1, 3) + 1.19209289550781e-7*pow(xi2, 3)*(2724366518055.0*pow(xi2, 26) - 19671038246691.0*pow(xi2, 24) + 63685586677986.0*pow(xi2, 22) - 122014869254850.0*pow(xi2, 20) + 153739905386925.0*pow(xi2, 18) - 133883441116425.0*pow(xi2, 16) + 82400413496940.0*pow(xi2, 14) - 36008321843340.0*pow(xi2, 12) + 11058376475025.0*pow(xi2, 10) - 2324678408325.0*pow(xi2, 8) + 318863452050.0*pow(xi2, 6) - 26258320530.0*pow(xi2, 4) + 1112084155.0*pow(xi2, 2) - 16900975.0);
case 6:
return -549402.240082785*pow(xi1, 30) + 4108503.63210596*pow(xi1, 28) - 13827208.0805501*pow(xi1, 26) + 27664083.4957633*pow(xi1, 24) - 36611156.418654*pow(xi1, 22) + 33744830.445754*pow(xi1, 20) - 22216010.2240916*pow(xi1, 18) + 10544759.5412088*pow(xi1, 16) - 3599355.56090511*pow(xi1, 14) + 872026.17332451*pow(xi1, 12) - 146323.561076894*pow(xi1, 10) + 16351.5572648495*pow(xi1, 8) - 1142.58334207038*pow(xi1, 6) + 44.5764150470495*pow(xi1, 4) - 0.755532458424568*pow(xi1, 2) + 4.96705373128255e-9*pow(xi2, 2)*(110609280633033.0*pow(xi2, 28) - 827151034471515.0*pow(xi2, 26) + 2.78378467973202e+15*pow(xi2, 24) - 5.56951565100548e+15*pow(xi2, 22) + 7.37079935094653e+15*pow(xi2, 20) - 6.7937317112615e+15*pow(xi2, 18) + 4.47267362625353e+15*pow(xi2, 16) - 2.12294050189106e+15*pow(xi2, 14) + 724645988473275.0*pow(xi2, 12) - 175562057610225.0*pow(xi2, 10) + 29458823880915.0*pow(xi2, 8) - 3292003298025.0*pow(xi2, 6) + 230032410335.0*pow(xi2, 4) - 8974417725.0*pow(xi2, 2) + 152108775.0);
case 7:
return -957023.256918401*pow(xi1, 31) + 7400111.8051967*pow(xi1, 29) - 25843137.068245*pow(xi1, 27) + 53877067.1146849*pow(xi1, 25) - 74671105.3192668*pow(xi1, 23) + 72510060.6815735*pow(xi1, 21) - 50652263.6690386*pow(xi1, 19) + 25722379.0240824*pow(xi1, 17) - 9480938.51420894*pow(xi1, 15) + 2503513.98898512*pow(xi1, 13) - 461137.163681835*pow(xi1, 11) + 56571.6800898314*pow(xi1, 9) - 4267.03145876527*pow(xi1, 7) + 170.246647298336*pow(xi1, 5) - 2.51844152808189*pow(xi1, 3) + 2.98023223876953e-8*pow(xi2, 3)*(32112371796687.0*pow(xi2, 28) - 248306548359870.0*pow(xi2, 26) + 867151785423105.0*pow(xi2, 24) - 1.80781438485913e+15*pow(xi2, 22) + 2.50554652580018e+15*pow(xi2, 20) - 2.43303390045573e+15*pow(xi2, 18) + 1.69960793692883e+15*pow(xi2, 16) - 863099817841800.0*pow(xi2, 14) + 318127506671205.0*pow(xi2, 12) - 84003989904450.0*pow(xi2, 10) + 15473195601435.0*pow(xi2, 8) - 1898230592700.0*pow(xi2, 6) + 143177816925.0*pow(xi2, 4) - 5712529550.0*pow(xi2, 2) + 84504875.0);
case 8:
return -1699713.18025612*pow(xi1, 32) + 13572477.7881676*pow(xi1, 30) - 49110727.486688*pow(xi1, 28) + 106498272.480833*pow(xi1, 26) - 154246386.564348*pow(xi1, 24) + 157401903.208298*pow(xi1, 22) - 116340051.261704*pow(xi1, 20) + 63051164.7932561*pow(xi1, 18) - 25082662.6889706*pow(xi1, 16) + 7261397.49628846*pow(xi1, 14) - 1501655.10006906*pow(xi1, 12) + 215279.573045634*pow(xi1, 10) - 20471.3273524772*pow(xi1, 8) + 1212.25182954222*pow(xi1, 6) - 40.6098696403205*pow(xi1, 4) + 0.629610382020473*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.65010626089009e+15*pow(xi2, 30) - 2.91466741129331e+16*pow(xi2, 28) + 1.05464484219047e+17*pow(xi2, 26) - 2.28703298692836e+17*pow(xi2, 24) + 3.31241592910024e+17*pow(xi2, 22) - 3.380180133039e+17*pow(xi2, 20) + 2.49838357691991e+17*pow(xi2, 18) - 1.35401345380871e+17*pow(xi2, 16) + 5.38646079728641e+16*pow(xi2, 14) - 1.55937323849076e+16*pow(xi2, 12) + 3.22477977233412e+15*pow(xi2, 10) - 462309362863920.0*pow(xi2, 8) + 43961840742300.0*pow(xi2, 6) - 2603290981200.0*pow(xi2, 4) + 87209031000.0*pow(xi2, 2) - 1352078000.0);
case 9:
return -3060955.33760409*pow(xi1, 33) + 25213238.0791345*pow(xi1, 31) - 94403567.7795993*pow(xi1, 29) + 212608488.378715*pow(xi1, 27) - 321179615.28731*pow(xi1, 25) + 343612154.357964*pow(xi1, 23) - 267922999.822594*pow(xi1, 21) + 154348350.525506*pow(xi1, 19) - 65889718.4853975*pow(xi1, 17) + 20712941.0533648*pow(xi1, 15) - 4720135.0192485*pow(xi1, 13) + 758719.445440695*pow(xi1, 11) - 82283.9487223575*pow(xi1, 9) + 5587.16253004968*pow(xi1, 7) - 206.260361149907*pow(xi1, 5) + 2.93818178276221*pow(xi1, 3) + 4.96705373128255e-9*pow(xi2, 3)*(616251706384041.0*pow(xi2, 30) - 5.07609529575677e+15*pow(xi2, 28) + 1.90059485737077e+16*pow(xi2, 26) - 4.28037423955582e+16*pow(xi2, 24) + 6.46619973656652e+16*pow(xi2, 22) - 6.91782640066668e+16*pow(xi2, 20) + 5.39400244726994e+16*pow(xi2, 18) - 3.10744273921216e+16*pow(xi2, 16) + 1.32653524705045e+16*pow(xi2, 14) - 4.17006583257083e+15*pow(xi2, 12) + 950288697205155.0*pow(xi2, 10) - 152750400234705.0*pow(xi2, 8) + 16565946972575.0*pow(xi2, 6) - 1124844391125.0*pow(xi2, 4) + 41525695575.0*pow(xi2, 2) - 591534125.0);
case 10:
return -5570488.57394862*pow(xi1, 34) + 47284732.262402*pow(xi1, 32) - 182982384.66517*pow(xi1, 30) + 427375626.699867*pow(xi1, 28) - 672235775.597369*pow(xi1, 26) + 752393678.105771*pow(xi1, 24) - 617247943.398835*pow(xi1, 22) + 376730544.227549*pow(xi1, 20) - 171849479.01199*pow(xi1, 18) + 58356796.5482171*pow(xi1, 16) - 14571815.0302654*pow(xi1, 14) + 2617997.25941163*pow(xi1, 12) - 327223.789883908*pow(xi1, 10) + 27078.8499592803*pow(xi1, 8) - 1383.00216514617*pow(xi1, 6) + 39.6654540672898*pow(xi1, 4) - 0.550909084267914*pow(xi1, 2) + 5.4783680859734e-11*pow(xi2, 2)*(1.01681531553367e+17*pow(xi2, 32) - 8.63117109335313e+17*pow(xi2, 30) + 3.34008927099425e+18*pow(xi2, 28) - 7.8011484440796e+18*pow(xi2, 26) + 1.22707303534156e+19*pow(xi2, 24) - 1.37339015250211e+19*pow(xi2, 22) + 1.12670038542903e+19*pow(xi2, 20) - 6.87669280916182e+18*pow(xi2, 18) + 3.13687354181233e+18*pow(xi2, 16) - 1.06522226386415e+18*pow(xi2, 14) + 2.65988243242993e+17*pow(xi2, 12) - 4.77879035933099e+16*pow(xi2, 10) + 5.97301577310438e+15*pow(xi2, 8) - 494286793700700.0*pow(xi2, 6) + 25244783545800.0*pow(xi2, 4) - 724037769000.0*pow(xi2, 2) + 10056080125.0);
case 11:
return -10221404.4309279*pow(xi1, 35) + 89329921.0770173*pow(xi1, 33) - 356895696.139291*pow(xi1, 31) + 863342628.482774*pow(xi1, 29) - 1411735169.97465*pow(xi1, 27) + 1649833527.66496*pow(xi1, 25) - 1420653947.98565*pow(xi1, 23) + 915870100.569113*pow(xi1, 21) - 444718654.137696*pow(xi1, 19) + 162314054.739406*pow(xi1, 17) - 44101073.3600514*pow(xi1, 15) + 8760388.7429215*pow(xi1, 13) - 1236316.72201056*pow(xi1, 11) + 118607.011141628*pow(xi1, 9) - 7205.51305599511*pow(xi1, 7) + 243.281451612711*pow(xi1, 5) - 3.30545450560749*pow(xi1, 3) + 1.86264514923096e-9*pow(xi2, 3)*(5.48757471875313e+15*pow(xi2, 32) - 4.79586361975063e+16*pow(xi2, 30) + 1.91606917875176e+17*pow(xi2, 28) - 4.63503544322024e+17*pow(xi2, 26) + 7.57919548206765e+17*pow(xi2, 24) - 8.85747630645665e+17*pow(xi2, 22) + 7.62707780691457e+17*pow(xi2, 20) - 4.91704016166071e+17*pow(xi2, 18) + 2.38756509430317e+17*pow(xi2, 16) - 8.71416945983628e+16*pow(xi2, 14) + 2.36765834749897e+16*pow(xi2, 12) - 4.7031978938868e+15*pow(xi2, 10) + 663742486066660.0*pow(xi2, 8) - 63676654241200.0*pow(xi2, 6) + 3868430365800.0*pow(xi2, 4) - 130610734800.0*pow(xi2, 2) + 1774602375.0);
case 12:
return -18881205.4071308*pow(xi1, 36) + 169748323.585053*pow(xi1, 34) - 699467399.742545*pow(xi1, 32) + 1750356773.84535*pow(xi1, 30) - 2971138571.87629*pow(xi1, 28) + 3619131142.81016*pow(xi1, 26) - 3263928373.91906*pow(xi1, 24) + 2216578467.81839*pow(xi1, 22) - 1141774660.52333*pow(xi1, 20) + 445928084.89317*pow(xi1, 18) - 131076153.815987*pow(xi1, 16) + 28570462.2379647*pow(xi1, 14) - 4509449.15763886*pow(xi1, 12) + 497319.399947701*pow(xi1, 10) - 36350.1304189442*pow(xi1, 8) + 1629.89758035168*pow(xi1, 6) - 40.4091813310515*pow(xi1, 4) + 0.495818175841123*pow(xi1, 2) + 7.76102145512899e-11*pow(xi2, 2)*(2.43282479198055e+17*pow(xi2, 34) - 2.18719049504589e+18*pow(xi2, 32) + 9.01256881953717e+18*pow(xi2, 30) - 2.25531752999935e+19*pow(xi2, 28) + 3.82828289942784e+19*pow(xi2, 26) - 4.66321496949142e+19*pow(xi2, 24) + 4.20553968674065e+19*pow(xi2, 22) - 2.85603960848933e+19*pow(xi2, 20) + 1.47116544790477e+19*pow(xi2, 18) - 5.74573962295223e+18*pow(xi2, 16) + 1.68890338177539e+18*pow(xi2, 14) - 3.68127602830984e+17*pow(xi2, 12) + 5.81038099651009e+16*pow(xi2, 10) - 6.40791167532516e+15*pow(xi2, 8) + 468367864064100.0*pow(xi2, 6) - 21001070410320.0*pow(xi2, 4) + 520668336825.0*pow(xi2, 2) - 6388568550.0);
case 13:
return -35071723.0658252*pow(xi1, 37) + 324098167.76767*pow(xi1, 35) - 1376090817.03142*pow(xi1, 33) + 3558247605.06085*pow(xi1, 31) - 6261438377.81587*pow(xi1, 29) + 7936747811.00169*pow(xi1, 27) - 7481739208.62345*pow(xi1, 25) + 5339168617.26796*pow(xi1, 23) - 2908563110.5598*pow(xi1, 21) + 1210800767.34823*pow(xi1, 19) - 383074743.250645*pow(xi1, 17) + 90999253.9513292*pow(xi1, 15) - 15910711.3587747*pow(xi1, 13) + 1987040.60669569*pow(xi1, 11) - 169509.625385143*pow(xi1, 9) + 9217.57154602557*pow(xi1, 7) - 282.880796589889*pow(xi1, 5) + 3.63599995616823*pow(xi1, 3) + 9.31322574615479e-10*pow(xi2, 3)*(3.76579758955221e+16*pow(xi2, 34) - 3.47997757813916e+17*pow(xi2, 32) + 1.47756626386897e+18*pow(xi2, 30) - 3.82063927370167e+18*pow(xi2, 28) + 6.72316826465961e+18*pow(xi2, 26) - 8.52201807121296e+18*pow(xi2, 24) + 8.03345630455966e+18*pow(xi2, 22) - 5.73288864974886e+18*pow(xi2, 20) + 3.1230458595516e+18*pow(xi2, 18) - 1.30008742443309e+18*pow(xi2, 16) + 4.11323373546279e+17*pow(xi2, 14) - 9.77097049203395e+16*pow(xi2, 12) + 1.70839962355083e+16*pow(xi2, 10) - 2.1335686053955e+15*pow(xi2, 8) + 182009574346600.0*pow(xi2, 6) - 9897292084680.0*pow(xi2, 4) + 303740942505.0*pow(xi2, 2) - 3904125225.0);
case 14:
return -65451834.0548625*pow(xi1, 38) + 621240699.986569*pow(xi1, 36) - 2715536282.22465*pow(xi1, 34) + 7248028820.61917*pow(xi1, 32) - 13205547592.7004*pow(xi1, 30) + 17392354377.2915*pow(xi1, 28) - 17105998563.4686*pow(xi1, 26) + 12798948921.0048*pow(xi1, 24) - 7353212013.68346*pow(xi1, 22) + 3251293169.35963*pow(xi1, 20) - 1102203636.20301*pow(xi1, 18) + 283667425.441783*pow(xi1, 16) - 54506868.3388107*pow(xi1, 14) + 7624781.68265513*pow(xi1, 12) - 748280.220408097*pow(xi1, 10) + 48779.5884976792*pow(xi1, 8) - 1945.89627654233*pow(xi1, 6) + 42.2684994904557*pow(xi1, 4) - 0.454499994521029*pow(xi1, 2) + 1.16415321826935e-10*pow(xi2, 2)*(5.62226973457707e+17*pow(xi2, 36) - 5.33641697877293e+18*pow(xi2, 34) + 2.33262790465126e+19*pow(xi2, 32) - 6.22600934900496e+19*pow(xi2, 30) + 1.1343479007284e+20*pow(xi2, 28) - 1.49399186501819e+20*pow(xi2, 26) + 1.46939408791041e+20*pow(xi2, 24) - 1.0994213407778e+20*pow(xi2, 22) + 6.31636102386496e+19*pow(xi2, 20) - 2.79283956642156e+19*pow(xi2, 18) + 9.46785714204841e+18*pow(xi2, 16) - 2.43668463042595e+18*pow(xi2, 14) + 4.6821043384514e+17*pow(xi2, 12) - 6.54963759322873e+16*pow(xi2, 10) + 6.4276781497929e+15*pow(xi2, 8) - 419013474619740.0*pow(xi2, 6) + 16715121738315.0*pow(xi2, 4) - 363083645925.0*pow(xi2, 2) + 3904125225.0);
case 15:
return -122641503.653095*pow(xi1, 39) + 1194778534.36411*pow(xi1, 37) - 5372147407.37006*pow(xi1, 35) + 14786375338.0881*pow(xi1, 33) - 27860617378.6798*pow(xi1, 31) + 38073285463.0875*pow(xi1, 29) - 39004003866.1513*pow(xi1, 27) + 30535049585.1998*pow(xi1, 25) - 18454438615.023*pow(xi1, 23) + 8639576881.10214*pow(xi1, 21) - 3125725551.60628*pow(xi1, 19) + 867032659.727804*pow(xi1, 17) - 181832151.94781*pow(xi1, 15) + 28221925.8980201*pow(xi1, 13) - 3142373.53276822*pow(xi1, 11) + 239854.335394284*pow(xi1, 9) - 11716.0489159066*pow(xi1, 7) + 326.149196068291*pow(xi1, 5) - 3.93899995251559*pow(xi1, 3) + 7.76102145512899e-11*pow(xi2, 3)*(1.58022374196693e+18*pow(xi2, 36) - 1.539460419317e+19*pow(xi2, 34) + 6.92195922718368e+19*pow(xi2, 32) - 1.90520995510407e+20*pow(xi2, 30) + 3.58981321463397e+20*pow(xi2, 28) - 4.90570547745699e+20*pow(xi2, 26) + 5.02562763054532e+20*pow(xi2, 24) - 3.93441118050514e+20*pow(xi2, 22) + 2.37783630952689e+20*pow(xi2, 20) - 1.11320100466834e+20*pow(xi2, 18) + 4.02746670612616e+19*pow(xi2, 16) - 1.11716307542844e+19*pow(xi2, 14) + 2.34288943793144e+18*pow(xi2, 12) - 3.63636746286395e+17*pow(xi2, 10) + 4.04891746651665e+16*pow(xi2, 8) - 3.0904995789668e+15*pow(xi2, 6) + 150960140796465.0*pow(xi2, 4) - 4202400392190.0*pow(xi2, 2) + 50753627925.0);
case 16:
return -230609827.404838*pow(xi1, 40) + 2304355191.45273*pow(xi1, 38) - 10649642753.0921*pow(xi1, 36) + 30199427443.2348*pow(xi1, 34) - 58782403427.0816*pow(xi1, 32) + 83241776377.9778*pow(xi1, 30) - 88685550540.2*pow(xi1, 28) + 72508203254.0171*pow(xi1, 26) - 45992495366.913*pow(xi1, 24) + 22732658206.1636*pow(xi1, 22) - 8745833685.74116*pow(xi1, 20) + 2602712863.83558*pow(xi1, 18) - 592164491.208723*pow(xi1, 16) + 101153806.264636*pow(xi1, 14) - 12635421.9150379*pow(xi1, 12) + 1111150.22967046*pow(xi1, 10) - 65066.1647220088*pow(xi1, 8) + 2331.07203618478*pow(xi1, 6) - 44.9468030295975*pow(xi1, 4) + 0.422035709198099*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(1.58473866694398e+19*pow(xi2, 38) - 1.58354082970517e+20*pow(xi2, 36) + 7.31837877417824e+20*pow(xi2, 34) - 2.07528885162589e+21*pow(xi2, 32) + 4.0394960047935e+21*pow(xi2, 30) - 5.72033131526976e+21*pow(xi2, 28) + 6.09442462716663e+21*pow(xi2, 26) - 4.98272578668358e+21*pow(xi2, 24) + 3.16058021539716e+21*pow(xi2, 22) - 1.5621763767459e+21*pow(xi2, 20) + 6.01009114504215e+20*pow(xi2, 18) - 1.78857066096837e+20*pow(xi2, 16) + 4.06932339775031e+19*pow(xi2, 14) - 6.95123663636049e+18*pow(xi2, 12) + 8.6829958233999e+17*pow(xi2, 10) - 7.63576623580399e+16*pow(xi2, 8) + 4.47131279291483e+15*pow(xi2, 6) - 160190050560540.0*pow(xi2, 4) + 3088720785150.0*pow(xi2, 2) - 29002073100.0);
case 17:
return -434971381.771727*pow(xi1, 41) + 4455319114.48803*pow(xi1, 39) - 21147968135.187*pow(xi1, 37) + 61731405121.2206*pow(xi1, 35) - 124002779366.724*pow(xi1, 33) + 181745921271.371*pow(xi1, 31) - 201081427440.588*pow(xi1, 29) + 171394317814.652*pow(xi1, 27) - 113861451013.844*pow(xi1, 25) + 59263087448.0283*pow(xi1, 23) - 24167044891.3457*pow(xi1, 21) + 7684417935.61208*pow(xi1, 19) - 1886737635.04339*pow(xi1, 17) + 352236432.233255*pow(xi1, 15) - 48889832.5121684*pow(xi1, 13) + 4885812.67061053*pow(xi1, 11) - 335681.455371747*pow(xi1, 9) + 14797.8983624285*pow(xi1, 7) - 373.923638349515*pow(xi1, 5) + 4.22035709198099*pow(xi1, 3) + 1.16415321826935e-10*pow(xi2, 3)*(3.736375718811e+18*pow(xi2, 38) - 3.82708997799395e+19*pow(xi2, 36) + 1.81659663034956e+20*pow(xi2, 34) - 5.30268732263539e+20*pow(xi2, 32) + 1.06517576398637e+21*pow(xi2, 30) - 1.56118557608386e+21*pow(xi2, 28) + 1.72727630938065e+21*pow(xi2, 26) - 1.47226597946832e+21*pow(xi2, 24) + 9.78062416759128e+20*pow(xi2, 22) - 5.09066044898539e+20*pow(xi2, 20) + 2.07593334898588e+20*pow(xi2, 18) - 6.60086474444994e+19*pow(xi2, 16) + 1.62069528772875e+19*pow(xi2, 14) - 3.0256879138031e+18*pow(xi2, 12) + 4.19960463493362e+17*pow(xi2, 10) - 4.19688112693093e+16*pow(xi2, 8) + 2.88348174539068e+15*pow(xi2, 6) - 127112979032325.0*pow(xi2, 4) + 3211979595825.0*pow(xi2, 2) - 36252591375.0);
case 18:
return -822691408.083133*pow(xi1, 42) + 8632572977.90458*pow(xi1, 40) - 42056253141.7558*pow(xi1, 38) + 126266287574.99*pow(xi1, 36) - 261501013397.442*pow(xi1, 34) + 396237078099.193*pow(xi1, 32) - 454647922164.956*pow(xi1, 30) + 403359319727.115*pow(xi1, 28) - 280098134146.143*pow(xi1, 26) + 153155936673.263*pow(xi1, 24) - 66007168841.7615*pow(xi1, 22) + 22343350843.1183*pow(xi1, 20) - 5892511135.08151*pow(xi1, 18) + 1194958667.49436*pow(xi1, 16) - 182789740.258828*pow(xi1, 14) + 20523114.9238803*pow(xi1, 12) - 1627047.87812054*pow(xi1, 10) + 86086.5914944378*pow(xi1, 8) - 2789.11090834172*pow(xi1, 6) + 48.2703342395325*pow(xi1, 4) - 0.395658477373217*pow(xi1, 2) + 1.2126596023639e-12*pow(xi2, 2)*(6.78419076944111e+20*pow(xi2, 40) - 7.11871077512323e+21*pow(xi2, 38) + 3.46810045125385e+22*pow(xi2, 36) - 1.04123438538607e+23*pow(xi2, 34) + 2.15642553679271e+23*pow(xi2, 32) - 3.26750456044538e+23*pow(xi2, 30) + 3.74918007723425e+23*pow(xi2, 28) - 3.32623696658836e+23*pow(xi2, 26) + 2.30978366559034e+23*pow(xi2, 24) - 1.26297549926383e+23*pow(xi2, 22) + 5.44317372435678e+22*pow(xi2, 20) - 1.84250805416155e+22*pow(xi2, 18) + 4.85916338236626e+21*pow(xi2, 16) - 9.85403212216326e+20*pow(xi2, 14) + 1.50734583639552e+20*pow(xi2, 12) - 1.69240526227421e+19*pow(xi2, 10) + 1.34171854570635e+18*pow(xi2, 8) - 7.09899062578027e+16*pow(xi2, 6) + 2.29999490615895e+15*pow(xi2, 4) - 39805345329750.0*pow(xi2, 2) + 326273322375.0);
case 19:
return -1559849920.11385*pow(xi1, 43) + 16758016581.4581*pow(xi1, 41) - 83738552891.7078*pow(xi1, 39) + 258384653060.602*pow(xi1, 37) - 551216342688.762*pow(xi1, 35) + 862566527590.693*pow(xi1, 33) - 1025137419153.52*pow(xi1, 31) + 945245017769.346*pow(xi1, 29) - 684894432229.456*pow(xi1, 27) + 392574311178.262*pow(xi1, 25) - 178337649002.54*pow(xi1, 23) + 64052489187.5357*pow(xi1, 21) - 18068776057.7848*pow(xi1, 19) + 3958930149.3731*pow(xi1, 17) - 662688642.100233*pow(xi1, 15) + 82788410.2822969*pow(xi1, 13) - 7469672.88666969*pow(xi1, 11) + 464477.057046165*pow(xi1, 9) - 18568.1392978458*pow(xi1, 7) + 426.889119853877*pow(xi1, 5) - 4.4841294102298*pow(xi1, 3) + 7.27595761418343e-12*pow(xi2, 3)*(2.1438414059383e+20*pow(xi2, 40) - 2.30320426122203e+21*pow(xi2, 38) + 1.1508939074696e+22*pow(xi2, 36) - 3.55121163098749e+22*pow(xi2, 34) + 7.57585972758068e+22*pow(xi2, 32) - 1.18550240852042e+23*pow(xi2, 30) + 1.40893814053447e+23*pow(xi2, 28) - 1.29913486016841e+23*pow(xi2, 26) + 9.4131174004416e+22*pow(xi2, 24) - 5.39550024883316e+22*pow(xi2, 22) + 2.4510539843566e+22*pow(xi2, 20) - 8.80330708121151e+21*pow(xi2, 18) + 2.48335367190187e+21*pow(xi2, 16) - 5.44111216598588e+20*pow(xi2, 14) + 9.10792334480368e+19*pow(xi2, 12) - 1.13783524688094e+19*pow(xi2, 10) + 1.02662402432205e+18*pow(xi2, 8) - 6.38372406321793e+16*pow(xi2, 6) + 2.55198563301825e+15*pow(xi2, 4) - 58671193881300.0*pow(xi2, 2) + 616294053375.0);
case 20:
return -2964108749.71129*pow(xi1, 44) + 32586184470.587*pow(xi1, 42) - 166907325447.439*pow(xi1, 40) + 528912960881.657*pow(xi1, 38) - 1161288561403.75*pow(xi1, 36) + 1874856086782.63*pow(xi1, 34) - 2305255330325.58*pow(xi1, 32) + 2206100246925.95*pow(xi1, 30) - 1665127529061.39*pow(xi1, 28) + 998516875157.21*pow(xi1, 26) - 476966272244.759*pow(xi1, 24) + 181225405807.216*pow(xi1, 22) - 54479098236.3531*pow(xi1, 20) + 12835406932.7529*pow(xi1, 18) - 2336598245.351*pow(xi1, 16) + 322113828.809707*pow(xi1, 14) - 32696942.1566639*pow(xi1, 12) + 2349491.17916685*pow(xi1, 10) - 112895.628966776*pow(xi1, 8) + 3325.87878356744*pow(xi1, 6) - 52.1280043939214*pow(xi1, 4) + 0.373677450852483*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(3.25907203630014e+21*pow(xi2, 42) - 3.58288887302641e+22*pow(xi2, 40) + 1.83516545090453e+23*pow(xi2, 38) - 5.81545950570815e+23*pow(xi2, 36) + 1.27685027646668e+24*pow(xi2, 34) - 2.06142606782411e+24*pow(xi2, 32) + 2.53465504068558e+24*pow(xi2, 30) - 2.42563287353459e+24*pow(xi2, 28) + 1.83082707993292e+24*pow(xi2, 26) - 1.09788091476591e+24*pow(xi2, 24) + 5.24429962390086e+23*pow(xi2, 22) - 1.99259440933458e+23*pow(xi2, 20) + 5.99004019816212e+22*pow(xi2, 18) - 1.41126791697985e+22*pow(xi2, 16) + 2.56911694020443e+21*pow(xi2, 14) - 3.5416790024372e+20*pow(xi2, 12) + 3.59506680939712e+19*pow(xi2, 10) - 2.5832928708511e+18*pow(xi2, 8) + 1.24130056774055e+17*pow(xi2, 6) - 3.6568423951059e+15*pow(xi2, 4) + 57315346963875.0*pow(xi2, 2) - 410862702250.0);
case 21:
return -5643940402.95904*pow(xi1, 45) + 63459307840.2206*pow(xi1, 43) - 332978508214.796*pow(xi1, 41) + 1082909699230.21*pow(xi1, 39) - 2445121682401.35*pow(xi1, 37) + 4068925192581.16*pow(xi1, 35) - 5170313921043.63*pow(xi1, 33) + 5128689225764.81*pow(xi1, 31) - 4026297675831.58*pow(xi1, 29) + 2521309801100.88*pow(xi1, 27) - 1263588399544.35*pow(xi1, 25) + 506520061817.221*pow(xi1, 23) - 161720234605.989*pow(xi1, 21) + 40797513653.6727*pow(xi1, 19) - 8033123179.43023*pow(xi1, 17) + 1213266304.17716*pow(xi1, 15) - 137206195.642171*pow(xi1, 13) + 11235918.5064705*pow(xi1, 11) - 635452.569682131*pow(xi1, 9) + 23142.3356502297*pow(xi1, 7) - 485.631215127887*pow(xi1, 5) + 4.73324771079812*pow(xi1, 3) + 1.2126596023639e-12*pow(xi2, 3)*(4.65418357464617e+21*pow(xi2, 42) - 5.23306851457044e+22*pow(xi2, 40) + 2.74585306186256e+23*pow(xi2, 38) - 8.93003854601274e+23*pow(xi2, 36) + 2.01632979084563e+24*pow(xi2, 34) - 3.35537292134527e+24*pow(xi2, 32) + 4.2636152065797e+24*pow(xi2, 30) - 4.22929007923342e+24*pow(xi2, 28) + 3.32022083359823e+24*pow(xi2, 26) - 2.07915708265201e+24*pow(xi2, 24) + 1.04199760351641e+24*pow(xi2, 22) - 4.1769352325239e+23*pow(xi2, 20) + 1.33359958796961e+23*pow(xi2, 18) - 3.36430054849224e+22*pow(xi2, 16) + 6.62438425735534e+21*pow(xi2, 14) - 1.0005003067737e+21*pow(xi2, 12) + 1.13144855633607e+20*pow(xi2, 10) - 9.26551728495589e+18*pow(xi2, 8) + 5.24015616949231e+17*pow(xi2, 6) - 1.90839503559919e+16*pow(xi2, 4) + 400467875883075.0*pow(xi2, 2) - 3903195671375.0);
case 22:
return -10766429790.4273*pow(xi1, 46) + 123749152457.737*pow(xi1, 44) - 664805249813.08*pow(xi1, 42) + 2217444024836.51*pow(xi1, 40) - 5144981244028.56*pow(xi1, 38) + 8817228144268.68*pow(xi1, 36) - 11566692718301.1*pow(xi1, 34) + 11878407054355.6*pow(xi1, 32) - 9685366353522.19*pow(xi1, 30) + 6322834046464.09*pow(xi1, 28) - 3317819280545.0*pow(xi1, 26) + 1399677324153.45*pow(xi1, 24) - 473184299476.64*pow(xi1, 22) + 127332537367.964*pow(xi1, 20) - 26987971774.8993*pow(xi1, 18) + 4437770795.40733*pow(xi1, 16) - 554449355.907009*pow(xi1, 14) + 51146299.3791467*pow(xi1, 12) - 3347235.88000065*pow(xi1, 10) + 146737.457721642*pow(xi1, 8) - 3948.73556897189*pow(xi1, 6) + 56.4439789512676*pow(xi1, 4) - 0.354993578309859*pow(xi1, 2) + 4.54747350886464e-13*pow(xi2, 2)*(2.36756294884175e+22*pow(xi2, 44) - 2.72127264109414e+23*pow(xi2, 42) + 1.46192220475202e+24*pow(xi2, 40) - 4.87621097850032e+24*pow(xi2, 38) + 1.13139334049977e+25*pow(xi2, 36) - 1.93892897387544e+25*pow(xi2, 34) + 2.54354262773681e+25*pow(xi2, 32) - 2.6120893351441e+25*pow(xi2, 30) + 2.12983458499362e+25*pow(xi2, 28) - 1.39040591091705e+25*pow(xi2, 26) + 7.29596175563726e+24*pow(xi2, 24) - 3.07792298608224e+24*pow(xi2, 22) + 1.04054327871121e+24*pow(xi2, 20) - 2.80007210860597e+23*pow(xi2, 18) + 5.93471775531844e+22*pow(xi2, 16) - 9.75876118191021e+21*pow(xi2, 14) + 1.21924702766534e+21*pow(xi2, 12) - 1.12471901770168e+20*pow(xi2, 10) + 7.36064954193949e+18*pow(xi2, 8) - 3.22679081990469e+17*pow(xi2, 6) + 8.68336134619454e+15*pow(xi2, 4) - 124121622349725.0*pow(xi2, 2) + 780639134275.0);
case 23:
return -20572934736.318*pow(xi1, 47) + 241611658620.551*pow(xi1, 45) - 1328205586844.64*pow(xi1, 43) + 4540825293226.5*pow(xi1, 41) - 10818742788273.6*pow(xi1, 39) + 19078016455492.4*pow(xi1, 37) - 25812540522610.2*pow(xi1, 35) + 27412521274463.8*pow(xi1, 33) - 23184006044249.6*pow(xi1, 31) + 15753474773929.5*pow(xi1, 29) - 8638981738369.39*pow(xi1, 27) + 3826812736646.04*pow(xi1, 25) - 1366069288952.07*pow(xi1, 23) + 390782719220.513*pow(xi1, 21) - 88772376837.7726*pow(xi1, 19) + 15805152724.9117*pow(xi1, 17) - 2165821655.69451*pow(xi1, 15) + 222848315.609907*pow(xi1, 13) - 16641856.2001029*pow(xi1, 11) + 859848.405690382*pow(xi1, 9) - 28648.4077618996*pow(xi1, 7) + 550.666038674253*pow(xi1, 5) - 4.96991009633803*pow(xi1, 3) + 9.09494701772928e-13*pow(xi2, 3)*(2.26201809600584e+22*pow(xi2, 44) - 2.65654828059541e+23*pow(xi2, 42) + 1.46037748681273e+24*pow(xi2, 40) - 4.9926902096019e+24*pow(xi2, 38) + 1.18953334936246e+25*pow(xi2, 36) - 2.09765009277157e+25*pow(xi2, 34) + 2.83811884470491e+25*pow(xi2, 32) - 3.01403858879299e+25*pow(xi2, 30) + 2.54910842240815e+25*pow(xi2, 28) - 1.73211286918114e+25*pow(xi2, 26) + 9.49866087348167e+24*pow(xi2, 24) - 4.20762510126362e+24*pow(xi2, 22) + 1.5020090675505e+24*pow(xi2, 20) - 4.29670143716877e+23*pow(xi2, 18) + 9.76062605584438e+22*pow(xi2, 16) - 1.7377949199816e+22*pow(xi2, 14) + 2.38134609412519e+21*pow(xi2, 12) - 2.45024314243389e+20*pow(xi2, 10) + 1.82979143997893e+19*pow(xi2, 8) - 9.4541332018123e+17*pow(xi2, 6) + 3.14992574514768e+16*pow(xi2, 4) - 605463712543690.0*pow(xi2, 2) + 5464473939925.0);
case 24:
return -39373012407.2904*pow(xi1, 48) + 472251907715.73*pow(xi1, 46) - 2655161515440.8*pow(xi1, 44) + 9298520803347.89*pow(xi1, 42) - 22733732541815.3*pow(xi1, 40) + 41218683269644.9*pow(xi1, 38) - 57466790358075.2*pow(xi1, 36) + 63044099317287.5*pow(xi1, 34) - 55236604541920.0*pow(xi1, 32) + 39009642190619.9*pow(xi1, 30) - 22317669184363.2*pow(xi1, 28) + 10359008774601.5*pow(xi1, 26) - 3894848291944.96*pow(xi1, 24) + 1180760210360.19*pow(xi1, 22) - 286378858115.921*pow(xi1, 20) + 54936919123.2888*pow(xi1, 18) - 8204676009.03359*pow(xi1, 16) + 933702334.618827*pow(xi1, 14) - 78638126.6143699*pow(xi1, 12) + 4707640.30819233*pow(xi1, 10) - 189062.861554361*pow(xi1, 8) + 4666.16575761683*pow(xi1, 6) - 61.1637799356146*pow(xi1, 4) + 0.338857506568502*pow(xi1, 2) + 9.473903143468e-15*pow(xi2, 2)*(4.15594415638892e+24*pow(xi2, 46) - 4.9847660522193e+25*pow(xi2, 44) + 2.80260572145649e+26*pow(xi2, 42) - 9.81487847462212e+26*pow(xi2, 40) + 2.39961631415766e+27*pow(xi2, 38) - 4.3507604675127e+27*pow(xi2, 36) + 6.06579880412826e+27*pow(xi2, 34) - 6.65450114515417e+27*pow(xi2, 32) + 5.83039574137974e+27*pow(xi2, 30) - 4.11758929766091e+27*pow(xi2, 28) + 2.35569953021429e+27*pow(xi2, 26) - 1.09342565759117e+27*pow(xi2, 24) + 4.1111337460003e+26*pow(xi2, 22) - 1.24632919767001e+26*pow(xi2, 20) + 3.02281809069761e+25*pow(xi2, 18) - 5.7987630115436e+24*pow(xi2, 16) + 8.66029120710453e+23*pow(xi2, 14) - 9.85551910843198e+22*pow(xi2, 12) + 8.30049932150602e+21*pow(xi2, 10) - 4.96906104791469e+20*pow(xi2, 8) + 1.99561742073239e+19*pow(xi2, 6) - 4.92528336732472e+17*pow(xi2, 4) + 6.4560275748423e+15*pow(xi2, 2) - 35767465788600.0);
case 25:
return -75462029103.5913*pow(xi1, 49) + 923990623023.973*pow(xi1, 47) - 5310546224741.19*pow(xi1, 45) + 19040128213834.7*pow(xi1, 43) - 47737585354992.4*pow(xi1, 41) + 88925785622554.7*pow(xi1, 39) - 127644777643775.0*pow(xi1, 37) + 144513202680571.0*pow(xi1, 35) - 131017392602932.0*pow(xi1, 33) + 96037179634663.5*pow(xi1, 31) - 57227856189002.6*pow(xi1, 29) + 27780346890298.2*pow(xi1, 27) - 10975970713836.3*pow(xi1, 25) + 3516415252299.31*pow(xi1, 23) - 907417367669.162*pow(xi1, 21) + 186740865006.986*pow(xi1, 19) - 30226326970.8981*pow(xi1, 17) + 3776677151.27261*pow(xi1, 15) - 355181293.097636*pow(xi1, 13) + 24291570.510322*pow(xi1, 11) - 1151268.66901578*pow(xi1, 9) + 35228.0717384415*pow(xi1, 7) - 622.4586490659*pow(xi1, 5) + 5.19581510071703*pow(xi1, 3) + 4.54747350886464e-13*pow(xi2, 3)*(1.65942756909939e+23*pow(xi2, 46) - 2.0318768679417e+24*pow(xi2, 44) + 1.16780146478898e+25*pow(xi2, 42) - 4.18696847309143e+25*pow(xi2, 40) + 1.04976060359527e+26*pow(xi2, 38) - 1.95549870602229e+26*pow(xi2, 36) + 2.80693834488425e+26*pow(xi2, 34) - 3.17787893428876e+26*pow(xi2, 32) + 2.88110293215634e+26*pow(xi2, 30) - 2.1118799141425e+26*pow(xi2, 28) + 1.25845386625002e+26*pow(xi2, 26) - 6.10896288590674e+25*pow(xi2, 24) + 2.41364148519837e+25*pow(xi2, 22) - 7.73267891598393e+24*pow(xi2, 20) + 1.99543189399627e+24*pow(xi2, 18) - 4.10647504912259e+23*pow(xi2, 16) + 6.64683959389236e+22*pow(xi2, 14) - 8.30500088436035e+21*pow(xi2, 12) + 7.81051923458733e+20*pow(xi2, 10) - 5.34177284660791e+19*pow(xi2, 8) + 2.53166657655409e+18*pow(xi2, 6) - 7.7467349001087e+16*pow(xi2, 4) + 1.3688010449154e+15*pow(xi2, 2) - 11425718238025.0);
case 26:
return -144824210854.642*pow(xi1, 50) + 1809516572879.87*pow(xi1, 48) - 10626311398270.7*pow(xi1, 46) + 38984017588812.6*pow(xi1, 44) - 100171327455461.0*pow(xi1, 42) + 191579165608972.0*pow(xi1, 40) - 282894076206354.0*pow(xi1, 38) + 330216112067159.0*pow(xi1, 36) - 309446644109395.0*pow(xi1, 34) + 235130614154372.0*pow(xi1, 32) - 145719751523803.0*pow(xi1, 30) + 73847974938271.3*pow(xi1, 28) - 30595276980720.1*pow(xi1, 26) + 10331946432099.3*pow(xi1, 24) - 2827813652143.41*pow(xi1, 22) + 621862223301.171*pow(xi1, 20) - 108552592052.753*pow(xi1, 18) + 14796557716.0717*pow(xi1, 16) - 1540678338.77952*pow(xi1, 14) + 118968280.900703*pow(xi1, 12) - 6540599.65782463*pow(xi1, 10) + 241550.011083072*pow(xi1, 8) - 5487.56011862229*pow(xi1, 6) + 66.2466425341421*pow(xi1, 4) - 0.324738443794814*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(5.09554892218119e+24*pow(xi2, 48) - 6.36667044011133e+25*pow(xi2, 46) + 3.73880094168553e+26*pow(xi2, 44) - 1.37162818036235e+27*pow(xi2, 42) + 3.52446525782516e+27*pow(xi2, 40) - 6.74059264725402e+27*pow(xi2, 38) + 9.95345043897074e+27*pow(xi2, 36) - 1.16184465566984e+28*pow(xi2, 34) + 1.08876858679853e+28*pow(xi2, 32) - 8.27292301788302e+27*pow(xi2, 30) + 5.12705795830563e+27*pow(xi2, 28) - 2.59829462823488e+27*pow(xi2, 26) + 1.07647560945053e+27*pow(xi2, 24) - 3.6352304766886e+26*pow(xi2, 22) + 9.94948477348925e+25*pow(xi2, 20) - 2.18798318526167e+25*pow(xi2, 18) + 3.81935478999124e+24*pow(xi2, 16) - 5.20607592316147e+23*pow(xi2, 14) + 5.42077999408221e+22*pow(xi2, 12) - 4.18582426197903e+21*pow(xi2, 10) + 2.30126892044989e+20*pow(xi2, 8) - 8.49878546800829e+18*pow(xi2, 6) + 1.93076357073442e+17*pow(xi2, 4) - 2.3308465205571e+15*pow(xi2, 2) + 11425718238025.0);
case 27:
return -278289660073.626*pow(xi1, 51) + 3546715367868.79*pow(xi1, 49) - 21271461544232.5*pow(xi1, 47) + 79808828305955.9*pow(xi1, 45) - 210048376018619.0*pow(xi1, 43) + 412164827885753.0*pow(xi1, 41) - 625623902809171.0*pow(xi1, 39) + 752270037009883.0*pow(xi1, 37) - 727919084957637.0*pow(xi1, 35) + 572667367194640.0*pow(xi1, 33) - 368593156629910.0*pow(xi1, 31) + 194689668307385.0*pow(xi1, 29) - 84414885419778.8*pow(xi1, 27) + 29977522291920.8*pow(xi1, 25) - 8677294497877.93*pow(xi1, 23) + 2031930156457.91*pow(xi1, 21) - 380836253965.713*pow(xi1, 19) + 56312570949.4745*pow(xi1, 17) - 6444024306.2957*pow(xi1, 15) + 556215115.741772*pow(xi1, 13) - 34974067.0802148*pow(xi1, 11) + 1526051.7193421*pow(xi1, 9) - 43038.0498681893*pow(xi1, 7) + 701.435038596799*pow(xi1, 5) - 5.41230739658024*pow(xi1, 3) + 1.114576840408e-15*pow(xi2, 3)*(2.49681897186879e+26*pow(xi2, 48) - 3.18211830650499e+27*pow(xi2, 46) + 1.90847869550617e+28*pow(xi2, 44) - 7.16045995328067e+28*pow(xi2, 42) + 1.88455715571597e+29*pow(xi2, 40) - 3.69794896989674e+29*pow(xi2, 38) + 5.61310696694681e+29*pow(xi2, 36) - 6.74937796782596e+29*pow(xi2, 34) + 6.53090086360646e+29*pow(xi2, 32) - 5.13798014127954e+29*pow(xi2, 30) + 3.30702328692729e+29*pow(xi2, 28) - 1.74675860155247e+29*pow(xi2, 26) + 7.57371608303632e+28*pow(xi2, 24) - 2.68958776148151e+28*pow(xi2, 22) + 7.78528153761165e+27*pow(xi2, 20) - 1.82305076042501e+27*pow(xi2, 18) + 3.41686853843387e+26*pow(xi2, 16) - 5.05237224639091e+25*pow(xi2, 14) + 5.78158819802573e+24*pow(xi2, 12) - 4.99037029639127e+23*pow(xi2, 10) + 3.13787850350562e+22*pow(xi2, 8) - 1.36917587376342e+21*pow(xi2, 6) + 3.8613802393772e+19*pow(xi2, 4) - 6.29328560550417e+17*pow(xi2, 2) + 4.85593025116063e+15);
case 28:
return -535378258765.904*pow(xi1, 52) + 6957132282978.78*pow(xi1, 50) - 42595443276427.3*pow(xi1, 48) + 163362474138947.0*pow(xi1, 46) - 440138555906054.0*pow(xi1, 44) + 885546290235663.0*pow(xi1, 42) - 1.38071645028501e+15*pow(xi1, 40) + 1.70878839294907e+15*pow(xi1, 38) - 1.70569451657033e+15*pow(xi1, 36) + 1.38781541457191e+15*pow(xi1, 34) - 926502730715607.0*pow(xi1, 32) + 509276709063429.0*pow(xi1, 30) - 230677032527233.0*pow(xi1, 28) + 85958980709566.8*pow(xi1, 26) - 26246208822548.7*pow(xi1, 24) + 6523592143785.49*pow(xi1, 22) - 1307618157198.77*pow(xi1, 20) + 208700139822.507*pow(xi1, 18) - 26077648271.0214*pow(xi1, 16) + 2494527583.2682*pow(xi1, 14) - 177278640.712216*pow(xi1, 12) + 8983106.36013146*pow(xi1, 10) - 306127.817401721*pow(xi1, 8) + 6423.07661945851*pow(xi1, 6) - 71.6610315874133*pow(xi1, 4) + 0.31224850364886*pow(xi1, 2) + 7.105427357601e-15*pow(xi2, 2)*(7.53477914587622e+25*pow(xi2, 50) - 9.79129323662202e+26*pow(xi2, 48) + 5.99477570210621e+27*pow(xi2, 46) - 2.29912243018276e+28*pow(xi2, 44) + 6.19439948865592e+28*pow(xi2, 42) - 1.24629560710145e+29*pow(xi2, 40) + 1.94318565343997e+29*pow(xi2, 38) - 2.4049058655439e+29*pow(xi2, 36) + 2.40055162163563e+29*pow(xi2, 34) - 1.95317655747658e+29*pow(xi2, 32) + 1.30393667275267e+29*pow(xi2, 30) - 7.16743249114541e+28*pow(xi2, 28) + 3.2464906179143e+28*pow(xi2, 26) - 1.20976510466485e+28*pow(xi2, 24) + 3.69382550853495e+27*pow(xi2, 22) - 9.1811397337092e+26*pow(xi2, 20) + 1.84030895171978e+26*pow(xi2, 18) - 2.93719334980254e+25*pow(xi2, 16) + 3.67010271987722e+24*pow(xi2, 14) - 3.51073546702253e+23*pow(xi2, 12) + 2.49497506328839e+22*pow(xi2, 10) - 1.26425982675367e+21*pow(xi2, 8) + 4.30836601368166e+19*pow(xi2, 6) - 9.03967670936421e+17*pow(xi2, 4) + 1.00853935985644e+16*pow(xi2, 2) - 43945070146250.0);
case 29:
return -1031098868734.33*pow(xi1, 53) + 13656799302216.0*pow(xi1, 51) - 85322239662808.6*pow(xi1, 49) + 334335254497875.0*pow(xi1, 47) - 921629169951347.0*pow(xi1, 45) + 1.90013792114849e+15*pow(xi1, 43) - 3.04108995585405e+15*pow(xi1, 41) + 3.87073358105217e+15*pow(xi1, 39) - 3.98213104426395e+15*pow(xi1, 37) + 3.34735422684659e+15*pow(xi1, 35) - 2.31503617547326e+15*pow(xi1, 33) + 1.32238476900186e+15*pow(xi1, 31) - 624675256927435.0*pow(xi1, 29) + 243773285298310.0*pow(xi1, 27) - 78326766091896.9*pow(xi1, 25) + 20604719081135.1*pow(xi1, 23) - 4401250638548.01*pow(xi1, 21) + 754840239473.165*pow(xi1, 19) - 102405233319.159*pow(xi1, 17) + 10775577645.0379*pow(xi1, 15) - 856837392.061791*pow(xi1, 13) + 49709190.4236064*pow(xi1, 11) - 2003680.2341744*pow(xi1, 9) + 52251.1293174511*pow(xi1, 7) - 787.990323808263*pow(xi1, 5) + 5.62047306567948*pow(xi1, 3) + 2.8421709430404e-14*pow(xi2, 3)*(3.62785662579225e+25*pow(xi2, 50) - 4.80505908191668e+26*pow(xi2, 48) + 3.00200942774876e+27*pow(xi2, 46) - 1.17633759966676e+28*pow(xi2, 44) + 3.24269436434896e+28*pow(xi2, 42) - 6.68551596377883e+28*pow(xi2, 40) + 1.06998840562379e+29*pow(xi2, 38) - 1.36189330572477e+29*pow(xi2, 36) + 1.40108780367872e+29*pow(xi2, 34) - 1.17774556630495e+29*pow(xi2, 32) + 8.14530941969576e+28*pow(xi2, 30) - 4.65272777571657e+28*pow(xi2, 28) + 2.19788066744216e+28*pow(xi2, 26) - 8.57700997525273e+27*pow(xi2, 24) + 2.75587808269221e+27*pow(xi2, 22) - 7.24964102936513e+26*pow(xi2, 20) + 1.54855240122882e+26*pow(xi2, 18) - 2.65585798532469e+25*pow(xi2, 16) + 3.60306383294494e+24*pow(xi2, 14) - 3.79131933335112e+23*pow(xi2, 12) + 3.01472856219265e+22*pow(xi2, 10) - 1.74898665209877e+21*pow(xi2, 8) + 7.04982309062303e+19*pow(xi2, 6) - 1.83842317596688e+18*pow(xi2, 4) + 2.77249447552691e+16*pow(xi2, 2) - 197752815658125.0);
default:
return 0.;
}
case 28:
switch(j) {
case 0:
return 1.49011611938477e-8*y1t*(-26567064265077.0*pow(xi1, 28) + 182322990054450.0*pow(xi1, 26) - 556271163533475.0*pow(xi1, 24) + 994186760357700.0*pow(xi1, 22) - 1.15436129397089e+15*pow(xi1, 20) + 912750790581630.0*pow(xi1, 18) - 500899824099675.0*pow(xi1, 16) + 190818980609400.0*pow(xi1, 14) - 49638721307175.0*pow(xi1, 12) + 8509495081230.0*pow(xi1, 10) - 902522205585.0*pow(xi1, 8) + 52933853700.0*pow(xi1, 6) - 1368978975.0*pow(xi1, 4) + 7800450.0*pow(xi1, 2) - 3.0*pow(xi2, 2)*(-8855688088359.0*pow(xi2, 26) + 60774330018150.0*pow(xi2, 24) - 185423721177825.0*pow(xi2, 22) + 331395586785900.0*pow(xi2, 20) - 384787097990295.0*pow(xi2, 18) + 304250263527210.0*pow(xi2, 16) - 166966608033225.0*pow(xi2, 14) + 63606326869800.0*pow(xi2, 12) - 16546240435725.0*pow(xi2, 10) + 2836498360410.0*pow(xi2, 8) - 300840735195.0*pow(xi2, 6) + 17644617900.0*pow(xi2, 4) - 456326325.0*pow(xi2, 2) + 2600150.0));
case 1:
return 7.45058059692383e-9*y1r*(-26567064265077.0*pow(xi1, 28) + 9183676536076.0*pow(xi1, 27) + 182322990054450.0*pow(xi1, 26) - 63205303218876.0*pow(xi1, 25) - 556271163533475.0*pow(xi1, 24) + 193485622098600.0*pow(xi1, 23) + 994186760357700.0*pow(xi1, 22) - 347176329013800.0*pow(xi1, 21) - 1.15436129397089e+15*pow(xi1, 20) + 405039050516100.0*pow(xi1, 19) + 912750790581630.0*pow(xi1, 18) - 322147337852340.0*pow(xi1, 17) - 500899824099675.0*pow(xi1, 16) + 178097715235440.0*pow(xi1, 15) + 190818980609400.0*pow(xi1, 14) - 68499121244400.0*pow(xi1, 13) - 49638721307175.0*pow(xi1, 12) + 18050444111700.0*pow(xi1, 11) + 8509495081230.0*pow(xi1, 10) - 3151664844900.0*pow(xi1, 9) - 902522205585.0*pow(xi1, 8) + 343817983080.0*pow(xi1, 7) + 52933853700.0*pow(xi1, 6) - 21173541480.0*pow(xi1, 5) - 1368978975.0*pow(xi1, 4) + 608435100.0*pow(xi1, 3) + 7800450.0*pow(xi1, 2) - 5200300.0*xi1 + xi2*(26567064265077.0*pow(xi2, 27) - 9183676536076.0*pow(xi2, 26) - 182322990054450.0*pow(xi2, 25) + 63205303218876.0*pow(xi2, 24) + 556271163533475.0*pow(xi2, 23) - 193485622098600.0*pow(xi2, 22) - 994186760357700.0*pow(xi2, 21) + 347176329013800.0*pow(xi2, 20) + 1.15436129397089e+15*pow(xi2, 19) - 405039050516100.0*pow(xi2, 18) - 912750790581630.0*pow(xi2, 17) + 322147337852340.0*pow(xi2, 16) + 500899824099675.0*pow(xi2, 15) - 178097715235440.0*pow(xi2, 14) - 190818980609400.0*pow(xi2, 13) + 68499121244400.0*pow(xi2, 12) + 49638721307175.0*pow(xi2, 11) - 18050444111700.0*pow(xi2, 10) - 8509495081230.0*pow(xi2, 9) + 3151664844900.0*pow(xi2, 8) + 902522205585.0*pow(xi2, 7) - 343817983080.0*pow(xi2, 6) - 52933853700.0*pow(xi2, 5) + 21173541480.0*pow(xi2, 4) + 1368978975.0*pow(xi2, 3) - 608435100.0*pow(xi2, 2) - 7800450.0*xi2 + 5200300.0));
case 2:
return 1.49011611938477e-8*y2t*(26567064265077.0*pow(xi1, 28) - 182322990054450.0*pow(xi1, 26) + 556271163533475.0*pow(xi1, 24) - 994186760357700.0*pow(xi1, 22) + 1.15436129397089e+15*pow(xi1, 20) - 912750790581630.0*pow(xi1, 18) + 500899824099675.0*pow(xi1, 16) - 190818980609400.0*pow(xi1, 14) + 49638721307175.0*pow(xi1, 12) - 8509495081230.0*pow(xi1, 10) + 902522205585.0*pow(xi1, 8) - 52933853700.0*pow(xi1, 6) + 1368978975.0*pow(xi1, 4) - 7800450.0*pow(xi1, 2) + 3.0*pow(xi2, 2)*(-8855688088359.0*pow(xi2, 26) + 60774330018150.0*pow(xi2, 24) - 185423721177825.0*pow(xi2, 22) + 331395586785900.0*pow(xi2, 20) - 384787097990295.0*pow(xi2, 18) + 304250263527210.0*pow(xi2, 16) - 166966608033225.0*pow(xi2, 14) + 63606326869800.0*pow(xi2, 12) - 16546240435725.0*pow(xi2, 10) + 2836498360410.0*pow(xi2, 8) - 300840735195.0*pow(xi2, 6) + 17644617900.0*pow(xi2, 4) - 456326325.0*pow(xi2, 2) + 2600150.0));
case 3:
return 7.45058059692383e-9*y2r*(-26567064265077.0*pow(xi1, 28) - 9183676536076.0*pow(xi1, 27) + 182322990054450.0*pow(xi1, 26) + 63205303218876.0*pow(xi1, 25) - 556271163533475.0*pow(xi1, 24) - 193485622098600.0*pow(xi1, 23) + 994186760357700.0*pow(xi1, 22) + 347176329013800.0*pow(xi1, 21) - 1.15436129397089e+15*pow(xi1, 20) - 405039050516100.0*pow(xi1, 19) + 912750790581630.0*pow(xi1, 18) + 322147337852340.0*pow(xi1, 17) - 500899824099675.0*pow(xi1, 16) - 178097715235440.0*pow(xi1, 15) + 190818980609400.0*pow(xi1, 14) + 68499121244400.0*pow(xi1, 13) - 49638721307175.0*pow(xi1, 12) - 18050444111700.0*pow(xi1, 11) + 8509495081230.0*pow(xi1, 10) + 3151664844900.0*pow(xi1, 9) - 902522205585.0*pow(xi1, 8) - 343817983080.0*pow(xi1, 7) + 52933853700.0*pow(xi1, 6) + 21173541480.0*pow(xi1, 5) - 1368978975.0*pow(xi1, 4) - 608435100.0*pow(xi1, 3) + 7800450.0*pow(xi1, 2) + 5200300.0*xi1 + xi2*(26567064265077.0*pow(xi2, 27) + 9183676536076.0*pow(xi2, 26) - 182322990054450.0*pow(xi2, 25) - 63205303218876.0*pow(xi2, 24) + 556271163533475.0*pow(xi2, 23) + 193485622098600.0*pow(xi2, 22) - 994186760357700.0*pow(xi2, 21) - 347176329013800.0*pow(xi2, 20) + 1.15436129397089e+15*pow(xi2, 19) + 405039050516100.0*pow(xi2, 18) - 912750790581630.0*pow(xi2, 17) - 322147337852340.0*pow(xi2, 16) + 500899824099675.0*pow(xi2, 15) + 178097715235440.0*pow(xi2, 14) - 190818980609400.0*pow(xi2, 13) - 68499121244400.0*pow(xi2, 12) + 49638721307175.0*pow(xi2, 11) + 18050444111700.0*pow(xi2, 10) - 8509495081230.0*pow(xi2, 9) - 3151664844900.0*pow(xi2, 8) + 902522205585.0*pow(xi2, 7) + 343817983080.0*pow(xi2, 6) - 52933853700.0*pow(xi2, 5) - 21173541480.0*pow(xi2, 4) + 1368978975.0*pow(xi2, 3) + 608435100.0*pow(xi2, 2) - 7800450.0*xi2 - 5200300.0));
case 4:
return -382229.068886697*pow(xi1, 29) + 2753048.58766758*pow(xi1, 27) - 8899355.23585993*pow(xi1, 25) + 17053587.3045981*pow(xi1, 23) - 21555543.5055122*pow(xi1, 21) + 18920754.2807454*pow(xi1, 19) - 11825300.252687*pow(xi1, 17) + 5307725.52595854*pow(xi1, 15) - 1703492.98975021*pow(xi1, 13) + 384246.5390414*pow(xi1, 11) - 58917.8026530147*pow(xi1, 9) + 5799.38080430031*pow(xi1, 7) - 331.82985574007*pow(xi1, 5) + 9.14388000965118*pow(xi1, 3) - 0.077490508556366*xi1 + 382229.068886697*pow(xi2, 29) - 2753048.58766758*pow(xi2, 27) + 8899355.23585993*pow(xi2, 25) - 17053587.3045981*pow(xi2, 23) + 21555543.5055122*pow(xi2, 21) - 18920754.2807454*pow(xi2, 19) + 11825300.252687*pow(xi2, 17) - 5307725.52595854*pow(xi2, 15) + 1703492.98975021*pow(xi2, 13) - 384246.5390414*pow(xi2, 11) + 58917.8026530147*pow(xi2, 9) - 5799.38080430031*pow(xi2, 7) + 331.82985574007*pow(xi2, 5) - 9.14388000965118*pow(xi2, 3) + 0.077490508556366*xi2;
case 5:
return -615813.499873012*pow(xi1, 30) + 4600489.08728662*pow(xi1, 28) - 15469264.6876864*pow(xi1, 26) + 30922406.9560893*pow(xi1, 24) - 40877148.8659076*pow(xi1, 22) + 37602893.7078018*pow(xi1, 20) - 24658808.1726824*pow(xi1, 18) + 11610649.5880343*pow(xi1, 16) - 3900102.37127021*pow(xi1, 14) + 915787.584715337*pow(xi1, 12) - 144732.863038927*pow(xi1, 10) + 14434.5987246931*pow(xi1, 8) - 811.441860347986*pow(xi1, 6) + 20.4962395131588*pow(xi1, 4) - 0.116235762834549*pow(xi1, 2) + 2.98023223876953e-8*pow(xi2, 2)*(20663272206171.0*pow(xi2, 28) - 154366798246101.0*pow(xi2, 26) + 519062390052975.0*pow(xi2, 24) - 1.03758380148443e+15*pow(xi2, 22) + 1.37160951197498e+15*pow(xi2, 20) - 1.26174373992167e+15*pow(xi2, 18) + 827412302031315.0*pow(xi2, 16) - 389588752077525.0*pow(xi2, 14) + 130865719809825.0*pow(xi2, 12) - 30728732237775.0*pow(xi2, 10) + 4856429011005.0*pow(xi2, 8) - 484344761355.0*pow(xi2, 6) + 27227470725.0*pow(xi2, 4) - 687739675.0*pow(xi2, 2) + 3900225.0);
case 6:
return -1042909.95946236*pow(xi1, 31) + 8059911.98363207*pow(xi1, 29) - 28133362.1181482*pow(xi1, 27) + 58624160.113125*pow(xi1, 25) - 81214983.145294*pow(xi1, 23) + 78838147.1421372*pow(xi1, 21) - 55072273.9968482*pow(xi1, 19) + 27992398.0403953*pow(xi1, 17) - 10350961.3508769*pow(xi1, 15) + 2756968.91762204*pow(xi1, 13) - 518441.73184298*pow(xi1, 11) + 66642.1722281724*pow(xi1, 9) - 5566.69839374721*pow(xi1, 7) + 277.567127123475*pow(xi1, 5) - 6.99351839721203*pow(xi1, 3) + 0.0581178814172745*xi1 + 1042909.95946236*pow(xi2, 31) - 8059911.98363207*pow(xi2, 29) + 28133362.1181482*pow(xi2, 27) - 58624160.113125*pow(xi2, 25) + 81214983.145294*pow(xi2, 23) - 78838147.1421372*pow(xi2, 21) + 55072273.9968482*pow(xi2, 19) - 27992398.0403953*pow(xi2, 17) + 10350961.3508769*pow(xi2, 15) - 2756968.91762204*pow(xi2, 13) + 518441.73184298*pow(xi2, 11) - 66642.1722281724*pow(xi2, 9) + 5566.69839374721*pow(xi2, 7) - 277.567127123475*pow(xi2, 5) + 6.99351839721203*pow(xi2, 3) - 0.0581178814172745*xi2;
case 7:
return -1818574.24181249*pow(xi1, 32) + 14516897.6514182*pow(xi1, 30) - 52511869.8034722*pow(xi1, 28) + 113840304.253635*pow(xi1, 26) - 164833771.490504*pow(xi1, 24) + 168159990.091489*pow(xi1, 22) - 124255903.500852*pow(xi1, 20) + 67314123.2068179*pow(xi1, 18) - 26755766.9500322*pow(xi1, 16) + 7728158.51647016*pow(xi1, 14) - 1588058.92531319*pow(xi1, 12) + 223746.609440781*pow(xi1, 10) - 20315.2289499063*pow(xi1, 8) + 1065.5041789636*pow(xi1, 6) - 25.8382414467633*pow(xi1, 4) + 0.145294703543186*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(3.90535844696632e+15*pow(xi2, 30) - 3.11748003261102e+16*pow(xi2, 28) + 1.12768381728861e+17*pow(xi2, 26) - 2.44470191868025e+17*pow(xi2, 24) + 3.53977828914025e+17*pow(xi2, 22) - 3.61120828969315e+17*pow(xi2, 20) + 2.66837520935546e+17*pow(xi2, 18) - 1.44555978866099e+17*pow(xi2, 16) + 5.7457572014893e+16*pow(xi2, 14) - 1.65960940432716e+16*pow(xi2, 12) + 3.41033057417052e+15*pow(xi2, 10) - 480492185069520.0*pow(xi2, 8) + 43626621975300.0*pow(xi2, 6) - 2288152801200.0*pow(xi2, 4) + 55487201000.0*pow(xi2, 2) - 312018000.0);
case 8:
return -3233020.87433331*pow(xi1, 33) + 26624877.7886273*pow(xi1, 31) - 99668638.718943*pow(xi1, 29) + 224421795.69438*pow(xi1, 27) - 338960904.584224*pow(xi1, 25) + 362568410.607603*pow(xi1, 23) - 282653208.096126*pow(xi1, 21) + 162807565.128513*pow(xi1, 19) - 69493811.927836*pow(xi1, 17) + 21849539.0316908*pow(xi1, 15) - 4984958.43316376*pow(xi1, 13) + 804945.792270452*pow(xi1, 11) - 88641.442552954*pow(xi1, 9) + 6313.27903792262*pow(xi1, 7) - 269.202026724815*pow(xi1, 5) + 6.00551441311836*pow(xi1, 3) - 0.0484315678477287*xi1 + 3233020.87433331*pow(xi2, 33) - 26624877.7886273*pow(xi2, 31) + 99668638.718943*pow(xi2, 29) - 224421795.69438*pow(xi2, 27) + 338960904.584224*pow(xi2, 25) - 362568410.607603*pow(xi2, 23) + 282653208.096126*pow(xi2, 21) - 162807565.128513*pow(xi2, 19) + 69493811.927836*pow(xi2, 17) - 21849539.0316908*pow(xi2, 15) + 4984958.43316376*pow(xi2, 13) - 804945.792270452*pow(xi2, 11) + 88641.442552954*pow(xi2, 9) - 6313.27903792262*pow(xi2, 7) + 269.202026724815*pow(xi2, 5) - 6.00551441311836*pow(xi2, 3) + 0.0484315678477287*xi2;
case 9:
return -5827588.0465924*pow(xi1, 34) + 49459785.7287714*pow(xi1, 32) - 191371992.258556*pow(xi1, 30) + 446908389.876074*pow(xi1, 28) - 702864733.260658*pow(xi1, 26) + 786571534.918486*pow(xi1, 24) - 645204185.079993*pow(xi1, 22) + 393744121.477465*pow(xi1, 20) - 179587759.860223*pow(xi1, 18) + 60975122.6641322*pow(xi1, 16) - 15220645.8223283*pow(xi1, 14) + 2731517.74901457*pow(xi1, 12) - 339940.64778775*pow(xi1, 10) + 27672.1318222582*pow(xi1, 8) - 1329.91148047149*pow(xi1, 6) + 30.5118877440691*pow(xi1, 4) - 0.169510487467051*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.56433125466718e+15*pow(xi2, 32) - 1.3276760135765e+16*pow(xi2, 30) + 5.1371028007554e+16*pow(xi2, 28) - 1.1996605742661e+17*pow(xi2, 26) + 1.88673815179143e+17*pow(xi2, 24) - 2.11143688652464e+17*pow(xi2, 22) + 1.73195679635056e+17*pow(xi2, 20) - 1.05694882796123e+17*pow(xi2, 18) + 4.82077222100974e+16*pow(xi2, 16) - 1.63678848570023e+16*pow(xi2, 14) + 4.08576100193118e+15*pow(xi2, 12) - 733236212528820.0*pow(xi2, 10) + 91252122801840.0*pow(xi2, 8) - 7428181324200.0*pow(xi2, 6) + 356995394700.0*pow(xi2, 4) - 8190472500.0*pow(xi2, 2) + 45502625.0);
case 10:
return -10614535.370579*pow(xi1, 35) + 92755776.4082624*pow(xi1, 33) - 370544334.663235*pow(xi1, 31) + 896268350.896106*pow(xi1, 29) - 1465430395.17544*pow(xi1, 27) + 1712419554.36447*pow(xi1, 25) - 1474407039.04468*pow(xi1, 23) + 950436059.72244*pow(xi1, 21) - 461461192.923372*pow(xi1, 19) + 168410243.079443*pow(xi1, 17) - 45754476.8418039*pow(xi1, 15) + 9089465.50231274*pow(xi1, 13) - 1283771.85423849*pow(xi1, 11) + 123681.481937598*pow(xi1, 9) - 7661.47689465433*pow(xi1, 7) + 281.319605000317*pow(xi1, 5) - 5.46671322081238*pow(xi1, 3) + 0.0423776218667626*xi1 + 10614535.370579*pow(xi2, 35) - 92755776.4082624*pow(xi2, 33) + 370544334.663235*pow(xi2, 31) - 896268350.896106*pow(xi2, 29) + 1465430395.17544*pow(xi2, 27) - 1712419554.36447*pow(xi2, 25) + 1474407039.04468*pow(xi2, 23) - 950436059.72244*pow(xi2, 21) + 461461192.923372*pow(xi2, 19) - 168410243.079443*pow(xi2, 17) + 45754476.8418039*pow(xi2, 15) - 9089465.50231274*pow(xi2, 13) + 1283771.85423849*pow(xi2, 11) - 123681.481937598*pow(xi2, 9) + 7661.47689465433*pow(xi2, 7) - 281.319605000317*pow(xi2, 5) + 5.46671322081238*pow(xi2, 3) - 0.0423776218667626*xi2;
case 11:
return -19492742.4243658*pow(xi1, 36) + 175232335.012119*pow(xi1, 34) - 722008921.923926*pow(xi1, 32) + 1806628056.05124*pow(xi1, 30) - 3066428693.32447*pow(xi1, 28) + 3734932372.32101*pow(xi1, 26) - 3368124476.71676*pow(xi1, 24) + 2287179847.95449*pow(xi1, 22) - 1178061248.61469*pow(xi1, 20) + 460069121.41871*pow(xi1, 18) - 135223661.775479*pow(xi1, 16) + 29472096.8897768*pow(xi1, 14) - 4650842.96896293*pow(xi1, 12) + 512427.983994139*pow(xi1, 10) - 37260.1692651166*pow(xi1, 8) + 1624.96143495664*pow(xi1, 6) - 34.866188390879*pow(xi1, 4) + 0.190699298400432*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(8.37206912220028e+16*pow(xi2, 34) - 7.52617148078766e+17*pow(xi2, 32) + 3.10100470708348e+18*pow(xi2, 30) - 7.75940841677612e+18*pow(xi2, 28) + 1.31702109533446e+19*pow(xi2, 26) - 1.60414123918904e+19*pow(xi2, 24) + 1.44659844763556e+19*pow(xi2, 22) - 9.8233626470348e+18*pow(xi2, 20) + 5.059734535485e+18*pow(xi2, 18) - 1.97598183039281e+18*pow(xi2, 16) + 5.80781204971046e+17*pow(xi2, 14) - 1.26581692286135e+17*pow(xi2, 12) + 1.99752184505273e+16*pow(xi2, 10) - 2.20086143281004e+15*pow(xi2, 8) + 160031208437100.0*pow(xi2, 6) - 6979156220400.0*pow(xi2, 4) + 149749138875.0*pow(xi2, 2) - 819047250.0);
case 12:
return -36035231.94126*pow(xi1, 37) + 332981905.88446*pow(xi1, 35) - 1413726939.76667*pow(xi1, 33) + 3655354391.35564*pow(xi1, 31) - 6431952084.25*pow(xi1, 29) + 8152430288.7193*pow(xi1, 27) - 7684636644.4594*pow(xi1, 25) + 5483667102.29229*pow(xi1, 23) - 2987122332.19582*pow(xi1, 21) + 1243439492.18471*pow(xi1, 19) - 393380943.358236*pow(xi1, 17) + 93442880.9754944*pow(xi1, 15) - 16337382.0053395*pow(xi1, 13) + 2040497.55025906*pow(xi1, 11) - 174241.619613813*pow(xi1, 9) + 9541.69497068971*pow(xi1, 7) - 306.184250854421*pow(xi1, 5) + 5.16159434337169*pow(xi1, 3) - 0.0381398596800864*xi1 + 36035231.94126*pow(xi2, 37) - 332981905.88446*pow(xi2, 35) + 1413726939.76667*pow(xi2, 33) - 3655354391.35564*pow(xi2, 31) + 6431952084.25*pow(xi2, 29) - 8152430288.7193*pow(xi2, 27) + 7684636644.4594*pow(xi2, 25) - 5483667102.29229*pow(xi2, 23) + 2987122332.19582*pow(xi2, 21) - 1243439492.18471*pow(xi2, 19) + 393380943.358236*pow(xi2, 17) - 93442880.9754944*pow(xi2, 15) + 16337382.0053395*pow(xi2, 13) - 2040497.55025906*pow(xi2, 11) + 174241.619613813*pow(xi2, 9) - 9541.69497068971*pow(xi2, 7) + 306.184250854421*pow(xi2, 5) - 5.16159434337169*pow(xi2, 3) + 0.0381398596800864*xi2;
case 13:
return -66984151.2400934*pow(xi1, 38) + 635755272.974369*pow(xi1, 36) - 2778854981.71771*pow(xi1, 34) + 7416700465.30732*pow(xi1, 32) - 13512264351.8898*pow(xi1, 30) + 17795545479.9828*pow(xi1, 28) - 17501806486.5197*pow(xi1, 26) + 13094549563.7091*pow(xi1, 24) - 7522729401.02621*pow(xi1, 22) + 3326111850.47562*pow(xi1, 20) - 1127522417.34474*pow(xi1, 18) + 290172121.541803*pow(xi1, 16) - 55754538.0001717*pow(xi1, 14) + 7798909.77564694*pow(xi1, 12) - 765222.40460386*pow(xi1, 10) + 49811.8488852354*pow(xi1, 8) - 1964.34897631989*pow(xi1, 6) + 39.0869995288085*pow(xi1, 4) - 0.209769228240475*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(2.87694738926519e+17*pow(xi2, 36) - 2.73054810568447e+18*pow(xi2, 34) + 1.19350912668042e+19*pow(xi2, 32) - 3.18544859427229e+19*pow(xi2, 30) + 5.80347334862732e+19*pow(xi2, 28) - 7.64312858510066e+19*pow(xi2, 26) + 7.5169686480523e+19*pow(xi2, 24) - 5.62406621319816e+19*pow(xi2, 22) + 3.23098767540653e+19*pow(xi2, 20) - 1.42855416206308e+19*pow(xi2, 18) + 4.84267190800251e+18*pow(xi2, 16) - 1.24627977223298e+18*pow(xi2, 14) + 2.39463917314327e+17*pow(xi2, 12) - 3.34960624308583e+16*pow(xi2, 10) + 3.28660520194006e+15*pow(xi2, 8) - 213940261915380.0*pow(xi2, 6) + 8436814611225.0*pow(xi2, 4) - 167877384675.0*pow(xi2, 2) + 900951975.0);
case 14:
return -125094333.726157*pow(xi1, 39) + 1218629967.16863*pow(xi1, 37) - 5479196736.83039*pow(xi1, 35) + 15080490963.6401*pow(xi1, 33) - 28413812500.6887*pow(xi1, 31) + 38827942540.1858*pow(xi1, 29) - 39775778008.2976*pow(xi1, 27) + 31138221454.6458*pow(xi1, 25) - 18818365412.316*pow(xi1, 23) + 8809669483.95246*pow(xi1, 21) - 3187162871.2602*pow(xi1, 19) + 884046946.742028*pow(xi1, 17) - 185394647.761177*pow(xi1, 15) + 28774004.6464238*pow(xi1, 13) - 3203798.15636541*pow(xi1, 11) + 244586.1160801*pow(xi1, 9) - 11973.6984699435*pow(xi1, 7) + 340.602295894059*pow(xi1, 5) - 4.99949993973132*pow(xi1, 3) + 0.0349615380400792*xi1 + 125094333.726157*pow(xi2, 39) - 1218629967.16863*pow(xi2, 37) + 5479196736.83039*pow(xi2, 35) - 15080490963.6401*pow(xi2, 33) + 28413812500.6887*pow(xi2, 31) - 38827942540.1858*pow(xi2, 29) + 39775778008.2976*pow(xi2, 27) - 31138221454.6458*pow(xi2, 25) + 18818365412.316*pow(xi2, 23) - 8809669483.95246*pow(xi2, 21) + 3187162871.2602*pow(xi2, 19) - 884046946.742028*pow(xi2, 17) + 185394647.761177*pow(xi2, 15) - 28774004.6464238*pow(xi2, 13) + 3203798.15636541*pow(xi2, 11) - 244586.1160801*pow(xi2, 9) + 11973.6984699435*pow(xi2, 7) - 340.602295894059*pow(xi2, 5) + 4.99949993973132*pow(xi2, 3) - 0.0349615380400792*xi2;
case 15:
return -234551875.736545*pow(xi1, 40) + 2343679134.81065*pow(xi1, 38) - 10831075689.4263*pow(xi1, 36) + 30713072121.1401*pow(xi1, 34) - 59780571314.211*pow(xi1, 32) + 84653008995.6795*pow(xi1, 30) - 90186685266.1405*pow(xi1, 28) + 73733585896.2953*pow(xi1, 26) - 46768558930.8651*pow(xi1, 24) + 23115653989.3216*pow(xi1, 22) - 8892958492.16441*pow(xi1, 20) + 2646430745.77703*pow(xi1, 18) - 602096347.338786*pow(xi1, 16) + 102847878.539102*pow(xi1, 14) - 12846714.7480362*pow(xi1, 12) + 1129681.26669604*pow(xi1, 10) - 66128.2185117568*pow(xi1, 8) + 2359.0822215614*pow(xi1, 6) - 43.291124478128*pow(xi1, 4) + 0.227249997260515*pow(xi1, 2) + 1.45519152283669e-11*pow(xi2, 2)*(1.61182821680627e+19*pow(xi2, 38) - 1.61056403781269e+20*pow(xi2, 36) + 7.44305853865387e+20*pow(xi2, 34) - 2.11058624511978e+21*pow(xi2, 32) + 4.10808957969171e+21*pow(xi2, 30) - 5.817310482311e+21*pow(xi2, 28) + 6.19758182004349e+21*pow(xi2, 26) - 5.06693344066232e+21*pow(xi2, 24) + 3.21391089742583e+21*pow(xi2, 22) - 1.58849564655661e+21*pow(xi2, 20) + 6.11119454216506e+20*pow(xi2, 18) - 1.8186133606786e+20*pow(xi2, 16) + 4.13757459337783e+19*pow(xi2, 14) - 7.06765239661478e+18*pow(xi2, 12) + 8.82819515261702e+17*pow(xi2, 10) - 7.76311055258138e+16*pow(xi2, 8) + 4.5442965736118e+15*pow(xi2, 6) - 162114895842900.0*pow(xi2, 4) + 2974943421450.0*pow(xi2, 2) - 15616500900.0);
case 16:
return -441317118.110572*pow(xi1, 41) + 4520215420.35694*pow(xi1, 39) - 21455533946.584*pow(xi1, 37) + 62627825964.2131*pow(xi1, 35) - 125800745105.801*pow(xi1, 33) + 184377197521.378*pow(xi1, 31) - 203988345809.981*pow(xi1, 29) + 173868453386.539*pow(xi1, 27) - 115502709028.459*pow(xi1, 25) + 60116117167.5139*pow(xi1, 23) - 24514412771.7272*pow(xi1, 21) + 7794716434.77033*pow(xi1, 19) - 1913781501.17792*pow(xi1, 17) + 357278354.291477*pow(xi1, 15) - 49588694.3055459*pow(xi1, 13) + 4955565.44394926*pow(xi1, 11) - 340478.339523105*pow(xi1, 9) + 15018.1416393653*pow(xi1, 7) - 383.065581096453*pow(xi1, 5) + 4.93457136908546*pow(xi1, 3) - 0.0324642853229307*xi1 + 441317118.110572*pow(xi2, 41) - 4520215420.35694*pow(xi2, 39) + 21455533946.584*pow(xi2, 37) - 62627825964.2131*pow(xi2, 35) + 125800745105.801*pow(xi2, 33) - 184377197521.378*pow(xi2, 31) + 203988345809.981*pow(xi2, 29) - 173868453386.539*pow(xi2, 27) + 115502709028.459*pow(xi2, 25) - 60116117167.5139*pow(xi2, 23) + 24514412771.7272*pow(xi2, 21) - 7794716434.77033*pow(xi2, 19) + 1913781501.17792*pow(xi2, 17) - 357278354.291477*pow(xi2, 15) + 49588694.3055459*pow(xi2, 13) - 4955565.44394926*pow(xi2, 11) + 340478.339523105*pow(xi2, 9) - 15018.1416393653*pow(xi2, 7) + 383.065581096453*pow(xi2, 5) - 4.93457136908546*pow(xi2, 3) + 0.0324642853229307*xi2;
case 17:
return -832898497.513445*pow(xi1, 42) + 8739521151.39361*pow(xi1, 40) - 42576535481.4103*pow(xi1, 38) + 127826121298.421*pow(xi1, 36) - 264726932148.851*pow(xi1, 34) + 401118326084.344*pow(xi1, 32) - 460241028009.732*pow(xi1, 30) + 408314713395.208*pow(xi1, 28) - 283534587979.19*pow(xi1, 26) + 155032460976.396*pow(xi1, 24) - 66814844868.7664*pow(xi1, 22) + 22616390444.5483*pow(xi1, 20) - 5964425288.95009*pow(xi1, 18) + 1209523608.00284*pow(xi1, 16) - 185014866.413594*pow(xi1, 14) + 20772630.3016105*pow(xi1, 12) - 1646801.49301984*pow(xi1, 10) + 87125.360217566*pow(xi1, 8) - 2818.97128744604*pow(xi1, 6) + 47.5601779980934*pow(xi1, 4) - 0.24348213992198*pow(xi1, 2) + 2.91038304567337e-11*pow(xi2, 2)*(2.86181744616623e+19*pow(xi2, 40) - 3.00287660223487e+20*pow(xi2, 38) + 1.46291861975713e+21*pow(xi2, 36) - 4.39207208440997e+21*pow(xi2, 34) + 9.0959481275978e+21*pow(xi2, 32) - 1.37823207388682e+22*pow(xi2, 30) + 1.58137613086337e+22*pow(xi2, 28) - 1.40295867240642e+22*pow(xi2, 26) + 9.74217426124363e+21*pow(xi2, 24) - 5.32687479769613e+21*pow(xi2, 22) + 2.29574058878932e+21*pow(xi2, 20) - 7.77093258503214e+20*pow(xi2, 18) + 2.04936092443808e+20*pow(xi2, 16) - 4.15589147208968e+19*pow(xi2, 14) + 6.35706240416157e+18*pow(xi2, 12) - 7.13742142378527e+17*pow(xi2, 10) + 5.65836684441936e+16*pow(xi2, 8) - 2.99360458229333e+15*pow(xi2, 6) + 96859115903550.0*pow(xi2, 4) - 1634155272750.0*pow(xi2, 2) + 8365982625.0);
case 18:
return -1576211982.21294*pow(xi1, 43) + 16933561364.8873*pow(xi1, 41) - 84614559003.2213*pow(xi1, 39) + 261084075522.621*pow(xi1, 37) - 556967491278.751*pow(xi1, 35) + 871554447543.638*pow(xi1, 33) - 1035805550194.54*pow(xi1, 31) + 955069184599.961*pow(xi1, 29) - 692003707251.794*pow(xi1, 27) + 396644167130.276*pow(xi1, 25) - 180184197345.899*pow(xi1, 23) + 64714887198.5536*pow(xi1, 21) - 18255406234.0253*pow(xi1, 19) + 3999772030.77123*pow(xi1, 17) - 669517007.246176*pow(xi1, 15) + 83640451.2585604*pow(xi1, 13) - 7546458.86981693*pow(xi1, 11) + 469247.674788719*pow(xi1, 9) - 18761.013674985*pow(xi1, 7) + 432.842258174969*pow(xi1, 5) - 4.94065842258351*pow(xi1, 3) + 0.0304352674902475*xi1 + 1576211982.21294*pow(xi2, 43) - 16933561364.8873*pow(xi2, 41) + 84614559003.2213*pow(xi2, 39) - 261084075522.621*pow(xi2, 37) + 556967491278.751*pow(xi2, 35) - 871554447543.638*pow(xi2, 33) + 1035805550194.54*pow(xi2, 31) - 955069184599.961*pow(xi2, 29) + 692003707251.794*pow(xi2, 27) - 396644167130.276*pow(xi2, 25) + 180184197345.899*pow(xi2, 23) - 64714887198.5536*pow(xi2, 21) + 18255406234.0253*pow(xi2, 19) - 3999772030.77123*pow(xi2, 17) + 669517007.246176*pow(xi2, 15) - 83640451.2585604*pow(xi2, 13) + 7546458.86981693*pow(xi2, 11) - 469247.674788719*pow(xi2, 9) + 18761.013674985*pow(xi2, 7) - 432.842258174969*pow(xi2, 5) + 4.94065842258351*pow(xi2, 3) - 0.0304352674902475*xi2;
case 19:
return -2990166848.60985*pow(xi1, 44) + 32872291760.5344*pow(xi1, 42) - 168370927902.997*pow(xi1, 40) + 533545185426.962*pow(xi1, 38) - 1171446565841.26*pow(xi1, 36) + 1891235717065.74*pow(xi1, 34) - 2325370700007.72*pow(xi1, 32) + 2225327260993.79*pow(xi1, 30) - 1679622467988.24*pow(xi1, 28) + 1007198702447.56*pow(xi1, 26) - 481108506863.906*pow(xi1, 24) + 182797439097.335*pow(xi1, 22) - 54951131326.4392*pow(xi1, 20) + 12946492132.2885*pow(xi1, 18) - 2356797655.27788*pow(xi1, 16) + 324895309.523393*pow(xi1, 14) - 32978968.5669253*pow(xi1, 12) + 2369734.10762014*pow(xi1, 10) - 113866.472549779*pow(xi1, 8) + 3353.33545287931*pow(xi1, 6) - 51.9555378781433*pow(xi1, 4) + 0.258699773667104*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(3.28772321903685e+21*pow(xi2, 42) - 3.61434670223528e+22*pow(xi2, 40) + 1.85125793008779e+23*pow(xi2, 38) - 5.86639135320847e+23*pow(xi2, 36) + 1.28801912046072e+24*pow(xi2, 34) - 2.07943566177906e+24*pow(xi2, 32) + 2.5567721235481e+24*pow(xi2, 30) - 2.44677319906959e+24*pow(xi2, 28) + 1.84676443382689e+24*pow(xi2, 26) - 1.10742668482199e+24*pow(xi2, 24) + 5.28984397518814e+23*pow(xi2, 22) - 2.00987909815195e+23*pow(xi2, 20) + 6.04194078528659e+22*pow(xi2, 18) - 1.42348186383617e+22*pow(xi2, 16) + 2.59132642629324e+21*pow(xi2, 14) - 3.57226170630853e+20*pow(xi2, 12) + 3.62607594113936e+19*pow(xi2, 10) - 2.60555020606573e+18*pow(xi2, 8) + 1.25197510582319e+17*pow(xi2, 6) - 3.6870313222743e+15*pow(xi2, 4) + 57125718024375.0*pow(xi2, 2) - 284443409250.0);
case 20:
return -5685008576.36934*pow(xi1, 45) + 63920516598.1696*pow(xi1, 43) - 335395652216.154*pow(xi1, 41) + 1090761466149.57*pow(xi1, 39) - 2462829664359.92*pow(xi1, 37) + 4098358985109.66*pow(xi1, 35) - 5207672102829.33*pow(xi1, 33) + 5165704568093.2*pow(xi1, 31) - 4055323997387.46*pow(xi1, 29) + 2539466092295.99*pow(xi1, 27) - 1272677592880.11*pow(xi1, 25) + 510159539292.741*pow(xi1, 23) - 162880969995.744*pow(xi1, 21) + 41090018295.1226*pow(xi1, 19) - 8090656221.72712*pow(xi1, 17) + 1221946438.94162*pow(xi1, 15) - 138186780.026711*pow(xi1, 13) + 11316135.0824385*pow(xi1, 11) - 639984.608374149*pow(xi1, 9) + 23307.6275589514*pow(xi1, 7) - 489.615191642361*pow(xi1, 5) + 5.00152895756401*pow(xi1, 3) - 0.0287444192963449*xi1 + 5685008576.36934*pow(xi2, 45) - 63920516598.1696*pow(xi2, 43) + 335395652216.154*pow(xi2, 41) - 1090761466149.57*pow(xi2, 39) + 2462829664359.92*pow(xi2, 37) - 4098358985109.66*pow(xi2, 35) + 5207672102829.33*pow(xi2, 33) - 5165704568093.2*pow(xi2, 31) + 4055323997387.46*pow(xi2, 29) - 2539466092295.99*pow(xi2, 27) + 1272677592880.11*pow(xi2, 25) - 510159539292.741*pow(xi2, 23) + 162880969995.744*pow(xi2, 21) - 41090018295.1226*pow(xi2, 19) + 8090656221.72712*pow(xi2, 17) - 1221946438.94162*pow(xi2, 15) + 138186780.026711*pow(xi2, 13) - 11316135.0824385*pow(xi2, 11) + 639984.608374149*pow(xi2, 9) - 23307.6275589514*pow(xi2, 7) + 489.615191642361*pow(xi2, 5) - 5.00152895756401*pow(xi2, 3) + 0.0287444192963449*xi2;
case 21:
return -10830136475.5778*pow(xi1, 46) + 124480567047.592*pow(xi1, 44) - 668730146595.075*pow(xi1, 42) + 2230520873347.34*pow(xi1, 40) - 5175289082189.45*pow(xi1, 38) + 8869111491786.76*pow(xi1, 36) - 11634680954177.8*pow(xi1, 34) + 11948152405933.1*pow(xi1, 32) - 9742174333567.36*pow(xi1, 30) + 6359880357274.0*pow(xi1, 28) - 3337238393035.54*pow(xi1, 26) + 1407861058998.53*pow(xi1, 24) - 475948085093.87*pow(xi1, 22) + 128075500365.761*pow(xi1, 20) - 27145281328.444*pow(xi1, 18) + 4463611836.62049*pow(xi1, 16) - 557674658.619336*pow(xi1, 14) + 51443527.1447734*pow(xi1, 12) - 3366668.49452746*pow(xi1, 10) + 147588.470953531*pow(xi1, 8) - 3971.39508214739*pow(xi1, 6) + 56.5259005462622*pow(xi1, 4) - 0.273071983315276*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(1.19078609852987e+22*pow(xi2, 44) - 1.36867830900977e+23*pow(xi2, 42) + 7.35276572025634e+23*pow(xi2, 40) - 2.45248363624248e+24*pow(xi2, 38) + 5.69029052296948e+24*pow(xi2, 36) - 9.75169121326128e+24*pow(xi2, 34) + 1.27924669945824e+25*pow(xi2, 32) - 1.31371325007633e+25*pow(xi2, 30) + 1.07116339595782e+25*pow(xi2, 28) - 6.99276240408694e+24*pow(xi2, 26) + 3.66933241780307e+24*pow(xi2, 24) - 1.54795960466192e+24*pow(xi2, 22) + 5.23310453778431e+23*pow(xi2, 20) - 1.40820501885384e+23*pow(xi2, 18) + 2.98465524598749e+22*pow(xi2, 16) - 4.90779311624281e+21*pow(xi2, 14) + 6.13169771667971e+20*pow(xi2, 12) - 5.65627562694886e+19*pow(xi2, 10) + 3.70169115660006e+18*pow(xi2, 8) - 1.62275239939087e+17*pow(xi2, 6) + 4.36659507131348e+15*pow(xi2, 4) - 62150884921125.0*pow(xi2, 2) + 300245820875.0);
case 22:
return -20669430677.858*pow(xi1, 47) + 242743705984.959*pow(xi1, 45) - 1334422142073.76*pow(xi1, 43) + 4562055823778.34*pow(xi1, 41) - 10869272649002.0*pow(xi1, 39) + 19167029443937.3*pow(xi1, 37) - 25932850957625.2*pow(xi1, 35) + 27540158501634.1*pow(xi1, 33) - 23291845098194.7*pow(xi1, 31) + 15826677366730.5*pow(xi1, 29) - 8679084881270.15*pow(xi1, 27) + 3844559615681.35*pow(xi1, 25) - 1372398208003.19*pow(xi1, 23) + 392591422175.228*pow(xi1, 21) - 89182852887.1235*pow(xi1, 19) + 15878163957.8501*pow(xi1, 17) - 2175816995.68173*pow(xi1, 15) + 223875789.885968*pow(xi1, 13) - 16718513.386797*pow(xi1, 11) + 863805.394274895*pow(xi1, 9) - 28780.1493897359*pow(xi1, 7) + 553.314836912411*pow(xi1, 5) - 5.10644608799566*pow(xi1, 3) + 0.0273071983315276*xi1 + 20669430677.858*pow(xi2, 47) - 242743705984.959*pow(xi2, 45) + 1334422142073.76*pow(xi2, 43) - 4562055823778.34*pow(xi2, 41) + 10869272649002.0*pow(xi2, 39) - 19167029443937.3*pow(xi2, 37) + 25932850957625.2*pow(xi2, 35) - 27540158501634.1*pow(xi2, 33) + 23291845098194.7*pow(xi2, 31) - 15826677366730.5*pow(xi2, 29) + 8679084881270.15*pow(xi2, 27) - 3844559615681.35*pow(xi2, 25) + 1372398208003.19*pow(xi2, 23) - 392591422175.228*pow(xi2, 21) + 89182852887.1235*pow(xi2, 19) - 15878163957.8501*pow(xi2, 17) + 2175816995.68173*pow(xi2, 15) - 223875789.885968*pow(xi2, 13) + 16718513.386797*pow(xi2, 11) - 863805.394274895*pow(xi2, 9) + 28780.1493897359*pow(xi2, 7) - 553.314836912411*pow(xi2, 5) + 5.10644608799566*pow(xi2, 3) - 0.0273071983315276*xi2;
case 23:
return -39513881861.3416*pow(xi1, 48) + 473939816873.48*pow(xi1, 46) - 2664641921512.91*pow(xi1, 44) + 9331688393323.42*pow(xi1, 42) - 22814742457657.3*pow(xi1, 40) + 41365417755535.0*pow(xi1, 38) - 57671165870739.0*pow(xi1, 36) + 63268091738868.2*pow(xi1, 34) - 55432667648218.2*pow(xi1, 32) + 39147974586004.8*pow(xi1, 30) - 22396734632040.0*pow(xi1, 28) + 10395673205955.8*pow(xi1, 26) - 3908620671560.13*pow(xi1, 24) + 1184931540983.06*pow(xi1, 22) - 287389625108.033*pow(xi1, 20) + 55130639039.3158*pow(xi1, 18) - 8233581071.61553*pow(xi1, 16) + 936988776.947738*pow(xi1, 14) - 78914666.8737741*pow(xi1, 12) + 4724180.42568061*pow(xi1, 10) - 189726.537067971*pow(xi1, 8) + 4682.51548749786*pow(xi1, 6) - 61.3114870538624*pow(xi1, 4) + 0.28672558248104*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(1.39027112208359e+24*pow(xi2, 46) - 1.66752748645894e+25*pow(xi2, 44) + 9.37537528500105e+25*pow(xi2, 42) - 3.28329596647726e+26*pow(xi2, 40) + 8.02722387741088e+26*pow(xi2, 38) - 1.45541624992072e+27*pow(xi2, 36) + 2.02912375879283e+27*pow(xi2, 34) - 2.2260480810907e+27*pow(xi2, 32) + 1.95036360441147e+27*pow(xi2, 30) - 1.37739690435813e+27*pow(xi2, 28) + 7.88015044868524e+26*pow(xi2, 26) - 3.6576523419225e+26*pow(xi2, 24) + 1.37522364062272e+26*pow(xi2, 22) - 4.16910722377411e+25*pow(xi2, 20) + 1.0111623504271e+25*pow(xi2, 18) - 1.93973691745437e+24*pow(xi2, 16) + 2.89693380047285e+23*pow(xi2, 14) - 3.29673617711888e+22*pow(xi2, 12) + 2.77656300255309e+21*pow(xi2, 10) - 1.66217321911923e+20*pow(xi2, 8) + 6.67540907532506e+18*pow(xi2, 6) - 1.64751367223843e+17*pow(xi2, 4) + 2.1572061738227e+15*pow(xi2, 2) - 10088259581400.0);
case 24:
return -75655521485.9082*pow(xi1, 49) + 926357529840.222*pow(xi1, 47) - 5324136684503.24*pow(xi1, 45) + 19088808068324.2*pow(xi1, 43) - 47859520057032.9*pow(xi1, 41) + 89152712018737.6*pow(xi1, 39) - 127970204724623.0*pow(xi1, 37) + 144881292955948.0*pow(xi1, 35) - 131350799622012.0*pow(xi1, 33) + 96281346590719.7*pow(xi1, 31) - 57373221024004.7*pow(xi1, 29) + 27850848100907.0*pow(xi1, 27) - 11003800602332.3*pow(xi1, 25) + 3525323265287.58*pow(xi1, 23) - 909714057948.449*pow(xi1, 21) + 187213093106.203*pow(xi1, 19) - 30302696016.6417*pow(xi1, 17) + 3786210901.09783*pow(xi1, 15) - 356077128.481597*pow(xi1, 13) + 24352785.8487305*pow(xi1, 11) - 1154167.4155017*pow(xi1, 9) + 35316.6945199066*pow(xi1, 7) - 624.033033173341*pow(xi1, 5) + 5.24794702480449*pow(xi1, 3) - 0.0260659620437309*xi1 + 75655521485.9082*pow(xi2, 49) - 926357529840.222*pow(xi2, 47) + 5324136684503.24*pow(xi2, 45) - 19088808068324.2*pow(xi2, 43) + 47859520057032.9*pow(xi2, 41) - 89152712018737.6*pow(xi2, 39) + 127970204724623.0*pow(xi2, 37) - 144881292955948.0*pow(xi2, 35) + 131350799622012.0*pow(xi2, 33) - 96281346590719.7*pow(xi2, 31) + 57373221024004.7*pow(xi2, 29) - 27850848100907.0*pow(xi2, 27) + 11003800602332.3*pow(xi2, 25) - 3525323265287.58*pow(xi2, 23) + 909714057948.449*pow(xi2, 21) - 187213093106.203*pow(xi2, 19) + 30302696016.6417*pow(xi2, 17) - 3786210901.09783*pow(xi2, 15) + 356077128.481597*pow(xi2, 13) - 24352785.8487305*pow(xi2, 11) + 1154167.4155017*pow(xi2, 9) - 35316.6945199066*pow(xi2, 7) + 624.033033173341*pow(xi2, 5) - 5.24794702480449*pow(xi2, 3) + 0.0260659620437309*xi2;
case 25:
return -145061239022.98*pow(xi1, 50) + 1812475393892.79*pow(xi1, 48) - 10643670964834.6*pow(xi1, 46) + 39047645249241.0*pow(xi1, 44) - 100334673478941.0*pow(xi1, 42) + 191891285821329.0*pow(xi1, 40) - 283354553901745.0*pow(xi1, 38) + 330753139825173.0*pow(xi1, 36) - 309949450203787.0*pow(xi1, 34) + 235512332226087.0*pow(xi1, 32) - 145956111105926.0*pow(xi1, 30) + 73967653689345.7*pow(xi1, 28) - 30644817310084.5*pow(xi1, 26) + 10348661764776.1*pow(xi1, 24) - 2832384684974.48*pow(xi1, 22) + 622866586202.908*pow(xi1, 20) - 108727766937.923*pow(xi1, 18) + 14820415476.7655*pow(xi1, 16) - 1543160445.53304*pow(xi1, 14) + 119159786.412311*pow(xi1, 12) - 6551119.55186054*pow(xi1, 10) + 241938.202705073*pow(xi1, 8) - 5496.37302038927*pow(xi1, 6) + 66.3465620553097*pow(xi1, 4) - 0.299758563502905*pow(xi1, 2) + 1.13686837721616e-13*pow(xi2, 2)*(1.27597215236289e+24*pow(xi2, 48) - 1.59427021651441e+25*pow(xi2, 46) + 9.36227199044597e+25*pow(xi2, 44) - 3.43466719910502e+26*pow(xi2, 42) + 8.82553121273627e+26*pow(xi2, 40) - 1.68789360023551e+27*pow(xi2, 38) + 2.492413014386e+27*pow(xi2, 36) - 2.90933538528959e+27*pow(xi2, 34) + 2.72634419617473e+27*pow(xi2, 32) - 2.07158838213781e+27*pow(xi2, 30) + 1.28384353044746e+27*pow(xi2, 28) - 6.50626362485951e+26*pow(xi2, 26) + 2.69554663708074e+26*pow(xi2, 24) - 9.10277915383376e+25*pow(xi2, 22) + 2.49139191637128e+25*pow(xi2, 20) - 5.47879243266592e+24*pow(xi2, 18) + 9.56379552082918e+23*pow(xi2, 16) - 1.303617531614e+23*pow(xi2, 14) + 1.35737828271005e+22*pow(xi2, 12) - 1.04814056578913e+21*pow(xi2, 10) + 5.76242569777709e+19*pow(xi2, 8) - 2.12811093661964e+18*pow(xi2, 6) + 4.83466083720984e+16*pow(xi2, 4) - 583590531542200.0*pow(xi2, 2) + 2636704208775.0);
case 26:
return -278508097797.389*pow(xi1, 51) + 3549496820864.59*pow(xi1, 49) - 21288128648696.6*pow(xi1, 47) + 79871307262862.2*pow(xi1, 45) - 210212671150195.0*pow(xi1, 43) + 412486935729554.0*pow(xi1, 41) - 626112410202269.0*pow(xi1, 39) + 752856933338791.0*pow(xi1, 37) - 728486502684749.0*pow(xi1, 35) + 573113389622653.0*pow(xi1, 33) - 368879995670080.0*pow(xi1, 31) + 194841049824986.0*pow(xi1, 29) - 84480468246275.5*pow(xi1, 27) + 30000793028347.5*pow(xi1, 25) - 8684024948552.07*pow(xi1, 23) + 2033504922658.4*pow(xi1, 21) - 381131167800.204*pow(xi1, 19) + 56356143580.967*pow(xi1, 17) - 6449006483.44302*pow(xi1, 15) + 556644810.745324*pow(xi1, 13) - 35001064.4284215*pow(xi1, 11) + 1527228.79271278*pow(xi1, 9) - 43071.2202943735*pow(xi1, 7) + 701.974604011104*pow(xi1, 5) - 5.42063402334421*pow(xi1, 3) + 0.0249798802919088*xi1 + 278508097797.389*pow(xi2, 51) - 3549496820864.59*pow(xi2, 49) + 21288128648696.6*pow(xi2, 47) - 79871307262862.2*pow(xi2, 45) + 210212671150195.0*pow(xi2, 43) - 412486935729554.0*pow(xi2, 41) + 626112410202269.0*pow(xi2, 39) - 752856933338791.0*pow(xi2, 37) + 728486502684749.0*pow(xi2, 35) - 573113389622653.0*pow(xi2, 33) + 368879995670080.0*pow(xi2, 31) - 194841049824986.0*pow(xi2, 29) + 84480468246275.5*pow(xi2, 27) - 30000793028347.5*pow(xi2, 25) + 8684024948552.07*pow(xi2, 23) - 2033504922658.4*pow(xi2, 21) + 381131167800.204*pow(xi2, 19) - 56356143580.967*pow(xi2, 17) + 6449006483.44302*pow(xi2, 15) - 556644810.745324*pow(xi2, 13) + 35001064.4284215*pow(xi2, 11) - 1527228.79271278*pow(xi2, 9) + 43071.2202943735*pow(xi2, 7) - 701.974604011104*pow(xi2, 5) + 5.42063402334421*pow(xi2, 3) - 0.0249798802919088*xi2;
case 27:
return -535378258765.904*pow(xi1, 52) + 6957132282978.78*pow(xi1, 50) - 42595443276427.3*pow(xi1, 48) + 163362474138947.0*pow(xi1, 46) - 440138555906054.0*pow(xi1, 44) + 885546290235663.0*pow(xi1, 42) - 1.38071645028501e+15*pow(xi1, 40) + 1.70878839294907e+15*pow(xi1, 38) - 1.70569451657033e+15*pow(xi1, 36) + 1.38781541457191e+15*pow(xi1, 34) - 926502730715607.0*pow(xi1, 32) + 509276709063429.0*pow(xi1, 30) - 230677032527233.0*pow(xi1, 28) + 85958980709566.8*pow(xi1, 26) - 26246208822548.7*pow(xi1, 24) + 6523592143785.49*pow(xi1, 22) - 1307618157198.77*pow(xi1, 20) + 208700139822.507*pow(xi1, 18) - 26077648271.0214*pow(xi1, 16) + 2494527583.2682*pow(xi1, 14) - 177278640.712216*pow(xi1, 12) + 8983106.36013146*pow(xi1, 10) - 306127.817401721*pow(xi1, 8) + 6423.07661945851*pow(xi1, 6) - 71.6610315874133*pow(xi1, 4) + 0.31224850364886*pow(xi1, 2) + 7.105427357601e-15*pow(xi2, 2)*(7.53477914587622e+25*pow(xi2, 50) - 9.79129323662202e+26*pow(xi2, 48) + 5.99477570210621e+27*pow(xi2, 46) - 2.29912243018276e+28*pow(xi2, 44) + 6.19439948865592e+28*pow(xi2, 42) - 1.24629560710145e+29*pow(xi2, 40) + 1.94318565343997e+29*pow(xi2, 38) - 2.4049058655439e+29*pow(xi2, 36) + 2.40055162163563e+29*pow(xi2, 34) - 1.95317655747658e+29*pow(xi2, 32) + 1.30393667275267e+29*pow(xi2, 30) - 7.16743249114541e+28*pow(xi2, 28) + 3.2464906179143e+28*pow(xi2, 26) - 1.20976510466485e+28*pow(xi2, 24) + 3.69382550853495e+27*pow(xi2, 22) - 9.1811397337092e+26*pow(xi2, 20) + 1.84030895171978e+26*pow(xi2, 18) - 2.93719334980254e+25*pow(xi2, 16) + 3.67010271987722e+24*pow(xi2, 14) - 3.51073546702253e+23*pow(xi2, 12) + 2.49497506328839e+22*pow(xi2, 10) - 1.26425982675367e+21*pow(xi2, 8) + 4.30836601368166e+19*pow(xi2, 6) - 9.03967670936421e+17*pow(xi2, 4) + 1.00853935985644e+16*pow(xi2, 2) - 43945070146250.0);
case 28:
return -1030350611209.85*pow(xi1, 53) + 13646896792072.1*pow(xi1, 51) - 85260422877749.6*pow(xi1, 49) + 334093220533705.0*pow(xi1, 47) - 920962512926415.0*pow(xi1, 45) + 1.89876455739826e+15*pow(xi1, 43) - 3.03889368452553e+15*pow(xi1, 41) + 3.86794034071254e+15*pow(xi1, 39) - 3.97925966295374e+15*pow(xi1, 37) + 3.34494243815037e+15*pow(xi1, 35) - 2.31336946732699e+15*pow(xi1, 33) + 1.32143345100665e+15*pow(xi1, 31) - 624226211633956.0*pow(xi1, 29) + 243598183030088.0*pow(xi1, 27) - 78270546525410.4*pow(xi1, 25) + 20589941021312.3*pow(xi1, 23) - 4398096345674.74*pow(xi1, 21) + 754299662069.146*pow(xi1, 19) - 102331950251.277*pow(xi1, 17) + 10767872117.2939*pow(xi1, 15) - 856225123.100907*pow(xi1, 13) + 49673695.6695208*pow(xi1, 11) - 2002250.54641144*pow(xi1, 9) + 52213.8736102729*pow(xi1, 7) - 787.428276501695*pow(xi1, 5) + 5.62047306567948*pow(xi1, 3) - 0.0240191156652969*xi1 + 1030350611209.85*pow(xi2, 53) - 13646896792072.1*pow(xi2, 51) + 85260422877749.6*pow(xi2, 49) - 334093220533705.0*pow(xi2, 47) + 920962512926415.0*pow(xi2, 45) - 1.89876455739826e+15*pow(xi2, 43) + 3.03889368452553e+15*pow(xi2, 41) - 3.86794034071254e+15*pow(xi2, 39) + 3.97925966295374e+15*pow(xi2, 37) - 3.34494243815037e+15*pow(xi2, 35) + 2.31336946732699e+15*pow(xi2, 33) - 1.32143345100665e+15*pow(xi2, 31) + 624226211633956.0*pow(xi2, 29) - 243598183030088.0*pow(xi2, 27) + 78270546525410.4*pow(xi2, 25) - 20589941021312.3*pow(xi2, 23) + 4398096345674.74*pow(xi2, 21) - 754299662069.146*pow(xi2, 19) + 102331950251.277*pow(xi2, 17) - 10767872117.2939*pow(xi2, 15) + 856225123.100907*pow(xi2, 13) - 49673695.6695208*pow(xi2, 11) + 2002250.54641144*pow(xi2, 9) - 52213.8736102729*pow(xi2, 7) + 787.428276501695*pow(xi2, 5) - 5.62047306567948*pow(xi2, 3) + 0.0240191156652969*xi2;
case 29:
return -1985085642584.69*pow(xi1, 54) + 26788741762693.9*pow(xi1, 52) - 170715251986214.0*pow(xi1, 50) + 683167689474105.0*pow(xi1, 48) - 1.92582698260844e+15*pow(xi1, 46) + 4.06633243625181e+15*pow(xi1, 44) - 6.67595460794649e+15*pow(xi1, 42) + 8.73238684495299e+15*pow(xi1, 40) - 9.25108297396294e+15*pow(xi1, 38) + 8.02612992827034e+15*pow(xi1, 36) - 5.74391288108549e+15*pow(xi1, 34) + 3.40505258328624e+15*pow(xi1, 32) - 1.67490311154428e+15*pow(xi1, 30) + 683229999465451.0*pow(xi1, 28) - 230508183911447.0*pow(xi1, 26) + 64007364830632.8*pow(xi1, 24) - 14522855116130.1*pow(xi1, 22) + 2665817039716.65*pow(xi1, 20) - 390684676159.123*pow(xi1, 18) + 44927685217.5777*pow(xi1, 16) - 3962823148.48188*pow(xi1, 14) + 260094754.560315*pow(xi1, 12) - 12187708.0158238*pow(xi1, 10) + 384471.912634116*pow(xi1, 8) - 7473.26201178072*pow(xi1, 6) + 77.2815046530928*pow(xi1, 4) - 0.324258061481508*pow(xi1, 2) + 7.105427357601e-15*pow(xi2, 2)*(2.79375967507591e+26*pow(xi2, 52) - 3.77018023188103e+27*pow(xi2, 50) + 2.40260357884866e+28*pow(xi2, 48) - 9.61473047420981e+28*pow(xi2, 46) + 2.71036052539231e+29*pow(xi2, 44) - 5.72285413895882e+29*pow(xi2, 42) + 9.39557083896568e+29*pow(xi2, 40) - 1.22897419190579e+30*pow(xi2, 38) + 1.30197418232228e+30*pow(xi2, 36) - 1.1295773673183e+30*pow(xi2, 34) + 8.08383872215787e+29*pow(xi2, 32) - 4.79218548289526e+29*pow(xi2, 30) + 2.35721657157265e+29*pow(xi2, 28) - 9.61560740937796e+28*pow(xi2, 26) + 3.24411428490451e+28*pow(xi2, 24) - 9.00823576250642e+27*pow(xi2, 22) + 2.04391015279248e+27*pow(xi2, 20) - 3.75180394584557e+26*pow(xi2, 18) + 5.49839800615497e+25*pow(xi2, 16) - 6.32300957514069e+24*pow(xi2, 14) + 5.57717776713693e+23*pow(xi2, 12) - 3.66050824912142e+22*pow(xi2, 10) + 1.71526741495514e+21*pow(xi2, 8) - 5.41096113272946e+19*pow(xi2, 6) + 1.0517681253593e+18*pow(xi2, 4) - 1.08764048611969e+16*pow(xi2, 2) + 45635265151875.0);
default:
return 0.;
}
case 29:
switch(j) {
case 0:
return 5.96046447753906e-8*y1t*(-12587970424449.0*pow(xi1, 29) + 89540846226741.0*pow(xi1, 27) - 284423864484942.0*pow(xi1, 25) + 532085460771150.0*pow(xi1, 23) - 650955616900875.0*pow(xi1, 21) + 546802718196735.0*pow(xi1, 19) - 322147337852340.0*pow(xi1, 17) + 133573286426580.0*pow(xi1, 15) - 38530755699975.0*pow(xi1, 13) + 7521018379875.0*pow(xi1, 11) - 945499453470.0*pow(xi1, 9) + 70326405630.0*pow(xi1, 7) - 2646692685.0*pow(xi1, 5) + 35102025.0*pow(xi1, 3) - 3.0*pow(xi2, 3)*(-4195990141483.0*pow(xi2, 26) + 29846948742247.0*pow(xi2, 24) - 94807954828314.0*pow(xi2, 22) + 177361820257050.0*pow(xi2, 20) - 216985205633625.0*pow(xi2, 18) + 182267572732245.0*pow(xi2, 16) - 107382445950780.0*pow(xi2, 14) + 44524428808860.0*pow(xi2, 12) - 12843585233325.0*pow(xi2, 10) + 2507006126625.0*pow(xi2, 8) - 315166484490.0*pow(xi2, 6) + 23442135210.0*pow(xi2, 4) - 882230895.0*pow(xi2, 2) + 11700675.0));
case 1:
return 7.45058059692383e-9*y1r*(-50351881697796.0*pow(xi1, 29) + 17383387729001.0*pow(xi1, 28) + 358163384906964.0*pow(xi1, 27) - 123979633237026.0*pow(xi1, 26) - 1.13769545793977e+15*pow(xi1, 25) + 395033145117975.0*pow(xi1, 24) + 2.1283418430846e+15*pow(xi1, 23) - 741694884711300.0*pow(xi1, 22) - 2.6038224676035e+15*pow(xi1, 21) + 911337863661225.0*pow(xi1, 20) + 2.18721087278694e+15*pow(xi1, 19) - 769574195980590.0*pow(xi1, 18) - 1.28858935140936e+15*pow(xi1, 17) + 456375395290815.0*pow(xi1, 16) + 534293145706320.0*pow(xi1, 15) - 190818980609400.0*pow(xi1, 14) - 154123022799900.0*pow(xi1, 13) + 55655536011075.0*pow(xi1, 12) + 30084073519500.0*pow(xi1, 11) - 11030826957150.0*pow(xi1, 10) - 3781997813880.0*pow(xi1, 9) + 1418249180205.0*pow(xi1, 8) + 281305622520.0*pow(xi1, 7) - 109396630980.0*pow(xi1, 6) - 10586770740.0*pow(xi1, 5) + 4411154475.0*pow(xi1, 4) + 140408100.0*pow(xi1, 3) - 70204050.0*pow(xi1, 2) + pow(xi2, 2)*(50351881697796.0*pow(xi2, 27) - 17383387729001.0*pow(xi2, 26) - 358163384906964.0*pow(xi2, 25) + 123979633237026.0*pow(xi2, 24) + 1.13769545793977e+15*pow(xi2, 23) - 395033145117975.0*pow(xi2, 22) - 2.1283418430846e+15*pow(xi2, 21) + 741694884711300.0*pow(xi2, 20) + 2.6038224676035e+15*pow(xi2, 19) - 911337863661225.0*pow(xi2, 18) - 2.18721087278694e+15*pow(xi2, 17) + 769574195980590.0*pow(xi2, 16) + 1.28858935140936e+15*pow(xi2, 15) - 456375395290815.0*pow(xi2, 14) - 534293145706320.0*pow(xi2, 13) + 190818980609400.0*pow(xi2, 12) + 154123022799900.0*pow(xi2, 11) - 55655536011075.0*pow(xi2, 10) - 30084073519500.0*pow(xi2, 9) + 11030826957150.0*pow(xi2, 8) + 3781997813880.0*pow(xi2, 7) - 1418249180205.0*pow(xi2, 6) - 281305622520.0*pow(xi2, 5) + 109396630980.0*pow(xi2, 4) + 10586770740.0*pow(xi2, 3) - 4411154475.0*pow(xi2, 2) - 140408100.0*xi2 + 70204050.0));
case 2:
return 5.96046447753906e-8*y2t*(12587970424449.0*pow(xi1, 29) - 89540846226741.0*pow(xi1, 27) + 284423864484942.0*pow(xi1, 25) - 532085460771150.0*pow(xi1, 23) + 650955616900875.0*pow(xi1, 21) - 546802718196735.0*pow(xi1, 19) + 322147337852340.0*pow(xi1, 17) - 133573286426580.0*pow(xi1, 15) + 38530755699975.0*pow(xi1, 13) - 7521018379875.0*pow(xi1, 11) + 945499453470.0*pow(xi1, 9) - 70326405630.0*pow(xi1, 7) + 2646692685.0*pow(xi1, 5) - 35102025.0*pow(xi1, 3) + 3.0*pow(xi2, 3)*(-4195990141483.0*pow(xi2, 26) + 29846948742247.0*pow(xi2, 24) - 94807954828314.0*pow(xi2, 22) + 177361820257050.0*pow(xi2, 20) - 216985205633625.0*pow(xi2, 18) + 182267572732245.0*pow(xi2, 16) - 107382445950780.0*pow(xi2, 14) + 44524428808860.0*pow(xi2, 12) - 12843585233325.0*pow(xi2, 10) + 2507006126625.0*pow(xi2, 8) - 315166484490.0*pow(xi2, 6) + 23442135210.0*pow(xi2, 4) - 882230895.0*pow(xi2, 2) + 11700675.0));
case 3:
return 7.45058059692383e-9*y2r*(-50351881697796.0*pow(xi1, 29) - 17383387729001.0*pow(xi1, 28) + 358163384906964.0*pow(xi1, 27) + 123979633237026.0*pow(xi1, 26) - 1.13769545793977e+15*pow(xi1, 25) - 395033145117975.0*pow(xi1, 24) + 2.1283418430846e+15*pow(xi1, 23) + 741694884711300.0*pow(xi1, 22) - 2.6038224676035e+15*pow(xi1, 21) - 911337863661225.0*pow(xi1, 20) + 2.18721087278694e+15*pow(xi1, 19) + 769574195980590.0*pow(xi1, 18) - 1.28858935140936e+15*pow(xi1, 17) - 456375395290815.0*pow(xi1, 16) + 534293145706320.0*pow(xi1, 15) + 190818980609400.0*pow(xi1, 14) - 154123022799900.0*pow(xi1, 13) - 55655536011075.0*pow(xi1, 12) + 30084073519500.0*pow(xi1, 11) + 11030826957150.0*pow(xi1, 10) - 3781997813880.0*pow(xi1, 9) - 1418249180205.0*pow(xi1, 8) + 281305622520.0*pow(xi1, 7) + 109396630980.0*pow(xi1, 6) - 10586770740.0*pow(xi1, 5) - 4411154475.0*pow(xi1, 4) + 140408100.0*pow(xi1, 3) + 70204050.0*pow(xi1, 2) + pow(xi2, 2)*(50351881697796.0*pow(xi2, 27) + 17383387729001.0*pow(xi2, 26) - 358163384906964.0*pow(xi2, 25) - 123979633237026.0*pow(xi2, 24) + 1.13769545793977e+15*pow(xi2, 23) + 395033145117975.0*pow(xi2, 22) - 2.1283418430846e+15*pow(xi2, 21) - 741694884711300.0*pow(xi2, 20) + 2.6038224676035e+15*pow(xi2, 19) + 911337863661225.0*pow(xi2, 18) - 2.18721087278694e+15*pow(xi2, 17) - 769574195980590.0*pow(xi2, 16) + 1.28858935140936e+15*pow(xi2, 15) + 456375395290815.0*pow(xi2, 14) - 534293145706320.0*pow(xi2, 13) - 190818980609400.0*pow(xi2, 12) + 154123022799900.0*pow(xi2, 11) + 55655536011075.0*pow(xi2, 10) - 30084073519500.0*pow(xi2, 9) - 11030826957150.0*pow(xi2, 8) + 3781997813880.0*pow(xi2, 7) + 1418249180205.0*pow(xi2, 6) - 281305622520.0*pow(xi2, 5) - 109396630980.0*pow(xi2, 4) + 10586770740.0*pow(xi2, 3) + 4411154475.0*pow(xi2, 2) - 140408100.0*xi2 - 70204050.0));
case 4:
return -725291.455405992*pow(xi1, 30) + 5405474.05444089*pow(xi1, 28) - 18148386.0844929*pow(xi1, 26) + 36279768.9150877*pow(xi1, 24) - 48088457.9659335*pow(xi1, 22) + 44542375.0997904*pow(xi1, 20) - 29602278.0252908*pow(xi1, 18) + 14264512.3510136*pow(xi1, 16) - 4975992.68058613*pow(xi1, 14) + 1240262.43990585*pow(xi1, 12) - 215092.673743397*pow(xi1, 10) + 24801.3675199449*pow(xi1, 8) - 1761.59948006272*pow(xi1, 6) + 67.3005066812038*pow(xi1, 4) - 1.04612186551094*pow(xi1, 2) + 5.96046447753906e-9*pow(xi2, 2)*(121683714103007.0*pow(xi2, 28) - 906888057937505.0*pow(xi2, 26) + 3.04479393390932e+15*pow(xi2, 24) - 6.08673519518513e+15*pow(xi2, 22) + 8.06790446401388e+15*pow(xi2, 20) - 7.47297048202205e+15*pow(xi2, 18) + 4.96643812522358e+15*pow(xi2, 16) - 2.39318804847623e+15*pow(xi2, 14) + 834833040166125.0*pow(xi2, 12) - 208081508509875.0*pow(xi2, 10) + 36086562474105.0*pow(xi2, 8) - 4160978999775.0*pow(xi2, 6) + 295547349825.0*pow(xi2, 4) - 11291151375.0*pow(xi2, 2) + 175510125.0);
case 5:
return -1169824.92807418*pow(xi1, 31) + 9031931.33147085*pow(xi1, 29) - 31499061.7647464*pow(xi1, 27) + 65582289.5567043*pow(xi1, 25) - 90758210.1336434*pow(xi1, 23) + 87946617.5024897*pow(xi1, 21) - 61225764.2230055*pow(xi1, 19) + 30909695.7099938*pow(xi1, 17) - 11278916.7426619*pow(xi1, 15) + 2928812.50869334*pow(xi1, 13) - 525136.936689913*pow(xi1, 11) + 61789.9485003948*pow(xi1, 9) - 4379.58420842886*pow(xi1, 7) + 159.847421050072*pow(xi1, 5) - 2.09224373102188*pow(xi1, 3) + 5.96046447753906e-8*pow(xi2, 3)*(19626405500485.0*pow(xi2, 28) - 151530662845254.0*pow(xi2, 26) + 528466563024491.0*pow(xi2, 24) - 1.10028823766737e+15*pow(xi2, 22) + 1.52267009518553e+15*pow(xi2, 20) - 1.47549939830865e+15*pow(xi2, 18) + 1.02719787113444e+15*pow(xi2, 16) - 518578641420840.0*pow(xi2, 14) + 189228822437655.0*pow(xi2, 12) - 49137320081850.0*pow(xi2, 10) + 8810335816425.0*pow(xi2, 8) - 1036663312620.0*pow(xi2, 6) + 73477230255.0*pow(xi2, 4) - 2681794710.0*pow(xi2, 2) + 35102025.0);
case 6:
return -1983218.82337576*pow(xi1, 32) + 15822985.760626*pow(xi1, 30) - 57208772.2688402*pow(xi1, 28) + 123966103.721286*pow(xi1, 26) - 179418908.264614*pow(xi1, 24) + 182977170.438836*pow(xi1, 22) - 135194614.345589*pow(xi1, 20) + 73288566.706319*pow(xi1, 18) - 29202857.0441898*pow(xi1, 16) + 8491314.83706627*pow(xi1, 14) - 1772603.99920279*pow(xi1, 12) + 258638.67419567*pow(xi1, 10) - 25307.2639591154*pow(xi1, 8) + 1554.31043241173*pow(xi1, 6) - 53.2214499078691*pow(xi1, 4) + 0.784591399133205*pow(xi1, 2) + 4.65661287307739e-10*pow(xi2, 2)*(4.25892999360525e+15*pow(xi2, 30) - 3.39796031834812e+16*pow(xi2, 28) + 1.2285490296949e+17*pow(xi2, 26) - 2.66215180647733e+17*pow(xi2, 24) + 3.8529917164027e+17*pow(xi2, 22) - 3.9294048147471e+17*pow(xi2, 20) + 2.90328223604819e+17*pow(xi2, 18) - 1.57385998587177e+17*pow(xi2, 16) + 6.27126579772793e+16*pow(xi2, 14) - 1.82349597626196e+16*pow(xi2, 12) + 3.8066381026674e+15*pow(xi2, 10) - 555422323575600.0*pow(xi2, 8) + 54346935527820.0*pow(xi2, 6) - 3337856237520.0*pow(xi2, 4) + 114292193400.0*pow(xi2, 2) - 1684897200.0);
case 7:
return -3461618.30989224*pow(xi1, 33) + 28498480.2996788*pow(xi1, 31) - 106650445.835851*pow(xi1, 29) + 240073829.195359*pow(xi1, 27) - 362501705.126616*pow(xi1, 25) + 387645522.427694*pow(xi1, 23) - 302119490.023002*pow(xi1, 21) + 173956904.077601*pow(xi1, 19) - 74200832.0310932*pow(xi1, 17) + 23288542.3204008*pow(xi1, 15) - 5288299.728707*pow(xi1, 13) + 843336.470763026*pow(xi1, 11) - 89923.5811349005*pow(xi1, 9) + 5901.7463196069*pow(xi1, 7) - 204.516824707389*pow(xi1, 5) + 2.61530466377735*pow(xi1, 3) + 1.35465101762251e-9*pow(xi2, 3)*(2.55535799616315e+15*pow(xi2, 30) - 2.10375070250161e+16*pow(xi2, 28) + 7.87290929165121e+16*pow(xi2, 26) - 1.77221901487736e+17*pow(xi2, 24) + 2.67597853920212e+17*pow(xi2, 22) - 2.861589570929e+17*pow(xi2, 20) + 2.23023853444733e+17*pow(xi2, 18) - 1.28414552393653e+17*pow(xi2, 16) + 5.47748690000762e+16*pow(xi2, 14) - 1.71915438127183e+16*pow(xi2, 12) + 3.90380966013539e+15*pow(xi2, 10) - 622548877749435.0*pow(xi2, 8) + 66381363144525.0*pow(xi2, 6) - 4356654402375.0*pow(xi2, 4) + 150973809525.0*pow(xi2, 2) - 1930611375.0);
case 8:
return -6159644.34554354*pow(xi1, 34) + 52267170.8017219*pow(xi1, 32) - 202194111.58739*pow(xi1, 30) + 472090210.646781*pow(xi1, 28) - 742330528.164016*pow(xi1, 26) + 830587403.930279*pow(xi1, 24) - 681190082.905951*pow(xi1, 22) + 415637119.889813*pow(xi1, 20) - 189551172.160955*pow(xi1, 18) + 64362896.3166805*pow(xi1, 16) - 16078796.4261874*pow(xi1, 14) + 2894443.79047908*pow(xi1, 12) - 363906.137368977*pow(xi1, 10) + 30556.7713536322*pow(xi1, 8) - 1607.71495364606*pow(xi1, 6) + 47.9472521692514*pow(xi1, 4) - 0.653826165944338*pow(xi1, 2) + 3.72529029846191e-9*pow(xi2, 2)*(1.6534669386938e+15*pow(xi2, 32) - 1.40303618279901e+16*pow(xi2, 30) + 5.4276068544476e+16*pow(xi2, 28) - 1.26725750968105e+17*pow(xi2, 26) + 1.99267833830428e+17*pow(xi2, 24) - 2.22959108521881e+17*pow(xi2, 22) + 1.82855570527537e+17*pow(xi2, 20) - 1.11571739808149e+17*pow(xi2, 18) + 5.08822553343604e+16*pow(xi2, 16) - 1.72772834222489e+16*pow(xi2, 14) + 4.31611905059478e+15*pow(xi2, 12) - 776971338763620.0*pow(xi2, 10) + 97685309925840.0*pow(xi2, 8) - 8202520852200.0*pow(xi2, 6) + 431567696700.0*pow(xi2, 4) - 12870742500.0*pow(xi2, 2) + 175510125.0);
case 9:
return -11112501.2274704*pow(xi1, 35) + 97093261.8133116*pow(xi1, 33) - 387817607.62591*pow(xi1, 31) + 937921252.467321*pow(xi1, 29) - 1533331634.12215*pow(xi1, 27) + 1791534433.11565*pow(xi1, 25) - 1542331961.52872*pow(xi1, 23) + 994100047.035712*pow(xi1, 21) - 482601965.041428*pow(xi1, 19) + 176100565.554967*pow(xi1, 17) - 47831521.5085922*pow(xi1, 15) + 9494731.97971299*pow(xi1, 13) - 1337246.817251*pow(xi1, 11) + 127520.279397815*pow(xi1, 9) - 7617.85942465067*pow(xi1, 7) + 246.536052972078*pow(xi1, 5) - 3.05118877440691*pow(xi1, 3) + 1.49011611938477e-9*pow(xi2, 3)*(7.45747333574143e+15*pow(xi2, 32) - 6.51581850234592e+16*pow(xi2, 30) + 2.60259990869726e+17*pow(xi2, 28) - 6.29428297745391e+17*pow(xi2, 26) + 1.02900144101201e+18*pow(xi2, 24) - 1.20227840623275e+18*pow(xi2, 22) + 1.03504145849084e+18*pow(xi2, 20) - 6.67129248589132e+17*pow(xi2, 18) + 3.2386869638098e+17*pow(xi2, 16) - 1.18179089041513e+17*pow(xi2, 14) + 3.20991907183319e+16*pow(xi2, 12) - 6.3718067714301e+15*pow(xi2, 10) + 897411147933300.0*pow(xi2, 8) - 85577410873500.0*pow(xi2, 6) + 5112258921000.0*pow(xi2, 4) - 165447544500.0*pow(xi2, 2) + 2047618125.0);
case 10:
return -20257163.6959095*pow(xi1, 36) + 182085146.881723*pow(xi1, 34) - 750168100.803257*pow(xi1, 32) + 1876902117.73599*pow(xi1, 30) - 3185397290.65285*pow(xi1, 28) + 3879469079.53952*pow(xi1, 26) - 3498141721.81091*pow(xi1, 24) + 2375254474.90776*pow(xi1, 22) - 1223317230.13363*pow(xi1, 20) + 477702027.144423*pow(xi1, 18) - 140396380.678918*pow(xi1, 16) + 30599953.4447357*pow(xi1, 14) - 4831031.28381934*pow(xi1, 12) + 533608.341681669*pow(xi1, 10) - 39235.2255529957*pow(xi1, 8) + 1791.96316720918*pow(xi1, 6) - 46.2445798621047*pow(xi1, 4) + 0.572097895201296*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(8.700385558365e+16*pow(xi2, 34) - 7.82049750944356e+17*pow(xi2, 32) + 3.22194745945242e+18*pow(xi2, 30) - 8.0612332134692e+18*pow(xi2, 28) + 1.3681177188121e+19*pow(xi2, 26) - 1.66621928224655e+19*pow(xi2, 24) + 1.5024404291951e+19*pow(xi2, 22) - 1.02016402894065e+19*pow(xi2, 20) + 5.25410749605725e+18*pow(xi2, 18) - 2.0517145838182e+18*pow(xi2, 16) + 6.02997863492717e+17*pow(xi2, 14) - 1.31425799304262e+17*pow(xi2, 12) + 2.0749121369957e+16*pow(xi2, 10) - 2.29183037639556e+15*pow(xi2, 8) + 168514010601300.0*pow(xi2, 6) - 7696423198800.0*pow(xi2, 4) + 198618958125.0*pow(xi2, 2) - 2457141750.0);
case 11:
return -37229381.9276175*pow(xi1, 37) + 343989572.19469*pow(xi1, 35) - 1460350397.15719*pow(xi1, 33) + 3775623106.58272*pow(xi1, 31) - 6643091344.53323*pow(xi1, 29) + 8419444305.04878*pow(xi1, 27) - 7935772040.54214*pow(xi1, 25) + 5662484321.43375*pow(xi1, 23) - 3084320984.90706*pow(xi1, 21) + 1283814730.95024*pow(xi1, 19) - 406127401.700268*pow(xi1, 17) + 96463492.5990974*pow(xi1, 15) - 16863098.3571735*pow(xi1, 13) + 2104960.9899391*pow(xi1, 11) - 179227.787553705*pow(xi1, 9) + 9672.70429898053*pow(xi1, 7) - 289.023856655695*pow(xi1, 5) + 3.43258737120777*pow(xi1, 3) + 9.31322574615479e-10*pow(xi2, 3)*(3.99747444573527e+16*pow(xi2, 34) - 3.69355990685307e+17*pow(xi2, 32) + 1.56803929912269e+18*pow(xi2, 30) - 4.05404444119867e+18*pow(xi2, 28) + 7.13296501727773e+18*pow(xi2, 26) - 9.04030948516949e+18*pow(xi2, 24) + 8.52097034565992e+18*pow(xi2, 22) - 6.08004624366768e+18*pow(xi2, 20) + 3.31176444013558e+18*pow(xi2, 18) - 1.37848557088858e+18*pow(xi2, 16) + 4.36075977078027e+17*pow(xi2, 14) - 1.03576886492765e+17*pow(xi2, 12) + 1.81066139883229e+16*pow(xi2, 10) - 2.26018465278606e+15*pow(xi2, 8) + 192444371519400.0*pow(xi2, 6) - 10385987157000.0*pow(xi2, 4) + 310337003025.0*pow(xi2, 2) - 3685712625.0);
case 12:
return -68874356.5660925*pow(xi1, 38) + 653656629.297066*pow(xi1, 36) - 2856934570.48049*pow(xi1, 34) + 7624657571.27675*pow(xi1, 32) - 13890356342.0884*pow(xi1, 30) + 18292482306.1948*pow(xi1, 28) - 17989567245.6529*pow(xi1, 26) + 13458767751.5738*pow(xi1, 24) - 7731565722.77115*pow(xi1, 22) + 3418271096.48544*pow(xi1, 20) - 1158704884.14768*pow(xi1, 18) + 298182338.803168*pow(xi1, 16) - 57291281.6304182*pow(xi1, 14) + 8014068.54624802*pow(xi1, 12) - 786727.024230338*pow(xi1, 10) + 51392.5738947513*pow(xi1, 8) - 2070.38795685978*pow(xi1, 6) + 46.5115588798653*pow(xi1, 4) - 0.514888105681166*pow(xi1, 2) + 2.3283064365387e-10*pow(xi2, 2)*(2.9581310898441e+17*pow(xi2, 36) - 2.80743384564449e+18*pow(xi2, 34) + 1.22704405470255e+19*pow(xi2, 32) - 3.27476549118324e+19*pow(xi2, 30) + 5.9658626219056e+19*pow(xi2, 28) - 7.85656132677653e+19*pow(xi2, 26) + 7.72646029892722e+19*pow(xi2, 24) - 5.78049673374688e+19*pow(xi2, 22) + 3.32068219261767e+19*pow(xi2, 20) - 1.4681362568267e+19*pow(xi2, 18) + 4.97659958312977e+18*pow(xi2, 16) - 1.2806833934044e+18*pow(xi2, 14) + 2.46064180948572e+17*pow(xi2, 12) - 3.44201623140375e+16*pow(xi2, 10) + 3.3789668399487e+15*pow(xi2, 8) - 220729424135220.0*pow(xi2, 6) + 8892248564745.0*pow(xi2, 4) - 199765624275.0*pow(xi2, 2) + 2211427575.0);
case 13:
return -128115935.990074*pow(xi1, 39) + 1248008066.49091*pow(xi1, 37) - 5611032814.52263*pow(xi1, 35) + 15442659831.8453*pow(xi1, 33) - 29094919819.8133*pow(xi1, 31) + 39756978325.8846*pow(xi1, 29) - 40725769961.2447*pow(xi1, 27) + 31880588934.2862*pow(xi1, 25) - 19266224339.3282*pow(xi1, 23) + 9018966525.34359*pow(xi1, 21) - 3262752368.84387*pow(xi1, 19) + 904978203.88722*pow(xi1, 17) - 189776731.449743*pow(xi1, 15) + 29452783.6369724*pow(xi1, 13) - 3278994.90893944*pow(xi1, 11) + 250145.992870219*pow(xi1, 9) - 12181.2751102983*pow(xi1, 7) + 333.784795976244*pow(xi1, 5) - 3.77584610832855*pow(xi1, 3) + 4.65661287307739e-10*pow(xi2, 3)*(2.75126877586899e+17*pow(xi2, 36) - 2.68007691536133e+18*pow(xi2, 34) + 1.20496012175788e+19*pow(xi2, 32) - 3.31628594705142e+19*pow(xi2, 30) + 6.24808645529203e+19*pow(xi2, 28) - 8.53774608487275e+19*pow(xi2, 26) + 8.74579250439826e+19*pow(xi2, 24) - 6.84630434249894e+19*pow(xi2, 22) + 4.13739017274069e+19*pow(xi2, 20) - 1.93680831350347e+19*pow(xi2, 18) + 7.00670735956548e+18*pow(xi2, 16) - 1.94342589464422e+18*pow(xi2, 14) + 4.0754242755921e+17*pow(xi2, 12) - 6.32493712484802e+16*pow(xi2, 10) + 7.0415879488227e+15*pow(xi2, 8) - 537184429301520.0*pow(xi2, 6) + 26159089111155.0*pow(xi2, 4) - 716797391310.0*pow(xi2, 2) + 8108567775.0);
case 14:
return -239416655.381451*pow(xi1, 40) + 2392202512.34296*pow(xi1, 38) - 11054929261.3249*pow(xi1, 36) + 31346745935.6135*pow(xi1, 34) - 61011867959.9384*pow(xi1, 32) + 86393672600.7061*pow(xi1, 30) - 92038058619.7648*pow(xi1, 28) + 75244727145.7414*pow(xi1, 26) - 47725511673.3336*pow(xi1, 24) + 23587877790.3469*pow(xi1, 22) - 9074343443.38154*pow(xi1, 20) + 2700324281.39419*pow(xi1, 18) - 614338874.893327*pow(xi1, 16) + 104935950.467495*pow(xi1, 14) - 13107241.3893501*pow(xi1, 12) + 1152668.27657894*pow(xi1, 10) - 67538.8728697514*pow(xi1, 8) + 2430.98412069463*pow(xi1, 6) - 48.0633744205988*pow(xi1, 4) + 0.471980763541069*pow(xi1, 2) + 2.91038304567337e-12*pow(xi2, 2)*(8.22629363984827e+19*pow(xi2, 38) - 8.21954524473765e+20*pow(xi2, 36) + 3.79844477095871e+21*pow(xi2, 34) - 1.07706598903585e+22*pow(xi2, 32) + 2.09635182044644e+22*pow(xi2, 30) - 2.96846398721091e+22*pow(xi2, 28) + 3.16240361407376e+22*pow(xi2, 26) - 2.58538913829922e+22*pow(xi2, 24) + 1.63983609457467e+22*pow(xi2, 22) - 8.10473309532676e+21*pow(xi2, 20) + 3.11792066575966e+21*pow(xi2, 18) - 9.27824358174619e+20*pow(xi2, 16) + 2.11085230106262e+20*pow(xi2, 14) - 3.60557180346053e+19*pow(xi2, 12) + 4.50361384864291e+18*pow(xi2, 10) - 3.96053804083457e+17*pow(xi2, 8) + 2.32061800147427e+16*pow(xi2, 6) - 835279783638300.0*pow(xi2, 4) + 16514449701750.0*pow(xi2, 2) - 162171355500.0);
case 15:
return -449186970.696906*pow(xi1, 41) + 4600691607.03978*pow(xi1, 39) - 21836906271.7554*pow(xi1, 37) + 63739269950.2658*pow(xi1, 35) - 128029808068.442*pow(xi1, 33) + 187639118172.457*pow(xi1, 31) - 207591696263.244*pow(xi1, 29) + 176935105732.693*pow(xi1, 27) - 117536872874.726*pow(xi1, 25) + 61173279940.9544*pow(xi1, 23) - 24944876505.7779*pow(xi1, 21) + 7931390553.5376*pow(xi1, 19) - 1947290061.31368*pow(xi1, 17) + 363525099.100395*pow(xi1, 15) - 50454477.3027972*pow(xi1, 13) + 5041918.86101217*pow(xi1, 11) - 346355.058153282*pow(xi1, 9) + 15251.3706304313*pow(xi1, 7) - 382.052695394377*pow(xi1, 5) + 4.09049995068926*pow(xi1, 3) + 1.16415321826935e-10*pow(xi2, 3)*(3.85848669786504e+18*pow(xi2, 38) - 3.95196399824351e+19*pow(xi2, 36) + 1.87577596566014e+20*pow(xi2, 34) - 5.47516159814615e+20*pow(xi2, 32) + 1.09976767713423e+21*pow(xi2, 30) - 1.61180775200196e+21*pow(xi2, 28) + 1.7831990927436e+21*pow(xi2, 26) - 1.51986098527244e+21*pow(xi2, 24) + 1.00963405014212e+21*pow(xi2, 22) - 5.25474473470904e+20*pow(xi2, 20) + 2.14274857590149e+20*pow(xi2, 18) - 6.81301260784947e+19*pow(xi2, 16) + 1.67270942583362e+19*pow(xi2, 14) - 3.12265682382271e+18*pow(xi2, 12) + 4.33400659904577e+17*pow(xi2, 10) - 4.33097532342657e+16*pow(xi2, 8) + 2.97516729514505e+15*pow(xi2, 6) - 131008276153755.0*pow(xi2, 4) + 3281807664135.0*pow(xi2, 2) - 35137127025.0);
case 16:
return -845663225.444685*pow(xi1, 42) + 8873258791.09151*pow(xi1, 40) - 43227100388.3104*pow(xi1, 38) + 129776422613.693*pow(xi1, 36) - 268760127505.3*pow(xi1, 34) + 407220712012.68*pow(xi1, 32) - 467232929734.276*pow(xi1, 30) + 414509044430.427*pow(xi1, 28) - 287829964191.486*pow(xi1, 26) + 157377876444.681*pow(xi1, 24) - 67824279307.8417*pow(xi1, 22) + 22957616604.4428*pow(xi1, 20) - 6054293730.11595*pow(xi1, 18) + 1227723888.89943*pow(xi1, 16) - 187795227.13452*pow(xi1, 14) + 21084402.1336859*pow(xi1, 12) - 1671508.25061792*pow(xi1, 10) + 88451.3556036221*pow(xi1, 8) - 2871.35565824312*pow(xi1, 6) + 50.546892247803*pow(xi1, 4) - 0.438267851859564*pow(xi1, 2) + 2.91038304567337e-11*pow(xi2, 2)*(2.90567671737184e+19*pow(xi2, 40) - 3.0488285053346e+20*pow(xi2, 38) + 1.48527185974962e+21*pow(xi2, 36) - 4.45908392734149e+21*pow(xi2, 34) + 9.23452766483241e+21*pow(xi2, 32) - 1.39919971227864e+22*pow(xi2, 30) + 1.60540012225838e+22*pow(xi2, 28) - 1.42424223177992e+22*pow(xi2, 26) + 9.88976226409026e+21*pow(xi2, 24) - 5.40746265955066e+21*pow(xi2, 22) + 2.3304244920156e+21*pow(xi2, 20) - 7.88817700081508e+20*pow(xi2, 18) + 2.08023948569807e+20*pow(xi2, 16) - 4.21842716107278e+19*pow(xi2, 14) + 6.45259487110124e+18*pow(xi2, 12) - 7.24454540959149e+17*pow(xi2, 10) + 5.74325861711852e+16*pow(xi2, 8) - 3.03916543683539e+15*pow(xi2, 6) + 98659029178710.0*pow(xi2, 4) - 1736777992950.0*pow(xi2, 2) + 15058768725.0);
case 17:
return -1596926835.02578*pow(xi1, 43) + 17155794339.5873*pow(xi1, 41) - 85723491017.7124*pow(xi1, 39) + 264501085869.306*pow(xi1, 37) - 564247100944.487*pow(xi1, 35) + 882930489041.186*pow(xi1, 33) - 1049307583130.46*pow(xi1, 31) + 967502466115.826*pow(xi1, 29) - 701000649302.07*pow(xi1, 27) + 401794420031.072*pow(xi1, 25) - 182520829969.247*pow(xi1, 23) + 65553051819.9223*pow(xi1, 21) - 18491548120.5668*pow(xi1, 19) + 4051446741.34114*pow(xi1, 17) - 678156146.789769*pow(xi1, 15) + 84718393.9058041*pow(xi1, 13) - 7643593.31681862*pow(xi1, 11) + 475270.013535954*pow(xi1, 9) - 18992.8591077769*pow(xi1, 7) + 434.761709044687*pow(xi1, 5) - 4.38267851859564*pow(xi1, 3) + 5.82076609134674e-11*pow(xi2, 3)*(2.7434994122162e+19*pow(xi2, 40) - 2.94734302501717e+20*pow(xi2, 38) + 1.4727183616801e+21*pow(xi2, 36) - 4.54409405426063e+21*pow(xi2, 34) + 9.69369138167753e+21*pow(xi2, 32) - 1.51686303002927e+22*pow(xi2, 30) + 1.80269670119606e+22*pow(xi2, 28) - 1.66215658030673e+22*pow(xi2, 26) + 1.20430994529086e+22*pow(xi2, 24) - 6.90277557499497e+21*pow(xi2, 22) + 3.13568398222678e+21*pow(xi2, 20) - 1.12619285487824e+21*pow(xi2, 18) + 3.17682377720978e+20*pow(xi2, 16) - 6.96033250221839e+19*pow(xi2, 14) + 1.16506338881737e+19*pow(xi2, 12) - 1.4554509247803e+18*pow(xi2, 10) + 1.31315933278641e+17*pow(xi2, 8) - 8.1650766596256e+15*pow(xi2, 6) + 326294834901750.0*pow(xi2, 4) - 7469149287600.0*pow(xi2, 2) + 75293843625.0);
case 18:
return -3023726521.43375*pow(xi1, 44) + 33240747675.0678*pow(xi1, 42) - 170255712367.296*pow(xi1, 40) + 539510185383.932*pow(xi1, 38) - 1184526688778.06*pow(xi1, 36) + 1912326388450.07*pow(xi1, 34) - 2351270564754.81*pow(xi1, 32) + 2250082365455.32*pow(xi1, 30) - 1698284245818.33*pow(xi1, 28) + 1018375869131.64*pow(xi1, 26) - 486441112729.579*pow(xi1, 24) + 184821161665.788*pow(xi1, 22) - 55558771326.0834*pow(xi1, 20) + 13089485207.7017*pow(xi1, 18) - 2382798209.34807*pow(xi1, 16) + 328475493.04593*pow(xi1, 14) - 33341967.2140553*pow(xi1, 12) + 2395791.07105762*pow(xi1, 10) - 115121.977334549*pow(xi1, 8) + 3393.85493899799*pow(xi1, 6) - 53.7562912046496*pow(xi1, 4) + 0.410876111118341*pow(xi1, 2) + 8.26813365248117e-14*pow(xi2, 2)*(3.6570847164842e+22*pow(xi2, 42) - 4.02034474431756e+23*pow(xi2, 40) + 2.0591794898744e+24*pow(xi2, 38) - 6.52517494346541e+24*pow(xi2, 36) + 1.43264095449473e+25*pow(xi2, 34) - 2.31288761022411e+25*pow(xi2, 32) + 2.84377425859489e+25*pow(xi2, 30) - 2.72139089669903e+25*pow(xi2, 28) + 2.05401160310065e+25*pow(xi2, 26) - 1.2316877205124e+25*pow(xi2, 24) + 5.88332425641915e+24*pow(xi2, 22) - 2.23534317941661e+24*pow(xi2, 20) + 6.71962666077741e+23*pow(xi2, 18) - 1.5831245306217e+23*pow(xi2, 16) + 2.88190577160423e+22*pow(xi2, 14) - 3.972788864478e+21*pow(xi2, 12) + 4.03258687092579e+20*pow(xi2, 10) - 2.89762015438475e+19*pow(xi2, 8) + 1.39235747961092e+18*pow(xi2, 6) - 4.10474126525463e+16*pow(xi2, 4) + 650162339701875.0*pow(xi2, 2) - 4969393679250.0);
case 19:
return -5739151515.19191*pow(xi1, 45) + 64528538905.8027*pow(xi1, 43) - 338582125411.19*pow(xi1, 41) + 1101111962091.26*pow(xi1, 39) - 2486172256125.54*pow(xi1, 37) + 4137157284655.27*pow(xi1, 35) - 5256914464518.41*pow(xi1, 33) + 5214493554143.21*pow(xi1, 31) - 4093581718892.25*pow(xi1, 29) + 2563396026608.8*pow(xi1, 27) - 1284656774810.01*pow(xi1, 25) + 514956083882.467*pow(xi1, 23) - 164410684836.72*pow(xi1, 21) + 41475494866.957*pow(xi1, 19) - 8166473938.34107*pow(xi1, 17) + 1233384913.79123*pow(xi1, 15) - 139478936.421598*pow(xi1, 13) + 11421836.7765192*pow(xi1, 11) - 645954.797160119*pow(xi1, 9) + 23522.5504032993*pow(xi1, 7) - 492.667848971632*pow(xi1, 5) + 4.65659592600787*pow(xi1, 3) + 7.27595761418343e-13*pow(xi2, 3)*(7.88782978065219e+21*pow(xi2, 42) - 8.86873485629076e+22*pow(xi2, 40) + 4.65343729808394e+23*pow(xi2, 38) - 1.51335675725323e+24*pow(xi2, 36) + 3.41696913033015e+24*pow(xi2, 34) - 5.68606567552082e+24*pow(xi2, 32) + 7.22504822495229e+24*pow(xi2, 30) - 7.16674536967933e+24*pow(xi2, 28) + 5.62617587396662e+24*pow(xi2, 26) - 3.52310467231396e+24*pow(xi2, 24) + 1.76561882700603e+24*pow(xi2, 22) - 7.07750252528458e+23*pow(xi2, 20) + 2.25964324635736e+23*pow(xi2, 18) - 5.70034860924788e+22*pow(xi2, 16) + 1.12239163164196e+22*pow(xi2, 14) - 1.6951513177962e+21*pow(xi2, 12) + 1.9169839053172e+20*pow(xi2, 10) - 1.5698052932928e+19*pow(xi2, 8) + 8.87793513119048e+17*pow(xi2, 6) - 3.23291471042182e+16*pow(xi2, 4) + 677117535719625.0*pow(xi2, 2) - 6399976708125.0);
case 20:
return -10916864295.202*pow(xi1, 46) + 125476260721.295*pow(xi1, 44) - 674073073816.212*pow(xi1, 42) + 2248321823144.9*pow(xi1, 40) - 5216544812047.65*pow(xi1, 38) + 8939734579066.18*pow(xi1, 36) - 11727223625887.1*pow(xi1, 34) + 12043084537277.8*pow(xi1, 32) - 9819495279736.75*pow(xi1, 30) + 6410302670942.14*pow(xi1, 28) - 3363668401955.01*pow(xi1, 26) + 1418999123886.7*pow(xi1, 24) - 479709514691.903*pow(xi1, 22) + 129086628714.985*pow(xi1, 20) - 27359365638.4866*pow(xi1, 18) + 4498778446.81622*pow(xi1, 16) - 562063823.082374*pow(xi1, 14) + 51848002.1788295*pow(xi1, 12) - 3393112.46214019*pow(xi1, 10) + 148747.317821576*pow(xi1, 8) - 4003.61182729473*pow(xi1, 6) + 57.5606996409306*pow(xi1, 4) - 0.388049660500656*pow(xi1, 2) + 9.09494701772928e-13*pow(xi2, 2)*(1.20032192314272e+22*pow(xi2, 44) - 1.37962607672917e+23*pow(xi2, 42) + 7.41151182631635e+23*pow(xi2, 40) - 2.47205598753035e+24*pow(xi2, 38) + 5.73565167766096e+24*pow(xi2, 36) - 9.82934211891445e+24*pow(xi2, 34) + 1.28942187381923e+25*pow(xi2, 32) - 1.32415114830263e+25*pow(xi2, 30) + 1.07966492389621e+25*pow(xi2, 28) - 7.04820232426443e+24*pow(xi2, 26) + 3.69839251993225e+24*pow(xi2, 24) - 1.56020603651738e+24*pow(xi2, 22) + 5.27446189358529e+23*pow(xi2, 20) - 1.4193224926253e+23*pow(xi2, 18) + 3.00819406480912e+22*pow(xi2, 16) - 4.94645921306248e+21*pow(xi2, 14) + 6.17995709031303e+20*pow(xi2, 12) - 5.70074812725784e+19*pow(xi2, 10) + 3.73076660647479e+18*pow(xi2, 8) - 1.63549405545315e+17*pow(xi2, 6) + 4.40201775721208e+15*pow(xi2, 4) - 63288658558125.0*pow(xi2, 2) + 426665113875.0);
case 21:
return -20806834300.5978*pow(xi1, 47) + 244355631791.314*pow(xi1, 45) - 1343273740298.02*pow(xi1, 43) + 4592284861114.13*pow(xi1, 41) - 10941218087890.8*pow(xi1, 39) + 19293765550349.6*pow(xi1, 37) - 26104144978494.4*pow(xi1, 35) + 27721880835822.7*pow(xi1, 33) - 23445377187979.1*pow(xi1, 31) + 15930895144025.1*pow(xi1, 29) - 8736178307237.03*pow(xi1, 27) + 3869824780370.31*pow(xi1, 25) - 1381408154889.13*pow(xi1, 23) + 395166275983.381*pow(xi1, 21) - 89767193240.2531*pow(xi1, 19) + 15982098655.2556*pow(xi1, 17) - 2190045568.70281*pow(xi1, 15) + 225338397.125726*pow(xi1, 13) - 16827632.97963*pow(xi1, 11) + 869437.913538747*pow(xi1, 9) - 28967.2419283845*pow(xi1, 7) + 556.411473203207*pow(xi1, 5) - 4.91529569967497*pow(xi1, 3) + 1.81898940354586e-12*pow(xi2, 3)*(1.14386781253579e+22*pow(xi2, 44) - 1.3433592923355e+23*pow(xi2, 42) + 7.38472548371917e+23*pow(xi2, 40) - 2.52463530142734e+24*pow(xi2, 38) + 6.0149982548345e+24*pow(xi2, 36) - 1.06068597830967e+25*pow(xi2, 34) + 1.43509054685025e+25*pow(xi2, 32) - 1.52402651614039e+25*pow(xi2, 30) + 1.28892324178886e+25*pow(xi2, 28) - 8.75810222586789e+24*pow(xi2, 26) + 4.80276481556578e+24*pow(xi2, 24) - 2.12745867173643e+24*pow(xi2, 22) + 7.59437164502595e+23*pow(xi2, 20) - 2.17244957674334e+23*pow(xi2, 18) + 4.93500363802367e+22*pow(xi2, 16) - 8.78625165385837e+21*pow(xi2, 14) + 1.20399028407402e+21*pow(xi2, 12) - 1.23881093912071e+20*pow(xi2, 10) + 9.25108906452505e+18*pow(xi2, 8) - 4.77978547782579e+17*pow(xi2, 6) + 1.59249096624296e+16*pow(xi2, 4) - 305890442307450.0*pow(xi2, 2) + 2702212387875.0);
case 22:
return -39728049242.7039*pow(xi1, 48) + 476505949117.133*pow(xi1, 46) - 2679054791412.26*pow(xi1, 44) + 9382111673603.37*pow(xi1, 42) - 22937896621590.0*pow(xi1, 40) + 41588485583490.6*pow(xi1, 38) - 57981856038508.5*pow(xi1, 36) + 63608598673568.9*pow(xi1, 34) - 55730713154580.7*pow(xi1, 32) + 39358257862237.2*pow(xi1, 30) - 22516922818681.8*pow(xi1, 28) + 10451406445051.6*pow(xi1, 26) - 3929555657141.43*pow(xi1, 24) + 1191272175390.01*pow(xi1, 22) - 288926022756.805*pow(xi1, 20) + 55425095713.3247*pow(xi1, 18) - 8277516579.76024*pow(xi1, 16) + 941984086.723766*pow(xi1, 14) - 79334996.0209767*pow(xi1, 12) + 4749320.37729368*pow(xi1, 10) - 190735.308470803*pow(xi1, 8) + 4707.5998798852*pow(xi1, 6) - 61.8712846196587*pow(xi1, 4) + 0.368647177475623*pow(xi1, 2) + 2.8421709430404e-14*pow(xi2, 2)*(1.39780646691873e+24*pow(xi2, 46) - 1.67655626162793e+25*pow(xi2, 44) + 9.4260860627417e+25*pow(xi2, 42) - 3.30103708103035e+26*pow(xi2, 40) + 8.07055489669184e+26*pow(xi2, 38) - 1.46326475138056e+27*pow(xi2, 36) + 2.04005519725997e+27*pow(xi2, 34) - 2.23802860378003e+27*pow(xi2, 32) + 1.96085014840673e+27*pow(xi2, 30) - 1.38479558939315e+27*pow(xi2, 28) + 7.92243790748012e+26*pow(xi2, 26) - 3.67726173214312e+26*pow(xi2, 24) + 1.38258948384639e+26*pow(xi2, 22) - 4.19141634779945e+25*pow(xi2, 20) + 1.01656806908218e+25*pow(xi2, 18) - 1.95009719063674e+24*pow(xi2, 16) + 2.9123922331376e+23*pow(xi2, 14) - 3.31431186090476e+22*pow(xi2, 12) + 2.79135201966805e+21*pow(xi2, 10) - 1.67101855323773e+20*pow(xi2, 8) + 6.71090206371489e+18*pow(xi2, 6) - 1.65633945819222e+17*pow(xi2, 4) + 2.1769022996721e+15*pow(xi2, 2) - 12970619461800.0);
case 23:
return -75981341991.8768*pow(xi1, 49) + 930343104637.766*pow(xi1, 47) - 5347021071237.98*pow(xi1, 45) + 19170777097011.4*pow(xi1, 43) - 48064836289803.9*pow(xi1, 41) + 89534811535571.6*pow(xi1, 39) - 128518154466020.0*pow(xi1, 37) + 145501072157689.0*pow(xi1, 35) - 131912174618258.0*pow(xi1, 33) + 96692459335021.2*pow(xi1, 31) - 57617974678786.9*pow(xi1, 29) + 27969551245737.2*pow(xi1, 27) - 11050657441547.3*pow(xi1, 25) + 3540321435715.92*pow(xi1, 23) - 913580894724.717*pow(xi1, 21) + 188008155558.22*pow(xi1, 19) - 30431272882.66*pow(xi1, 17) + 3802262020.28662*pow(xi1, 15) - 357585352.728971*pow(xi1, 13) + 24455846.7974416*pow(xi1, 11) - 1159047.64875872*pow(xi1, 9) + 35465.8737443918*pow(xi1, 7) - 626.552742837569*pow(xi1, 5) + 5.16106048465872*pow(xi1, 3) + 4.54747350886464e-13*pow(xi2, 3)*(1.67084738028187e+23*pow(xi2, 46) - 2.04584612274089e+24*pow(xi2, 44) + 1.17582236835789e+25*pow(xi2, 42) - 4.21569846633318e+25*pow(xi2, 40) + 1.05695692775578e+26*pow(xi2, 38) - 1.96889132748187e+26*pow(xi2, 36) + 2.82614410431401e+26*pow(xi2, 34) - 3.19960241382507e+26*pow(xi2, 32) + 2.90077939675986e+26*pow(xi2, 30) - 2.12628966714228e+26*pow(xi2, 28) + 1.26703266256459e+26*pow(xi2, 26) - 6.15056936367295e+25*pow(xi2, 24) + 2.43006527031012e+25*pow(xi2, 22) - 7.78524916926856e+24*pow(xi2, 20) + 2.00898563332766e+24*pow(xi2, 18) - 4.13434306305964e+23*pow(xi2, 16) + 6.69190767650184e+22*pow(xi2, 14) - 8.36126260631241e+21*pow(xi2, 12) + 7.86338506495773e+20*pow(xi2, 10) - 5.3778975841791e+19*pow(xi2, 8) + 2.54877273391329e+18*pow(xi2, 6) - 7.79902811423886e+16*pow(xi2, 4) + 1.37780405232971e+15*pow(xi2, 2) - 11349292029075.0);
case 24:
return -145538806888.077*pow(xi1, 50) + 1818436825861.34*pow(xi1, 48) - 10678646758589.6*pow(xi1, 46) + 39175840371527.9*pow(xi1, 44) - 100663775838791.0*pow(xi1, 42) + 192520127394647.0*pow(xi1, 40) - 284282290970171.0*pow(xi1, 38) + 331835096922265.0*pow(xi1, 36) - 310962453524380.0*pow(xi1, 34) + 236281374337303.0*pow(xi1, 32) - 146432298299480.0*pow(xi1, 30) + 74208765606632.7*pow(xi1, 28) - 30744623546611.0*pow(xi1, 26) + 10382337028640.8*pow(xi1, 24) - 2841593580509.51*pow(xi1, 22) + 624889983293.009*pow(xi1, 20) - 109080673375.912*pow(xi1, 18) + 14868478903.0804*pow(xi1, 16) - 1548160823.61131*pow(xi1, 14) + 119545585.350288*pow(xi1, 12) - 6572312.36046044*pow(xi1, 10) + 242720.226250891*pow(xi1, 8) - 5514.13958011828*pow(xi1, 6) + 66.6245989837762*pow(xi1, 4) - 0.351890487590367*pow(xi1, 2) + 2.27373675443232e-14*pow(xi2, 2)*(6.40086441864344e+24*pow(xi2, 48) - 7.99756973764248e+25*pow(xi2, 46) + 4.69651851199269e+26*pow(xi2, 44) - 1.72297168065566e+27*pow(xi2, 42) + 4.42723968122348e+27*pow(xi2, 40) - 8.46712474605324e+27*pow(xi2, 38) + 1.25028673797001e+28*pow(xi2, 36) - 1.45942619028083e+28*pow(xi2, 34) + 1.36762733380724e+28*pow(xi2, 32) - 1.03917647404303e+28*pow(xi2, 30) + 6.44016058648968e+27*pow(xi2, 28) - 3.26373602669586e+27*pow(xi2, 26) + 1.35216284324378e+27*pow(xi2, 24) - 4.56620011459194e+26*pow(xi2, 22) + 1.24974607327354e+26*pow(xi2, 20) - 2.74829521084565e+25*pow(xi2, 18) + 4.79741874969806e+24*pow(xi2, 16) - 6.53922617651163e+23*pow(xi2, 14) + 6.8088833089116e+22*pow(xi2, 12) - 5.25767044567719e+21*pow(xi2, 10) + 2.89053354468087e+20*pow(xi2, 8) - 1.06749484423711e+19*pow(xi2, 6) + 2.42514423420797e+17*pow(xi2, 4) - 2.930180851143e+15*pow(xi2, 2) + 15476307312375.0);
case 25:
return -279166509376.106*pow(xi1, 51) + 3557880594966.93*pow(xi1, 49) - 21338365920884.2*pow(xi1, 47) + 80059627822368.0*pow(xi1, 45) - 210707878128500.0*pow(xi1, 43) + 413457806621174.0*pow(xi1, 41) - 627584822582511.0*pow(xi1, 39) + 754625892772514.0*pow(xi1, 37) - 730196744663009.0*pow(xi1, 35) + 574457730986261.0*pow(xi1, 33) - 369744544138545.0*pow(xi1, 31) + 195297320104083.0*pow(xi1, 29) - 84678136859102.6*pow(xi1, 27) + 30070931450057.4*pow(xi1, 25) - 8704310569332.09*pow(xi1, 23) + 2038251259475.21*pow(xi1, 21) - 382020033084.267*pow(xi1, 19) + 56487470251.4904*pow(xi1, 17) - 6464022566.86872*pow(xi1, 15) + 557939889.530573*pow(xi1, 13) - 35082432.7556841*pow(xi1, 11) + 1530776.40533598*pow(xi1, 9) - 43171.1940575669*pow(xi1, 7) + 703.59330025402*pow(xi1, 5) - 5.3956541430523*pow(xi1, 3) + 2.27373675443232e-13*pow(xi2, 3)*(1.22778729257867e+24*pow(xi2, 48) - 1.56477243376189e+25*pow(xi2, 46) + 9.38471257910054e+25*pow(xi2, 44) - 3.5210596682445e+26*pow(xi2, 42) + 9.26703048265178e+26*pow(xi2, 40) - 1.81840666389897e+27*pow(xi2, 38) + 2.76014723938084e+27*pow(xi2, 36) - 3.3188797748969e+27*pow(xi2, 34) + 3.21143924528464e+27*pow(xi2, 32) - 2.52649181954084e+27*pow(xi2, 30) + 1.62615370234826e+27*pow(xi2, 28) - 8.58926697311723e+26*pow(xi2, 26) + 3.72418384379963e+26*pow(xi2, 24) - 1.32253355149573e+26*pow(xi2, 22) + 3.82819627310167e+25*pow(xi2, 20) - 8.96432384048829e+24*pow(xi2, 18) + 1.6801418736781e+24*pow(xi2, 16) - 2.48434521460659e+23*pow(xi2, 14) + 2.84290718979145e+22*pow(xi2, 12) - 2.45384558455569e+21*pow(xi2, 10) + 1.54294170982177e+20*pow(xi2, 8) - 6.73242582876822e+18*pow(xi2, 6) + 1.89868919405076e+17*pow(xi2, 4) - 3.09443605941834e+15*pow(xi2, 2) + 23730337878975.0);
case 26:
return -536187598537.281*pow(xi1, 52) + 6967640531775.1*pow(xi1, 50) - 42659726193562.7*pow(xi1, 48) + 163608805357696.0*pow(xi1, 46) - 440801678175839.0*pow(xi1, 44) + 886879365892137.0*pow(xi1, 42) - 1.38279322603835e+15*pow(xi1, 40) + 1.71135652394663e+15*pow(xi1, 38) - 1.70825590882209e+15*pow(xi1, 36) + 1.38989776889186e+15*pow(xi1, 34) - 927891786877753.0*pow(xi1, 32) + 510039629345147.0*pow(xi1, 30) - 231022322507251.0*pow(xi1, 28) + 86087547010722.5*pow(xi1, 26) - 26285433620239.1*pow(xi1, 24) + 6533333986439.11*pow(xi1, 22) - 1309569337206.32*pow(xi1, 20) + 209011313677.242*pow(xi1, 18) - 26116500380.1459*pow(xi1, 16) + 2498241243.17268*pow(xi1, 14) - 177542358.650584*pow(xi1, 12) + 8996459.42651258*pow(xi1, 10) - 306582.523307831*pow(xi1, 8) + 6432.6089417779*pow(xi1, 6) - 71.7734410487269*pow(xi1, 4) + 0.337228383940769*pow(xi1, 2) + 7.105427357601e-15*pow(xi2, 2)*(7.54616959054118e+25*pow(xi2, 50) - 9.8060822820481e+26*pow(xi2, 48) + 6.00382271840801e+27*pow(xi2, 46) - 2.30258923388578e+28*pow(xi2, 44) + 6.20373210492811e+28*pow(xi2, 42) - 1.24817174429825e+29*pow(xi2, 40) + 1.94610845547399e+29*pow(xi2, 38) - 2.40852018860754e+29*pow(xi2, 36) + 2.40415646075769e+29*pow(xi2, 34) - 1.95610721064514e+29*pow(xi2, 32) + 1.30589159550712e+29*pow(xi2, 30) - 7.17816963957185e+28*pow(xi2, 28) + 3.25135014236851e+28*pow(xi2, 26) - 1.21157451449603e+28*pow(xi2, 24) + 3.69934590804314e+27*pow(xi2, 22) - 9.19485015837942e+26*pow(xi2, 20) + 1.84305499345569e+26*pow(xi2, 18) - 2.94157273247826e+25*pow(xi2, 16) + 3.67557066813271e+24*pow(xi2, 14) - 3.51596197869815e+23*pow(xi2, 12) + 2.4986865633164e+22*pow(xi2, 10) - 1.266139103778e+21*pow(xi2, 8) + 4.31476543039829e+19*pow(xi2, 6) - 9.05309226037846e+17*pow(xi2, 4) + 1.0101213823817e+16*pow(xi2, 2) - 47460675757950.0);
case 27:
return -1031098868734.33*pow(xi1, 53) + 13656799302216.0*pow(xi1, 51) - 85322239662808.6*pow(xi1, 49) + 334335254497875.0*pow(xi1, 47) - 921629169951347.0*pow(xi1, 45) + 1.90013792114849e+15*pow(xi1, 43) - 3.04108995585405e+15*pow(xi1, 41) + 3.87073358105217e+15*pow(xi1, 39) - 3.98213104426395e+15*pow(xi1, 37) + 3.34735422684659e+15*pow(xi1, 35) - 2.31503617547326e+15*pow(xi1, 33) + 1.32238476900186e+15*pow(xi1, 31) - 624675256927435.0*pow(xi1, 29) + 243773285298310.0*pow(xi1, 27) - 78326766091896.9*pow(xi1, 25) + 20604719081135.1*pow(xi1, 23) - 4401250638548.01*pow(xi1, 21) + 754840239473.165*pow(xi1, 19) - 102405233319.159*pow(xi1, 17) + 10775577645.0379*pow(xi1, 15) - 856837392.061791*pow(xi1, 13) + 49709190.4236064*pow(xi1, 11) - 2003680.2341744*pow(xi1, 9) + 52251.1293174511*pow(xi1, 7) - 787.990323808263*pow(xi1, 5) + 5.62047306567948*pow(xi1, 3) + 2.8421709430404e-14*pow(xi2, 3)*(3.62785662579225e+25*pow(xi2, 50) - 4.80505908191668e+26*pow(xi2, 48) + 3.00200942774876e+27*pow(xi2, 46) - 1.17633759966676e+28*pow(xi2, 44) + 3.24269436434896e+28*pow(xi2, 42) - 6.68551596377883e+28*pow(xi2, 40) + 1.06998840562379e+29*pow(xi2, 38) - 1.36189330572477e+29*pow(xi2, 36) + 1.40108780367872e+29*pow(xi2, 34) - 1.17774556630495e+29*pow(xi2, 32) + 8.14530941969576e+28*pow(xi2, 30) - 4.65272777571657e+28*pow(xi2, 28) + 2.19788066744216e+28*pow(xi2, 26) - 8.57700997525273e+27*pow(xi2, 24) + 2.75587808269221e+27*pow(xi2, 22) - 7.24964102936513e+26*pow(xi2, 20) + 1.54855240122882e+26*pow(xi2, 18) - 2.65585798532469e+25*pow(xi2, 16) + 3.60306383294494e+24*pow(xi2, 14) - 3.79131933335112e+23*pow(xi2, 12) + 3.01472856219265e+22*pow(xi2, 10) - 1.74898665209877e+21*pow(xi2, 8) + 7.04982309062303e+19*pow(xi2, 6) - 1.83842317596688e+18*pow(xi2, 4) + 2.77249447552691e+16*pow(xi2, 2) - 197752815658125.0);
case 28:
return -1985085642584.69*pow(xi1, 54) + 26788741762693.9*pow(xi1, 52) - 170715251986214.0*pow(xi1, 50) + 683167689474105.0*pow(xi1, 48) - 1.92582698260844e+15*pow(xi1, 46) + 4.06633243625181e+15*pow(xi1, 44) - 6.67595460794649e+15*pow(xi1, 42) + 8.73238684495299e+15*pow(xi1, 40) - 9.25108297396294e+15*pow(xi1, 38) + 8.02612992827034e+15*pow(xi1, 36) - 5.74391288108549e+15*pow(xi1, 34) + 3.40505258328624e+15*pow(xi1, 32) - 1.67490311154428e+15*pow(xi1, 30) + 683229999465451.0*pow(xi1, 28) - 230508183911447.0*pow(xi1, 26) + 64007364830632.8*pow(xi1, 24) - 14522855116130.1*pow(xi1, 22) + 2665817039716.65*pow(xi1, 20) - 390684676159.123*pow(xi1, 18) + 44927685217.5777*pow(xi1, 16) - 3962823148.48188*pow(xi1, 14) + 260094754.560315*pow(xi1, 12) - 12187708.0158238*pow(xi1, 10) + 384471.912634116*pow(xi1, 8) - 7473.26201178072*pow(xi1, 6) + 77.2815046530928*pow(xi1, 4) - 0.324258061481508*pow(xi1, 2) + 7.105427357601e-15*pow(xi2, 2)*(2.79375967507591e+26*pow(xi2, 52) - 3.77018023188103e+27*pow(xi2, 50) + 2.40260357884866e+28*pow(xi2, 48) - 9.61473047420981e+28*pow(xi2, 46) + 2.71036052539231e+29*pow(xi2, 44) - 5.72285413895882e+29*pow(xi2, 42) + 9.39557083896568e+29*pow(xi2, 40) - 1.22897419190579e+30*pow(xi2, 38) + 1.30197418232228e+30*pow(xi2, 36) - 1.1295773673183e+30*pow(xi2, 34) + 8.08383872215787e+29*pow(xi2, 32) - 4.79218548289526e+29*pow(xi2, 30) + 2.35721657157265e+29*pow(xi2, 28) - 9.61560740937796e+28*pow(xi2, 26) + 3.24411428490451e+28*pow(xi2, 24) - 9.00823576250642e+27*pow(xi2, 22) + 2.04391015279248e+27*pow(xi2, 20) - 3.75180394584557e+26*pow(xi2, 18) + 5.49839800615497e+25*pow(xi2, 16) - 6.32300957514069e+24*pow(xi2, 14) + 5.57717776713693e+23*pow(xi2, 12) - 3.66050824912142e+22*pow(xi2, 10) + 1.71526741495514e+21*pow(xi2, 8) - 5.41096113272946e+19*pow(xi2, 6) + 1.0517681253593e+18*pow(xi2, 4) - 1.08764048611969e+16*pow(xi2, 2) + 45635265151875.0);
case 29:
return -3825801420254.13*pow(xi1, 55) + 52586042305451.0*pow(xi1, 53) - 341687969236169.0*pow(xi1, 51) + 1.39582701084848e+15*pow(xi1, 49) - 4.02184701701795e+15*pow(xi1, 47) + 8.69217561331876e+15*pow(xi1, 45) - 1.46296547399939e+16*pow(xi1, 43) + 1.96517271944361e+16*pow(xi1, 41) - 2.14212772656679e+16*pow(xi1, 39) + 1.91638297975192e+16*pow(xi1, 37) - 1.41763210139116e+16*pow(xi1, 35) + 8.71074098744053e+15*pow(xi1, 33) - 4.45512314357336e+15*pow(xi1, 31) + 1.89644758994893e+15*pow(xi1, 29) - 670465190273508.0*pow(xi1, 27) + 196044097813775.0*pow(xi1, 25) - 47109937320332.5*pow(xi1, 23) + 9221955750876.3*pow(xi1, 21) - 1453419608880.21*pow(xi1, 19) + 181616100635.238*pow(xi1, 17) - 17636765574.6625*pow(xi1, 15) + 1296385476.97221*pow(xi1, 13) - 69617217.8772325*pow(xi1, 11) + 2600317.96606451*pow(xi1, 9) - 62889.962198531*pow(xi1, 7) + 880.166082085406*pow(xi1, 5) - 5.83664510666715*pow(xi1, 3) + 2.58379176640036e-16*pow(xi2, 3)*(1.48069262779023e+28*pow(xi2, 52) - 2.03522756706945e+29*pow(xi2, 50) + 1.3224284312671e+30*pow(xi2, 48) - 5.40224266134686e+30*pow(xi2, 46) + 1.5565677812423e+31*pow(xi2, 44) - 3.36411615144527e+31*pow(xi2, 42) + 5.66208737493399e+31*pow(xi2, 40) - 7.60577049976984e+31*pow(xi2, 38) + 8.29063608926625e+31*pow(xi2, 36) - 7.4169405006726e+31*pow(xi2, 34) + 5.48663448744612e+31*pow(xi2, 32) - 3.37130147278702e+31*pow(xi2, 30) + 1.72425781423557e+31*pow(xi2, 28) - 7.33978494169052e+30*pow(xi2, 26) + 2.59488863999119e+30*pow(xi2, 24) - 7.58745733162915e+29*pow(xi2, 22) + 1.82328692013614e+29*pow(xi2, 20) - 3.56915594778133e+28*pow(xi2, 18) + 5.62514219520505e+27*pow(xi2, 16) - 7.02905330828026e+26*pow(xi2, 14) + 6.82592374664672e+25*pow(xi2, 12) - 5.0173759891583e+24*pow(xi2, 10) + 2.69438190734002e+23*pow(xi2, 8) - 1.00639610354017e+22*pow(xi2, 6) + 2.43401821371026e+20*pow(xi2, 4) - 3.40649000252686e+18*pow(xi2, 2) + 2.25894562501781e+16);
default:
return 0.;
}
default:
return 0.;
}
}
|
the_stack_data/87638884.c | #include <unistd.h>
void print_num(int val)
{
char num[32];
int top = 0;
if (val < 0)
return;
num[top++] = (val % 10) + '0';
while ((val /= 10) > 0)
num[top++] = (val % 10) + '0';
while (top >= 0)
write(1, &num[--top], 1);
}
int main()
{
print_num(0);
write(1, "\n", 1);
print_num(3);
write(1, "\n", 1);
print_num(42);
write(1, "\n", 1);
print_num(256);
write(1, "\n", 1);
print_num(1234);
write(1, "\n", 1);
print_num(49494);
write(1, "\n", 1);
print_num(150629);
write(1, "\n", 1);
print_num(9182734);
write(1, "\n", 1);
}
|
the_stack_data/72013578.c | //area do circulo
#include <stdio.h>
int main(){
double raio,area,n = 3.14159;
scanf("%lf", &raio);
area = (n * (raio * raio));
printf("A=%.4lf\n", area);
return 0;
}
|
the_stack_data/155312.c | typedef unsigned char undefined;
typedef unsigned char byte;
typedef unsigned int dword;
typedef long long longlong;
typedef unsigned char uchar;
typedef unsigned int uint;
typedef unsigned long ulong;
typedef unsigned long long ulonglong;
typedef unsigned short ushort;
typedef unsigned short word;
typedef struct Elf32_Shdr Elf32_Shdr, *PElf32_Shdr;
typedef enum Elf_SectionHeaderType_RISCV {
SHT_ANDROID_REL=1610612737,
SHT_ANDROID_RELA=1610612738,
SHT_CHECKSUM=1879048184,
SHT_DYNAMIC=6,
SHT_DYNSYM=11,
SHT_FINI_ARRAY=15,
SHT_GNU_ATTRIBUTES=1879048181,
SHT_GNU_HASH=1879048182,
SHT_GNU_LIBLIST=1879048183,
SHT_GNU_verdef=1879048189,
SHT_GNU_verneed=1879048190,
SHT_GNU_versym=1879048191,
SHT_GROUP=17,
SHT_HASH=5,
SHT_INIT_ARRAY=14,
SHT_NOBITS=8,
SHT_NOTE=7,
SHT_NULL=0,
SHT_PREINIT_ARRAY=16,
SHT_PROGBITS=1,
SHT_REL=9,
SHT_RELA=4,
SHT_SHLIB=10,
SHT_STRTAB=3,
SHT_SUNW_COMDAT=1879048187,
SHT_SUNW_move=1879048186,
SHT_SUNW_syminfo=1879048188,
SHT_SYMTAB=2,
SHT_SYMTAB_SHNDX=18
} Elf_SectionHeaderType_RISCV;
struct Elf32_Shdr {
dword sh_name;
enum Elf_SectionHeaderType_RISCV sh_type;
dword sh_flags;
dword sh_addr;
dword sh_offset;
dword sh_size;
dword sh_link;
dword sh_info;
dword sh_addralign;
dword sh_entsize;
};
typedef struct Elf32_Sym Elf32_Sym, *PElf32_Sym;
struct Elf32_Sym {
dword st_name;
dword st_value;
dword st_size;
byte st_info;
byte st_other;
word st_shndx;
};
typedef struct Elf32_Rela Elf32_Rela, *PElf32_Rela;
struct Elf32_Rela {
dword r_offset; // location to apply the relocation action
dword r_info; // the symbol table index and the type of relocation
dword r_addend; // a constant addend used to compute the relocatable field value
};
typedef struct Elf32_Ehdr Elf32_Ehdr, *PElf32_Ehdr;
struct Elf32_Ehdr {
byte e_ident_magic_num;
char e_ident_magic_str[3];
byte e_ident_class;
byte e_ident_data;
byte e_ident_version;
byte e_ident_osabi;
byte e_ident_abiversion;
byte e_ident_pad[7];
word e_type;
word e_machine;
dword e_version;
dword e_entry;
dword e_phoff;
dword e_shoff;
dword e_flags;
word e_ehsize;
word e_phentsize;
word e_phnum;
word e_shentsize;
word e_shnum;
word e_shstrndx;
};
|
the_stack_data/867488.c | int main(){
int x = 6&5|4^7&4^7|10+2-6&7/8;
x = x&3 | x ^ 7;
x = 3-x;
x >>= 6&5|4^7&4^7|10+2-6&7/8;
return x;
}
|
the_stack_data/193894327.c | // gcc -Ofast -march=native ./pinwheels.c -o pinwheels; ./pinwheels | mpv - -scale oversample
#include <stdio.h>
#include <stdint.h>
#include <stdlib.h>
#define W (1080 / 4)
#define H (1920 / 4)
#define STATES 3
char rule[] = "--+---00000+---++"
"------00000++++++"
"--+++-00000+++-++";
int8_t table[3][17];
int main(int argc, char **argv){
static int8_t world[W][H][2] = {0};
static uint32_t color[STATES] = {0x20400FF, 0, 0xFF4020};
int16_t i, j, k;
int8_t flag = 0;
srand(12343);
for(i = 0; i < 3; i ++){
for(j = 0; j < 17; j ++){
k = rule[17 * i + j];
switch(k){
case '0':
table[i][j] = 0;
break;
case '+':
table[i][j] = 1;
break;
case '-':
table[i][j] = -1;
}
}
}
for(i = 0; i < W; i ++){
for(j = 0; j < H; j ++){
world[i][j][0] = world[i][j][1] = (rand() % 3) - 1;
}
}
flag = 0;
while (1){
printf("P6\n%d %d\n255\n", H, W);
for(i = 0; i < W; i ++){
for(j = 0; j < H; j ++){
int8_t temp[9], sum = 8;
int64_t u;
// Put all neighbors into an array.
temp[0] = world[i][j][flag];
temp[1] = world[(W + i - 1) % W][j][flag];
temp[2] = world[(i + 1) % W][j][flag];
temp[3] = world[i][(H + j - 1) % H][flag];
temp[4] = world[i][(j + 1) % H][flag];
temp[5] = world[(i + 1) % W][(H + j - 1) % H][flag];
temp[6] = world[(W + i - 1) % W][(j + 1) % H][flag];
temp[7] = world[(i + 1) % W][(j + 1) % H][flag];
temp[8] = world[(W + i - 1) % W][(H + j - 1) % H][flag];
for (k = 1; k < 9; k ++){
sum += temp[k];
}
u = table[temp[0] + 1][sum];
world[i][j][!flag] = u;
u = color[u + 1];
putchar(u & 255); u >>= 8;
putchar(u & 255); u >>= 8;
putchar(u & 255);
}
}
flag ^= 1;
}
}
|
the_stack_data/43467.c | #include <stdio.h>
int main(void)
{
int n;
scanf("%d", &n);
printf("%d\n", 1 << n);
return 0;
}
|
the_stack_data/70449148.c | #include <pthread.h>
#include <stdio.h>
#include <stdlib.h>
#define NUM_THREADS 4
void *PrintHelloWorld(void *InputArg)
{
printf(" Hello ");
printf(" World \n");
}
void pthreads_c_()
{
pthread_t threads[NUM_THREADS];
int id;
pthread_attr_t attr;
pthread_attr_init(&attr);
pthread_attr_setdetachstate(&attr, PTHREAD_CREATE_JOINABLE);
for (id = 0; id < NUM_THREADS; id++) {
pthread_create(&threads[id], &attr, PrintHelloWorld, NULL);
}
for (id = 0; id < NUM_THREADS; id++){
pthread_join(threads[id], NULL);
}
pthread_attr_destroy(&attr);
pthread_exit(NULL);
}
|
the_stack_data/64321.c | /* ====================================================================
* Copyright (c) 2015 The OpenSSL Project. All rights reserved.
*
* Redistribution and use in source and binary forms, with or without
* modification, are permitted provided that the following conditions
* are met:
*
* 1. Redistributions of source code must retain the above copyright
* notice, this list of conditions and the following disclaimer.
*
* 2. Redistributions in binary form must reproduce the above copyright
* notice, this list of conditions and the following disclaimer in
* the documentation and/or other materials provided with the
* distribution.
*
* 3. All advertising materials mentioning features or use of this
* software must display the following acknowledgment:
* "This product includes software developed by the OpenSSL Project
* for use in the OpenSSL Toolkit. (http://www.openssl.org/)"
*
* 4. The names "OpenSSL Toolkit" and "OpenSSL Project" must not be used to
* endorse or promote products derived from this software without
* prior written permission. For written permission, please contact
* [email protected].
*
* 5. Products derived from this software may not be called "OpenSSL"
* nor may "OpenSSL" appear in their names without prior written
* permission of the OpenSSL Project.
*
* 6. Redistributions of any form whatsoever must retain the following
* acknowledgment:
* "This product includes software developed by the OpenSSL Project
* for use in the OpenSSL Toolkit (http://www.openssl.org/)"
*
* THIS SOFTWARE IS PROVIDED BY THE OpenSSL PROJECT ``AS IS'' AND ANY
* EXPRESSED OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
* IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
* PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE OpenSSL PROJECT OR
* ITS CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL,
* SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT
* NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES;
* LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
* HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT,
* STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE)
* ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED
* OF THE POSSIBILITY OF SUCH DAMAGE.
* ====================================================================
*
* This product includes cryptographic software written by Eric Young
* ([email protected]). This product includes software written by Tim
* Hudson ([email protected]).
*
*/
#include <stdio.h>
#include <string.h>
int main()
{
char *p = NULL;
char bytes[sizeof(p)];
memset(bytes, 0, sizeof bytes);
return memcmp(&p, bytes, sizeof(bytes)) == 0 ? 0 : 1;
}
|
the_stack_data/1112541.c | /* ************************************************************************** */
/* */
/* ::: :::::::: */
/* ft_strwcnumber.c :+: :+: :+: */
/* +:+ +:+ +:+ */
/* By: sbecker <[email protected]> +#+ +:+ +#+ */
/* +#+#+#+#+#+ +#+ */
/* Created: 2018/12/02 20:08:27 by sbecker #+# #+# */
/* Updated: 2018/12/02 20:46:37 by sbecker ### ########.fr */
/* */
/* ************************************************************************** */
#include <string.h>
size_t ft_strwcnumber(const char *s, int c)
{
size_t a;
a = 0;
if (!s)
return (0);
while (*s == (unsigned char)c)
s++;
while (*s)
{
a++;
while (*s != (unsigned char)c && *s != '\0')
s++;
while (*s == (unsigned char)c)
s++;
if (*s == '\0')
return (a);
}
return (0);
}
|
the_stack_data/84667.c | // Test the driver's control over the PIC behavior. These consist of tests of
// the relocation model flags and the pic level flags passed to CC1.
//
// CHECK-NO-PIC: "-mrelocation-model" "static"
// CHECK-NO-PIC-NOT: "-pic-level"
// CHECK-NO-PIC-NOT: "-pie-level"
//
// CHECK-PIC1: "-mrelocation-model" "pic"
// CHECK-PIC1: "-pic-level" "1"
//
// CHECK-PIC2: "-mrelocation-model" "pic"
// CHECK-PIC2: "-pic-level" "2"
//
// CHECK-PIE1: "-mrelocation-model" "pic"
// CHECK-PIE1: "-pic-level" "1"
// CHECK-PIE1: "-pie-level" "1"
//
// CHECK-PIE2: "-mrelocation-model" "pic"
// CHECK-PIE2: "-pic-level" "2"
// CHECK-PIE2: "-pie-level" "2"
//
// CHECK-PIE-LD: "{{.*}}ld{{(.exe)?}}"
// CHECK-PIE-LD: "-pie"
// CHECK-PIE-LD: "Scrt1.o" "crti.o" "crtbeginS.o"
// CHECK-PIE-LD: "crtendS.o" "crtn.o"
//
// CHECK-NOPIE-LD: "-nopie"
//
// CHECK-DYNAMIC-NO-PIC-32: "-mrelocation-model" "dynamic-no-pic"
// CHECK-DYNAMIC-NO-PIC-32-NOT: "-pic-level"
// CHECK-DYNAMIC-NO-PIC-32-NOT: "-pie-level"
//
// CHECK-DYNAMIC-NO-PIC-64: "-mrelocation-model" "dynamic-no-pic"
// CHECK-DYNAMIC-NO-PIC-64: "-pic-level" "2"
// CHECK-DYNAMIC-NO-PIC-64-NOT: "-pie-level"
//
// CHECK-NON-DARWIN-DYNAMIC-NO-PIC: error: unsupported option '-mdynamic-no-pic' for target 'i386-unknown-unknown'
//
// CHECK-NO-PIE-NOT: "-pie"
//
// CHECK-NO-UNUSED-ARG-NOT: argument unused during compilation
//
// RUN: %clang -c %s -target i386-unknown-unknown -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE2
//
// Check that PIC and PIE flags obey last-match-wins. If the last flag is
// a no-* variant, regardless of which variant or which flags precede it, we
// get no PIC.
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fno-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fno-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fno-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -fno-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fno-PIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fno-PIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fno-PIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -fno-PIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fno-pie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fno-pie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fno-pie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -fno-pie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fno-PIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fno-PIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fno-PIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -fno-PIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
//
// Last-match-wins where both pic and pie are specified.
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-unknown-unknown -fPIE -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE2
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE2
//
// Last-match-wins when selecting level 1 vs. level 2.
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-unknown-unknown -fPIC -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target i386-unknown-unknown -fpic -fPIE -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target i386-unknown-unknown -fpie -fPIC -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE2
//
// Make sure -pie is passed to along to ld and that the right *crt* files
// are linked in.
// RUN: %clang %s -target i386-unknown-freebsd -fPIE -pie -### \
// RUN: --sysroot=%S/Inputs/basic_freebsd_tree 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE-LD
// RUN: %clang %s -target i386-linux-gnu -fPIE -pie -### \
// RUN: --sysroot=%S/Inputs/basic_linux_tree 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE-LD
// RUN: %clang %s -target i386-linux-gnu -fPIC -pie -### \
// RUN: --sysroot=%S/Inputs/basic_linux_tree 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE-LD
//
// Disregard any of the PIC-specific flags if we have a trump-card flag.
// RUN: %clang -c %s -target i386-unknown-unknown -mkernel -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-unknown-unknown -static -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
//
// On Linux, disregard -pie if we have -shared.
// RUN: %clang %s -target i386-unknown-linux -shared -pie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIE
//
// Darwin is a beautiful and unique snowflake when it comes to these flags.
// When targeting a 32-bit darwin system, the -fno-* flag variants work and
// disable PIC, but any other flag enables PIC (*not* PIE) even if the flag
// specifies PIE. On 64-bit targets, there is simply nothing you can do, there
// is no PIE, there is only PIC when it comes to compilation.
// RUN: %clang -c %s -target i386-apple-darwin -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-apple-darwin -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-apple-darwin -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-apple-darwin -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-apple-darwin -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-apple-darwin -fno-PIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-apple-darwin -fno-PIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target i386-apple-darwin -fno-PIC -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target i386-apple-darwin -fno-PIC -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target x86_64-apple-darwin -fno-PIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target x86_64-apple-darwin -fno-PIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target x86_64-apple-darwin -fpic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target x86_64-apple-darwin -fPIE -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target x86_64-apple-darwin -fPIC -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-UNUSED-ARG
//
// Darwin gets even more special with '-mdynamic-no-pic'. This flag is only
// valid on Darwin, and it's behavior is very strange but needs to remain
// consistent for compatibility.
// RUN: %clang -c %s -target i386-unknown-unknown -mdynamic-no-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NON-DARWIN-DYNAMIC-NO-PIC
// RUN: %clang -c %s -target i386-apple-darwin -mdynamic-no-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-DYNAMIC-NO-PIC-32
// RUN: %clang -c %s -target i386-apple-darwin -mdynamic-no-pic -fno-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-DYNAMIC-NO-PIC-32
// RUN: %clang -c %s -target i386-apple-darwin -mdynamic-no-pic -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-DYNAMIC-NO-PIC-32
// RUN: %clang -c %s -target x86_64-apple-darwin -mdynamic-no-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-DYNAMIC-NO-PIC-64
// RUN: %clang -c %s -target x86_64-apple-darwin -mdynamic-no-pic -fno-pic -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-DYNAMIC-NO-PIC-64
// RUN: %clang -c %s -target x86_64-apple-darwin -mdynamic-no-pic -fpie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-DYNAMIC-NO-PIC-64
//
// Checks for ARM+Apple+IOS including -fapple-kext, -mkernel, and iphoneos
// version boundaries.
// RUN: %clang -c %s -target armv7-apple-ios -fapple-kext -miphoneos-version-min=6.0.0 -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target armv7-apple-ios -mkernel -miphoneos-version-min=6.0.0 -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target armv7-apple-ios -fapple-kext -miphoneos-version-min=5.0.0 -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
// RUN: %clang -c %s -target armv7-apple-ios -fapple-kext -miphoneos-version-min=6.0.0 -static -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
//
// On OpenBSD, PIE is enabled by default, but can be disabled.
// RUN: %clang -c %s -target amd64-pc-openbsd -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target i386-pc-openbsd -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target mips64-unknown-openbsd -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target mips64el-unknown-openbsd -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE1
// RUN: %clang -c %s -target powerpc-unknown-openbsd -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE2
// RUN: %clang -c %s -target sparc64-unknown-openbsd -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIE2
// RUN: %clang -c %s -target i386-pc-openbsd -fno-pie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NO-PIC
//
// On OpenBSD, -nopie needs to be passed through to the linker.
// RUN: %clang %s -target i386-pc-openbsd -nopie -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-NOPIE-LD
//
// On Android PIC is enabled by default
// RUN: %clang -c %s -target i686-linux-android -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC2
// RUN: %clang -c %s -target arm-linux-androideabi -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target mipsel-linux-android -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target aarch64-linux-android -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
// RUN: %clang -c %s -target arm64-linux-android -### 2>&1 \
// RUN: | FileCheck %s --check-prefix=CHECK-PIC1
|
the_stack_data/165767184.c | //*****************************************************************************
//
// startup_gcc.c - Startup code for use with GNU tools.
//
// Copyright (c) 2009-2013 Texas Instruments Incorporated. All rights reserved.
// Software License Agreement
//
// Texas Instruments (TI) is supplying this software for use solely and
// exclusively on TI's microcontroller products. The software is owned by
// TI and/or its suppliers, and is protected under applicable copyright
// laws. You may not combine this software with "viral" open-source
// software in order to form a larger program.
//
// THIS SOFTWARE IS PROVIDED "AS IS" AND WITH ALL FAULTS.
// NO WARRANTIES, WHETHER EXPRESS, IMPLIED OR STATUTORY, INCLUDING, BUT
// NOT LIMITED TO, IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR
// A PARTICULAR PURPOSE APPLY TO THIS SOFTWARE. TI SHALL NOT, UNDER ANY
// CIRCUMSTANCES, BE LIABLE FOR SPECIAL, INCIDENTAL, OR CONSEQUENTIAL
// DAMAGES, FOR ANY REASON WHATSOEVER.
//
// This is part of revision 10636 of the EK-LM3S9D92 Firmware Package.
//
//*****************************************************************************
//*****************************************************************************
//
// Forward declaration of the default fault handlers.
//
//*****************************************************************************
void ResetISR(void);
static void NmiSR(void);
static void FaultISR(void);
static void IntDefaultHandler(void);
//*****************************************************************************
//
// External declarations for the interrupt handlers used by the application.
//
//*****************************************************************************
extern void Timer0IntHandler(void);
extern void Timer1IntHandler(void);
//*****************************************************************************
//
// The entry point for the application.
//
//*****************************************************************************
extern int main(void);
//*****************************************************************************
//
// Reserve space for the system stack.
//
//*****************************************************************************
static unsigned long pulStack[64];
//*****************************************************************************
//
// The vector table. Note that the proper constructs must be placed on this to
// ensure that it ends up at physical address 0x0000.0000.
//
//*****************************************************************************
__attribute__ ((section(".isr_vector")))
void (* const g_pfnVectors[])(void) =
{
(void (*)(void))((unsigned long)pulStack + sizeof(pulStack)),
// The initial stack pointer
ResetISR, // The reset handler
NmiSR, // The NMI handler
FaultISR, // The hard fault handler
IntDefaultHandler, // The MPU fault handler
IntDefaultHandler, // The bus fault handler
IntDefaultHandler, // The usage fault handler
0, // Reserved
0, // Reserved
0, // Reserved
0, // Reserved
IntDefaultHandler, // SVCall handler
IntDefaultHandler, // Debug monitor handler
0, // Reserved
IntDefaultHandler, // The PendSV handler
IntDefaultHandler, // The SysTick handler
IntDefaultHandler, // GPIO Port A
IntDefaultHandler, // GPIO Port B
IntDefaultHandler, // GPIO Port C
IntDefaultHandler, // GPIO Port D
IntDefaultHandler, // GPIO Port E
IntDefaultHandler, // UART0 Rx and Tx
IntDefaultHandler, // UART1 Rx and Tx
IntDefaultHandler, // SSI0 Rx and Tx
IntDefaultHandler, // I2C0 Master and Slave
IntDefaultHandler, // PWM Fault
IntDefaultHandler, // PWM Generator 0
IntDefaultHandler, // PWM Generator 1
IntDefaultHandler, // PWM Generator 2
IntDefaultHandler, // Quadrature Encoder 0
IntDefaultHandler, // ADC Sequence 0
IntDefaultHandler, // ADC Sequence 1
IntDefaultHandler, // ADC Sequence 2
IntDefaultHandler, // ADC Sequence 3
IntDefaultHandler, // Watchdog timer
Timer0IntHandler, // Timer 0 subtimer A
IntDefaultHandler, // Timer 0 subtimer B
Timer1IntHandler, // Timer 1 subtimer A
IntDefaultHandler, // Timer 1 subtimer B
IntDefaultHandler, // Timer 2 subtimer A
IntDefaultHandler, // Timer 2 subtimer B
IntDefaultHandler, // Analog Comparator 0
IntDefaultHandler, // Analog Comparator 1
IntDefaultHandler, // Analog Comparator 2
IntDefaultHandler, // System Control (PLL, OSC, BO)
IntDefaultHandler, // FLASH Control
IntDefaultHandler, // GPIO Port F
IntDefaultHandler, // GPIO Port G
IntDefaultHandler, // GPIO Port H
IntDefaultHandler, // UART2 Rx and Tx
IntDefaultHandler, // SSI1 Rx and Tx
IntDefaultHandler, // Timer 3 subtimer A
IntDefaultHandler, // Timer 3 subtimer B
IntDefaultHandler, // I2C1 Master and Slave
IntDefaultHandler, // Quadrature Encoder 1
IntDefaultHandler, // CAN0
IntDefaultHandler, // CAN1
IntDefaultHandler, // CAN2
IntDefaultHandler, // Ethernet
IntDefaultHandler, // Hibernate
IntDefaultHandler, // USB0
IntDefaultHandler, // PWM Generator 3
IntDefaultHandler, // uDMA Software Transfer
IntDefaultHandler, // uDMA Error
IntDefaultHandler, // ADC1 Sequence 0
IntDefaultHandler, // ADC1 Sequence 1
IntDefaultHandler, // ADC1 Sequence 2
IntDefaultHandler, // ADC1 Sequence 3
IntDefaultHandler, // I2S0
IntDefaultHandler, // External Bus Interface 0
IntDefaultHandler // GPIO Port J
};
//*****************************************************************************
//
// The following are constructs created by the linker, indicating where the
// the "data" and "bss" segments reside in memory. The initializers for the
// for the "data" segment resides immediately following the "text" segment.
//
//*****************************************************************************
extern unsigned long _etext;
extern unsigned long _data;
extern unsigned long _edata;
extern unsigned long _bss;
extern unsigned long _ebss;
//*****************************************************************************
//
// This is the code that gets called when the processor first starts execution
// following a reset event. Only the absolutely necessary set is performed,
// after which the application supplied entry() routine is called. Any fancy
// actions (such as making decisions based on the reset cause register, and
// resetting the bits in that register) are left solely in the hands of the
// application.
//
//*****************************************************************************
void
ResetISR(void)
{
unsigned long *pulSrc, *pulDest;
//
// Copy the data segment initializers from flash to SRAM.
//
pulSrc = &_etext;
for(pulDest = &_data; pulDest < &_edata; )
{
*pulDest++ = *pulSrc++;
}
//
// Zero fill the bss segment.
//
__asm(" ldr r0, =_bss\n"
" ldr r1, =_ebss\n"
" mov r2, #0\n"
" .thumb_func\n"
"zero_loop:\n"
" cmp r0, r1\n"
" it lt\n"
" strlt r2, [r0], #4\n"
" blt zero_loop");
//
// Call the application's entry point.
//
main();
}
//*****************************************************************************
//
// This is the code that gets called when the processor receives a NMI. This
// simply enters an infinite loop, preserving the system state for examination
// by a debugger.
//
//*****************************************************************************
static void
NmiSR(void)
{
//
// Enter an infinite loop.
//
while(1)
{
}
}
//*****************************************************************************
//
// This is the code that gets called when the processor receives a fault
// interrupt. This simply enters an infinite loop, preserving the system state
// for examination by a debugger.
//
//*****************************************************************************
static void
FaultISR(void)
{
//
// Enter an infinite loop.
//
while(1)
{
}
}
//*****************************************************************************
//
// This is the code that gets called when the processor receives an unexpected
// interrupt. This simply enters an infinite loop, preserving the system state
// for examination by a debugger.
//
//*****************************************************************************
static void
IntDefaultHandler(void)
{
//
// Go into an infinite loop.
//
while(1)
{
}
}
|
the_stack_data/82950780.c | //Classification: #default/p/ZD/AE/aS+dS/v/fpb/cd
//Written by: Alexey Salmin
//Reviewed by: Igor Eremeev
void f(int *p, int *c) {
*p = 0;
*c = 1;
}
int main(void) {
int a = 1, c = 0;
f(&a, &c);
if (c != 1)
return 1 / a;
return 0;
}
|
the_stack_data/541725.c | // REQUIRES: x86-registered-target
// RUN: %clang -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -o - | FileCheck %s
// RUN: %clang -O1 -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -o - | FileCheck %s
// RUN: %clang -O2 -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -o - | FileCheck %s
// RUN: %clang -O3 -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -o - | FileCheck %s
// RUN: %clang -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -o - | FileCheck %s
// RUN: %clang -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -flto=thin -o - | FileCheck %s
// RUN: %clang -O2 -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -flto=thin -o - | FileCheck %s
// RUN: %clang -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -flto -o - | FileCheck %s
// RUN: %clang -O2 -target x86_64-unknown-linux -fsanitize=thread %s -S -emit-llvm -flto -o - | FileCheck %s
int foo(int *a) { return *a; }
// CHECK: __tsan_init
|
the_stack_data/95449547.c | // RUN: %clang_cc1 -emit-llvm -o - %s | FileCheck %s
// END.
static long long llfoo;
static int intfoo;
static short shortfoo;
static char charfoo;
// CHECK: private unnamed_addr constant [13 x i8] {{.*}}annotation_a{{.*}} section "llvm.metadata"
// CHECK-NOT: {{.*}}annotation_a{{.*}}
static int foo(int a) {
return a + 1;
}
int main(int argc, char **argv) {
char barray[16];
char *b = (char *) __builtin_annotation((int)barray, "annotation_a");
// CHECK: ptrtoint i8* {{.*}} to i32
// CHECK-NEXT: call i32 @llvm.annotation.i32
// CHECK: inttoptr {{.*}} to i8*
int call = __builtin_annotation(foo(argc), "annotation_a");
// CHECK: call {{.*}} @foo
// CHECK: call i32 @llvm.annotation.i32
long long lla = __builtin_annotation(llfoo, "annotation_a");
// CHECK: call i64 @llvm.annotation.i64
int inta = __builtin_annotation(intfoo, "annotation_a");
// CHECK: load i32* @intfoo
// CHECK-NEXT: call i32 @llvm.annotation.i32
// CHECK-NEXT: store
short shorta = __builtin_annotation(shortfoo, "annotation_a");
// CHECK: call i16 @llvm.annotation.i16
char chara = __builtin_annotation(charfoo, "annotation_a");
// CHECK: call i8 @llvm.annotation.i8
char **arg = (char**) __builtin_annotation((int) argv, "annotation_a");
// CHECK: ptrtoint i8** {{.*}} to
// CHECK: call i32 @llvm.annotation.i32
// CHECK: inttoptr {{.*}} to i8**
return 0;
}
|
the_stack_data/107209.c | /* ************************************************************************** */
/* */
/* ::: :::::::: */
/* _1_ft_putstr.c :+: :+: :+: */
/* +:+ +:+ +:+ */
/* By: dakim <[email protected]> +#+ +:+ +#+ */
/* +#+#+#+#+#+ +#+ */
/* Created: 2018/08/10 10:48:24 by dakim #+# #+# */
/* Updated: 2018/08/10 10:55:48 by dakim ### ########.fr */
/* */
/* ************************************************************************** */
#include <unistd.h>
void ft_putstr(char *str)
{
int i;
i = 0;
while (str[i] != '\0')
{
write(1, str[i], 1);
i++;
}
}
|
the_stack_data/31389204.c | #include <stdio.h>
#include <math.h>
int exponent(int);
int apart(int n,int first_printed){
int ansi = 0;
while(n != 0){
int l2 = log2(n);
if(first_printed == 1){
printf("+");
}
else{
first_printed = 1;
}
if(l2 == 0){
printf("2(0)");
}
else if(l2 == 1){
printf("2");
}
else{
printf("2(");
exponent(l2);
printf(")");
}
n -= pow(2,l2);
}
return ansi-1;
}
int exponent(int n){
int l2 = log2(n);
if(l2 == 0){
printf("2(0)");
}
else if(n == 2){
printf("2");
}
else{
apart(n,0);
}
}
int main(){
int n;
while(scanf("%d",&n) != EOF){
exponent(n);
printf("\n");
}
return 0;
} |
the_stack_data/184519173.c | // network.c
// Helper functions for POSIX network communication in C (sendall and recvall).
// Author: Dénes Fintha
// Year: 2021
// -------------------------------------------------------------------------- //
// Interface
#include <errno.h>
#include <stdint.h>
#include <sys/socket.h>
ssize_t sendall(int sockfd, const void *buffer, size_t length, int flags);
ssize_t recvall(int sockfd, void *buffer, size_t length, int flags);
// Implementation
ssize_t sendall(int sockfd, const void *buffer, size_t length, int flags) {
size_t total = 0;
size_t left = length;
const uint8_t *bytes = (const uint8_t *) buffer;
while (total < length) {
int current = send(sockfd, bytes + total, left, flags);
if (current == -1) {
if (errno == EAGAIN)
continue;
return -1;
}
total += current;
left -= current;
}
return total;
}
ssize_t recvall(int sockfd, void *buffer, size_t length, int flags) {
size_t total = 0;
size_t left = length;
uint8_t *bytes = (uint8_t *) buffer;
while (total < length) {
int current = recv(sockfd, bytes + total, left, flags);
if (current == -1) {
if (errno == EAGAIN)
continue;
return -1;
}
if (current == 0)
return total;
total += current;
left -= current;
}
return total;
}
// Demonstration
#include <arpa/inet.h>
#include <netdb.h>
#include <stdio.h>
#include <string.h>
#include <unistd.h>
int main(void) {
struct protoent *proto = getprotobyname("tcp");
if (proto == NULL)
return 1;
int sockfd = socket(AF_INET, SOCK_STREAM, proto->p_proto);
if (sockfd < 0)
return 2;
struct hostent *host = gethostbyname("neverssl.com");
if (host == NULL)
return 3;
in_addr_t in_address = inet_addr(inet_ntoa(*(struct in_addr *) *(host->h_addr_list)));
if (in_address == (in_addr_t) -1)
return 4;
struct sockaddr_in address;
memset(&address, 0x00, sizeof(struct sockaddr_in));
address.sin_family = AF_INET;
address.sin_addr.s_addr = in_address;
address.sin_port = htons(80);
if (connect(sockfd, (struct sockaddr *) &address, sizeof(struct sockaddr_in)) < 0)
return 5;
const char *request = "GET / HTTP/1.1\r\nHost: neverssl.com\r\n\r\n";
if (sendall(sockfd, request, strlen(request), 0) < 0)
return 6;
char buffer[1024];
memset(buffer, 0x00, 1024);
if (recvall(sockfd, buffer, 1024, 0) < 1)
return 7;
printf("%s\n", buffer);
close(sockfd);
return 0;
}
|
the_stack_data/25138064.c | #include <stdio.h>
#include <sys/socket.h>
#include <arpa/inet.h>
#include <string.h>
#include <unistd.h>
#include <stdlib.h>
#define MAXLINE 1024
#define ERROR -1
int main(int argc, char **argv) {
struct sockaddr_in serveraddr;
int server_sockfd;
int client_len;
char buf[MAXLINE];
if ((server_sockfd = socket(AF_INET, SOCK_STREAM, 0)) == ERROR) {
printf("socket() error : cannot create socket.\n");
return 1;
}
serveraddr.sin_family = AF_INET;
serveraddr.sin_addr.s_addr = inet_addr("127.0.0.1");
serveraddr.sin_port = htons(4000);
client_len = sizeof(serveraddr);
if (connect(server_sockfd, (struct sockaddr*)&serveraddr, client_len) == ERROR) {
perror("connect() error : connction fail.\n");
return 1;
}
memset(buf, 0x00, MAXLINE);
read(0, buf, MAXLINE);
if (write(server_sockfd, buf, MAXLINE) <= 0) {
perror("write() error : ");
return 1;
}
memset(buf, 0x00, MAXLINE);
if (read(server_sockfd, buf, MAXLINE) <= 0) {
perror("read() error : ");
return 1;
}
close(server_sockfd);
printf("server : %s\n", buf);
return 0;
} |
the_stack_data/41934.c | #include <stdio.h>
#include <stdlib.h>
int main()
{
char *p;
p = getenv("SHELL");
if (p == NULL)
{
printf("getenv error\n");
exit(1);
}
else
{
printf("SHELL=%s\n", p);
}
return 0;
}
|
the_stack_data/1178250.c | extern int __mark(int);
int memcpy(int *dest, int *src, int size) {
int i = 0;
while(__mark(42) & (i < size)) {
dest[i] = src[i];
i++;
}
return 1;
}
|
the_stack_data/82951408.c |
#include <stdio.h>
void scilab_rt_contour_d2d2d2d2d0d0s0i2_(int in00, int in01, double matrixin0[in00][in01],
int in10, int in11, double matrixin1[in10][in11],
int in20, int in21, double matrixin2[in20][in21],
int in30, int in31, double matrixin3[in30][in31],
double scalarin0,
double scalarin1,
char* scalarin2,
int in40, int in41, int matrixin4[in40][in41])
{
int i;
int j;
double val0 = 0;
double val1 = 0;
double val2 = 0;
double val3 = 0;
int val4 = 0;
for (i = 0; i < in00; ++i) {
for (j = 0; j < in01; ++j) {
val0 += matrixin0[i][j];
}
}
printf("%f", val0);
for (i = 0; i < in10; ++i) {
for (j = 0; j < in11; ++j) {
val1 += matrixin1[i][j];
}
}
printf("%f", val1);
for (i = 0; i < in20; ++i) {
for (j = 0; j < in21; ++j) {
val2 += matrixin2[i][j];
}
}
printf("%f", val2);
for (i = 0; i < in30; ++i) {
for (j = 0; j < in31; ++j) {
val3 += matrixin3[i][j];
}
}
printf("%f", val3);
printf("%f", scalarin0);
printf("%f", scalarin1);
printf("%s", scalarin2);
for (i = 0; i < in40; ++i) {
for (j = 0; j < in41; ++j) {
val4 += matrixin4[i][j];
}
}
printf("%d", val4);
}
|
the_stack_data/647806.c |
#include <stdio.h>
int main(void) {
// valor hard-coded
int var = 1;
float x = 0.0;
switch (var) {
case 1: x = 10.0;
break;
case 2: x = 20.0;
break;
case 3: x = 30.0;
break;
default: x = -1.0;
}
// a instrucao 'break' leva o codigo ate aqui.
printf("Apos o switch:\n");
printf("%d %f\n", var, x);
if (var == 1) {
x = 10.0;
// break; // isso da erro porque break nao pode ser usado dentro de IF
x = 20.0;
x = 30.0;
}
printf("Apos o IF:\n");
printf("%d %f\n", var, x);
return 0;
}
|
the_stack_data/29376.c | /*
* 3dplot_lx
*
* routine to display a hips 3d-plot on the Lexidata
*
* Charles Carman 7/29/87
*/
plot3d_lx(buf,nb)
char *buf;
int nb;
{
double br, x1, y1, z1, x2, y2, z2;
int in, op;
short chan, err;
dsopn_(&err,&chan);
for(in=0; in<nb; ) {
in = getplot(buf,in,&op,&br,&x1,&y1,&z1,&x2,&y2,&z2);
switch (op) {
case 'p':
l_point_3d(br,x1,y1);
break;
case 'v':
l_vec_3d(br,x1,y1,x2,y2);
break;
case 'n':
l_endp_3d(x2,y2);
break;
default:
perror("unknown op-code");
break;
}
}
dscls_();
}
l_point_3d(b,x,y)
double b,x,y ;
{
short npix = 1;
short ci, xydata[2];
ci = (short)(b + 0.5);
xydata[0] = (short)(x + 0.5);
xydata[1] = (short)(y + 0.5);
dspnt_(&npix,&ci,xydata);
dsowt_();
}
l_vec_3d(b,x1,y1,x2,y2)
double b,x1,y1,x2,y2 ;
{
extern double cur_b, cur_x, cur_y;
short ci, xstr, ystr, xend, yend;
ci = (short)(b + 0.5);
xstr = (short)(x1 + 0.5);
ystr = (short)(y1 + 0.5);
xend = (short)(x2 + 0.5);
yend = (short)(y2 + 0.5);
dsvec_(&xstr,&ystr,&xend,¥d,&ci);
dsowt_();
cur_b = b; cur_x = x2; cur_y = y2;
}
l_endp_3d(x,y)
double x,y ;
{
extern double cur_b, cur_x, cur_y;
short ci, xstr, ystr, xend, yend;
ci = (short)(cur_b + 0.5);
xstr = (short)(cur_x + 0.5);
ystr = (short)(cur_y + 0.5);
xend = (short)(x + 0.5);
yend = (short)(y + 0.5);
dsvec_(&xstr,&ystr,&xend,¥d,&ci);
dsowt_();
cur_x = x; cur_y = y;
}
|
the_stack_data/106181.c | #include <stdio.h>
#include <stdlib.h>
#include <sys/ipc.h>
#include <sys/msg.h>
#include <sys/types.h>
#include <unistd.h>
#include <string.h>
typedef struct
{
long type;
int flag;
char message[50];
} msg;
#define PORUKA_SIZE sizeof(msg) - sizeof(long)
#define MAX_SIZE 10
int main()
{
key_t kljuc = ftok("./server.c", 10);
int i, j;
int queeID = msgget(kljuc, 0660 | IPC_CREAT);
if (queeID == -1)
{
printf("GRESKA\n");
exit(1);
}
msg poruka;
poruka.type = MAX_SIZE + 1;
poruka.flag = getpid();
msgsnd(queeID, &poruka, PORUKA_SIZE, 0);
msgrcv(queeID, &poruka, PORUKA_SIZE, getpid(), 0);
int rbr = poruka.flag;
if (rbr % 2)
{
//prvi
printf("Unesite rec koja se pogadja\n");
char rec[50], pogodjeno[50];
scanf("%s", rec);
int n = strlen(rec), p = 0;
for (i = 0; i < n; i++)
pogodjeno[i] = '*';
pogodjeno[n] = '\0';
poruka.type = rbr;
strcpy(poruka.message, pogodjeno);
poruka.flag = 0;
msgsnd(queeID, &poruka, PORUKA_SIZE, 0); //pogadjanje pocinje
for (i = 0; i < 5; i++)
{
msgrcv(queeID, &poruka, PORUKA_SIZE, rbr + 1, 0);
char c = poruka.message[0];
for (j = 0; j < n; j++)
{
if (c == rec[j] && pogodjeno[j] == '*')
{
pogodjeno[j] = c;
p++;
}
}
if (p == n)
{
printf("Igrac je pogodio rec. Kraj igre.\n");
poruka.type = rbr;
poruka.flag = 1;
strcpy(poruka.message, pogodjeno);
msgsnd(queeID, &poruka, PORUKA_SIZE, 0);
exit(0);
}
poruka.type = rbr;
strcpy(poruka.message, pogodjeno);
msgsnd(queeID, &poruka, PORUKA_SIZE, 0);
}
msgrcv(queeID, &poruka, PORUKA_SIZE, rbr + 1, 0);
if (strcmp(poruka.message, rec) == 0)
{
printf("Igrac je pogodio rec. Kraj igre.\n");
poruka.flag = 1;
}
else
{
printf("Igrac nije pogodio rec. Kraj igre.\n");
poruka.flag = 0;
}
strcpy(poruka.message, rec);
poruka.type = rbr;
msgsnd(queeID, &poruka, PORUKA_SIZE, 0);
}
else
{
//drugi
for (i = 0; i < 5; i++)
{
msgrcv(queeID, &poruka, PORUKA_SIZE, rbr - 1, 0);
printf("Igra pocinje\n");
char c;
for (i = 0; i < 5; i++)
{
printf("\nUnesite slovo koje pogadjate\n");
c = getchar();
if (c == ' ' || c == '\n' || c == '\t')
scanf("%c", &c);
poruka.type = rbr;
poruka.message[0] = c;
msgsnd(queeID, &poruka, PORUKA_SIZE, 0);
msgrcv(queeID, &poruka, PORUKA_SIZE, rbr - 1, 0);
printf("Rec posle pogadjanja:%s\n", poruka.message);
if (poruka.flag)
{
printf("Pogodio sam rec.Kraj igre\n");
exit(0);
}
}
printf("\nUnesite rec koju pogadjate\n");
scanf("%s", poruka.message);
poruka.type = rbr;
msgsnd(queeID, &poruka, PORUKA_SIZE, 0);
msgrcv(queeID, &poruka, PORUKA_SIZE, rbr - 1, 0);
printf("Zadata rec:%s\n", poruka.message);
if (poruka.flag)
{
printf("Pogodio sam rec.Kraj igre\n");
}
else
{
printf("Nisam pogodio sam rec.Kraj igre\n");
}
}
}
return 0;
}
|
the_stack_data/159516119.c | // Program to produce a file with the expected output
// for all possible inputs to an unsigned 4-bit divider pursuant to
// RISC-V ISA Manual: Section 7.2 - Division Operations
#include <stdio.h>
#include <math.h>
#include <limits.h>
#define WIDTH 4
#define ITERS 1 << (WIDTH*2)
// #define ITERS 10000
// Function to compute quotient
unsigned long long int quotient(unsigned long long int a, unsigned long long int b){
if (b == 0) { // RISC-V 7.2: Quotient of division by zero has all bits set
if (WIDTH == 64) {
return ULLONG_MAX;
} else {
return (pow(2, WIDTH) - 1);
}
} else { // Return integer division result when not a RISC-V edge case
return a / b;
}
}
// Function to compute remainder
unsigned long long int rem(unsigned long long int a, unsigned long long int b){
if (b == 0) { // RISC-V 7.2: Remainder of division by zero is dividend
return a;
} else {
return a % b; // Return modulus when not a RISC-V edge case
}
}
int main(){
FILE *file_in, *file_out;
unsigned long long int dividend, divisor, remain, quot;
file_in = fopen("u.txt", "r");
file_out = fopen("u_expected.txt", "w");
for (int i = 0; i < ITERS; i ++) {
fscanf(file_in, "%llu", ÷nd);
fscanf(file_in, "%llu", &divisor);
//Calling function quotient()
quot = quotient(dividend, divisor);
//Calling function remainder()
remain = rem(dividend, divisor);
fprintf(file_out, "%llu %llu %llu %llu\n", dividend, divisor, quot, remain);
}
fclose(file_in);
fclose(file_out);
return 0;
}
|
the_stack_data/118345.c | #include <string.h>
#include <stdio.h>
#include <ctype.h>
#define STR_LEN 81
//声明函数,字符串转大写
void toUpper(char *);
//声明函数,标点符号计数
int punctCount(const char *);
int main(void){
char str[STR_LEN];
char *findLF;
puts("input something:");
fgets(str,STR_LEN,stdin);
findLF=strchr(str,'\n');
if(findLF!=NULL){
*findLF='\0';//行尾空字符替换 换行符
}
toUpper(str);
puts(str);
printf("Has %d punctuation characters.\n",punctCount(str));
return 0;
}
//定义函数,字符串转大写
void toUpper(char * str){
while(*str){
*str=toupper(*str); //ctype.h库函数
str++;
}
}
//定义函数,标点符号计数
int punctCount(const char * str){
int count=0;
while(*str!='\0'){
if(ispunct(*str)){//ctype.h库函数
count++;
}
str++;
}
return count;
}
|
the_stack_data/491794.c | /*************************************************************************\
* Copyright (C) Michael Kerrisk, 2018. *
* *
* This program is free software. You may use, modify, and redistribute it *
* under the terms of the GNU General Public License as published by the *
* Free Software Foundation, either version 3 or (at your option) any *
* later version. This program is distributed without any warranty. See *
* the file COPYING.gpl-v3 for details. *
\*************************************************************************/
/* prog.c
*/
#include <stdlib.h>
#include <stdio.h>
void
xyz(void)
{
printf(" main-xyz\n");
}
int
main(int argc, char*argv[])
{
void func1(void), func2(void), func3(void);
func1();
func2();
exit(EXIT_SUCCESS);
}
|
the_stack_data/242330593.c | #include <stdio.h>
#include <stdlib.h>
struct linked_node{
int value;
struct linked_node * next;
};
typedef struct linked_node node;
struct node_cache{
int count;
node *cache;
};
typedef struct node_cache cache;
struct linked_list{
node * head;
node * tail;
int count;
};
typedef struct linked_list linked_list;
enum position{
END, START, MID
};
typedef enum position position;
linked_list create_linked_list(int values[]);
node * create_empty_node(void);
node * create_node(int val);
node * insert_at_end(node* head, int val);
node * insert_at_start(node*head, int val);
node * insert_at_mid(node* head, int val);
node * insert(node*head, int val, position pos);
node * replace_head(node*head, int val);
node * replace_tail(node*head, int val);
node * replace_mid(node * head, int val);
node * replace(node * head, int val, position pos);
node * last_node(node *anyNode);
void append(node * tail, int val);
void print_list(node*head);
cache create_cache();
node * GetLocalizedNodes();
int main(){
//node * head = create_node(1);
//print_list(head);
//head = insert(head, 2, END);
//print_list(head);
//head = insert(head, 3, START);
//print_list(head);
//head = insert(head, 4, MID);
//print_list(head);
//head = replace_head(head, 40);
//print_list(head);
//head = replace_tail(head, 80);
//print_list(head);
//head = replace_mid(head, 120);
//print_list(head);
//head = replace(head, 800, START);
//print_list(head);
int i = 0, end = 10;
node * head = GetLocalizedNodes();
cache cache = create_cache();
printf("\nlocalized:");
for(i = 0; i < end; i++, head=head->next)
printf("\t%p (%i)->", head, head->value);
printf("\ncache:");
for(i = 0; i < end; i++, cache.cache = cache.cache->next)
printf("\t%p (%i)->", cache.cache, cache.cache->value);
return 0;
}
node * create_empty_node()
{
return (node*)malloc(sizeof(node));
}
node * create_node(int val)
{
node * tmp = create_empty_node();
if (!tmp)
abort();
tmp->next = NULL;
tmp->value = val;
return tmp;
}
node * insert_at_end(node* head, int val)
{
node* curr = head;
if (!curr)
return NULL;
while (curr->next)
curr = curr->next;
curr->next = create_node(val);
return head;
}
node * insert_at_start(node*head, int val)
{
node *curr = NULL;
if (!head)
return NULL;
curr = create_node(val);
curr->next = head;
head = curr;
return head;
}
node * insert_at_mid(node* head, int val)
{
node *curr = NULL;
node *slow = head;
node *fast = head;
while (fast && fast->next){
fast = fast->next->next;
if (fast)
slow = slow->next;
}
curr = create_node(val);
curr->next = slow->next;
slow->next = curr;
return head;
}
node * insert(node*head, int val, position pos)
{
if (pos == END)
head = insert_at_end(head, val);
else if (pos == START)
head = insert_at_start(head, val);
else if (pos == MID)
head = insert_at_mid(head, val);
return head;
}
void print_list(node *head)
{
node*tmp = head;
printf("\n");
while (tmp){
printf("\t%d->", tmp->value);
tmp = tmp->next;
}
printf("\n");
}
node * replace_head(node*head, int val)
{
node *curr = NULL;
if (!head)
return NULL;
curr = create_node(val);
curr->next = head->next;
free(head);
head = curr;
return head;
}
node * replace_tail(node*head, int val)
{
node* curr = head;
if (!curr)
return NULL;
while (curr->next && curr->next->next)
curr = curr->next;
free(curr->next);
curr->next = create_node(val);
return head;
}
node * replace_mid(node * head, int val)
{
node *curr = NULL;
node *slow = head;
node *fast = head;
while (fast && fast->next){
fast = fast->next->next;
if (fast)
slow = slow->next;
}
curr = create_node(val);
curr->next = slow->next->next;
free(slow->next);
slow->next = curr;
return head;
}
node * replace(node * head, int val, position pos)
{
if (pos == END)
head = replace_tail(head, val);
else if (pos == START)
head = replace_head(head, val);
else if (pos == MID)
head = replace_mid(head, val);
return head;
}
linked_list create_linked_list(int values[])
{
linked_list list;
int count = sizeof(values)/sizeof(int);
int i;
list.tail = list.head = create_node(values[0]);
list.count = 1;
for(i = 1; i < count; i++){
append(list.tail, values[i]);
list.count++;
}
return list;
}
node * last_node(node *anyNode)
{
node * curr = anyNode;
if(curr == NULL) return NULL;
while(curr->next != NULL) curr = curr->next;
return curr;
}
void append(node * tail, int val)
{
node * last = last_node(tail);
last->next = create_node(val);
}
cache create_cache()
{
cache cache;
node * tail = NULL;
int i = 0;
cache.count = 1024;
tail = cache.cache = create_node(i);
for(i = 1; i < cache.count; i++){
append(tail, i);
}
return cache;
}
node * get_node_from_cache(cache cache)
{
node * tmp;
if(cache.count > 0){
tmp = cache.cache;
cache.cache = cache.cache->next;
tmp->next = NULL;
cache.count--;
}
else {
int i = 0;
node * tail = NULL;
cache.count = 1024;
tail = cache.cache = create_node(i);
for(i = 1; i < cache.count; i++){
append(tail, i);
}
tmp = get_node_from_cache(cache);
}
return tmp;
}
node * GetLocalizedNodes()
{
node * localizedNodes = NULL;
int i = 0;
int count = 1024;
int end = count - 1;
node * tmp = NULL;
localizedNodes = (node*)malloc(sizeof(node)*count);
tmp = (node*)localizedNodes;
for(i = 0; i < end; i++){
tmp->next = tmp+1;
tmp->value = i;
tmp++;
}
tmp->next = NULL;
return localizedNodes;
}
|
the_stack_data/296362.c | /*
* ARM64 signal handling routines
*
* Copyright 2010-2013 André Hentschel
*
* This library is free software; you can redistribute it and/or
* modify it under the terms of the GNU Lesser General Public
* License as published by the Free Software Foundation; either
* version 2.1 of the License, or (at your option) any later version.
*
* This library is distributed in the hope that it will be useful,
* but WITHOUT ANY WARRANTY; without even the implied warranty of
* MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
* Lesser General Public License for more details.
*
* You should have received a copy of the GNU Lesser General Public
* License along with this library; if not, write to the Free Software
* Foundation, Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301, USA
*/
#ifdef __aarch64__
#include "config.h"
#include "wine/port.h"
#include <assert.h>
#include <signal.h>
#include <stdlib.h>
#include <stdarg.h>
#include <stdio.h>
#ifdef HAVE_UNISTD_H
# include <unistd.h>
#endif
#ifdef HAVE_SYS_PARAM_H
# include <sys/param.h>
#endif
#ifdef HAVE_SYSCALL_H
# include <syscall.h>
#else
# ifdef HAVE_SYS_SYSCALL_H
# include <sys/syscall.h>
# endif
#endif
#ifdef HAVE_SYS_SIGNAL_H
# include <sys/signal.h>
#endif
#ifdef HAVE_SYS_UCONTEXT_H
# include <sys/ucontext.h>
#endif
#define NONAMELESSUNION
#define NONAMELESSSTRUCT
#include "ntstatus.h"
#define WIN32_NO_STATUS
#include "windef.h"
#include "winternl.h"
#include "wine/library.h"
#include "wine/exception.h"
#include "ntdll_misc.h"
#include "wine/debug.h"
#include "winnt.h"
WINE_DEFAULT_DEBUG_CHANNEL(seh);
WINE_DECLARE_DEBUG_CHANNEL(relay);
static pthread_key_t teb_key;
/***********************************************************************
* signal context platform-specific definitions
*/
#ifdef linux
/* All Registers access - only for local access */
# define REG_sig(reg_name, context) ((context)->uc_mcontext.reg_name)
# define REGn_sig(reg_num, context) ((context)->uc_mcontext.regs[reg_num])
/* Special Registers access */
# define SP_sig(context) REG_sig(sp, context) /* Stack pointer */
# define PC_sig(context) REG_sig(pc, context) /* Program counter */
# define PSTATE_sig(context) REG_sig(pstate, context) /* Current State Register */
# define FP_sig(context) REGn_sig(29, context) /* Frame pointer */
# define LR_sig(context) REGn_sig(30, context) /* Link Register */
/* Exceptions */
# define FAULT_sig(context) REG_sig(fault_address, context)
#endif /* linux */
static const size_t teb_size = 0x2000; /* we reserve two pages for the TEB */
static size_t signal_stack_size;
typedef void (WINAPI *raise_func)( EXCEPTION_RECORD *rec, CONTEXT *context );
typedef int (*wine_signal_handler)(unsigned int sig);
static wine_signal_handler handlers[256];
/***********************************************************************
* dispatch_signal
*/
static inline int dispatch_signal(unsigned int sig)
{
if (handlers[sig] == NULL) return 0;
return handlers[sig](sig);
}
/*******************************************************************
* is_valid_frame
*/
static inline BOOL is_valid_frame( void *frame )
{
if ((ULONG_PTR)frame & 3) return FALSE;
return (frame >= NtCurrentTeb()->Tib.StackLimit &&
(void **)frame < (void **)NtCurrentTeb()->Tib.StackBase - 1);
}
/***********************************************************************
* save_context
*
* Set the register values from a sigcontext.
*/
static void save_context( CONTEXT *context, const ucontext_t *sigcontext )
{
DWORD i;
context->ContextFlags = CONTEXT_FULL;
context->Fp = FP_sig(sigcontext); /* Frame pointer */
context->Lr = LR_sig(sigcontext); /* Link register */
context->Sp = SP_sig(sigcontext); /* Stack pointer */
context->Pc = PC_sig(sigcontext); /* Program Counter */
context->Cpsr = PSTATE_sig(sigcontext); /* Current State Register */
for (i = 0; i <= 28; i++) context->u.X[i] = REGn_sig( i, sigcontext );
}
/***********************************************************************
* restore_context
*
* Build a sigcontext from the register values.
*/
static void restore_context( const CONTEXT *context, ucontext_t *sigcontext )
{
DWORD i;
FP_sig(sigcontext) = context->Fp; /* Frame pointer */
LR_sig(sigcontext) = context->Lr; /* Link register */
SP_sig(sigcontext) = context->Sp; /* Stack pointer */
PC_sig(sigcontext) = context->Pc; /* Program Counter */
PSTATE_sig(sigcontext) = context->Cpsr; /* Current State Register */
for (i = 0; i <= 28; i++) REGn_sig( i, sigcontext ) = context->u.X[i];
}
/***********************************************************************
* save_fpu
*
* Set the FPU context from a sigcontext.
*/
static inline void save_fpu( CONTEXT *context, const ucontext_t *sigcontext )
{
FIXME( "Not implemented on ARM64\n" );
}
/***********************************************************************
* restore_fpu
*
* Restore the FPU context to a sigcontext.
*/
static inline void restore_fpu( CONTEXT *context, const ucontext_t *sigcontext )
{
FIXME( "Not implemented on ARM64\n" );
}
/***********************************************************************
* RtlCaptureContext (NTDLL.@)
*/
/* FIXME: Use the Stack instead of the actual register values? */
__ASM_STDCALL_FUNC( RtlCaptureContext, 8,
"stp x0, x1, [sp, #-32]!\n\t"
"mov w1, #0x400000\n\t" /* CONTEXT_ARM64 */
"add w1, w1, #0x3\n\t" /* CONTEXT_FULL */
"str w1, [x0]\n\t" /* context->ContextFlags */ /* 32-bit, look at cpsr */
"mrs x1, NZCV\n\t"
"str w1, [x0, #0x4]\n\t" /* context->Cpsr */
"ldp x0, x1, [sp], #32\n\t"
"str x0, [x0, #0x8]\n\t" /* context->X0 */
"str x1, [x0, #0x10]\n\t" /* context->X1 */
"str x2, [x0, #0x18]\n\t" /* context->X2 */
"str x3, [x0, #0x20]\n\t" /* context->X3 */
"str x4, [x0, #0x28]\n\t" /* context->X4 */
"str x5, [x0, #0x30]\n\t" /* context->X5 */
"str x6, [x0, #0x38]\n\t" /* context->X6 */
"str x7, [x0, #0x40]\n\t" /* context->X7 */
"str x8, [x0, #0x48]\n\t" /* context->X8 */
"str x9, [x0, #0x50]\n\t" /* context->X9 */
"str x10, [x0, #0x58]\n\t" /* context->X10 */
"str x11, [x0, #0x60]\n\t" /* context->X11 */
"str x12, [x0, #0x68]\n\t" /* context->X12 */
"str x13, [x0, #0x70]\n\t" /* context->X13 */
"str x14, [x0, #0x78]\n\t" /* context->X14 */
"str x15, [x0, #0x80]\n\t" /* context->X15 */
"str x16, [x0, #0x88]\n\t" /* context->X16 */
"str x17, [x0, #0x90]\n\t" /* context->X17 */
"str x18, [x0, #0x98]\n\t" /* context->X18 */
"str x19, [x0, #0xa0]\n\t" /* context->X19 */
"str x20, [x0, #0xa8]\n\t" /* context->X20 */
"str x21, [x0, #0xb0]\n\t" /* context->X21 */
"str x22, [x0, #0xb8]\n\t" /* context->X22 */
"str x23, [x0, #0xc0]\n\t" /* context->X23 */
"str x24, [x0, #0xc8]\n\t" /* context->X24 */
"str x25, [x0, #0xd0]\n\t" /* context->X25 */
"str x26, [x0, #0xd8]\n\t" /* context->X26 */
"str x27, [x0, #0xe0]\n\t" /* context->X27 */
"str x28, [x0, #0xe8]\n\t" /* context->X28 */
"str x29, [x0, #0xf0]\n\t" /* context->Fp */
"str x30, [x0, #0xf8]\n\t" /* context->Lr */
"mov x1, sp\n\t"
"str x1, [x0, #0x100]\n\t" /* context->Sp */
"adr x1, 1f\n\t"
"1: str x1, [x0, #0x108]\n\t" /* context->Pc */
"ret"
)
/***********************************************************************
* set_cpu_context
*
* Set the new CPU context.
*/
static void set_cpu_context( const CONTEXT *context )
{
FIXME( "Not implemented on ARM64\n" );
}
/***********************************************************************
* copy_context
*
* Copy a register context according to the flags.
*/
static void copy_context( CONTEXT *to, const CONTEXT *from, DWORD flags )
{
flags &= ~CONTEXT_ARM64; /* get rid of CPU id */
if (flags & CONTEXT_CONTROL)
{
to->Fp = from->Fp;
to->Lr = from->Lr;
to->Sp = from->Sp;
to->Pc = from->Pc;
to->Cpsr = from->Cpsr;
}
if (flags & CONTEXT_INTEGER)
{
memcpy( to->u.X, from->u.X, sizeof(to->u.X) );
}
if (flags & CONTEXT_FLOATING_POINT)
{
memcpy( to->V, from->V, sizeof(to->V) );
to->Fpcr = from->Fpcr;
to->Fpsr = from->Fpsr;
}
if (flags & CONTEXT_DEBUG_REGISTERS)
{
memcpy( to->Bcr, from->Bcr, sizeof(to->Bcr) );
memcpy( to->Bvr, from->Bvr, sizeof(to->Bvr) );
memcpy( to->Wcr, from->Wcr, sizeof(to->Wcr) );
memcpy( to->Wvr, from->Wvr, sizeof(to->Wvr) );
}
}
/***********************************************************************
* context_to_server
*
* Convert a register context to the server format.
*/
NTSTATUS context_to_server( context_t *to, const CONTEXT *from )
{
DWORD i, flags = from->ContextFlags & ~CONTEXT_ARM64; /* get rid of CPU id */
memset( to, 0, sizeof(*to) );
to->cpu = CPU_ARM64;
if (flags & CONTEXT_CONTROL)
{
to->flags |= SERVER_CTX_CONTROL;
to->integer.arm64_regs.x[29] = from->Fp;
to->integer.arm64_regs.x[30] = from->Lr;
to->ctl.arm64_regs.sp = from->Sp;
to->ctl.arm64_regs.pc = from->Pc;
to->ctl.arm64_regs.pstate = from->Cpsr;
}
if (flags & CONTEXT_INTEGER)
{
to->flags |= SERVER_CTX_INTEGER;
for (i = 0; i <= 28; i++) to->integer.arm64_regs.x[i] = from->u.X[i];
}
if (flags & CONTEXT_FLOATING_POINT)
{
to->flags |= SERVER_CTX_FLOATING_POINT;
for (i = 0; i < 64; i++) to->fp.arm64_regs.d[i] = from->V[i / 2].D[i % 2];
to->fp.arm64_regs.fpcr = from->Fpcr;
to->fp.arm64_regs.fpsr = from->Fpsr;
}
if (flags & CONTEXT_DEBUG_REGISTERS)
{
to->flags |= SERVER_CTX_DEBUG_REGISTERS;
for (i = 0; i < ARM64_MAX_BREAKPOINTS; i++) to->debug.arm64_regs.bcr[i] = from->Bcr[i];
for (i = 0; i < ARM64_MAX_BREAKPOINTS; i++) to->debug.arm64_regs.bvr[i] = from->Bvr[i];
for (i = 0; i < ARM64_MAX_WATCHPOINTS; i++) to->debug.arm64_regs.wcr[i] = from->Wcr[i];
for (i = 0; i < ARM64_MAX_WATCHPOINTS; i++) to->debug.arm64_regs.wvr[i] = from->Wvr[i];
}
return STATUS_SUCCESS;
}
/***********************************************************************
* context_from_server
*
* Convert a register context from the server format.
*/
NTSTATUS context_from_server( CONTEXT *to, const context_t *from )
{
DWORD i;
if (from->cpu != CPU_ARM64) return STATUS_INVALID_PARAMETER;
to->ContextFlags = CONTEXT_ARM64;
if (from->flags & SERVER_CTX_CONTROL)
{
to->ContextFlags |= CONTEXT_CONTROL;
to->Fp = from->integer.arm64_regs.x[29];
to->Lr = from->integer.arm64_regs.x[30];
to->Sp = from->ctl.arm64_regs.sp;
to->Pc = from->ctl.arm64_regs.pc;
to->Cpsr = from->ctl.arm64_regs.pstate;
}
if (from->flags & SERVER_CTX_INTEGER)
{
to->ContextFlags |= CONTEXT_INTEGER;
for (i = 0; i <= 28; i++) to->u.X[i] = from->integer.arm64_regs.x[i];
}
if (from->flags & SERVER_CTX_FLOATING_POINT)
{
to->ContextFlags |= CONTEXT_FLOATING_POINT;
for (i = 0; i < 64; i++) to->V[i / 2].D[i % 2] = from->fp.arm64_regs.d[i];
to->Fpcr = from->fp.arm64_regs.fpcr;
to->Fpsr = from->fp.arm64_regs.fpsr;
}
if (from->flags & SERVER_CTX_DEBUG_REGISTERS)
{
to->ContextFlags |= CONTEXT_DEBUG_REGISTERS;
for (i = 0; i < ARM64_MAX_BREAKPOINTS; i++) to->Bcr[i] = from->debug.arm64_regs.bcr[i];
for (i = 0; i < ARM64_MAX_BREAKPOINTS; i++) to->Bvr[i] = from->debug.arm64_regs.bvr[i];
for (i = 0; i < ARM64_MAX_WATCHPOINTS; i++) to->Wcr[i] = from->debug.arm64_regs.wcr[i];
for (i = 0; i < ARM64_MAX_WATCHPOINTS; i++) to->Wvr[i] = from->debug.arm64_regs.wvr[i];
}
return STATUS_SUCCESS;
}
/***********************************************************************
* NtSetContextThread (NTDLL.@)
* ZwSetContextThread (NTDLL.@)
*/
NTSTATUS WINAPI NtSetContextThread( HANDLE handle, const CONTEXT *context )
{
NTSTATUS ret;
BOOL self;
ret = set_thread_context( handle, context, &self );
if (self && ret == STATUS_SUCCESS) set_cpu_context( context );
return ret;
}
/***********************************************************************
* NtGetContextThread (NTDLL.@)
* ZwGetContextThread (NTDLL.@)
*/
NTSTATUS WINAPI NtGetContextThread( HANDLE handle, CONTEXT *context )
{
NTSTATUS ret;
DWORD needed_flags = context->ContextFlags;
BOOL self = (handle == GetCurrentThread());
if (!self)
{
if ((ret = get_thread_context( handle, context, &self ))) return ret;
needed_flags &= ~context->ContextFlags;
}
if (self && needed_flags)
{
CONTEXT ctx;
RtlCaptureContext( &ctx );
copy_context( context, &ctx, ctx.ContextFlags & needed_flags );
context->ContextFlags |= ctx.ContextFlags & needed_flags;
}
return STATUS_SUCCESS;
}
/***********************************************************************
* setup_exception_record
*
* Setup the exception record and context on the thread stack.
*/
static EXCEPTION_RECORD *setup_exception( ucontext_t *sigcontext, raise_func func )
{
struct stack_layout
{
CONTEXT context;
EXCEPTION_RECORD rec;
} *stack;
DWORD exception_code = 0;
/* push the stack_layout structure */
stack = (struct stack_layout *)((SP_sig(sigcontext) - sizeof(*stack)) & ~15);
stack->rec.ExceptionRecord = NULL;
stack->rec.ExceptionCode = exception_code;
stack->rec.ExceptionFlags = EXCEPTION_CONTINUABLE;
stack->rec.ExceptionAddress = (LPVOID)PC_sig(sigcontext);
stack->rec.NumberParameters = 0;
save_context( &stack->context, sigcontext );
/* now modify the sigcontext to return to the raise function */
SP_sig(sigcontext) = (ULONG_PTR)stack;
PC_sig(sigcontext) = (ULONG_PTR)func;
REGn_sig(0, sigcontext) = (ULONG_PTR)&stack->rec; /* first arg for raise_func */
REGn_sig(1, sigcontext) = (ULONG_PTR)&stack->context; /* second arg for raise_func */
return &stack->rec;
}
/**********************************************************************
* raise_segv_exception
*/
static void WINAPI raise_segv_exception( EXCEPTION_RECORD *rec, CONTEXT *context )
{
NTSTATUS status;
switch(rec->ExceptionCode)
{
case EXCEPTION_ACCESS_VIOLATION:
if (rec->NumberParameters == 2)
{
if (!(rec->ExceptionCode = virtual_handle_fault( (void *)rec->ExceptionInformation[1],
rec->ExceptionInformation[0], FALSE )))
goto done;
}
break;
}
status = NtRaiseException( rec, context, TRUE );
if (status) raise_status( status, rec );
done:
set_cpu_context( context );
}
/**********************************************************************
* call_stack_handlers
*
* Call the stack handlers chain.
*/
static NTSTATUS call_stack_handlers( EXCEPTION_RECORD *rec, CONTEXT *context )
{
EXCEPTION_REGISTRATION_RECORD *frame, *dispatch, *nested_frame;
DWORD res;
frame = NtCurrentTeb()->Tib.ExceptionList;
nested_frame = NULL;
while (frame != (EXCEPTION_REGISTRATION_RECORD*)~0UL)
{
/* Check frame address */
if (!is_valid_frame( frame ))
{
rec->ExceptionFlags |= EH_STACK_INVALID;
break;
}
/* Call handler */
TRACE( "calling handler at %p code=%x flags=%x\n",
frame->Handler, rec->ExceptionCode, rec->ExceptionFlags );
res = frame->Handler( rec, frame, context, &dispatch );
TRACE( "handler at %p returned %x\n", frame->Handler, res );
if (frame == nested_frame)
{
/* no longer nested */
nested_frame = NULL;
rec->ExceptionFlags &= ~EH_NESTED_CALL;
}
switch(res)
{
case ExceptionContinueExecution:
if (!(rec->ExceptionFlags & EH_NONCONTINUABLE)) return STATUS_SUCCESS;
return STATUS_NONCONTINUABLE_EXCEPTION;
case ExceptionContinueSearch:
break;
case ExceptionNestedException:
if (nested_frame < dispatch) nested_frame = dispatch;
rec->ExceptionFlags |= EH_NESTED_CALL;
break;
default:
return STATUS_INVALID_DISPOSITION;
}
frame = frame->Prev;
}
return STATUS_UNHANDLED_EXCEPTION;
}
/*******************************************************************
* raise_exception
*
* Implementation of NtRaiseException.
*/
static NTSTATUS raise_exception( EXCEPTION_RECORD *rec, CONTEXT *context, BOOL first_chance )
{
NTSTATUS status;
if (first_chance)
{
DWORD c;
for (c = 0; c < rec->NumberParameters; c++)
TRACE( " info[%d]=%016lx\n", c, rec->ExceptionInformation[c] );
if (rec->ExceptionCode == EXCEPTION_WINE_STUB)
{
if (rec->ExceptionInformation[1] >> 16)
MESSAGE( "wine: Call from %p to unimplemented function %s.%s, aborting\n",
rec->ExceptionAddress,
(char*)rec->ExceptionInformation[0], (char*)rec->ExceptionInformation[1] );
else
MESSAGE( "wine: Call from %p to unimplemented function %s.%ld, aborting\n",
rec->ExceptionAddress,
(char*)rec->ExceptionInformation[0], rec->ExceptionInformation[1] );
}
else
{
/* FIXME: dump context */
}
status = send_debug_event( rec, TRUE, context );
if (status == DBG_CONTINUE || status == DBG_EXCEPTION_HANDLED)
return STATUS_SUCCESS;
if (call_vectored_handlers( rec, context ) == EXCEPTION_CONTINUE_EXECUTION)
return STATUS_SUCCESS;
if ((status = call_stack_handlers( rec, context )) != STATUS_UNHANDLED_EXCEPTION)
return status;
}
/* last chance exception */
status = send_debug_event( rec, FALSE, context );
if (status != DBG_CONTINUE)
{
if (rec->ExceptionFlags & EH_STACK_INVALID)
ERR("Exception frame is not in stack limits => unable to dispatch exception.\n");
else if (rec->ExceptionCode == STATUS_NONCONTINUABLE_EXCEPTION)
ERR("Process attempted to continue execution after noncontinuable exception.\n");
else
ERR("Unhandled exception code %x flags %x addr %p\n",
rec->ExceptionCode, rec->ExceptionFlags, rec->ExceptionAddress );
NtTerminateProcess( NtCurrentProcess(), rec->ExceptionCode );
}
return STATUS_SUCCESS;
}
static inline DWORD is_write_fault( ucontext_t *context )
{
DWORD inst = *(DWORD *)PC_sig(context);
if ((inst & 0xbfff0000) == 0x0c000000 /* C3.3.1 */ ||
(inst & 0xbfe00000) == 0x0c800000 /* C3.3.2 */ ||
(inst & 0xbfdf0000) == 0x0d000000 /* C3.3.3 */ ||
(inst & 0xbfc00000) == 0x0d800000 /* C3.3.4 */ ||
(inst & 0x3f400000) == 0x08000000 /* C3.3.6 */ ||
(inst & 0x3bc00000) == 0x38000000 /* C3.3.8-12 */ ||
(inst & 0x3fe00000) == 0x3c800000 /* C3.3.8-12 128bit */ ||
(inst & 0x3bc00000) == 0x39000000 /* C3.3.13 */ ||
(inst & 0x3fc00000) == 0x3d800000 /* C3.3.13 128bit */ ||
(inst & 0x3a400000) == 0x28000000) /* C3.3.7,14-16 */
return EXCEPTION_WRITE_FAULT;
return EXCEPTION_READ_FAULT;
}
/**********************************************************************
* segv_handler
*
* Handler for SIGSEGV and related errors.
*/
static void segv_handler( int signal, siginfo_t *info, void *ucontext )
{
EXCEPTION_RECORD *rec;
ucontext_t *context = ucontext;
/* check for page fault inside the thread stack */
if (signal == SIGSEGV &&
(char *)info->si_addr >= (char *)NtCurrentTeb()->DeallocationStack &&
(char *)info->si_addr < (char *)NtCurrentTeb()->Tib.StackBase &&
virtual_handle_stack_fault( info->si_addr ))
{
/* check if this was the last guard page */
if ((char *)info->si_addr < (char *)NtCurrentTeb()->DeallocationStack + 2*4096)
{
rec = setup_exception( context, raise_segv_exception );
rec->ExceptionCode = EXCEPTION_STACK_OVERFLOW;
}
return;
}
rec = setup_exception( context, raise_segv_exception );
if (rec->ExceptionCode == EXCEPTION_STACK_OVERFLOW) return;
switch(signal)
{
case SIGILL: /* Invalid opcode exception */
rec->ExceptionCode = EXCEPTION_ILLEGAL_INSTRUCTION;
break;
case SIGSEGV: /* Segmentation fault */
rec->ExceptionCode = EXCEPTION_ACCESS_VIOLATION;
rec->NumberParameters = 2;
rec->ExceptionInformation[0] = is_write_fault(context);
rec->ExceptionInformation[1] = (ULONG_PTR)info->si_addr;
break;
case SIGBUS: /* Alignment check exception */
rec->ExceptionCode = EXCEPTION_DATATYPE_MISALIGNMENT;
break;
default:
ERR("Got unexpected signal %i\n", signal);
rec->ExceptionCode = EXCEPTION_ILLEGAL_INSTRUCTION;
break;
}
}
/**********************************************************************
* trap_handler
*
* Handler for SIGTRAP.
*/
static void trap_handler( int signal, siginfo_t *info, void *ucontext )
{
EXCEPTION_RECORD rec;
CONTEXT context;
NTSTATUS status;
switch ( info->si_code )
{
case TRAP_TRACE:
rec.ExceptionCode = EXCEPTION_SINGLE_STEP;
break;
case TRAP_BRKPT:
default:
rec.ExceptionCode = EXCEPTION_BREAKPOINT;
break;
}
save_context( &context, ucontext );
rec.ExceptionFlags = EXCEPTION_CONTINUABLE;
rec.ExceptionRecord = NULL;
rec.ExceptionAddress = (LPVOID)context.Pc;
rec.NumberParameters = 0;
status = raise_exception( &rec, &context, TRUE );
if (status) raise_status( status, &rec );
restore_context( &context, ucontext );
}
/**********************************************************************
* fpe_handler
*
* Handler for SIGFPE.
*/
static void fpe_handler( int signal, siginfo_t *siginfo, void *sigcontext )
{
EXCEPTION_RECORD rec;
CONTEXT context;
NTSTATUS status;
save_fpu( &context, sigcontext );
save_context( &context, sigcontext );
switch (siginfo->si_code & 0xffff )
{
#ifdef FPE_FLTSUB
case FPE_FLTSUB:
rec.ExceptionCode = EXCEPTION_ARRAY_BOUNDS_EXCEEDED;
break;
#endif
#ifdef FPE_INTDIV
case FPE_INTDIV:
rec.ExceptionCode = EXCEPTION_INT_DIVIDE_BY_ZERO;
break;
#endif
#ifdef FPE_INTOVF
case FPE_INTOVF:
rec.ExceptionCode = EXCEPTION_INT_OVERFLOW;
break;
#endif
#ifdef FPE_FLTDIV
case FPE_FLTDIV:
rec.ExceptionCode = EXCEPTION_FLT_DIVIDE_BY_ZERO;
break;
#endif
#ifdef FPE_FLTOVF
case FPE_FLTOVF:
rec.ExceptionCode = EXCEPTION_FLT_OVERFLOW;
break;
#endif
#ifdef FPE_FLTUND
case FPE_FLTUND:
rec.ExceptionCode = EXCEPTION_FLT_UNDERFLOW;
break;
#endif
#ifdef FPE_FLTRES
case FPE_FLTRES:
rec.ExceptionCode = EXCEPTION_FLT_INEXACT_RESULT;
break;
#endif
#ifdef FPE_FLTINV
case FPE_FLTINV:
#endif
default:
rec.ExceptionCode = EXCEPTION_FLT_INVALID_OPERATION;
break;
}
rec.ExceptionFlags = EXCEPTION_CONTINUABLE;
rec.ExceptionRecord = NULL;
rec.ExceptionAddress = (LPVOID)context.Pc;
rec.NumberParameters = 0;
status = raise_exception( &rec, &context, TRUE );
if (status) raise_status( status, &rec );
restore_context( &context, sigcontext );
restore_fpu( &context, sigcontext );
}
/**********************************************************************
* int_handler
*
* Handler for SIGINT.
*/
static void int_handler( int signal, siginfo_t *siginfo, void *sigcontext )
{
if (!dispatch_signal(SIGINT))
{
EXCEPTION_RECORD rec;
CONTEXT context;
NTSTATUS status;
save_context( &context, sigcontext );
rec.ExceptionCode = CONTROL_C_EXIT;
rec.ExceptionFlags = EXCEPTION_CONTINUABLE;
rec.ExceptionRecord = NULL;
rec.ExceptionAddress = (LPVOID)context.Pc;
rec.NumberParameters = 0;
status = raise_exception( &rec, &context, TRUE );
if (status) raise_status( status, &rec );
restore_context( &context, sigcontext );
}
}
/**********************************************************************
* abrt_handler
*
* Handler for SIGABRT.
*/
static void abrt_handler( int signal, siginfo_t *siginfo, void *sigcontext )
{
EXCEPTION_RECORD rec;
CONTEXT context;
NTSTATUS status;
save_context( &context, sigcontext );
rec.ExceptionCode = EXCEPTION_WINE_ASSERTION;
rec.ExceptionFlags = EH_NONCONTINUABLE;
rec.ExceptionRecord = NULL;
rec.ExceptionAddress = (LPVOID)context.Pc;
rec.NumberParameters = 0;
status = raise_exception( &rec, &context, TRUE );
if (status) raise_status( status, &rec );
restore_context( &context, sigcontext );
}
/**********************************************************************
* quit_handler
*
* Handler for SIGQUIT.
*/
static void quit_handler( int signal, siginfo_t *siginfo, void *sigcontext )
{
abort_thread(0);
}
/**********************************************************************
* usr1_handler
*
* Handler for SIGUSR1, used to signal a thread that it got suspended.
*/
static void usr1_handler( int signal, siginfo_t *siginfo, void *sigcontext )
{
CONTEXT context;
save_context( &context, sigcontext );
wait_suspend( &context );
restore_context( &context, sigcontext );
}
/***********************************************************************
* __wine_set_signal_handler (NTDLL.@)
*/
int CDECL __wine_set_signal_handler(unsigned int sig, wine_signal_handler wsh)
{
if (sig >= sizeof(handlers) / sizeof(handlers[0])) return -1;
if (handlers[sig] != NULL) return -2;
handlers[sig] = wsh;
return 0;
}
/**********************************************************************
* signal_alloc_thread
*/
NTSTATUS signal_alloc_thread( TEB **teb )
{
static size_t sigstack_zero_bits;
SIZE_T size;
NTSTATUS status;
if (!sigstack_zero_bits)
{
size_t min_size = teb_size + max( MINSIGSTKSZ, 8192 );
/* find the first power of two not smaller than min_size */
sigstack_zero_bits = 12;
while ((1u << sigstack_zero_bits) < min_size) sigstack_zero_bits++;
signal_stack_size = (1 << sigstack_zero_bits) - teb_size;
assert( sizeof(TEB) <= teb_size );
}
size = 1 << sigstack_zero_bits;
*teb = NULL;
if (!(status = NtAllocateVirtualMemory( NtCurrentProcess(), (void **)teb, sigstack_zero_bits,
&size, MEM_COMMIT | MEM_TOP_DOWN, PAGE_READWRITE )))
{
(*teb)->Tib.Self = &(*teb)->Tib;
(*teb)->Tib.ExceptionList = (void *)~0UL;
}
return status;
}
/**********************************************************************
* signal_free_thread
*/
void signal_free_thread( TEB *teb )
{
SIZE_T size = 0;
NtFreeVirtualMemory( NtCurrentProcess(), (void **)&teb, &size, MEM_RELEASE );
}
/**********************************************************************
* signal_init_thread
*/
void signal_init_thread( TEB *teb )
{
static BOOL init_done;
if (!init_done)
{
pthread_key_create( &teb_key, NULL );
init_done = TRUE;
}
/* Win64/ARM applications expect the TEB pointer to be in the x18 platform register. */
__asm__ __volatile__( "mov x18, %0" : : "r" (teb) );
pthread_setspecific( teb_key, teb );
}
/**********************************************************************
* signal_init_process
*/
void signal_init_process(void)
{
struct sigaction sig_act;
sig_act.sa_mask = server_block_set;
sig_act.sa_flags = SA_RESTART | SA_SIGINFO;
sig_act.sa_sigaction = int_handler;
if (sigaction( SIGINT, &sig_act, NULL ) == -1) goto error;
sig_act.sa_sigaction = fpe_handler;
if (sigaction( SIGFPE, &sig_act, NULL ) == -1) goto error;
sig_act.sa_sigaction = abrt_handler;
if (sigaction( SIGABRT, &sig_act, NULL ) == -1) goto error;
sig_act.sa_sigaction = quit_handler;
if (sigaction( SIGQUIT, &sig_act, NULL ) == -1) goto error;
sig_act.sa_sigaction = usr1_handler;
if (sigaction( SIGUSR1, &sig_act, NULL ) == -1) goto error;
sig_act.sa_sigaction = segv_handler;
if (sigaction( SIGSEGV, &sig_act, NULL ) == -1) goto error;
if (sigaction( SIGILL, &sig_act, NULL ) == -1) goto error;
#ifdef SIGBUS
if (sigaction( SIGBUS, &sig_act, NULL ) == -1) goto error;
#endif
#ifdef SIGTRAP
sig_act.sa_sigaction = trap_handler;
if (sigaction( SIGTRAP, &sig_act, NULL ) == -1) goto error;
#endif
return;
error:
perror("sigaction");
exit(1);
}
/**********************************************************************
* __wine_enter_vm86 (NTDLL.@)
*/
void __wine_enter_vm86( CONTEXT *context )
{
MESSAGE("vm86 mode not supported on this platform\n");
}
/***********************************************************************
* RtlUnwind (NTDLL.@)
*/
void WINAPI RtlUnwind( PVOID pEndFrame, PVOID targetIp, PEXCEPTION_RECORD pRecord, PVOID retval )
{
FIXME( "Not implemented on ARM64\n" );
}
/*******************************************************************
* NtRaiseException (NTDLL.@)
*/
NTSTATUS WINAPI NtRaiseException( EXCEPTION_RECORD *rec, CONTEXT *context, BOOL first_chance )
{
NTSTATUS status = raise_exception( rec, context, first_chance );
if (status == STATUS_SUCCESS) NtSetContextThread( GetCurrentThread(), context );
return status;
}
/***********************************************************************
* RtlRaiseException (NTDLL.@)
*/
void WINAPI RtlRaiseException( EXCEPTION_RECORD *rec )
{
CONTEXT context;
NTSTATUS status;
RtlCaptureContext( &context );
rec->ExceptionAddress = (LPVOID)context.Pc;
status = raise_exception( rec, &context, TRUE );
if (status) raise_status( status, rec );
}
/*************************************************************************
* RtlCaptureStackBackTrace (NTDLL.@)
*/
USHORT WINAPI RtlCaptureStackBackTrace( ULONG skip, ULONG count, PVOID *buffer, ULONG *hash )
{
FIXME( "(%d, %d, %p, %p) stub!\n", skip, count, buffer, hash );
return 0;
}
/***********************************************************************
* call_thread_entry_point
*/
static void WINAPI call_thread_entry_point( LPTHREAD_START_ROUTINE entry, void *arg )
{
__TRY
{
TRACE_(relay)( "\1Starting thread proc %p (arg=%p)\n", entry, arg );
RtlExitUserThread( entry( arg ));
}
__EXCEPT(unhandled_exception_filter)
{
NtTerminateThread( GetCurrentThread(), GetExceptionCode() );
}
__ENDTRY
abort(); /* should not be reached */
}
typedef void (WINAPI *thread_start_func)(LPTHREAD_START_ROUTINE,void *);
struct startup_info
{
thread_start_func start;
LPTHREAD_START_ROUTINE entry;
void *arg;
BOOL suspend;
};
/***********************************************************************
* thread_startup
*/
static void thread_startup( void *param )
{
CONTEXT context = { 0 };
struct startup_info *info = param;
/* build the initial context */
context.ContextFlags = CONTEXT_FULL;
context.u.s.X0 = (DWORD_PTR)info->entry;
context.u.s.X1 = (DWORD_PTR)info->arg;
context.Sp = (DWORD_PTR)NtCurrentTeb()->Tib.StackBase;
context.Pc = (DWORD_PTR)info->start;
if (info->suspend) wait_suspend( &context );
attach_dlls( &context );
((thread_start_func)context.Pc)( (LPTHREAD_START_ROUTINE)context.u.s.X0, (void *)context.u.s.X1 );
}
/***********************************************************************
* signal_start_thread
*
* Thread startup sequence:
* signal_start_thread()
* -> thread_startup()
* -> call_thread_entry_point()
*/
void signal_start_thread( LPTHREAD_START_ROUTINE entry, void *arg, BOOL suspend )
{
struct startup_info info = { call_thread_entry_point, entry, arg, suspend };
wine_switch_to_stack( thread_startup, &info, NtCurrentTeb()->Tib.StackBase );
}
/**********************************************************************
* signal_start_process
*
* Process startup sequence:
* signal_start_process()
* -> thread_startup()
* -> kernel32_start_process()
*/
void signal_start_process( LPTHREAD_START_ROUTINE entry, BOOL suspend )
{
struct startup_info info = { kernel32_start_process, entry, NtCurrentTeb()->Peb, suspend };
wine_switch_to_stack( thread_startup, &info, NtCurrentTeb()->Tib.StackBase );
}
/***********************************************************************
* signal_exit_thread
*/
void signal_exit_thread( int status )
{
exit_thread( status );
}
/***********************************************************************
* signal_exit_process
*/
void signal_exit_process( int status )
{
exit( status );
}
/**********************************************************************
* DbgBreakPoint (NTDLL.@)
*/
void WINAPI DbgBreakPoint(void)
{
kill(getpid(), SIGTRAP);
}
/**********************************************************************
* DbgUserBreakPoint (NTDLL.@)
*/
void WINAPI DbgUserBreakPoint(void)
{
kill(getpid(), SIGTRAP);
}
/**********************************************************************
* NtCurrentTeb (NTDLL.@)
*/
TEB * WINAPI NtCurrentTeb(void)
{
return pthread_getspecific( teb_key );
}
#endif /* __aarch64__ */
|
the_stack_data/140765038.c | #include <stdio.h>
#include <limits.h>
int main(void)
{
printf("Maximum int vlaue on this system = %u\n",UINT_MAX );
system("PAUSE");
return 0;
} |
the_stack_data/97013177.c | float min2(float x, float y) {
return x < y ? x : y;
} |
the_stack_data/156391864.c | /*
* Generated with test/generate_buildtest.pl, to check that such a simple
* program builds.
*/
#include <openssl/opensslconf.h>
#ifndef OPENSSL_NO_STDIO
# include <stdio.h>
#endif
#ifndef OPENSSL_NO_PROVIDER
# include <openssl/provider.h>
#endif
int main(void)
{
return 0;
}
|
the_stack_data/212643489.c | int gbn_polling_thread_cpu = 0;
int mgmt_dispatcher_thread_cpu = 1;
|
the_stack_data/23575626.c | #include <stdio.h>
#include <stdlib.h>
int main(int argc, char *argv[]) {
int y,m,d,y0,m0,d0,ny,nm,counter,sum,ycounter=0,flag1=0;
for(counter=0;1;counter++)
{
scanf("%d %d %d",&y,&m,&d);
if(counter==1) break;
y0=y,m0=m,d0=d;
}
if(leap_year(y0)) flag1=1;else flag1=2;
ny=y-y0,nm=m-m0;
for(y0++;y0<y;y0++)
{
if(leap_year(y0)) ycounter++;
}
sum=(ny-ycounter-1)*365+ycounter*366;
if(ny==0&&nm==0) {printf("%d days\n",sum=d-d0);return 0;}
switch(m0)
{
case 1:case 3:case 5:case 7:case 8:case 10:case 12: sum+=31-d0; break;
case 4:case 6:case 9:case 11: sum+=30-d0; break;
case 2: if(flag1==1) sum+=29-d0;
else sum+=28-d0; break;
}
if(ny==0&&nm!=0)
{
for(m0++;m0<m;m0++)
{
if(m0==1||m0==3||m0==5||m0==7||m0==8||m0==10) sum+=31;
if(m0==4||m0==6||m0==9||m0==11) sum+=30;
if(m0==2)
{
if(flag1==1) sum+=29;
else sum+=28;
}
}
sum+=d+365;
printf("%d days\n",sum);
return 0;
}
for(m0++;m0<=12;m0++)
{
if(m0==1||m0==3||m0==5||m0==7||m0==8||m0==10||m0==12) sum+=31;
if(m0==4||m0==6||m0==9||m0==11) sum+=30;
if(m0==2)
{
if(flag1==1) sum+=29;
else sum+=28;
}
}
sum+=d;
for(m--;m>=1;m--)
{
if(m==1||m==3||m==5||m==7||m==8||m==10||m==12) sum+=31;
if(m==4||m==6||m==9||m==11) sum+=30;
if(m==2)
{
if(flag1==1) sum+=29;
else sum+=28;
}
}
printf("%d days\n",sum);
return 0;
}
|
the_stack_data/1081639.c | #define NULL ((void*)0)
typedef unsigned long size_t; // Customize by platform.
typedef long intptr_t; typedef unsigned long uintptr_t;
typedef long scalar_t__; // Either arithmetic or pointer type.
/* By default, we understand bool (as a convenience). */
typedef int bool;
#define false 0
#define true 1
/* Forward declarations */
typedef struct TYPE_2__ TYPE_1__ ;
/* Type definitions */
struct socket {struct sock* sk; } ;
struct sockaddr {int dummy; } ;
struct sock {int sk_state; struct l2tp_tunnel* sk_user_data; } ;
struct TYPE_2__ {int /*<<< orphan*/ mtu; int /*<<< orphan*/ * ops; struct sock* private; int /*<<< orphan*/ hdrlen; } ;
struct pppox_sock {TYPE_1__ chan; } ;
struct pppol2tp_session {int /*<<< orphan*/ sk_lock; int /*<<< orphan*/ sk; scalar_t__ __sk; } ;
struct l2tp_tunnel_cfg {int /*<<< orphan*/ debug; int /*<<< orphan*/ encap; } ;
struct l2tp_tunnel {scalar_t__ peer_tunnel_id; scalar_t__ pwtype; scalar_t__ session_id; scalar_t__ peer_session_id; int /*<<< orphan*/ name; int /*<<< orphan*/ * sock; } ;
struct l2tp_session_cfg {scalar_t__ pw_type; int /*<<< orphan*/ member_0; } ;
struct l2tp_session {scalar_t__ peer_tunnel_id; scalar_t__ pwtype; scalar_t__ session_id; scalar_t__ peer_session_id; int /*<<< orphan*/ name; int /*<<< orphan*/ * sock; } ;
struct l2tp_connect_info {scalar_t__ fd; scalar_t__ peer_tunnel_id; int /*<<< orphan*/ peer_session_id; int /*<<< orphan*/ session_id; int /*<<< orphan*/ tunnel_id; int /*<<< orphan*/ version; } ;
/* Variables and functions */
int EALREADY ;
int EBADF ;
int EBUSY ;
int EEXIST ;
int EINVAL ;
int ENOENT ;
int EPROTOTYPE ;
scalar_t__ IS_ERR (struct l2tp_tunnel*) ;
int /*<<< orphan*/ L2TP_ENCAPTYPE_UDP ;
int /*<<< orphan*/ L2TP_MSG_CONTROL ;
scalar_t__ L2TP_PWTYPE_PPP ;
int /*<<< orphan*/ PPPOL2TP_L2TP_HDR_SIZE_NOSEQ ;
int PPPOX_CONNECTED ;
int PTR_ERR (struct l2tp_tunnel*) ;
int /*<<< orphan*/ kfree (struct l2tp_tunnel*) ;
int /*<<< orphan*/ l2tp_info (struct l2tp_tunnel*,int /*<<< orphan*/ ,char*,int /*<<< orphan*/ ) ;
struct l2tp_tunnel* l2tp_session_create (int,struct l2tp_tunnel*,int /*<<< orphan*/ ,int /*<<< orphan*/ ,struct l2tp_session_cfg*) ;
int /*<<< orphan*/ l2tp_session_dec_refcount (struct l2tp_tunnel*) ;
int /*<<< orphan*/ l2tp_session_delete (struct l2tp_tunnel*) ;
int /*<<< orphan*/ l2tp_session_inc_refcount (struct l2tp_tunnel*) ;
struct pppol2tp_session* l2tp_session_priv (struct l2tp_tunnel*) ;
int l2tp_session_register (struct l2tp_tunnel*,struct l2tp_tunnel*) ;
int l2tp_tunnel_create (int /*<<< orphan*/ ,scalar_t__,int /*<<< orphan*/ ,int /*<<< orphan*/ ,scalar_t__,struct l2tp_tunnel_cfg*,struct l2tp_tunnel**) ;
int /*<<< orphan*/ l2tp_tunnel_dec_refcount (struct l2tp_tunnel*) ;
int /*<<< orphan*/ l2tp_tunnel_delete (struct l2tp_tunnel*) ;
struct l2tp_tunnel* l2tp_tunnel_get (int /*<<< orphan*/ ,int /*<<< orphan*/ ) ;
struct l2tp_tunnel* l2tp_tunnel_get_session (struct l2tp_tunnel*,int /*<<< orphan*/ ) ;
int /*<<< orphan*/ l2tp_tunnel_inc_refcount (struct l2tp_tunnel*) ;
int l2tp_tunnel_register (struct l2tp_tunnel*,int /*<<< orphan*/ ,struct l2tp_tunnel_cfg*) ;
int /*<<< orphan*/ lock_sock (struct sock*) ;
int /*<<< orphan*/ lockdep_is_held (int /*<<< orphan*/ *) ;
int /*<<< orphan*/ mutex_lock (int /*<<< orphan*/ *) ;
int /*<<< orphan*/ mutex_unlock (int /*<<< orphan*/ *) ;
int ppp_register_net_channel (int /*<<< orphan*/ ,TYPE_1__*) ;
int /*<<< orphan*/ pppol2tp_chan_ops ;
int /*<<< orphan*/ pppol2tp_session_init (struct l2tp_tunnel*) ;
int pppol2tp_sockaddr_get_info (struct sockaddr*,int,struct l2tp_connect_info*) ;
int /*<<< orphan*/ pppol2tp_tunnel_mtu (struct l2tp_tunnel*) ;
struct pppox_sock* pppox_sk (struct sock*) ;
int /*<<< orphan*/ rcu_assign_pointer (int /*<<< orphan*/ ,struct sock*) ;
scalar_t__ rcu_dereference_protected (int /*<<< orphan*/ ,int /*<<< orphan*/ ) ;
int /*<<< orphan*/ release_sock (struct sock*) ;
int /*<<< orphan*/ sock_net (struct sock*) ;
__attribute__((used)) static int pppol2tp_connect(struct socket *sock, struct sockaddr *uservaddr,
int sockaddr_len, int flags)
{
struct sock *sk = sock->sk;
struct pppox_sock *po = pppox_sk(sk);
struct l2tp_session *session = NULL;
struct l2tp_connect_info info;
struct l2tp_tunnel *tunnel;
struct pppol2tp_session *ps;
struct l2tp_session_cfg cfg = { 0, };
bool drop_refcnt = false;
bool drop_tunnel = false;
bool new_session = false;
bool new_tunnel = false;
int error;
error = pppol2tp_sockaddr_get_info(uservaddr, sockaddr_len, &info);
if (error < 0)
return error;
lock_sock(sk);
/* Check for already bound sockets */
error = -EBUSY;
if (sk->sk_state & PPPOX_CONNECTED)
goto end;
/* We don't supporting rebinding anyway */
error = -EALREADY;
if (sk->sk_user_data)
goto end; /* socket is already attached */
/* Don't bind if tunnel_id is 0 */
error = -EINVAL;
if (!info.tunnel_id)
goto end;
tunnel = l2tp_tunnel_get(sock_net(sk), info.tunnel_id);
if (tunnel)
drop_tunnel = true;
/* Special case: create tunnel context if session_id and
* peer_session_id is 0. Otherwise look up tunnel using supplied
* tunnel id.
*/
if (!info.session_id && !info.peer_session_id) {
if (tunnel == NULL) {
struct l2tp_tunnel_cfg tcfg = {
.encap = L2TP_ENCAPTYPE_UDP,
.debug = 0,
};
/* Prevent l2tp_tunnel_register() from trying to set up
* a kernel socket.
*/
if (info.fd < 0) {
error = -EBADF;
goto end;
}
error = l2tp_tunnel_create(sock_net(sk), info.fd,
info.version,
info.tunnel_id,
info.peer_tunnel_id, &tcfg,
&tunnel);
if (error < 0)
goto end;
l2tp_tunnel_inc_refcount(tunnel);
error = l2tp_tunnel_register(tunnel, sock_net(sk),
&tcfg);
if (error < 0) {
kfree(tunnel);
goto end;
}
drop_tunnel = true;
new_tunnel = true;
}
} else {
/* Error if we can't find the tunnel */
error = -ENOENT;
if (tunnel == NULL)
goto end;
/* Error if socket is not prepped */
if (tunnel->sock == NULL)
goto end;
}
if (tunnel->peer_tunnel_id == 0)
tunnel->peer_tunnel_id = info.peer_tunnel_id;
session = l2tp_tunnel_get_session(tunnel, info.session_id);
if (session) {
drop_refcnt = true;
if (session->pwtype != L2TP_PWTYPE_PPP) {
error = -EPROTOTYPE;
goto end;
}
ps = l2tp_session_priv(session);
/* Using a pre-existing session is fine as long as it hasn't
* been connected yet.
*/
mutex_lock(&ps->sk_lock);
if (rcu_dereference_protected(ps->sk,
lockdep_is_held(&ps->sk_lock)) ||
ps->__sk) {
mutex_unlock(&ps->sk_lock);
error = -EEXIST;
goto end;
}
} else {
cfg.pw_type = L2TP_PWTYPE_PPP;
session = l2tp_session_create(sizeof(struct pppol2tp_session),
tunnel, info.session_id,
info.peer_session_id, &cfg);
if (IS_ERR(session)) {
error = PTR_ERR(session);
goto end;
}
pppol2tp_session_init(session);
ps = l2tp_session_priv(session);
l2tp_session_inc_refcount(session);
mutex_lock(&ps->sk_lock);
error = l2tp_session_register(session, tunnel);
if (error < 0) {
mutex_unlock(&ps->sk_lock);
kfree(session);
goto end;
}
drop_refcnt = true;
new_session = true;
}
/* Special case: if source & dest session_id == 0x0000, this
* socket is being created to manage the tunnel. Just set up
* the internal context for use by ioctl() and sockopt()
* handlers.
*/
if ((session->session_id == 0) &&
(session->peer_session_id == 0)) {
error = 0;
goto out_no_ppp;
}
/* The only header we need to worry about is the L2TP
* header. This size is different depending on whether
* sequence numbers are enabled for the data channel.
*/
po->chan.hdrlen = PPPOL2TP_L2TP_HDR_SIZE_NOSEQ;
po->chan.private = sk;
po->chan.ops = &pppol2tp_chan_ops;
po->chan.mtu = pppol2tp_tunnel_mtu(tunnel);
error = ppp_register_net_channel(sock_net(sk), &po->chan);
if (error) {
mutex_unlock(&ps->sk_lock);
goto end;
}
out_no_ppp:
/* This is how we get the session context from the socket. */
sk->sk_user_data = session;
rcu_assign_pointer(ps->sk, sk);
mutex_unlock(&ps->sk_lock);
/* Keep the reference we've grabbed on the session: sk doesn't expect
* the session to disappear. pppol2tp_session_destruct() is responsible
* for dropping it.
*/
drop_refcnt = false;
sk->sk_state = PPPOX_CONNECTED;
l2tp_info(session, L2TP_MSG_CONTROL, "%s: created\n",
session->name);
end:
if (error) {
if (new_session)
l2tp_session_delete(session);
if (new_tunnel)
l2tp_tunnel_delete(tunnel);
}
if (drop_refcnt)
l2tp_session_dec_refcount(session);
if (drop_tunnel)
l2tp_tunnel_dec_refcount(tunnel);
release_sock(sk);
return error;
} |
the_stack_data/150142706.c | //******************************************************************
//
// Copyright 2017 Microsoft
//
//-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=-=
//
// Licensed under the Apache License, Version 2.0 (the "License");
// you may not use this file except in compliance with the License.
// You may obtain a copy of the License at
//
// http://www.apache.org/licenses/LICENSE-2.0
//
// Unless required by applicable law or agreed to in writing, software
// distributed under the License is distributed on an "AS IS" BASIS,
// WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
// See the License for the specific language governing permissions and
// limitations under the License.
//
//******************************************************************
#if defined(__WITH_DTLS__) || defined(__WITH_TLS__)
#include "iotivity_config.h"
#include <stdlib.h>
#ifdef HAVE_STRING_H
#include <string.h>
#endif
#ifdef HAVE_STRINGS_H
#include <strings.h>
#endif
#include <stdint.h>
#include <stdbool.h>
#include <inttypes.h>
#include "oic_string.h"
#include "cainterface.h"
#include "experimental/payload_logging.h"
#include "ocstack.h"
#include "experimental/ocrandom.h"
#include "cacommon.h"
#include "srmresourcestrings.h"
#include "ocpayload.h"
#include "ocpayloadcbor.h"
#include "credresource.h"
#include "experimental/doxmresource.h"
#include "srmutility.h"
#include "certhelpers.h"
#include "resourcemanager.h"
#include "utlist.h"
#include "ca_adapter_net_ssl.h"
#include "ocstackinternal.h"
#include "rolesresource.h"
#include "secureresourcemanager.h"
#include "parsechain.h"
#define TAG "OIC_SRM_ROLES"
typedef struct RolesEntry {
uint8_t *publicKey; /**< DER-encoded public key */
size_t publicKeyLength; /**< length of publicKey */
RoleCertChain_t *chains; /**< stored certificates */
struct tm cacheValidUntil; /**< Cache valid until time; use 0 if cache is not yet set */
OicSecRole_t *cachedRoles; /**< Cached roles; must free with OICFree */
size_t cachedRolesLength; /**< Length of cachedRoles array */
struct RolesEntry *next;
} RolesEntry_t;
typedef struct SymmetricRoleEntry {
OicUuid_t subject; /**< Subject of the symmetric credential */
OicSecRole_t role; /**< Role of the symmetric credential */
struct SymmetricRoleEntry *next;
} SymmetricRoleEntry_t;
static OCResourceHandle gRolesHandle = NULL;
static RolesEntry_t *gRoles = NULL;
static SymmetricRoleEntry_t *gSymmetricRoles = NULL;
static uint32_t gIdCounter = 1;
/**
* Default cbor payload size. This value is increased in case of CborErrorOutOfMemory.
* The value of payload size is increased until reaching max cbor size.
*/
static const uint16_t CBOR_SIZE = 2048;
/**
* Zero subject UUID.
*/
static const char EMPTY_UUID[] = "00000000-0000-0000-0000-000000000000";
/**
* Mandatory parts of a role map cred entry: 4 key/value pairs: credId, subject, publicData, and credType.
*/
static const uint8_t ROLE_MAP_SIZE = 4;
static void InvalidateRoleCache(RolesEntry_t *entry)
{
memset(&entry->cacheValidUntil, 0, sizeof(entry->cacheValidUntil));
OICFree(entry->cachedRoles);
entry->cachedRoles = NULL;
entry->cachedRolesLength = 0;
}
/* Caller must call OICFree on publicKey when finished. */
static OCStackResult GetPeerPublicKeyFromEndpoint(const CAEndpoint_t *endpoint,
uint8_t **publicKey,
size_t *publicKeyLength)
{
CASecureEndpoint_t sep;
CAResult_t res = GetCASecureEndpointData(endpoint, &sep);
if (CA_STATUS_OK != res)
{
OIC_LOG_V(ERROR, TAG, "%s: Failed to GetCASecureEndpointData: %d", __func__, res);
return OC_STACK_INVALID_PARAM;
}
if ((NULL == sep.publicKey) || (0 == sep.publicKeyLength))
{
OIC_LOG_V(WARNING, TAG, "%s: Peer did not have a public key", __func__);
return OC_STACK_NO_RESOURCE;
}
*publicKey = OICCalloc(1, sep.publicKeyLength);
if (NULL == *publicKey)
{
OIC_LOG_V(ERROR, TAG, "%s: No memory for publicKey", __func__);
return OC_STACK_NO_MEMORY;
}
memcpy(*publicKey, sep.publicKey, sep.publicKeyLength);
*publicKeyLength = sep.publicKeyLength;
return OC_STACK_OK;
}
/* Caller must call OICFree on publicKey when finished. */
static OCStackResult GetPeerPublicKey(const OCDevAddr *peer, uint8_t **publicKey, size_t *publicKeyLength)
{
CAEndpoint_t endpoint;
CopyDevAddrToEndpoint(peer, &endpoint);
return GetPeerPublicKeyFromEndpoint(&endpoint, publicKey, publicKeyLength);
}
static void FreeRoleCertChain(RoleCertChain_t *roleCert)
{
if (NULL == roleCert)
{
return;
}
OICFree(roleCert->certificate.data);
OICFree(roleCert);
}
void FreeRoleCertChainList(RoleCertChain_t *roleCertList)
{
if (NULL == roleCertList)
{
return;
}
RoleCertChain_t *certTmp1 = NULL;
RoleCertChain_t *certTmp2 = NULL;
LL_FOREACH_SAFE(roleCertList, certTmp1, certTmp2)
{
LL_DELETE(roleCertList, certTmp1);
FreeRoleCertChain(certTmp1);
}
}
static void FreeRolesEntry(RolesEntry_t *rolesEntry)
{
if (NULL == rolesEntry)
{
return;
}
FreeRoleCertChainList(rolesEntry->chains);
OICFree(rolesEntry->publicKey);
OICFree(rolesEntry->cachedRoles);
OICFree(rolesEntry);
}
static void FreeRolesList(RolesEntry_t *roles)
{
if (NULL != roles)
{
RolesEntry_t *entryTmp1 = NULL;
RolesEntry_t *entryTmp2 = NULL;
LL_FOREACH_SAFE(roles, entryTmp1, entryTmp2)
{
LL_DELETE(roles, entryTmp1);
FreeRolesEntry(entryTmp1);
}
}
}
static void FreeSymmetricRoleEntry(SymmetricRoleEntry_t *symRoleEntry)
{
OICFree(symRoleEntry);
}
static void FreeSymmetricRolesList(SymmetricRoleEntry_t *head)
{
if (NULL != head)
{
SymmetricRoleEntry_t *entryTmp1 = NULL;
SymmetricRoleEntry_t *entryTmp2 = NULL;
LL_FOREACH_SAFE(head, entryTmp1, entryTmp2)
{
LL_DELETE(head, entryTmp1);
FreeSymmetricRoleEntry(entryTmp1);
}
}
}
OCStackResult RegisterSymmetricCredentialRole(const OicSecCred_t *cred)
{
VERIFY_NON_NULL_RET(cred, TAG, "Parameter cred is NULL", OC_STACK_INVALID_PARAM);
VERIFY_SUCCESS_RETURN(TAG, (SYMMETRIC_PAIR_WISE_KEY == cred->credType), ERROR, OC_STACK_INVALID_PARAM);
SymmetricRoleEntry_t *curr = NULL;
LL_FOREACH(gSymmetricRoles, curr)
{
if (0 == memcmp(&cred->subject, &curr->subject, sizeof(curr->subject)))
{
if (!IsNonEmptyRole(&cred->roleId))
{
LL_DELETE(gSymmetricRoles, curr);
}
else
{
curr->role = cred->roleId;
}
return OC_STACK_OK;
}
}
/* No entry found; add a new one if we're setting a role. */
if (IsNonEmptyRole(&cred->roleId))
{
curr = (SymmetricRoleEntry_t *)OICCalloc(1, sizeof(SymmetricRoleEntry_t));
if (NULL == curr)
{
OIC_LOG(ERROR, TAG, "No memory allocating new symmetric role entry");
return OC_STACK_NO_MEMORY;
}
LL_APPEND(gSymmetricRoles, curr);
curr->subject = cred->subject;
curr->role = cred->roleId;
}
return OC_STACK_OK;
}
static OCStackResult DuplicateRoleCertChain(const RoleCertChain_t *roleCert, RoleCertChain_t **duplicate)
{
OIC_LOG(DEBUG, TAG, "DuplicateRoleCertChain IN");
OCStackResult res = OC_STACK_ERROR;
RoleCertChain_t *tmp = NULL;
if ((NULL == roleCert) || (NULL == duplicate))
{
res = OC_STACK_INVALID_PARAM;
goto exit;
}
tmp = (RoleCertChain_t *)OICCalloc(1, sizeof(RoleCertChain_t));
if (NULL == tmp)
{
OIC_LOG(ERROR, TAG, "No memory for tmp");
res = OC_STACK_NO_MEMORY;
goto exit;
}
tmp->certificate.data = (uint8_t *)OICCalloc(1, roleCert->certificate.len);
if (NULL == tmp->certificate.data)
{
OIC_LOG(ERROR, TAG, "No memory for certificate data");
res = OC_STACK_NO_MEMORY;
goto exit;
}
tmp->credId = roleCert->credId;
tmp->certificate.len = roleCert->certificate.len;
tmp->certificate.encoding = roleCert->certificate.encoding;
memcpy(tmp->certificate.data, roleCert->certificate.data, roleCert->certificate.len);
*duplicate = tmp;
res = OC_STACK_OK;
exit:
OIC_LOG_V(DEBUG, TAG, "DuplicateRoleCertChain OUT: %d", res);
if (OC_STACK_OK != res)
{
FreeRoleCertChain(tmp);
}
return res;
}
static bool RoleCertChainContains(RoleCertChain_t *chain, const RoleCertChain_t* roleCert)
{
RoleCertChain_t *temp = NULL;
LL_FOREACH(chain, temp)
{
if (IsSameSecKey(&temp->certificate, &roleCert->certificate))
{
return true;
}
}
return false;
}
static OCStackResult AddRoleCertificate(const RoleCertChain_t *roleCert, const uint8_t *pubKey, size_t pubKeyLength)
{
OCStackResult res = OC_STACK_ERROR;
RolesEntry_t *targetEntry = NULL;
RoleCertChain_t *copy = NULL;
OIC_LOG(DEBUG, TAG, "AddRoleCertificate IN");
if ((NULL == pubKey) || (0 == pubKeyLength))
{
assert(!"AddRoleCertificate called with no public key");
res = OC_STACK_INVALID_PARAM;
goto exit;
}
for (targetEntry = gRoles; NULL != targetEntry; targetEntry = targetEntry->next)
{
if ((targetEntry->publicKeyLength == pubKeyLength) &&
(0 == memcmp(targetEntry->publicKey, pubKey, pubKeyLength)))
{
break;
}
}
if (NULL != targetEntry)
{
InvalidateRoleCache(targetEntry);
}
else
{
/* We haven't seen this public key before and need a new entry. */
targetEntry = (RolesEntry_t *)OICCalloc(1, sizeof(RolesEntry_t));
if (NULL == targetEntry)
{
OIC_LOG(ERROR, TAG, "No memory for new targetEntry");
res = OC_STACK_NO_MEMORY;
goto exit;
}
targetEntry->publicKey = (uint8_t *)OICCalloc(1, pubKeyLength);
if (NULL == targetEntry->publicKey)
{
OIC_LOG(ERROR, TAG, "No memory for new targetEntry public key");
OICFree(targetEntry);
res = OC_STACK_NO_MEMORY;
goto exit;
}
targetEntry->publicKeyLength = pubKeyLength;
memcpy(targetEntry->publicKey, pubKey, pubKeyLength);
LL_PREPEND(gRoles, targetEntry);
}
if (!RoleCertChainContains(targetEntry->chains, roleCert))
{
res = DuplicateRoleCertChain(roleCert, ©);
if (OC_STACK_OK != res)
{
OIC_LOG_V(ERROR, TAG, "%s: Could not duplicate role cert chain: %d", __func__, res);
goto exit;
}
// Assign our own credId.
copy->credId = gIdCounter++;
LL_APPEND(targetEntry->chains, copy);
}
else
{
OIC_LOG_V(DEBUG, TAG, "%s: Role cert chain already present, not going to add it again", __func__);
}
res = OC_STACK_OK;
exit:
if (OC_STACK_OK != res)
{
FreeRoleCertChain(copy);
}
OIC_LOG_V(DEBUG, TAG, "AddRoleCertificate Out: %d", res);
return res;
}
OCStackResult RolesToCBORPayload(const RoleCertChain_t *roles, uint8_t **cborPayload,
size_t *cborSize)
{
OCStackResult ret = OC_STACK_OK;
CborError cborEncoderResult = CborNoError;
uint8_t *outPayload = NULL;
CborEncoder encoder;
CborEncoder rolesRootMap;
CborEncoder rolesArray;
size_t roleCount = 0;
const RoleCertChain_t *currChain = NULL;
VERIFY_NOT_NULL_RETURN(TAG, cborPayload, ERROR, OC_STACK_INVALID_PARAM);
VERIFY_NOT_NULL_RETURN(TAG, cborSize, ERROR, OC_STACK_INVALID_PARAM);
size_t cborLen = *cborSize;
*cborSize = 0;
*cborPayload = NULL;
if (0 == cborLen)
{
cborLen = CBOR_SIZE;
}
outPayload = (uint8_t *)OICCalloc(1, cborLen);
VERIFY_NOT_NULL_RETURN(TAG, outPayload, ERROR, OC_STACK_NO_MEMORY);
cbor_encoder_init(&encoder, outPayload, cborLen, 0);
// Create roles root map (roles, rt, if)
cborEncoderResult = cbor_encoder_create_map(&encoder, &rolesRootMap, 3);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding roles root map");
// Roles array
cborEncoderResult = cbor_encode_text_string(&rolesRootMap, OIC_JSON_ROLES_NAME, strlen(OIC_JSON_ROLES_NAME));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding roles name tag");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for roles name tag")
// If roles is NULL, the "roles" array will be empty
for (currChain = roles; NULL != currChain; currChain = currChain->next)
{
roleCount++;
}
cborEncoderResult = cbor_encoder_create_array(&rolesRootMap, &rolesArray, roleCount);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding roles array");
for (currChain = roles; NULL != currChain; currChain = currChain->next)
{
CborEncoder roleMap;
size_t mapSize = ROLE_MAP_SIZE;
cborEncoderResult = cbor_encoder_create_map(&rolesArray, &roleMap, mapSize);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding role map");
// credId - mandatory
cborEncoderResult = cbor_encode_text_string(&roleMap, OIC_JSON_CREDID_NAME, strlen(OIC_JSON_CREDID_NAME));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding credId tag");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for credId tag")
cborEncoderResult = cbor_encode_int(&roleMap, currChain->credId);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding credId value");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for credId value")
// subjectuuid - mandatory - always zero for role certificates
cborEncoderResult = cbor_encode_text_string(&roleMap, OIC_JSON_SUBJECTID_NAME, strlen(OIC_JSON_SUBJECTID_NAME));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding subject tag");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for subject tag")
cborEncoderResult = cbor_encode_text_string(&roleMap, EMPTY_UUID, sizeof(EMPTY_UUID) - 1);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding subject value");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for subject value")
// publicData - mandatory
cborEncoderResult = SerializeEncodingToCbor(&roleMap, OIC_JSON_PUBLICDATA_NAME, &currChain->certificate);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding publicData");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for publicData")
// credType - mandatory
cborEncoderResult = cbor_encode_text_string(&roleMap, OIC_JSON_CREDTYPE_NAME, strlen(OIC_JSON_CREDTYPE_NAME));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding credType tag");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for credType tag")
// Per security spec, only SIGNED_ASYMMETRIC_KEY is supported here.
cborEncoderResult = cbor_encode_int(&roleMap, SIGNED_ASYMMETRIC_KEY);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed adding credType value");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for credType value")
cborEncoderResult = cbor_encoder_close_container(&rolesArray, &roleMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed closing role map");
}
cborEncoderResult = cbor_encoder_close_container(&rolesRootMap, &rolesArray);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed closing roles array");
// RT -- Mandatory
CborEncoder rtArray;
cborEncoderResult = cbor_encode_text_string(&rolesRootMap, OIC_JSON_RT_NAME,
strlen(OIC_JSON_RT_NAME));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Addding RT Name Tag.");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for RT Name Tag")
cborEncoderResult = cbor_encoder_create_array(&rolesRootMap, &rtArray, 1);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Addding RT Value.");
for (size_t i = 0; i < 1; i++)
{
cborEncoderResult = cbor_encode_text_string(&rtArray, OIC_RSRC_TYPE_SEC_ROLES,
strlen(OIC_RSRC_TYPE_SEC_ROLES));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Adding RT Value.");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for RT Value")
}
cborEncoderResult = cbor_encoder_close_container(&rolesRootMap, &rtArray);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Closing RT.");
// IF-- Mandatory
CborEncoder ifArray;
cborEncoderResult = cbor_encode_text_string(&rolesRootMap, OIC_JSON_IF_NAME,
strlen(OIC_JSON_IF_NAME));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Addding IF Name Tag.");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for IF Name Tag")
cborEncoderResult = cbor_encoder_create_array(&rolesRootMap, &ifArray, 1);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Addding IF Value.");
for (size_t i = 0; i < 1; i++)
{
cborEncoderResult = cbor_encode_text_string(&ifArray, OC_RSRVD_INTERFACE_DEFAULT,
strlen(OC_RSRVD_INTERFACE_DEFAULT));
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Adding IF Value.");
VERIFY_CBOR_NOT_OUTOFMEMORY(TAG, cborEncoderResult, "Not enough memory for IF Value")
}
cborEncoderResult = cbor_encoder_close_container(&rolesRootMap, &ifArray);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed Closing IF.");
// Close roles root map
cborEncoderResult = cbor_encoder_close_container(&encoder, &rolesRootMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborEncoderResult, "Failed closing roles root map");
*cborSize = cbor_encoder_get_buffer_size(&encoder, outPayload);
*cborPayload = outPayload;
exit:
if (CborErrorOutOfMemory == cborEncoderResult)
{
OIC_LOG(DEBUG, TAG, "RolesToCBORPayload:CborErrorOutOfMemory : retry with more memory");
// reallocate and try again!
OICFree(outPayload);
// Since the initially-allocated memory failed, double the memory.
cborLen *= 2;
OIC_LOG_V(DEBUG, TAG, "Roles reallocation size: %" PRIuPTR ".", cborLen);
ret = RolesToCBORPayload(roles, cborPayload, &cborLen);
*cborSize = cborLen;
}
else if (cborEncoderResult != CborNoError)
{
OIC_LOG(ERROR, TAG, "Failed to RolesToCBORPayload");
OICFree(outPayload);
*cborSize = 0;
*cborPayload = NULL;
ret = OC_STACK_ERROR;
}
return ret;
}
/* Caller must call FreeRoleCertChainList on roleEntries when finished. */
OCStackResult CBORPayloadToRoles(const uint8_t *cborPayload, size_t size, RoleCertChain_t **roleEntries)
{
if (NULL == cborPayload || 0 == size || NULL == roleEntries)
{
return OC_STACK_INVALID_PARAM;
}
CborValue rolesCbor = { .parser = NULL };
CborParser parser = { .end = NULL };
CborError cborFindResult = CborNoError;
RoleCertChain_t *headRoleCertChain = NULL;
char* tagName = NULL;
size_t len = 0;
cborFindResult = cbor_parser_init(cborPayload, size, 0, &parser, &rolesCbor);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed to initialize parser.");
if (!cbor_value_is_container(&rolesCbor))
{
return OC_STACK_ERROR;
}
// Enter roles Root Map
CborValue rolesRootMap;
memset(&rolesRootMap, 0, sizeof(rolesRootMap));
cborFindResult = cbor_value_enter_container(&rolesCbor, &rolesRootMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed Entering roles Root Map.");
while (cbor_value_is_valid(&rolesRootMap))
{
if (NULL != tagName)
{
free(tagName);
tagName = NULL;
}
len = 0;
CborType type = cbor_value_get_type(&rolesRootMap);
if (type == CborTextStringType && cbor_value_is_text_string(&rolesRootMap))
{
cborFindResult = cbor_value_dup_text_string(&rolesRootMap, &tagName, &len, NULL);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed finding name in roles Root Map.");
cborFindResult = cbor_value_advance(&rolesRootMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed advancing value in roles Root Map.");
}
else
{
OIC_LOG_V(WARNING, TAG, "Value is not of type string, but of type %x", type);
}
if (NULL != tagName)
{
if (strcmp(tagName, OIC_JSON_ROLES_NAME) == 0)
{
// Enter role array
int roleCount = 0;
RoleCertChain_t *currEntry = NULL;
CborValue roleArray;
memset(&roleArray, 0, sizeof(roleArray));
cborFindResult = cbor_value_enter_container(&rolesRootMap, &roleArray);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed entering role array.");
while (cbor_value_is_valid(&roleArray))
{
roleCount++;
CborValue roleMap;
memset(&roleMap, 0, sizeof(roleMap));
cborFindResult = cbor_value_enter_container(&roleArray, &roleMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed entering role map.");
if (NULL == currEntry)
{
assert(NULL == headRoleCertChain);
headRoleCertChain = currEntry = (RoleCertChain_t *)OICCalloc(1, sizeof(RoleCertChain_t));
VERIFY_NOT_NULL(TAG, currEntry, ERROR);
}
else
{
assert(NULL != headRoleCertChain);
currEntry->next = (RoleCertChain_t *)OICCalloc(1, sizeof(RoleCertChain_t));
VERIFY_NOT_NULL(TAG, currEntry->next, ERROR);
currEntry = currEntry->next;
}
while (cbor_value_is_valid(&roleMap))
{
free(tagName);
tagName = NULL;
CborType innerType = cbor_value_get_type(&roleMap);
if (innerType == CborTextStringType)
{
cborFindResult = cbor_value_dup_text_string(&roleMap, &tagName, &len, NULL);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed finding name in role map.");
cborFindResult = cbor_value_advance(&roleMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed advancing value in role map.");
}
if (NULL != tagName)
{
//credid
if (strcmp(tagName, OIC_JSON_CREDID_NAME) == 0)
{
uint64_t credId64 = 0;
cborFindResult = cbor_value_get_uint64(&roleMap, &credId64);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed retrieving credId.");
if (UINT32_MAX < credId64)
{
cborFindResult = CborUnknownError;
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "credId was too large.");
}
currEntry->credId = (uint32_t)credId64;
}
else if (strcmp(tagName, OIC_JSON_PUBLICDATA_NAME) == 0)
{
cborFindResult = DeserializeEncodingFromCbor(&roleMap, &currEntry->certificate);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed to read publicData");
}
else if (strcmp(tagName, OIC_JSON_CREDTYPE_NAME) == 0)
{
uint64_t credType = 0;
cborFindResult = cbor_value_get_uint64(&roleMap, &credType);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed retrieving credType.");
/* Only SIGNED_ASYMMETRIC_KEY is supported. */
if (SIGNED_ASYMMETRIC_KEY != (OicSecCredType_t)credType)
{
OIC_LOG_V(ERROR, TAG, "Unsupported role credential type: %" PRIu64 , credType);
goto exit;
}
}
// Silently ignore subject field; log anything else.
else if (strcmp(tagName, OIC_JSON_SUBJECTID_NAME) != 0)
{
OIC_LOG_V(WARNING, TAG, "Unknown role map tag: %s", tagName);
}
}
if (cbor_value_is_valid(&roleMap))
{
cborFindResult = cbor_value_advance(&roleMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed advancing role map.");
}
}
if (NULL == currEntry->certificate.data)
{
OIC_LOG(ERROR, TAG, "Role credential did not have publicData");
goto exit;
}
if (cbor_value_is_valid(&roleArray))
{
cborFindResult = cbor_value_advance(&roleArray);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed advancing role array.");
}
}
}
else
{
// Ignore any other tag type for now.
OIC_LOG_V(WARNING, TAG, "Unknown role root map tag %s", tagName);
}
}
if (cbor_value_is_valid(&rolesRootMap))
{
cborFindResult = cbor_value_advance(&rolesRootMap);
VERIFY_CBOR_SUCCESS_OR_OUT_OF_MEMORY(TAG, cborFindResult, "Failed advancing CSR Root Map");
}
}
*roleEntries = headRoleCertChain;
exit:
if (NULL != tagName)
{
free(tagName);
}
if (CborNoError != cborFindResult)
{
if (NULL != headRoleCertChain)
{
FreeRoleCertChainList(headRoleCertChain);
}
return OC_STACK_ERROR;
}
else
{
return OC_STACK_OK;
}
}
static OCEntityHandlerResult HandleGetRequest(OCEntityHandlerRequest *ehRequest)
{
OIC_LOG(DEBUG, TAG, "Roles HandleGetRequest IN");
OCStackResult res = OC_STACK_ERROR;
OCEntityHandlerResult ehRet = OC_EH_ERROR;
size_t size = 0;
uint8_t *payload = NULL;
const RoleCertChain_t *roles = NULL;
uint8_t *publicKey = NULL;
size_t publicKeyLength = 0;
res = GetPeerPublicKey(&ehRequest->devAddr, &publicKey, &publicKeyLength);
// OC_STACK_NO_RESOURCE means that the Peer doesn't have a Public Key.
if ((OC_STACK_OK != res) && (OC_STACK_NO_RESOURCE != res))
{
OIC_LOG_V(ERROR, TAG, "Could not get remote peer's public key: %d", res);
ehRet = OC_EH_ERROR;
goto exit;
}
if (NULL != publicKey)
{
for (const RolesEntry_t *entry = gRoles; NULL != entry; entry = entry->next)
{
if ((entry->publicKeyLength == publicKeyLength) &&
(0 == memcmp(entry->publicKey, publicKey, publicKeyLength)))
{
roles = entry->chains;
break;
}
}
}
// If roles is NULL, we will return success with an empty "roles" array
res = RolesToCBORPayload(roles, &payload, &size);
ehRet = (OC_STACK_OK == res) ? OC_EH_OK : OC_EH_ERROR;
exit:
ehRet = ((SendSRMResponse(ehRequest, ehRet, payload, size)) == OC_STACK_OK) ? OC_EH_OK : OC_EH_ERROR;
OICFree(payload);
OICFree(publicKey);
OIC_LOG(DEBUG, TAG, "Roles HandleGetRequest OUT");
return ehRet;
}
static OCEntityHandlerResult HandlePostRequest(OCEntityHandlerRequest *ehRequest)
{
OCEntityHandlerResult ehRet = OC_EH_ERROR;
uint8_t *pubKey = NULL;
size_t pubKeyLength = 0;
uint8_t *peerPubKey = NULL;
size_t peerPubKeyLen = 0;
OIC_LOG(DEBUG, TAG, "Roles HandlePostRequest IN");
RoleCertChain_t *chains = NULL;
uint8_t *payload = (((OCSecurityPayload*)ehRequest->payload)->securityData);
size_t size = (((OCSecurityPayload*)ehRequest->payload)->payloadSize);
OCStackResult res = GetPeerPublicKey(&ehRequest->devAddr, &peerPubKey, &peerPubKeyLen);
if (OC_STACK_OK != res)
{
OIC_LOG_V(ERROR, TAG, "Could not get peer's public key: %d", res);
ehRet = OC_EH_ERROR;
goto exit;
}
res = CBORPayloadToRoles(payload, size, &chains);
if (OC_STACK_OK == res)
{
RoleCertChain_t *curr;
// Validate the new roles.
for (curr = chains; NULL != curr; curr = curr->next)
{
bool freeData = false;
uint8_t *data = curr->certificate.data;
size_t dataLength = curr->certificate.len;
if ((dataLength > 0) && (data[dataLength - 1] != 0))
{
/* mbedtls_x509_crt_parse requires null terminator */
data = OICMalloc(dataLength + 1);
if (data == NULL)
{
OIC_LOG_V(ERROR, TAG, "%s: OICMalloc failed", __func__);
res = OC_STACK_NO_MEMORY;
break;
}
OIC_LOG(DEBUG, TAG, "Adding null terminator");
memcpy(data, curr->certificate.data, dataLength);
data[dataLength] = 0;
dataLength++;
freeData = true;
}
OCStackResult validationResult = OCInternalIsValidRoleCertificate(data, dataLength,
&pubKey, &pubKeyLength);
if (freeData)
{
OICFree(data);
freeData = false;
}
if (OC_STACK_OK != validationResult)
{
OIC_LOG(ERROR, TAG, "Could not verify certificate is a valid role certificate");
ehRet = OC_EH_ERROR;
break;
}
if ((pubKeyLength != peerPubKeyLen) ||
(0 != memcmp(pubKey, peerPubKey, pubKeyLength)))
{
OIC_LOG(ERROR, TAG, "Peer sent us certificate not for its public key");
ehRet = OC_EH_ERROR;
break;
}
}
// Check if the loop above verified the new roles successfully.
if (NULL != curr)
{
assert(OC_EH_OK != ehRet);
}
else
{
// Store the new roles.
for (curr = chains; NULL != curr; curr = curr->next)
{
if (OC_STACK_OK != AddRoleCertificate(curr, pubKey, pubKeyLength))
{
OIC_LOG(ERROR, TAG, "Could not AddRoleCertificate");
ehRet = OC_EH_ERROR;
break;
}
}
ehRet = OC_EH_OK;
}
}
exit:
ehRet = (SendSRMResponse(ehRequest, ehRet, NULL, 0) == OC_STACK_OK) ? OC_EH_OK : OC_EH_ERROR;
FreeRoleCertChainList(chains);
OICFree(pubKey);
OICFree(peerPubKey);
OIC_LOG(DEBUG, TAG, "Roles HandlePostRequest OUT");
return ehRet;
}
static OCEntityHandlerResult HandleDeleteRequest(OCEntityHandlerRequest *ehRequest)
{
OIC_LOG(DEBUG, TAG, "Roles HandleDeleteRequest IN");
OCEntityHandlerResult ehRet = OC_EH_ERROR;
uint8_t *peerPubKey = NULL;
size_t peerPubKeyLen = 0;
OicParseQueryIter_t parseIter = { .attrPos = NULL };
uint32_t credId = 0;
if (NULL == ehRequest->query)
{
return ehRet;
}
// Parsing REST query to get the credId
ParseQueryIterInit((unsigned char *)ehRequest->query, &parseIter);
while (GetNextQuery(&parseIter))
{
if (strncasecmp((const char *)parseIter.attrPos, OIC_JSON_CREDID_NAME,
parseIter.attrLen) == 0)
{
int ret = sscanf((const char *)parseIter.valPos, "%u", &credId);
if (1 > ret)
{
OIC_LOG_V(ERROR, TAG, "credId was not valid: %s", parseIter.valPos);
ehRet = OC_EH_ERROR;
goto exit;
}
}
else
{
OIC_LOG_V(DEBUG, TAG, "Unexpected in query string: %s=%s", parseIter.attrPos, parseIter.valPos);
}
}
OCStackResult res = GetPeerPublicKey(&ehRequest->devAddr, &peerPubKey, &peerPubKeyLen);
if (OC_STACK_OK != res)
{
OIC_LOG_V(ERROR, TAG, "Could not get peer's public key: %d", res);
ehRet = OC_EH_RESOURCE_DELETED;
goto exit;
}
RolesEntry_t *entry = NULL;
for (entry = gRoles; NULL != entry; entry = entry->next)
{
assert((0 < entry->publicKeyLength) && (NULL != entry->publicKey));
if ((entry->publicKeyLength == peerPubKeyLen) &&
(0 == memcmp(entry->publicKey, peerPubKey, peerPubKeyLen)))
{
break;
}
}
if (NULL == entry)
{
/* No entry for this peer. */
OIC_LOG(WARNING, TAG, "No roles for this peer's public key");
// if no entry, the request is successful by definition
ehRet = OC_EH_RESOURCE_DELETED;
goto exit;
}
InvalidateRoleCache(entry);
if (NULL != entry->chains)
{
RoleCertChain_t *curr1 = NULL;
RoleCertChain_t *curr2 = NULL;
LL_FOREACH_SAFE(entry->chains, curr1, curr2)
{
// credId of zero means delete all creds; we never assign zero as a credId.
if ((0 == credId) || (curr1->credId == credId))
{
LL_DELETE(entry->chains, curr1);
FreeRoleCertChain(curr1);
ehRet = OC_EH_RESOURCE_DELETED;
if (0 != credId)
{
break;
}
}
}
}
else
{
/* No cert chains are present in the entry. */
OIC_LOG(WARNING, TAG, "No cert chains are present in the entry");
/* Request is successful since everything has been removed. */
ehRet = OC_EH_RESOURCE_DELETED;
goto exit;
}
exit:
ehRet = ((SendSRMResponse(ehRequest, ehRet, NULL, 0)) == OC_STACK_OK) ? OC_EH_OK : OC_EH_ERROR;
OIC_LOG(DEBUG, TAG, "Roles HandleDeleteRequest OUT");
OICFree(peerPubKey);
return ehRet;
}
static OCEntityHandlerResult RolesEntityHandler(OCEntityHandlerFlag flag,
OCEntityHandlerRequest * ehRequest,
void* callbackParameter)
{
OCEntityHandlerResult ehRet = OC_EH_ERROR;
OC_UNUSED(callbackParameter);
if (!ehRequest)
{
return OC_EH_ERROR;
}
if (flag & OC_REQUEST_FLAG)
{
OIC_LOG(DEBUG, TAG, "Flag includes OC_REQUEST_FLAG");
switch (ehRequest->method)
{
case OC_REST_GET:
ehRet = HandleGetRequest(ehRequest);
break;
case OC_REST_PUT:
case OC_REST_POST:
ehRet = HandlePostRequest(ehRequest);
break;
case OC_REST_DELETE:
ehRet = HandleDeleteRequest(ehRequest);
break;
default:
ehRet = ((SendSRMResponse(ehRequest, OC_EH_ERROR, NULL, 0)) == OC_STACK_OK) ?
OC_EH_OK : OC_EH_ERROR;
break;
}
}
return ehRet;
}
OCStackResult InitRolesResource(void)
{
OCStackResult res = OCCreateResource(&gRolesHandle,
OIC_RSRC_TYPE_SEC_ROLES,
OC_RSRVD_INTERFACE_DEFAULT,
OIC_RSRC_ROLES_URI,
RolesEntityHandler,
NULL,
OC_SECURE |
OC_DISCOVERABLE);
if (OC_STACK_OK != res)
{
OIC_LOG_V(FATAL, TAG, "Unable to instantiate roles resource: %d", res);
}
return res;
}
OCStackResult DeInitRolesResource(void)
{
OCStackResult res = OCDeleteResource(gRolesHandle);
if (OC_STACK_OK != res)
{
OIC_LOG_V(ERROR, TAG, "Failed to delete roles resource: %d", res);
}
gRolesHandle = NULL;
FreeRolesList(gRoles);
FreeSymmetricRolesList(gSymmetricRoles);
gRoles = NULL;
gSymmetricRoles = NULL;
return res;
}
/*
* true if before < after, false if before >= after
*/
static bool IsBefore(const struct tm *before, const struct tm *after)
{
if (before->tm_year > after->tm_year)
{
return false;
}
if (before->tm_year == after->tm_year)
{
if (before->tm_mon > after->tm_mon)
{
return false;
}
if (before->tm_mon == after->tm_mon)
{
if (before->tm_mday > after->tm_mday)
{
return false;
}
if (before->tm_mday == after->tm_mday)
{
if (before->tm_hour > after->tm_hour)
{
return false;
}
if (before->tm_hour == after->tm_hour)
{
if (before->tm_min > after->tm_min)
{
return false;
}
if (before->tm_min == after->tm_min)
{
return (before->tm_sec < after->tm_sec);
}
}
}
}
}
return true;
}
OCStackResult GetEndpointRoles(const CAEndpoint_t *endpoint, OicSecRole_t **roles, size_t *roleCount)
{
VERIFY_NOT_NULL_RETURN(TAG, endpoint, ERROR, OC_STACK_INVALID_PARAM);
VERIFY_NOT_NULL_RETURN(TAG, roles, ERROR, OC_STACK_INVALID_PARAM);
VERIFY_NOT_NULL_RETURN(TAG, roleCount, ERROR, OC_STACK_INVALID_PARAM);
uint8_t *publicKey = NULL;
size_t publicKeyLength = 0;
RolesEntry_t *targetEntry = NULL;
OicSecRole_t *rolesToReturn = NULL;
size_t rolesToReturnCount = 0;
ByteArrayLL_t trustedCaCerts;
memset(&trustedCaCerts, 0, sizeof(trustedCaCerts));
OCStackResult res = GetPeerPublicKeyFromEndpoint(endpoint, &publicKey, &publicKeyLength);
if ((OC_STACK_INVALID_PARAM == res) || (OC_STACK_NO_RESOURCE == res))
{
/*
* OC_STACK_INVALID_PARAM or OC_STACK_NO_RESOURCE indicate the endpoint didn't authenticate
* with a certificate. Look for a symmetric key-based role and return that if present.
*/
CASecureEndpoint_t sep;
CAResult_t caRes = GetCASecureEndpointData(endpoint, &sep);
if (CA_STATUS_OK != caRes)
{
*roles = NULL;
*roleCount = 0;
return OC_STACK_OK;
}
SymmetricRoleEntry_t *curr = NULL;
LL_FOREACH(gSymmetricRoles, curr)
{
if ((UUID_LENGTH == sep.identity.id_length) &&
(0 == memcmp(curr->subject.id, sep.identity.id, sizeof(curr->subject.id))))
{
*roles = (OicSecRole_t *)OICCalloc(1, sizeof(OicSecRole_t));
if (NULL == *roles)
{
OIC_LOG(ERROR, TAG, "No memory allocating roles for symmetric credential");
return OC_STACK_NO_MEMORY;
}
(*roles)[0] = curr->role;
*roleCount = 1;
return OC_STACK_OK;
}
}
/* No symmetric role found. Return empty list. */
*roles = NULL;
*roleCount = 0;
return OC_STACK_OK;
}
else if (OC_STACK_OK != res)
{
/* Any other error is a fatal error. */
OIC_LOG_V(ERROR, TAG, "Could not GetPeerPublicKeyFromEndpoint: %d", res);
return res;
}
for (targetEntry = gRoles; NULL != targetEntry; targetEntry = targetEntry->next)
{
if ((targetEntry->publicKeyLength == publicKeyLength) &&
(0 == memcmp(targetEntry->publicKey, publicKey, publicKeyLength)))
{
break;
}
}
if (NULL == targetEntry)
{
/* No roles for this peer. */
*roles = NULL;
*roleCount = 0;
OICFree(publicKey);
return OC_STACK_OK;
}
/* Is the cache still valid? */
struct tm now;
memset(&now, 0, sizeof(now));
time_t nowTimeT = 0;
nowTimeT = time(NULL);
/* If we failed to get the current time, assume the cache is valid if present. */
if ((time_t)-1 != nowTimeT)
{
/* gmtime_{s,r} should not ever fail. */
#ifdef HAVE_WINDOWS_H
if (0 != gmtime_s(&now, &nowTimeT))
{
assert(!"gmtime_s failed");
OIC_LOG(WARNING, TAG, "gmtime_s failed; assuming role cache is valid");
memset(&now, 0, sizeof(now));
}
#else
if (NULL == gmtime_r(&nowTimeT, &now))
{
assert(!"gmtime_r failed");
OIC_LOG(WARNING, TAG, "gmtime_r failed; assuming role cache is valid");
memset(&now, 0, sizeof(now));
}
#endif
}
if (IsBefore(&now, &targetEntry->cacheValidUntil))
{
/* now < cacheValidUntil: provide caller with a copy of the cached roles */
*roles = (OicSecRole_t *)OICCalloc(targetEntry->cachedRolesLength, sizeof(OicSecRole_t));
if (NULL == *roles)
{
OICFree(publicKey);
return OC_STACK_NO_MEMORY;
}
memcpy(*roles, targetEntry->cachedRoles, (targetEntry->cachedRolesLength * sizeof(OicSecRole_t)));
*roleCount = targetEntry->cachedRolesLength;
OICFree(publicKey);
return OC_STACK_OK;
}
InvalidateRoleCache(targetEntry);
/* Retrieve the current set of trusted CAs from the cred resource. */
GetCaCert(&trustedCaCerts, TRUST_CA);
if (NULL == trustedCaCerts.cert || 0 == trustedCaCerts.cert->len)
{
OIC_LOG_V(ERROR, TAG, "Could not get CA certs: %d", res);
OICFree(publicKey);
return res;
}
RoleCertChain_t *chain = targetEntry->chains;
while (NULL != chain)
{
RoleCertChain_t *chainToRemove = NULL;
OicSecRole_t *currCertRoles = NULL;
size_t currCertRolesCount = 0;
struct tm notValidAfter;
memset(¬ValidAfter, 0, sizeof(notValidAfter));
res = OCInternalVerifyRoleCertificate(&chain->certificate, &trustedCaCerts, &currCertRoles,
&currCertRolesCount, ¬ValidAfter);
if (OC_STACK_OK != res)
{
OIC_LOG_V(ERROR, TAG, "Failed to verify a role certificate: %d", res);
/* Remove the invalid cert chain, but don't exit; try all certificates presented. */
LL_DELETE(targetEntry->chains, chain);
chainToRemove = chain;
}
else
{
/* Add returned roles to current list. */
OicSecRole_t *savePtr = rolesToReturn;
rolesToReturn = (OicSecRole_t *)OICRealloc(rolesToReturn,
sizeof(rolesToReturn[0]) * (rolesToReturnCount + currCertRolesCount));
if (NULL == rolesToReturn)
{
OIC_LOG(ERROR, TAG, "No memory reallocating rolesToReturn");
memset(&targetEntry->cacheValidUntil, 0, sizeof(targetEntry->cacheValidUntil));
FreeCertChain(&trustedCaCerts);
OICFree(savePtr);
OICFree(currCertRoles);
OICFree(publicKey);
return OC_STACK_NO_MEMORY;
}
memcpy((rolesToReturn + rolesToReturnCount),
currCertRoles,
(currCertRolesCount * sizeof(currCertRoles[0])));
rolesToReturnCount += currCertRolesCount;
OICFree(currCertRoles);
}
/*
* Set the cacheValidUntil value to be the earliest notValidUntil date amongst
* all the certificates.
*
* Assumption is that if tm_year is zero, the cacheValidUntil is all zero, and so the
* cacheValidUntil value hasn't yet been set. tm_year of 0 means the year 1900, and we
* should never see this value in a certificate.
*/
if ((0 == targetEntry->cacheValidUntil.tm_year) ||
IsBefore(¬ValidAfter, &targetEntry->cacheValidUntil))
{
memcpy(&targetEntry->cacheValidUntil, ¬ValidAfter, sizeof(targetEntry->cacheValidUntil));
}
/*
* If the cert chain was invalid it has already been removed from the list.
* We clean it up here so that we can continue checking all of the certificates.
*/
chain = chain->next;
FreeRoleCertChain(chainToRemove);
}
targetEntry->cachedRoles = rolesToReturn;
targetEntry->cachedRolesLength = rolesToReturnCount;
/* Make a copy for the caller. */
*roles = (OicSecRole_t *)OICCalloc(targetEntry->cachedRolesLength, sizeof(OicSecRole_t));
if (NULL == *roles)
{
OICFree(publicKey);
FreeCertChain(&trustedCaCerts);
return OC_STACK_NO_MEMORY;
}
memcpy(*roles, targetEntry->cachedRoles, (targetEntry->cachedRolesLength * sizeof(OicSecRole_t)));
*roleCount = targetEntry->cachedRolesLength;
OICFree(publicKey);
FreeCertChain(&trustedCaCerts);
return OC_STACK_OK;
}
void DeleteRolesCB(const unsigned char *uuid, size_t uuidLen)
{
(void)(uuid);
(void)(uuidLen);
OIC_LOG_V(DEBUG, TAG, "IN %s:", __func__);
if (IsDoxmOwned())
{
FreeRolesList(gRoles);
gRoles = NULL;
OIC_LOG_V(DEBUG, TAG, "%s: done", __func__);
}
OIC_LOG_V(DEBUG, TAG, "OUT %s:", __func__);
}
#endif /* defined(__WITH_DTLS__) || defined(__WITH_TLS__) */
|
the_stack_data/212642701.c | //
// Created by zhangrongxiang on 2017/10/17 15:10
// File p1
//
#include <stdio.h>
int main() {
puts("this is p1 ");
}
|
the_stack_data/7949559.c | int N=100;
int b[100],c[100];
int j;
void foo()
{
#pragma omp parallel for shared(b) firstprivate(c)
for (j=0; j<N; j++)
{
b[j] = c[j];
}
#pragma omp parallel for shared(b) firstprivate(c)
for (j=0; j<N; j++)
{
b[j] = c[j];
}
}
|
the_stack_data/130415.c | /*
* Copyright (c) 2017, 2018, Oracle and/or its affiliates.
*
* All rights reserved.
*
* Redistribution and use in source and binary forms, with or without modification, are
* permitted provided that the following conditions are met:
*
* 1. Redistributions of source code must retain the above copyright notice, this list of
* conditions and the following disclaimer.
*
* 2. Redistributions in binary form must reproduce the above copyright notice, this list of
* conditions and the following disclaimer in the documentation and/or other materials provided
* with the distribution.
*
* 3. Neither the name of the copyright holder nor the names of its contributors may be used to
* endorse or promote products derived from this software without specific prior written
* permission.
*
* THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS IS" AND ANY EXPRESS
* OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF
* MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE
* COPYRIGHT HOLDER OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
* EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE
* GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED
* AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
* NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED
* OF THE POSSIBILITY OF SUCH DAMAGE.
*/
#ifndef __clang__
unsigned long __builtin_subcl(unsigned long, unsigned long, unsigned long, unsigned long *);
#endif
int main(int argc, const char **argv) {
unsigned long carryout, res;
res = __builtin_subcl((unsigned long)0x0, (unsigned long)0x0, 0, &carryout);
if (res != 0x0 || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFF, (unsigned long)0x0, 0, &carryout);
if (res != 0xFFFFFFFFFFFFFFFF || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0x0, (unsigned long)0xFFFFFFFFFFFFFFFF, 0, &carryout);
if (res != 0x01 || carryout != 1) {
return -1;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFF, (unsigned long)0x1, 0, &carryout);
if (res != 0xFFFFFFFFFFFFFFFE || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0x1, (unsigned long)0xFFFFFFFFFFFFFFFF, 0, &carryout);
if (res != 0x2 || carryout != 1) {
return -1;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFF, (unsigned long)0xFFFFFFFFFFFFFFFF, 0, &carryout);
if (res != 0x0 || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0x8FFFFFFFFFFFFFFF, (unsigned long)0x0FFFFFFFFFFFFFFF, 0, &carryout);
if (res != 0x8000000000000000 || carryout != 0) {
return res;
}
res = __builtin_subcl((unsigned long)0x0, (unsigned long)0xFFFFFFFFFFFFFFFE, 1, &carryout);
if (res != 0x1 || carryout != 1) {
return -1;
}
res = __builtin_subcl((unsigned long)0x0, (unsigned long)0xFFFFFFFFFFFFFFFF, 1, &carryout);
if (res != 0x0 || carryout != 1) {
return -1;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFE, (unsigned long)0x0, 1, &carryout);
if (res != 0xFFFFFFFFFFFFFFFD || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFE, (unsigned long)0xFFFFFFFFFFFFFFFE, 1, &carryout);
if (res != 0xFFFFFFFFFFFFFFFF || carryout != 1) {
return res;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFE, (unsigned long)0xFFFFFFFFFFFFFFFF, 0, &carryout);
if (res != 0xFFFFFFFFFFFFFFFF || carryout != 1) {
return res;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFE, (unsigned long)0xFFFFFFFFFFFFFFFF, 1, &carryout);
if (res != 0xFFFFFFFFFFFFFFFE || carryout != 1) {
return res;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFF, (unsigned long)0x0, 1, &carryout);
if (res != 0xFFFFFFFFFFFFFFFE || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0xFFFFFFFFFFFFFFFF, (unsigned long)0xFFFFFFFFFFFFFFFF, 1, &carryout);
if (res != 0xFFFFFFFFFFFFFFFF || carryout != 1) {
return -1;
}
res = __builtin_subcl((unsigned long)0x0F, (unsigned long)0x1, 0, &carryout);
if (res != 0x0E || carryout != 0) {
return -1;
}
res = __builtin_subcl((unsigned long)0x0F, (unsigned long)0x1, 1, &carryout);
if (res != 0x0D || carryout != 0) {
return -1;
}
return 0;
}
|
the_stack_data/9969.c |
void scilab_rt_mean_i2s0_d2(int in00, int in01, int matrixin0[in00][in01],
char* scalarin0,
int out00, int out01, double matrixout0[out00][out01])
{
int i;
int j;
int val0 = 0;
if (scalarin0) {
for (i = 0; i < in00; ++i) {
for (j = 0; j < in01; ++j) {
val0 += matrixin0[i][j];
}
}
for (i = 0; i < out00; ++i) {
for (j = 0; j < out01; ++j) {
matrixout0[i][j] = val0;
}
}
}
}
|
the_stack_data/117353.c | #include <stdio.h>
#include <stdlib.h>
void troca(int i,int j,int *V)
{
int aux;
aux = *(V+i);
*(V+i) = *(V+j);
*(V+j) = aux;
}
int separa(int p, int r, int *V)
{
int *x,i,j;
x = (V+p);
i = p;
j = r;
while (1)
{
while(*(V+j) > *x)
j--;
while(*(V+i) < *x)
i--;
if (i < j){
troca(i, j, V);
}
else
return j;
j--;
i++;
}
}
void quicksort(int p, int r, int *V)
{
int q;
if (p < r){
q = separa(p,r,V);
quicksort(p,q,V);
quicksort(q+1,r,V);
}
}
int soma_balanceada(int n, int *V)
{
int i=0,somacerta=0,correto=1,soma=0;
somacerta = *(V+i) + *(V+(n-1)-i);
for(i=1; i < (n/2); i++){
soma = *(V+i) + *(V+n-1-i);
if (soma == somacerta)
correto++;
}
if (correto == (n/2))
return 1;
else
return -1;
}
int main()
{
int *V,n,i=0,p=0;
scanf("%d",&n);
V = (int *) malloc(n * sizeof(int));
if (V != NULL){
for (i=0; i < n; i++)
scanf("%d",(V+i));
quicksort(p,n-1,V);
if (soma_balanceada(n,V) == 1)
printf("A sequencia eh balanceada\n");
else
printf("A sequencia nao eh balanceada\n");
}
else
printf("Num vai dar nao\n");
return 0;
}
|
the_stack_data/175143861.c | /* ************************************************************************** */
/* */
/* ::: :::::::: */
/* ft_strcat.c :+: :+: :+: */
/* +:+ +:+ +:+ */
/* By: soumanso <[email protected]> +#+ +:+ +#+ */
/* +#+#+#+#+#+ +#+ */
/* Created: 2021/09/03 00:05:27 by soumanso #+# #+# */
/* Updated: 2021/09/03 21:09:13 by soumanso ### ########lyon.fr */
/* */
/* ************************************************************************** */
unsigned int ft_strlen(char *str)
{
int i;
i = 0;
while (str[i])
i += 1;
return (i);
}
char *ft_strcat(char *dest, char *src)
{
unsigned int dest_len;
char *curr;
unsigned int i;
dest_len = ft_strlen (dest);
curr = dest + dest_len;
i = 0;
while (src[i])
{
curr[i] = src[i];
i += 1;
}
curr[i] = 0;
return (dest);
}
|
the_stack_data/237643866.c | /*
* Copyright (c) 1980 Regents of the University of California.
* All rights reserved. The Berkeley software License Agreement
* specifies the terms and conditions for redistribution.
*/
char *message[] = {
"Last update on Friday, November 26, 1999.",
0
};
|
the_stack_data/153268168.c | #include <stdio.h>
int main() {
setbuf(stdout, NULL);
setbuf(stdin, NULL);
setbuf(stderr, NULL);
unsigned int x = 0;
char inp[8];
puts("Ain't you a sweet n00b to be here :P");
gets(inp);
if (x == 0xdeadbeef) {
puts("flag{fake_flag_lol}");
}
} |
the_stack_data/589533.c | a, b, c;
d() {
int e;
while (e) {
if (a)
break;
if (c)
e = f();
if (a < b)
continue;
if (b)
g();
if (a)
g();
if (e == a)
g();
if (a)
e = 0;
}
}
|
the_stack_data/109197.c | #include <stdio.h>
int binary(int start , int end){
if ( start == end ){
return start;
}
if ( start + 1 == end){
return start + end;
}
int left = (end - start + 1) / 2;
return binary(start , start + left) + binary(start + left + 1 , end);
}
int main()
{
int n;
while( scanf("%d" , &n) != EOF ){
printf("%d\n\n" , binary( 1 , n));
}
return 0;
} |
the_stack_data/26360.c | #include <limits.h>
#include <stdbool.h>
#include <stdarg.h>
#include "stdio.h"
#include "string.h"
static bool print(const char* data, size_t length) {
const unsigned char* bytes = (const unsigned char*) data;
for (size_t i = 0; i < length; i++)
if (putchar(bytes[i]) == EOF)
return false;
return true;
}
int printf(const char* restrict format, ...) {
va_list parameters;
va_start(parameters, format);
int written = 0;
while (*format != '\0') {
size_t maxrem = INT_MAX - written;
if (format[0] != '%' || format[1] == '%') {
if (format[0] == '%')
format++;
size_t amount = 1;
while (format[amount] && format[amount] != '%')
amount++;
if (maxrem < amount) {
// TODO: Set errno to EOVERFLOW.
return -1;
}
if (!print(format, amount))
return -1;
format += amount;
written += amount;
continue;
}
const char* format_begun_at = format++;
if (*format == 'c') {
format++;
char c = (char) va_arg(parameters, int /* char promotes to int */);
if (!maxrem) {
// TODO: Set errno to EOVERFLOW.
return -1;
}
if (!print(&c, sizeof(c)))
return -1;
written++;
} else if (*format == 's') {
format++;
const char* str = va_arg(parameters, const char*);
size_t len = strlen(str);
if (maxrem < len) {
// TODO: Set errno to EOVERFLOW.
return -1;
}
if (!print(str, len)) {
return -1;
}
written += len;
} else if (*format == 'd') {
format++;
int d = va_arg(parameters, int);
char buff[16];
size_t len = itoa(d, buff, 10);
if (maxrem < len) {
return -1;
}
if (!print(buff, len))
return -1;
written += len;
} else if (*format == 'x') {
format++;
int d = va_arg(parameters, int);
char buff[16];
size_t len = itoa(d, buff, 16);
if (maxrem < len) {
return -1;
}
if (!print(buff, len))
return -1;
written += len;
} else {
format = format_begun_at;
size_t len = strlen(format);
if (maxrem < len) {
// TODO: Set errno to EOVERFLOW.
return -1;
}
if (!print(format, len))
return -1;
written += len;
format += len;
}
}
va_end(parameters);
return written;
}
|
the_stack_data/248580797.c | #include <stdio.h>
#include <stdbool.h>
#define SIZE 6 //remember to set this number to actual arr size
//Given a list of numbers and a number k, print whether any two numbers from the list add up to k.
bool test(int *arr, int k);
int main()
{
int arr[]={5, 10, 2, 15, 7, 23};
int k = 17; //let's hardcode the k
// int k = 18; //for testing purposes
printf("Does any given numbers sum to %d?\n", k);
printf("%s", test(arr, k) ? "true" : "false");
getchar();//pause
return 0;
}
bool test(int *arr, int k)
{
int i,j; //iteration counters
for( i = 0 ; i < SIZE ; i++ )
{
for( j = 0 ; j < ( SIZE ); j++ )
{
if( arr[i] == ( k - arr[j] ) )
return true;
}
}
return false;
}
|
the_stack_data/1219727.c | ///
void f90_markovstsen_gs_dense_(int* n,
double* Q, int* ldq, double* dQ, int* lddq,
double* pis, int* incp, double* sstart, int* incss,
double* s, int* incs, int* maxiter, double* rtol, int* steps,
int* iter, double* rerror, int* info, void (*callback)(int*,double*));
void f90_markovstsen_gs_csr_(int* n,
double* Q, int* rowptr0, int* colind0, int* nnz0,
double* dQ, int* rowptr1, int* colind1, int* nnz1,
double* pis, int* incp, double* sstart, int* incss,
double* s, int* incs, int* maxiter, double* rtol, int* steps,
int* iter, double* rerror, int* info, void (*callback)(int*,double*));
void f90_markovstsen_gs_csc_(int* n,
double* Q, int* colptr0, int* rowind0, int* nnz0,
double* dQ, int* colptr1, int* rowind1, int* nnz1,
double* pis, int* incp, double* sstart, int* incss,
double* s, int* incs, int* maxiter, double* rtol, int* steps,
int* iter, double* rerror, int* info, void (*callback)(int*,double*));
///
void cc_markovstsen_gs_dense(int n,
double* Q, int ldq, double* dQ, int lddq,
double* pis, int incp, double* sstart, int incss,
double* s, int incs, int maxiter, double rtol, int steps,
int* iter, double* rerror, int* info, void (*callback)(int*,double*)) {
f90_markovstsen_gs_dense_(&n, Q, &ldq, dQ, &lddq, pis, &incp,
sstart, &incss, s, &incs, &maxiter, &rtol, &steps,
iter, rerror, info, callback);
}
void cc_markovstsen_gs_csr(int n,
double* Q, int* rowptr0, int* colind0, int nnz0,
double* dQ, int* rowptr1, int* colind1, int nnz1,
double* pis, int incp, double* sstart, int incss,
double* s, int incs, int maxiter, double rtol, int steps,
int* iter, double* rerror, int* info, void (*callback)(int*,double*)) {
f90_markovstsen_gs_csr_(&n, Q, rowptr0, colind0, &nnz0,
dQ, rowptr1, colind1, &nnz1, pis, &incp,
sstart, &incss, s, &incs, &maxiter, &rtol, &steps,
iter, rerror, info, callback);
}
void cc_markovstsen_gs_csc(int n,
double* Q, int* colptr0, int* rowind0, int nnz0,
double* dQ, int* colptr1, int* rowind1, int nnz1,
double* pis, int incp, double* sstart, int incss,
double* s, int incs, int maxiter, double rtol, int steps,
int* iter, double* rerror, int* info, void (*callback)(int*,double*)) {
f90_markovstsen_gs_csc_(&n, Q, colptr0, rowind0, &nnz0,
dQ, colptr1, rowind1, &nnz1, pis, &incp,
sstart, &incss, s, &incs, &maxiter, &rtol, &steps,
iter, rerror, info, callback);
}
|
the_stack_data/86075268.c | /* Lorenz system animation
* $ cc -Ofast -o lorenz lorenz.c -lm
* $ ./lorenz | mpv --no-correct-pts --fps=60 --fs -
* $ ./lorenz | x264 --fps 60 --frames 3600 -o lorenz.mp4 /dev/stdin
* Ref: https://nullprogram.com/video/?v=lorenz
* Ref: https://nullprogram.com/blog/2017/11/03/
* Ref: https://nullprogram.com/blog/2018/02/15/
* This is free and unencumbered software released into the public domain.
*/
#include <math.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <time.h>
#define N 256
#define W 1920
#define H 1080
#define SCALE 20.0f
#define MAX 128
#define PI 3.1415927f
static unsigned long long u32s;
static unsigned long u32(void)
{
return (u32s = u32s*0xfc5434fdb4a9e74d + 1) >> 32 & 0xffffffff;
}
static float rnd(float min, float max)
{
return ldexpf(u32(), -32)*(max - min) + min;
}
struct v2 { int x, y; };
struct v3 { float x, y, z; };
static struct v2
ortho(struct v3 p, float scale, float az, float el)
{
float x = p.x*cosf(az) - p.y*sinf(az);
float y = p.x*sinf(az) + p.y*cosf(az);
return (struct v2){
roundf(scale*x + W/2),
roundf(scale*(y*sinf(el) + p.z*cosf(el)) + H/2)
};
}
static unsigned char buf[H][W][3];
static void
clear(void)
{
memset(buf, 0, sizeof(buf));
}
static void
point(struct v2 p, long color)
{
if (p.x >= 0 && p.x < W && p.y >= 0 && p.y < H) {
buf[p.y][p.x][0] = color >> 16;
buf[p.y][p.x][1] = color >> 8;
buf[p.y][p.x][2] = color >> 0;
}
}
static void
line(struct v2 a, struct v2 b, long color)
{
int dx = abs(b.x - a.x);
int dy = abs(b.y - a.y);
int sx = b.x < a.x ? -1 : 1;
int sy = b.y < a.y ? -1 : 1;
if (dx > dy) {
int d = 2 * dy - dx;
struct v2 p = {0, a.y};
for (p.x = a.x; p.x != b.x; p.x += sx) {
point(p, color);
if (d > 0) {
p.y += sy;
d -= 2 * dx;
}
d += 2 * dy;
}
} else {
int d = 2 * dx - dy;
struct v2 p = {a.x, 0};
for (p.y = a.y; p.y != b.y; p.y += sy) {
point(p, color);
if (d > 0) {
p.x += sx;
d -= 2 * dy;
}
d += 2 * dx;
}
}
point(b, color);
}
static void
frame(void)
{
#define xstr(s) str(s)
#define str(s) #s
const char header[] = "P6\n" xstr(W) " " xstr(H) "\n255\n";
if (!fwrite(header, sizeof(header) - 1, 1, stdout) ||
!fwrite(buf, sizeof(buf), 1, stdout)) {
exit(1);
}
}
static struct v3
lorenz(struct v3 s)
{
#define SIGMA 10.0f
#define BETA 8.0f/3.0f
#define RHO 28.0f
#define DT 0.004f
#define DX(x, y, z) (SIGMA*(y - x))
#define DY(x, y, z) (x*(RHO - z) - y)
#define DZ(x, y, z) (x*y - BETA*z)
float x = s.x;
float y = s.y;
float z = s.z;
float k1dx = DX(x, y, z);
float k1dy = DY(x, y, z);
float k1dz = DZ(x, y, z);
float k2x = x + k1dx * DT / 2;
float k2y = y + k1dy * DT / 2;
float k2z = z + k1dz * DT / 2;
float k2dx = DX(k2x, k2y, k2z);
float k2dy = DY(k2x, k2y, k2z);
float k2dz = DZ(k2x, k2y, k2z);
float k3x = x + k2dx * DT / 2;
float k3y = y + k2dy * DT / 2;
float k3z = z + k2dz * DT / 2;
float k3dx = DX(k3x, k3y, k3z);
float k3dy = DY(k3x, k3y, k3z);
float k3dz = DZ(k3x, k3y, k3z);
float k4x = x + k3dx * DT;
float k4y = y + k3dy * DT;
float k4z = z + k3dz * DT;
float k4dx = DX(k4x, k4y, k4z);
float k4dy = DY(k4x, k4y, k4z);
float k4dz = DZ(k4x, k4y, k4z);
s.x = x + (k1dx + 2*k2dx + 2*k3dx + k4dx) * DT / 6;
s.y = y + (k1dy + 2*k2dy + 2*k3dy + k4dy) * DT / 6;
s.z = z + (k1dz + 2*k2dz + 2*k3dz + k4dz) * DT / 6;
return s;
};
static struct v3
translate(struct v3 v)
{
v.z -= RHO;
return v;
}
int
main(void)
{
#ifdef _WIN32
int _setmode(int, int);
_setmode(1, 0x8000); /* set stdout to binary mode */
#endif
struct {
long color;
int head, tail;
struct v3 pos[MAX];
} points[N];
u32s = time(0);
for (int i = 0; i < N; i++) {
points[i].color = u32()>>8 | 0x404040;
points[i].head = points[i].tail = 0;
points[i].pos[0].x = rnd(-0.01f, +0.01f) + 25;
points[i].pos[0].y = rnd(-0.01f, +0.01f) + 25;
points[i].pos[0].z = rnd(-0.01f, +0.01f);
}
float az = rnd(-PI, PI);
float elv = rnd(-PI, PI);
for (;;) {
clear();
float el = sinf(elv)*0.5f;
for (int i = 0; i < N; i++) {
int head = (points[i].head + 1)%MAX;
int tail = points[i].tail;
if (head == tail) {
tail = (tail + 1)%MAX;
}
points[i].pos[head] = lorenz(points[i].pos[points[i].head]);
points[i].head = head;
points[i].tail = tail;
for (int j = head; j != tail; j = (j + MAX - 1)%MAX) {
struct v3 h = translate(points[i].pos[j]);
struct v3 t = translate(points[i].pos[(j+MAX-1)%MAX]);
struct v2 a = ortho(h, SCALE, az, el);
struct v2 b = ortho(t, SCALE, az, el);
line(a, b, points[i].color);
}
struct v3 h = translate(points[i].pos[head]);
struct v2 r = ortho(h, SCALE, az, el);
point((struct v2){r.x+1, r.y+0}, points[i].color);
point((struct v2){r.x-1, r.y+0}, points[i].color);
point((struct v2){r.x+0, r.y+1}, points[i].color);
point((struct v2){r.x+0, r.y-1}, points[i].color);
}
frame();
az += 0.0027f;
elv += 0.01f;
}
}
|
the_stack_data/460000.c | /* f2c.h -- Standard Fortran to C header file */
/** barf [ba:rf] 2. "He suggested using FORTRAN, and everybody barfed."
- From The Shogakukan DICTIONARY OF NEW ENGLISH (Second edition) */
#ifndef F2C_INCLUDE
#define F2C_INCLUDE
#include <math.h>
#include <stdlib.h>
#include <string.h>
#include <stdio.h>
#include <complex.h>
#ifdef complex
#undef complex
#endif
#ifdef I
#undef I
#endif
#if defined(_WIN64)
typedef long long BLASLONG;
typedef unsigned long long BLASULONG;
#else
typedef long BLASLONG;
typedef unsigned long BLASULONG;
#endif
#ifdef LAPACK_ILP64
typedef BLASLONG blasint;
#if defined(_WIN64)
#define blasabs(x) llabs(x)
#else
#define blasabs(x) labs(x)
#endif
#else
typedef int blasint;
#define blasabs(x) abs(x)
#endif
typedef blasint integer;
typedef unsigned int uinteger;
typedef char *address;
typedef short int shortint;
typedef float real;
typedef double doublereal;
typedef struct { real r, i; } complex;
typedef struct { doublereal r, i; } doublecomplex;
static inline _Complex float Cf(complex *z) {return z->r + z->i*_Complex_I;}
static inline _Complex double Cd(doublecomplex *z) {return z->r + z->i*_Complex_I;}
static inline _Complex float * _pCf(complex *z) {return (_Complex float*)z;}
static inline _Complex double * _pCd(doublecomplex *z) {return (_Complex double*)z;}
#define pCf(z) (*_pCf(z))
#define pCd(z) (*_pCd(z))
typedef int logical;
typedef short int shortlogical;
typedef char logical1;
typedef char integer1;
#define TRUE_ (1)
#define FALSE_ (0)
/* Extern is for use with -E */
#ifndef Extern
#define Extern extern
#endif
/* I/O stuff */
typedef int flag;
typedef int ftnlen;
typedef int ftnint;
/*external read, write*/
typedef struct
{ flag cierr;
ftnint ciunit;
flag ciend;
char *cifmt;
ftnint cirec;
} cilist;
/*internal read, write*/
typedef struct
{ flag icierr;
char *iciunit;
flag iciend;
char *icifmt;
ftnint icirlen;
ftnint icirnum;
} icilist;
/*open*/
typedef struct
{ flag oerr;
ftnint ounit;
char *ofnm;
ftnlen ofnmlen;
char *osta;
char *oacc;
char *ofm;
ftnint orl;
char *oblnk;
} olist;
/*close*/
typedef struct
{ flag cerr;
ftnint cunit;
char *csta;
} cllist;
/*rewind, backspace, endfile*/
typedef struct
{ flag aerr;
ftnint aunit;
} alist;
/* inquire */
typedef struct
{ flag inerr;
ftnint inunit;
char *infile;
ftnlen infilen;
ftnint *inex; /*parameters in standard's order*/
ftnint *inopen;
ftnint *innum;
ftnint *innamed;
char *inname;
ftnlen innamlen;
char *inacc;
ftnlen inacclen;
char *inseq;
ftnlen inseqlen;
char *indir;
ftnlen indirlen;
char *infmt;
ftnlen infmtlen;
char *inform;
ftnint informlen;
char *inunf;
ftnlen inunflen;
ftnint *inrecl;
ftnint *innrec;
char *inblank;
ftnlen inblanklen;
} inlist;
#define VOID void
union Multitype { /* for multiple entry points */
integer1 g;
shortint h;
integer i;
/* longint j; */
real r;
doublereal d;
complex c;
doublecomplex z;
};
typedef union Multitype Multitype;
struct Vardesc { /* for Namelist */
char *name;
char *addr;
ftnlen *dims;
int type;
};
typedef struct Vardesc Vardesc;
struct Namelist {
char *name;
Vardesc **vars;
int nvars;
};
typedef struct Namelist Namelist;
#define abs(x) ((x) >= 0 ? (x) : -(x))
#define dabs(x) (fabs(x))
#define f2cmin(a,b) ((a) <= (b) ? (a) : (b))
#define f2cmax(a,b) ((a) >= (b) ? (a) : (b))
#define dmin(a,b) (f2cmin(a,b))
#define dmax(a,b) (f2cmax(a,b))
#define bit_test(a,b) ((a) >> (b) & 1)
#define bit_clear(a,b) ((a) & ~((uinteger)1 << (b)))
#define bit_set(a,b) ((a) | ((uinteger)1 << (b)))
#define abort_() { sig_die("Fortran abort routine called", 1); }
#define c_abs(z) (cabsf(Cf(z)))
#define c_cos(R,Z) { pCf(R)=ccos(Cf(Z)); }
#define c_div(c, a, b) {pCf(c) = Cf(a)/Cf(b);}
#define z_div(c, a, b) {pCd(c) = Cd(a)/Cd(b);}
#define c_exp(R, Z) {pCf(R) = cexpf(Cf(Z));}
#define c_log(R, Z) {pCf(R) = clogf(Cf(Z));}
#define c_sin(R, Z) {pCf(R) = csinf(Cf(Z));}
//#define c_sqrt(R, Z) {*(R) = csqrtf(Cf(Z));}
#define c_sqrt(R, Z) {pCf(R) = csqrtf(Cf(Z));}
#define d_abs(x) (fabs(*(x)))
#define d_acos(x) (acos(*(x)))
#define d_asin(x) (asin(*(x)))
#define d_atan(x) (atan(*(x)))
#define d_atn2(x, y) (atan2(*(x),*(y)))
#define d_cnjg(R, Z) { pCd(R) = conj(Cd(Z)); }
#define r_cnjg(R, Z) { pCf(R) = conj(Cf(Z)); }
#define d_cos(x) (cos(*(x)))
#define d_cosh(x) (cosh(*(x)))
#define d_dim(__a, __b) ( *(__a) > *(__b) ? *(__a) - *(__b) : 0.0 )
#define d_exp(x) (exp(*(x)))
#define d_imag(z) (cimag(Cd(z)))
#define r_imag(z) (cimag(Cf(z)))
#define d_int(__x) (*(__x)>0 ? floor(*(__x)) : -floor(- *(__x)))
#define r_int(__x) (*(__x)>0 ? floor(*(__x)) : -floor(- *(__x)))
#define d_lg10(x) ( 0.43429448190325182765 * log(*(x)) )
#define r_lg10(x) ( 0.43429448190325182765 * log(*(x)) )
#define d_log(x) (log(*(x)))
#define d_mod(x, y) (fmod(*(x), *(y)))
#define u_nint(__x) ((__x)>=0 ? floor((__x) + .5) : -floor(.5 - (__x)))
#define d_nint(x) u_nint(*(x))
#define u_sign(__a,__b) ((__b) >= 0 ? ((__a) >= 0 ? (__a) : -(__a)) : -((__a) >= 0 ? (__a) : -(__a)))
#define d_sign(a,b) u_sign(*(a),*(b))
#define r_sign(a,b) u_sign(*(a),*(b))
#define d_sin(x) (sin(*(x)))
#define d_sinh(x) (sinh(*(x)))
#define d_sqrt(x) (sqrt(*(x)))
#define d_tan(x) (tan(*(x)))
#define d_tanh(x) (tanh(*(x)))
#define i_abs(x) abs(*(x))
#define i_dnnt(x) ((integer)u_nint(*(x)))
#define i_len(s, n) (n)
#define i_nint(x) ((integer)u_nint(*(x)))
#define i_sign(a,b) ((integer)u_sign((integer)*(a),(integer)*(b)))
#define pow_dd(ap, bp) ( pow(*(ap), *(bp)))
#define pow_si(B,E) spow_ui(*(B),*(E))
#define pow_ri(B,E) spow_ui(*(B),*(E))
#define pow_di(B,E) dpow_ui(*(B),*(E))
#define pow_zi(p, a, b) {pCd(p) = zpow_ui(Cd(a), *(b));}
#define pow_ci(p, a, b) {pCf(p) = cpow_ui(Cf(a), *(b));}
#define pow_zz(R,A,B) {pCd(R) = cpow(Cd(A),*(B));}
#define s_cat(lpp, rpp, rnp, np, llp) { ftnlen i, nc, ll; char *f__rp, *lp; ll = (llp); lp = (lpp); for(i=0; i < (int)*(np); ++i) { nc = ll; if((rnp)[i] < nc) nc = (rnp)[i]; ll -= nc; f__rp = (rpp)[i]; while(--nc >= 0) *lp++ = *(f__rp)++; } while(--ll >= 0) *lp++ = ' '; }
#define s_cmp(a,b,c,d) ((integer)strncmp((a),(b),f2cmin((c),(d))))
#define s_copy(A,B,C,D) { int __i,__m; for (__i=0, __m=f2cmin((C),(D)); __i<__m && (B)[__i] != 0; ++__i) (A)[__i] = (B)[__i]; }
#define sig_die(s, kill) { exit(1); }
#define s_stop(s, n) {exit(0);}
static char junk[] = "\n@(#)LIBF77 VERSION 19990503\n";
#define z_abs(z) (cabs(Cd(z)))
#define z_exp(R, Z) {pCd(R) = cexp(Cd(Z));}
#define z_sqrt(R, Z) {pCd(R) = csqrt(Cd(Z));}
#define myexit_() break;
#define mycycle() continue;
#define myceiling(w) {ceil(w)}
#define myhuge(w) {HUGE_VAL}
//#define mymaxloc_(w,s,e,n) {if (sizeof(*(w)) == sizeof(double)) dmaxloc_((w),*(s),*(e),n); else dmaxloc_((w),*(s),*(e),n);}
#define mymaxloc(w,s,e,n) {dmaxloc_(w,*(s),*(e),n)}
/* procedure parameter types for -A and -C++ */
#define F2C_proc_par_types 1
#ifdef __cplusplus
typedef logical (*L_fp)(...);
#else
typedef logical (*L_fp)();
#endif
static float spow_ui(float x, integer n) {
float pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static double dpow_ui(double x, integer n) {
double pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static _Complex float cpow_ui(_Complex float x, integer n) {
_Complex float pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static _Complex double zpow_ui(_Complex double x, integer n) {
_Complex double pow=1.0; unsigned long int u;
if(n != 0) {
if(n < 0) n = -n, x = 1/x;
for(u = n; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static integer pow_ii(integer x, integer n) {
integer pow; unsigned long int u;
if (n <= 0) {
if (n == 0 || x == 1) pow = 1;
else if (x != -1) pow = x == 0 ? 1/x : 0;
else n = -n;
}
if ((n > 0) || !(n == 0 || x == 1 || x != -1)) {
u = n;
for(pow = 1; ; ) {
if(u & 01) pow *= x;
if(u >>= 1) x *= x;
else break;
}
}
return pow;
}
static integer dmaxloc_(double *w, integer s, integer e, integer *n)
{
double m; integer i, mi;
for(m=w[s-1], mi=s, i=s+1; i<=e; i++)
if (w[i-1]>m) mi=i ,m=w[i-1];
return mi-s+1;
}
static integer smaxloc_(float *w, integer s, integer e, integer *n)
{
float m; integer i, mi;
for(m=w[s-1], mi=s, i=s+1; i<=e; i++)
if (w[i-1]>m) mi=i ,m=w[i-1];
return mi-s+1;
}
static inline void cdotc_(complex *z, integer *n_, complex *x, integer *incx_, complex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
_Complex float zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conjf(Cf(&x[i])) * Cf(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conjf(Cf(&x[i*incx])) * Cf(&y[i*incy]);
}
}
pCf(z) = zdotc;
}
static inline void zdotc_(doublecomplex *z, integer *n_, doublecomplex *x, integer *incx_, doublecomplex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
_Complex double zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conj(Cd(&x[i])) * Cd(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += conj(Cd(&x[i*incx])) * Cd(&y[i*incy]);
}
}
pCd(z) = zdotc;
}
static inline void cdotu_(complex *z, integer *n_, complex *x, integer *incx_, complex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
_Complex float zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cf(&x[i]) * Cf(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cf(&x[i*incx]) * Cf(&y[i*incy]);
}
}
pCf(z) = zdotc;
}
static inline void zdotu_(doublecomplex *z, integer *n_, doublecomplex *x, integer *incx_, doublecomplex *y, integer *incy_) {
integer n = *n_, incx = *incx_, incy = *incy_, i;
_Complex double zdotc = 0.0;
if (incx == 1 && incy == 1) {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cd(&x[i]) * Cd(&y[i]);
}
} else {
for (i=0;i<n;i++) { /* zdotc = zdotc + dconjg(x(i))* y(i) */
zdotc += Cd(&x[i*incx]) * Cd(&y[i*incy]);
}
}
pCd(z) = zdotc;
}
#endif
/* -- translated by f2c (version 20000121).
You must link the resulting object file with the libraries:
-lf2c -lm (in that order)
*/
/* Table of constant values */
static doublecomplex c_b1 = {1.,0.};
static doublecomplex c_b2 = {0.,0.};
static integer c__1 = 1;
/* > \brief \b ZUNGTSQR */
/* =========== DOCUMENTATION =========== */
/* Online html documentation available at */
/* http://www.netlib.org/lapack/explore-html/ */
/* > \htmlonly */
/* > Download ZUNGTSQR + dependencies */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/zuntsqr
.f"> */
/* > [TGZ]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/zungtsq
r.f"> */
/* > [ZIP]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/zungtsq
r.f"> */
/* > [TXT]</a> */
/* > */
/* Definition: */
/* =========== */
/* SUBROUTINE ZUNGTSQR( M, N, MB, NB, A, LDA, T, LDT, WORK, LWORK, */
/* $ INFO ) */
/* INTEGER INFO, LDA, LDT, LWORK, M, N, MB, NB */
/* COMPLEX*16 A( LDA, * ), T( LDT, * ), WORK( * ) */
/* > \par Purpose: */
/* ============= */
/* > */
/* > \verbatim */
/* > */
/* > ZUNGTSQR generates an M-by-N complex matrix Q_out with orthonormal */
/* > columns, which are the first N columns of a product of comlpex unitary */
/* > matrices of order M which are returned by ZLATSQR */
/* > */
/* > Q_out = first_N_columns_of( Q(1)_in * Q(2)_in * ... * Q(k)_in ). */
/* > */
/* > See the documentation for ZLATSQR. */
/* > \endverbatim */
/* Arguments: */
/* ========== */
/* > \param[in] M */
/* > \verbatim */
/* > M is INTEGER */
/* > The number of rows of the matrix A. M >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in] N */
/* > \verbatim */
/* > N is INTEGER */
/* > The number of columns of the matrix A. M >= N >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in] MB */
/* > \verbatim */
/* > MB is INTEGER */
/* > The row block size used by DLATSQR to return */
/* > arrays A and T. MB > N. */
/* > (Note that if MB > M, then M is used instead of MB */
/* > as the row block size). */
/* > \endverbatim */
/* > */
/* > \param[in] NB */
/* > \verbatim */
/* > NB is INTEGER */
/* > The column block size used by ZLATSQR to return */
/* > arrays A and T. NB >= 1. */
/* > (Note that if NB > N, then N is used instead of NB */
/* > as the column block size). */
/* > \endverbatim */
/* > */
/* > \param[in,out] A */
/* > \verbatim */
/* > A is COMPLEX*16 array, dimension (LDA,N) */
/* > */
/* > On entry: */
/* > */
/* > The elements on and above the diagonal are not accessed. */
/* > The elements below the diagonal represent the unit */
/* > lower-trapezoidal blocked matrix V computed by ZLATSQR */
/* > that defines the input matrices Q_in(k) (ones on the */
/* > diagonal are not stored) (same format as the output A */
/* > below the diagonal in ZLATSQR). */
/* > */
/* > On exit: */
/* > */
/* > The array A contains an M-by-N orthonormal matrix Q_out, */
/* > i.e the columns of A are orthogonal unit vectors. */
/* > \endverbatim */
/* > */
/* > \param[in] LDA */
/* > \verbatim */
/* > LDA is INTEGER */
/* > The leading dimension of the array A. LDA >= f2cmax(1,M). */
/* > \endverbatim */
/* > */
/* > \param[in] T */
/* > \verbatim */
/* > T is COMPLEX*16 array, */
/* > dimension (LDT, N * NIRB) */
/* > where NIRB = Number_of_input_row_blocks */
/* > = MAX( 1, CEIL((M-N)/(MB-N)) ) */
/* > Let NICB = Number_of_input_col_blocks */
/* > = CEIL(N/NB) */
/* > */
/* > The upper-triangular block reflectors used to define the */
/* > input matrices Q_in(k), k=(1:NIRB*NICB). The block */
/* > reflectors are stored in compact form in NIRB block */
/* > reflector sequences. Each of NIRB block reflector sequences */
/* > is stored in a larger NB-by-N column block of T and consists */
/* > of NICB smaller NB-by-NB upper-triangular column blocks. */
/* > (same format as the output T in ZLATSQR). */
/* > \endverbatim */
/* > */
/* > \param[in] LDT */
/* > \verbatim */
/* > LDT is INTEGER */
/* > The leading dimension of the array T. */
/* > LDT >= f2cmax(1,f2cmin(NB1,N)). */
/* > \endverbatim */
/* > */
/* > \param[out] WORK */
/* > \verbatim */
/* > (workspace) COMPLEX*16 array, dimension (MAX(2,LWORK)) */
/* > On exit, if INFO = 0, WORK(1) returns the optimal LWORK. */
/* > \endverbatim */
/* > */
/* > \param[in] LWORK */
/* > \verbatim */
/* > The dimension of the array WORK. LWORK >= (M+NB)*N. */
/* > If LWORK = -1, then a workspace query is assumed. */
/* > The routine only calculates the optimal size of the WORK */
/* > array, returns this value as the first entry of the WORK */
/* > array, and no error message related to LWORK is issued */
/* > by XERBLA. */
/* > \endverbatim */
/* > */
/* > \param[out] INFO */
/* > \verbatim */
/* > INFO is INTEGER */
/* > = 0: successful exit */
/* > < 0: if INFO = -i, the i-th argument had an illegal value */
/* > \endverbatim */
/* > */
/* Authors: */
/* ======== */
/* > \author Univ. of Tennessee */
/* > \author Univ. of California Berkeley */
/* > \author Univ. of Colorado Denver */
/* > \author NAG Ltd. */
/* > \date November 2019 */
/* > \ingroup comlex16OTHERcomputational */
/* > \par Contributors: */
/* ================== */
/* > */
/* > \verbatim */
/* > */
/* > November 2019, Igor Kozachenko, */
/* > Computer Science Division, */
/* > University of California, Berkeley */
/* > */
/* > \endverbatim */
/* ===================================================================== */
/* Subroutine */ int zungtsqr_(integer *m, integer *n, integer *mb, integer *
nb, doublecomplex *a, integer *lda, doublecomplex *t, integer *ldt,
doublecomplex *work, integer *lwork, integer *info)
{
/* System generated locals */
integer a_dim1, a_offset, t_dim1, t_offset, i__1, i__2;
doublecomplex z__1;
/* Local variables */
extern /* Subroutine */ int zlamtsqr_(char *, char *, integer *, integer *
, integer *, integer *, integer *, doublecomplex *, integer *,
doublecomplex *, integer *, doublecomplex *, integer *,
doublecomplex *, integer *, integer *);
integer lworkopt, j, iinfo;
extern /* Subroutine */ int zcopy_(integer *, doublecomplex *, integer *,
doublecomplex *, integer *);
integer lc, lw;
extern /* Subroutine */ int xerbla_(char *, integer *, ftnlen), zlaset_(
char *, integer *, integer *, doublecomplex *, doublecomplex *,
doublecomplex *, integer *);
logical lquery;
integer ldc, nblocal;
/* -- LAPACK computational routine (version 3.9.0) -- */
/* -- LAPACK is a software package provided by Univ. of Tennessee, -- */
/* -- Univ. of California Berkeley, Univ. of Colorado Denver and NAG Ltd..-- */
/* November 2019 */
/* ===================================================================== */
/* Test the input parameters */
/* Parameter adjustments */
a_dim1 = *lda;
a_offset = 1 + a_dim1 * 1;
a -= a_offset;
t_dim1 = *ldt;
t_offset = 1 + t_dim1 * 1;
t -= t_offset;
--work;
/* Function Body */
lquery = *lwork == -1;
*info = 0;
if (*m < 0) {
*info = -1;
} else if (*n < 0 || *m < *n) {
*info = -2;
} else if (*mb <= *n) {
*info = -3;
} else if (*nb < 1) {
*info = -4;
} else if (*lda < f2cmax(1,*m)) {
*info = -6;
} else /* if(complicated condition) */ {
/* Computing MAX */
i__1 = 1, i__2 = f2cmin(*nb,*n);
if (*ldt < f2cmax(i__1,i__2)) {
*info = -8;
} else {
/* Test the input LWORK for the dimension of the array WORK. */
/* This workspace is used to store array C(LDC, N) and WORK(LWORK) */
/* in the call to ZLAMTSQR. See the documentation for ZLAMTSQR. */
if (*lwork < 2 && ! lquery) {
*info = -10;
} else {
/* Set block size for column blocks */
nblocal = f2cmin(*nb,*n);
/* LWORK = -1, then set the size for the array C(LDC,N) */
/* in ZLAMTSQR call and set the optimal size of the work array */
/* WORK(LWORK) in ZLAMTSQR call. */
ldc = *m;
lc = ldc * *n;
lw = *n * nblocal;
lworkopt = lc + lw;
if (*lwork < f2cmax(1,lworkopt) && ! lquery) {
*info = -10;
}
}
}
}
/* Handle error in the input parameters and return workspace query. */
if (*info != 0) {
i__1 = -(*info);
xerbla_("ZUNGTSQR", &i__1, (ftnlen)8);
return 0;
} else if (lquery) {
z__1.r = (doublereal) lworkopt, z__1.i = 0.;
work[1].r = z__1.r, work[1].i = z__1.i;
return 0;
}
/* Quick return if possible */
if (f2cmin(*m,*n) == 0) {
z__1.r = (doublereal) lworkopt, z__1.i = 0.;
work[1].r = z__1.r, work[1].i = z__1.i;
return 0;
}
/* (1) Form explicitly the tall-skinny M-by-N left submatrix Q1_in */
/* of M-by-M orthogonal matrix Q_in, which is implicitly stored in */
/* the subdiagonal part of input array A and in the input array T. */
/* Perform by the following operation using the routine ZLAMTSQR. */
/* Q1_in = Q_in * ( I ), where I is a N-by-N identity matrix, */
/* ( 0 ) 0 is a (M-N)-by-N zero matrix. */
/* (1a) Form M-by-N matrix in the array WORK(1:LDC*N) with ones */
/* on the diagonal and zeros elsewhere. */
zlaset_("F", m, n, &c_b2, &c_b1, &work[1], &ldc);
/* (1b) On input, WORK(1:LDC*N) stores ( I ); */
/* ( 0 ) */
/* On output, WORK(1:LDC*N) stores Q1_in. */
zlamtsqr_("L", "N", m, n, n, mb, &nblocal, &a[a_offset], lda, &t[t_offset]
, ldt, &work[1], &ldc, &work[lc + 1], &lw, &iinfo);
/* (2) Copy the result from the part of the work array (1:M,1:N) */
/* with the leading dimension LDC that starts at WORK(1) into */
/* the output array A(1:M,1:N) column-by-column. */
i__1 = *n;
for (j = 1; j <= i__1; ++j) {
zcopy_(m, &work[(j - 1) * ldc + 1], &c__1, &a[j * a_dim1 + 1], &c__1);
}
z__1.r = (doublereal) lworkopt, z__1.i = 0.;
work[1].r = z__1.r, work[1].i = z__1.i;
return 0;
/* End of ZUNGTSQR */
} /* zungtsqr_ */
|
the_stack_data/25137072.c | #include <float.h>
#include <stdio.h>
#include <stdlib.h>
#include <ctype.h>
#include <string.h>
void exit_with_help()
{
printf(
"Usage: svm-scale [options] data_filename\n"
"options:\n"
"-l lower : x scaling lower limit (default -1)\n"
"-u upper : x scaling upper limit (default +1)\n"
"-y y_lower y_upper : y scaling limits (default: no y scaling)\n"
"-s save_filename : save scaling parameters to save_filename\n"
"-r restore_filename : restore scaling parameters from restore_filename\n"
);
exit(1);
}
char *line = NULL;
int max_line_len = 1024;
double lower=-1.0,upper=1.0,y_lower,y_upper;
int y_scaling = 0;
double *feature_max;
double *feature_min;
double y_max = -DBL_MAX;
double y_min = DBL_MAX;
int max_index;
int min_index;
long int num_nonzeros = 0;
long int new_num_nonzeros = 0;
#define max(x,y) (((x)>(y))?(x):(y))
#define min(x,y) (((x)<(y))?(x):(y))
void output_target(double value);
void output(int index, double value);
char* readline(FILE *input);
int clean_up(FILE *fp_restore, FILE *fp, const char *msg);
int main(int argc,char **argv)
{
int i,index;
FILE *fp, *fp_restore = NULL;
char *save_filename = NULL;
char *restore_filename = NULL;
for(i=1;i<argc;i++)
{
if(argv[i][0] != '-') break;
++i;
switch(argv[i-1][1])
{
case 'l': lower = atof(argv[i]); break;
case 'u': upper = atof(argv[i]); break;
case 'y':
y_lower = atof(argv[i]);
++i;
y_upper = atof(argv[i]);
y_scaling = 1;
break;
case 's': save_filename = argv[i]; break;
case 'r': restore_filename = argv[i]; break;
default:
fprintf(stderr,"unknown option\n");
exit_with_help();
}
}
if(!(upper > lower) || (y_scaling && !(y_upper > y_lower)))
{
fprintf(stderr,"inconsistent lower/upper specification\n");
exit(1);
}
if(restore_filename && save_filename)
{
fprintf(stderr,"cannot use -r and -s simultaneously\n");
exit(1);
}
if(argc != i+1)
exit_with_help();
fp=fopen(argv[i],"r");
if(fp==NULL)
{
fprintf(stderr,"can't open file %s\n", argv[i]);
exit(1);
}
line = (char *) malloc(max_line_len*sizeof(char));
#define SKIP_TARGET\
while(isspace(*p)) ++p;\
while(!isspace(*p)) ++p;
#define SKIP_ELEMENT\
while(*p!=':') ++p;\
++p;\
while(isspace(*p)) ++p;\
while(*p && !isspace(*p)) ++p;
/* assumption: min index of attributes is 1 */
/* pass 1: find out max index of attributes */
max_index = 0;
min_index = 1;
if(restore_filename)
{
int idx, c;
fp_restore = fopen(restore_filename,"r");
if(fp_restore==NULL)
{
fprintf(stderr,"can't open file %s\n", restore_filename);
exit(1);
}
c = fgetc(fp_restore);
if(c == 'y')
{
readline(fp_restore);
readline(fp_restore);
readline(fp_restore);
}
readline(fp_restore);
readline(fp_restore);
while(fscanf(fp_restore,"%d %*f %*f\n",&idx) == 1)
max_index = max(idx,max_index);
rewind(fp_restore);
}
while(readline(fp)!=NULL)
{
char *p=line;
SKIP_TARGET
while(sscanf(p,"%d:%*f",&index)==1)
{
max_index = max(max_index, index);
min_index = min(min_index, index);
SKIP_ELEMENT
num_nonzeros++;
}
}
if(min_index < 1)
fprintf(stderr,
"WARNING: minimal feature index is %d, but indices should start from 1\n", min_index);
rewind(fp);
feature_max = (double *)malloc((max_index+1)* sizeof(double));
feature_min = (double *)malloc((max_index+1)* sizeof(double));
if(feature_max == NULL || feature_min == NULL)
{
fprintf(stderr,"can't allocate enough memory\n");
exit(1);
}
for(i=0;i<=max_index;i++)
{
feature_max[i]=-DBL_MAX;
feature_min[i]=DBL_MAX;
}
/* pass 2: find out min/max value */
while(readline(fp)!=NULL)
{
char *p=line;
int next_index=1;
double target;
double value;
if (sscanf(p,"%lf",&target) != 1)
return clean_up(fp_restore, fp, "ERROR: failed to read labels\n");
y_max = max(y_max,target);
y_min = min(y_min,target);
SKIP_TARGET
while(sscanf(p,"%d:%lf",&index,&value)==2)
{
for(i=next_index;i<index;i++)
{
feature_max[i]=max(feature_max[i],0);
feature_min[i]=min(feature_min[i],0);
}
feature_max[index]=max(feature_max[index],value);
feature_min[index]=min(feature_min[index],value);
SKIP_ELEMENT
next_index=index+1;
}
for(i=next_index;i<=max_index;i++)
{
feature_max[i]=max(feature_max[i],0);
feature_min[i]=min(feature_min[i],0);
}
}
rewind(fp);
/* pass 2.5: save/restore feature_min/feature_max */
if(restore_filename)
{
/* fp_restore rewinded in finding max_index */
int idx, c;
double fmin, fmax;
int next_index = 1;
if((c = fgetc(fp_restore)) == 'y')
{
if(fscanf(fp_restore, "%lf %lf\n", &y_lower, &y_upper) != 2 ||
fscanf(fp_restore, "%lf %lf\n", &y_min, &y_max) != 2)
return clean_up(fp_restore, fp, "ERROR: failed to read scaling parameters\n");
y_scaling = 1;
}
else
ungetc(c, fp_restore);
if (fgetc(fp_restore) == 'x')
{
if(fscanf(fp_restore, "%lf %lf\n", &lower, &upper) != 2)
return clean_up(fp_restore, fp, "ERROR: failed to read scaling parameters\n");
while(fscanf(fp_restore,"%d %lf %lf\n",&idx,&fmin,&fmax)==3)
{
for(i = next_index;i<idx;i++)
if(feature_min[i] != feature_max[i])
fprintf(stderr,
"WARNING: feature index %d appeared in file %s was not seen in the scaling factor file %s.\n",
i, argv[argc-1], restore_filename);
feature_min[idx] = fmin;
feature_max[idx] = fmax;
next_index = idx + 1;
}
for(i=next_index;i<=max_index;i++)
if(feature_min[i] != feature_max[i])
fprintf(stderr,
"WARNING: feature index %d appeared in file %s was not seen in the scaling factor file %s.\n",
i, argv[argc-1], restore_filename);
}
fclose(fp_restore);
}
if(save_filename)
{
FILE *fp_save = fopen(save_filename,"w");
if(fp_save==NULL)
{
fprintf(stderr,"can't open file %s\n", save_filename);
exit(1);
}
if(y_scaling)
{
fprintf(fp_save, "y\n");
fprintf(fp_save, "%.16g %.16g\n", y_lower, y_upper);
fprintf(fp_save, "%.16g %.16g\n", y_min, y_max);
}
fprintf(fp_save, "x\n");
fprintf(fp_save, "%.16g %.16g\n", lower, upper);
for(i=1;i<=max_index;i++)
{
if(feature_min[i]!=feature_max[i])
fprintf(fp_save,"%d %.16g %.16g\n",i,feature_min[i],feature_max[i]);
}
if(min_index < 1)
fprintf(stderr,
"WARNING: scaling factors with indices smaller than 1 are not stored to the file %s.\n", save_filename);
fclose(fp_save);
}
/* pass 3: scale */
while(readline(fp)!=NULL)
{
char *p=line;
int next_index=1;
double target;
double value;
if (sscanf(p,"%lf",&target) != 1)
return clean_up(NULL, fp, "ERROR: failed to read labels\n");
output_target(target);
SKIP_TARGET
while(sscanf(p,"%d:%lf",&index,&value)==2)
{
for(i=next_index;i<index;i++)
output(i,0);
output(index,value);
SKIP_ELEMENT
next_index=index+1;
}
for(i=next_index;i<=max_index;i++)
output(i,0);
printf("\n");
}
if (new_num_nonzeros > num_nonzeros)
fprintf(stderr,
"WARNING: original #nonzeros %ld\n"
" > new #nonzeros %ld\n"
"If feature values are non-negative and sparse, use -l 0 rather than the default -l -1\n",
num_nonzeros, new_num_nonzeros);
free(line);
free(feature_max);
free(feature_min);
fclose(fp);
return 0;
}
char* readline(FILE *input)
{
int len;
if(fgets(line,max_line_len,input) == NULL)
return NULL;
while(strrchr(line,'\n') == NULL)
{
max_line_len *= 2;
line = (char *) realloc(line, max_line_len);
len = (int) strlen(line);
if(fgets(line+len,max_line_len-len,input) == NULL)
break;
}
return line;
}
void output_target(double value)
{
if(y_scaling)
{
if(value == y_min)
value = y_lower;
else if(value == y_max)
value = y_upper;
else value = y_lower + (y_upper-y_lower) *
(value - y_min)/(y_max-y_min);
}
printf("%g ",value);
}
void output(int index, double value)
{
/* skip single-valued attribute */
if(feature_max[index] == feature_min[index])
return;
if(value == feature_min[index])
value = lower;
else if(value == feature_max[index])
value = upper;
else
value = lower + (upper-lower) *
(value-feature_min[index])/
(feature_max[index]-feature_min[index]);
if(value != 0)
{
printf("%d:%g ",index, value);
new_num_nonzeros++;
}
}
int clean_up(FILE *fp_restore, FILE *fp, const char* msg)
{
fprintf(stderr, "%s", msg);
free(line);
free(feature_max);
free(feature_min);
fclose(fp);
if (fp_restore)
fclose(fp_restore);
return -1;
}
|
the_stack_data/321987.c | /* lower: convert c to lower case; ASCII only */
#include <stdio.h>
int lower(int character);
int main(void)
{
printf("%c", lower('G'));
return 0;
}
int lower(int c)
{
if (c >= 'A' && c <= 'Z')
{
return c + 'a' - 'A';
}
else
return c;
} |
the_stack_data/607514.c | /* Autogenerated: 'src/ExtractionOCaml/word_by_word_montgomery' --inline --static --use-value-barrier secp256k1 64 '2^256 - 2^32 - 977' mul square add sub opp from_montgomery to_montgomery nonzero selectznz to_bytes from_bytes one msat divstep divstep_precomp */
/* curve description: secp256k1 */
/* machine_wordsize = 64 (from "64") */
/* requested operations: mul, square, add, sub, opp, from_montgomery, to_montgomery, nonzero, selectznz, to_bytes, from_bytes, one, msat, divstep, divstep_precomp */
/* m = 0xfffffffffffffffffffffffffffffffffffffffffffffffffffffffefffffc2f (from "2^256 - 2^32 - 977") */
/* */
/* NOTE: In addition to the bounds specified above each function, all */
/* functions synthesized for this Montgomery arithmetic require the */
/* input to be strictly less than the prime modulus (m), and also */
/* require the input to be in the unique saturated representation. */
/* All functions also ensure that these two properties are true of */
/* return values. */
/* */
/* Computed values: */
/* eval z = z[0] + (z[1] << 64) + (z[2] << 128) + (z[3] << 192) */
/* bytes_eval z = z[0] + (z[1] << 8) + (z[2] << 16) + (z[3] << 24) + (z[4] << 32) + (z[5] << 40) + (z[6] << 48) + (z[7] << 56) + (z[8] << 64) + (z[9] << 72) + (z[10] << 80) + (z[11] << 88) + (z[12] << 96) + (z[13] << 104) + (z[14] << 112) + (z[15] << 120) + (z[16] << 128) + (z[17] << 136) + (z[18] << 144) + (z[19] << 152) + (z[20] << 160) + (z[21] << 168) + (z[22] << 176) + (z[23] << 184) + (z[24] << 192) + (z[25] << 200) + (z[26] << 208) + (z[27] << 216) + (z[28] << 224) + (z[29] << 232) + (z[30] << 240) + (z[31] << 248) */
/* twos_complement_eval z = let x1 := z[0] + (z[1] << 64) + (z[2] << 128) + (z[3] << 192) in */
/* if x1 & (2^256-1) < 2^255 then x1 & (2^256-1) else (x1 & (2^256-1)) - 2^256 */
#include <stdint.h>
typedef unsigned char fiat_secp256k1_uint1;
typedef signed char fiat_secp256k1_int1;
#if defined(__GNUC__) || defined(__clang__)
# define FIAT_SECP256K1_FIAT_EXTENSION __extension__
# define FIAT_SECP256K1_FIAT_INLINE __inline__
#else
# define FIAT_SECP256K1_FIAT_EXTENSION
# define FIAT_SECP256K1_FIAT_INLINE
#endif
FIAT_SECP256K1_FIAT_EXTENSION typedef signed __int128 fiat_secp256k1_int128;
FIAT_SECP256K1_FIAT_EXTENSION typedef unsigned __int128 fiat_secp256k1_uint128;
/* The type fiat_secp256k1_montgomery_domain_field_element is a field element in the Montgomery domain. */
/* Bounds: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]] */
typedef uint64_t fiat_secp256k1_montgomery_domain_field_element[4];
/* The type fiat_secp256k1_non_montgomery_domain_field_element is a field element NOT in the Montgomery domain. */
/* Bounds: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]] */
typedef uint64_t fiat_secp256k1_non_montgomery_domain_field_element[4];
#if (-1 & 3) != 3
#error "This code only works on a two's complement system"
#endif
#if !defined(FIAT_SECP256K1_NO_ASM) && (defined(__GNUC__) || defined(__clang__))
static __inline__ uint64_t fiat_secp256k1_value_barrier_u64(uint64_t a) {
__asm__("" : "+r"(a) : /* no inputs */);
return a;
}
#else
# define fiat_secp256k1_value_barrier_u64(x) (x)
#endif
/*
* The function fiat_secp256k1_addcarryx_u64 is an addition with carry.
*
* Postconditions:
* out1 = (arg1 + arg2 + arg3) mod 2^64
* out2 = ⌊(arg1 + arg2 + arg3) / 2^64⌋
*
* Input Bounds:
* arg1: [0x0 ~> 0x1]
* arg2: [0x0 ~> 0xffffffffffffffff]
* arg3: [0x0 ~> 0xffffffffffffffff]
* Output Bounds:
* out1: [0x0 ~> 0xffffffffffffffff]
* out2: [0x0 ~> 0x1]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_addcarryx_u64(uint64_t* out1, fiat_secp256k1_uint1* out2, fiat_secp256k1_uint1 arg1, uint64_t arg2, uint64_t arg3) {
fiat_secp256k1_uint128 x1;
uint64_t x2;
fiat_secp256k1_uint1 x3;
x1 = ((arg1 + (fiat_secp256k1_uint128)arg2) + arg3);
x2 = (uint64_t)(x1 & UINT64_C(0xffffffffffffffff));
x3 = (fiat_secp256k1_uint1)(x1 >> 64);
*out1 = x2;
*out2 = x3;
}
/*
* The function fiat_secp256k1_subborrowx_u64 is a subtraction with borrow.
*
* Postconditions:
* out1 = (-arg1 + arg2 + -arg3) mod 2^64
* out2 = -⌊(-arg1 + arg2 + -arg3) / 2^64⌋
*
* Input Bounds:
* arg1: [0x0 ~> 0x1]
* arg2: [0x0 ~> 0xffffffffffffffff]
* arg3: [0x0 ~> 0xffffffffffffffff]
* Output Bounds:
* out1: [0x0 ~> 0xffffffffffffffff]
* out2: [0x0 ~> 0x1]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_subborrowx_u64(uint64_t* out1, fiat_secp256k1_uint1* out2, fiat_secp256k1_uint1 arg1, uint64_t arg2, uint64_t arg3) {
fiat_secp256k1_int128 x1;
fiat_secp256k1_int1 x2;
uint64_t x3;
x1 = ((arg2 - (fiat_secp256k1_int128)arg1) - arg3);
x2 = (fiat_secp256k1_int1)(x1 >> 64);
x3 = (uint64_t)(x1 & UINT64_C(0xffffffffffffffff));
*out1 = x3;
*out2 = (fiat_secp256k1_uint1)(0x0 - x2);
}
/*
* The function fiat_secp256k1_mulx_u64 is a multiplication, returning the full double-width result.
*
* Postconditions:
* out1 = (arg1 * arg2) mod 2^64
* out2 = ⌊arg1 * arg2 / 2^64⌋
*
* Input Bounds:
* arg1: [0x0 ~> 0xffffffffffffffff]
* arg2: [0x0 ~> 0xffffffffffffffff]
* Output Bounds:
* out1: [0x0 ~> 0xffffffffffffffff]
* out2: [0x0 ~> 0xffffffffffffffff]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_mulx_u64(uint64_t* out1, uint64_t* out2, uint64_t arg1, uint64_t arg2) {
fiat_secp256k1_uint128 x1;
uint64_t x2;
uint64_t x3;
x1 = ((fiat_secp256k1_uint128)arg1 * arg2);
x2 = (uint64_t)(x1 & UINT64_C(0xffffffffffffffff));
x3 = (uint64_t)(x1 >> 64);
*out1 = x2;
*out2 = x3;
}
/*
* The function fiat_secp256k1_cmovznz_u64 is a single-word conditional move.
*
* Postconditions:
* out1 = (if arg1 = 0 then arg2 else arg3)
*
* Input Bounds:
* arg1: [0x0 ~> 0x1]
* arg2: [0x0 ~> 0xffffffffffffffff]
* arg3: [0x0 ~> 0xffffffffffffffff]
* Output Bounds:
* out1: [0x0 ~> 0xffffffffffffffff]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_cmovznz_u64(uint64_t* out1, fiat_secp256k1_uint1 arg1, uint64_t arg2, uint64_t arg3) {
fiat_secp256k1_uint1 x1;
uint64_t x2;
uint64_t x3;
x1 = (!(!arg1));
x2 = ((fiat_secp256k1_int1)(0x0 - x1) & UINT64_C(0xffffffffffffffff));
x3 = ((fiat_secp256k1_value_barrier_u64(x2) & arg3) | (fiat_secp256k1_value_barrier_u64((~x2)) & arg2));
*out1 = x3;
}
/*
* The function fiat_secp256k1_mul multiplies two field elements in the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* 0 ≤ eval arg2 < m
* Postconditions:
* eval (from_montgomery out1) mod m = (eval (from_montgomery arg1) * eval (from_montgomery arg2)) mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_mul(fiat_secp256k1_montgomery_domain_field_element out1, const fiat_secp256k1_montgomery_domain_field_element arg1, const fiat_secp256k1_montgomery_domain_field_element arg2) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
uint64_t x5;
uint64_t x6;
uint64_t x7;
uint64_t x8;
uint64_t x9;
uint64_t x10;
uint64_t x11;
uint64_t x12;
uint64_t x13;
fiat_secp256k1_uint1 x14;
uint64_t x15;
fiat_secp256k1_uint1 x16;
uint64_t x17;
fiat_secp256k1_uint1 x18;
uint64_t x19;
uint64_t x20;
uint64_t x21;
uint64_t x22;
uint64_t x23;
uint64_t x24;
uint64_t x25;
uint64_t x26;
uint64_t x27;
uint64_t x28;
uint64_t x29;
uint64_t x30;
fiat_secp256k1_uint1 x31;
uint64_t x32;
fiat_secp256k1_uint1 x33;
uint64_t x34;
fiat_secp256k1_uint1 x35;
uint64_t x36;
uint64_t x37;
fiat_secp256k1_uint1 x38;
uint64_t x39;
fiat_secp256k1_uint1 x40;
uint64_t x41;
fiat_secp256k1_uint1 x42;
uint64_t x43;
fiat_secp256k1_uint1 x44;
uint64_t x45;
fiat_secp256k1_uint1 x46;
uint64_t x47;
uint64_t x48;
uint64_t x49;
uint64_t x50;
uint64_t x51;
uint64_t x52;
uint64_t x53;
uint64_t x54;
uint64_t x55;
fiat_secp256k1_uint1 x56;
uint64_t x57;
fiat_secp256k1_uint1 x58;
uint64_t x59;
fiat_secp256k1_uint1 x60;
uint64_t x61;
uint64_t x62;
fiat_secp256k1_uint1 x63;
uint64_t x64;
fiat_secp256k1_uint1 x65;
uint64_t x66;
fiat_secp256k1_uint1 x67;
uint64_t x68;
fiat_secp256k1_uint1 x69;
uint64_t x70;
fiat_secp256k1_uint1 x71;
uint64_t x72;
uint64_t x73;
uint64_t x74;
uint64_t x75;
uint64_t x76;
uint64_t x77;
uint64_t x78;
uint64_t x79;
uint64_t x80;
uint64_t x81;
uint64_t x82;
fiat_secp256k1_uint1 x83;
uint64_t x84;
fiat_secp256k1_uint1 x85;
uint64_t x86;
fiat_secp256k1_uint1 x87;
uint64_t x88;
uint64_t x89;
fiat_secp256k1_uint1 x90;
uint64_t x91;
fiat_secp256k1_uint1 x92;
uint64_t x93;
fiat_secp256k1_uint1 x94;
uint64_t x95;
fiat_secp256k1_uint1 x96;
uint64_t x97;
fiat_secp256k1_uint1 x98;
uint64_t x99;
uint64_t x100;
uint64_t x101;
uint64_t x102;
uint64_t x103;
uint64_t x104;
uint64_t x105;
uint64_t x106;
uint64_t x107;
uint64_t x108;
fiat_secp256k1_uint1 x109;
uint64_t x110;
fiat_secp256k1_uint1 x111;
uint64_t x112;
fiat_secp256k1_uint1 x113;
uint64_t x114;
uint64_t x115;
fiat_secp256k1_uint1 x116;
uint64_t x117;
fiat_secp256k1_uint1 x118;
uint64_t x119;
fiat_secp256k1_uint1 x120;
uint64_t x121;
fiat_secp256k1_uint1 x122;
uint64_t x123;
fiat_secp256k1_uint1 x124;
uint64_t x125;
uint64_t x126;
uint64_t x127;
uint64_t x128;
uint64_t x129;
uint64_t x130;
uint64_t x131;
uint64_t x132;
uint64_t x133;
uint64_t x134;
uint64_t x135;
fiat_secp256k1_uint1 x136;
uint64_t x137;
fiat_secp256k1_uint1 x138;
uint64_t x139;
fiat_secp256k1_uint1 x140;
uint64_t x141;
uint64_t x142;
fiat_secp256k1_uint1 x143;
uint64_t x144;
fiat_secp256k1_uint1 x145;
uint64_t x146;
fiat_secp256k1_uint1 x147;
uint64_t x148;
fiat_secp256k1_uint1 x149;
uint64_t x150;
fiat_secp256k1_uint1 x151;
uint64_t x152;
uint64_t x153;
uint64_t x154;
uint64_t x155;
uint64_t x156;
uint64_t x157;
uint64_t x158;
uint64_t x159;
uint64_t x160;
uint64_t x161;
fiat_secp256k1_uint1 x162;
uint64_t x163;
fiat_secp256k1_uint1 x164;
uint64_t x165;
fiat_secp256k1_uint1 x166;
uint64_t x167;
uint64_t x168;
fiat_secp256k1_uint1 x169;
uint64_t x170;
fiat_secp256k1_uint1 x171;
uint64_t x172;
fiat_secp256k1_uint1 x173;
uint64_t x174;
fiat_secp256k1_uint1 x175;
uint64_t x176;
fiat_secp256k1_uint1 x177;
uint64_t x178;
uint64_t x179;
uint64_t x180;
uint64_t x181;
uint64_t x182;
uint64_t x183;
uint64_t x184;
uint64_t x185;
uint64_t x186;
uint64_t x187;
uint64_t x188;
fiat_secp256k1_uint1 x189;
uint64_t x190;
fiat_secp256k1_uint1 x191;
uint64_t x192;
fiat_secp256k1_uint1 x193;
uint64_t x194;
uint64_t x195;
fiat_secp256k1_uint1 x196;
uint64_t x197;
fiat_secp256k1_uint1 x198;
uint64_t x199;
fiat_secp256k1_uint1 x200;
uint64_t x201;
fiat_secp256k1_uint1 x202;
uint64_t x203;
fiat_secp256k1_uint1 x204;
uint64_t x205;
uint64_t x206;
fiat_secp256k1_uint1 x207;
uint64_t x208;
fiat_secp256k1_uint1 x209;
uint64_t x210;
fiat_secp256k1_uint1 x211;
uint64_t x212;
fiat_secp256k1_uint1 x213;
uint64_t x214;
fiat_secp256k1_uint1 x215;
uint64_t x216;
uint64_t x217;
uint64_t x218;
uint64_t x219;
x1 = (arg1[1]);
x2 = (arg1[2]);
x3 = (arg1[3]);
x4 = (arg1[0]);
fiat_secp256k1_mulx_u64(&x5, &x6, x4, (arg2[3]));
fiat_secp256k1_mulx_u64(&x7, &x8, x4, (arg2[2]));
fiat_secp256k1_mulx_u64(&x9, &x10, x4, (arg2[1]));
fiat_secp256k1_mulx_u64(&x11, &x12, x4, (arg2[0]));
fiat_secp256k1_addcarryx_u64(&x13, &x14, 0x0, x12, x9);
fiat_secp256k1_addcarryx_u64(&x15, &x16, x14, x10, x7);
fiat_secp256k1_addcarryx_u64(&x17, &x18, x16, x8, x5);
x19 = (x18 + x6);
fiat_secp256k1_mulx_u64(&x20, &x21, x11, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x22, &x23, x20, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x24, &x25, x20, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x26, &x27, x20, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x28, &x29, x20, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x30, &x31, 0x0, x29, x26);
fiat_secp256k1_addcarryx_u64(&x32, &x33, x31, x27, x24);
fiat_secp256k1_addcarryx_u64(&x34, &x35, x33, x25, x22);
x36 = (x35 + x23);
fiat_secp256k1_addcarryx_u64(&x37, &x38, 0x0, x11, x28);
fiat_secp256k1_addcarryx_u64(&x39, &x40, x38, x13, x30);
fiat_secp256k1_addcarryx_u64(&x41, &x42, x40, x15, x32);
fiat_secp256k1_addcarryx_u64(&x43, &x44, x42, x17, x34);
fiat_secp256k1_addcarryx_u64(&x45, &x46, x44, x19, x36);
fiat_secp256k1_mulx_u64(&x47, &x48, x1, (arg2[3]));
fiat_secp256k1_mulx_u64(&x49, &x50, x1, (arg2[2]));
fiat_secp256k1_mulx_u64(&x51, &x52, x1, (arg2[1]));
fiat_secp256k1_mulx_u64(&x53, &x54, x1, (arg2[0]));
fiat_secp256k1_addcarryx_u64(&x55, &x56, 0x0, x54, x51);
fiat_secp256k1_addcarryx_u64(&x57, &x58, x56, x52, x49);
fiat_secp256k1_addcarryx_u64(&x59, &x60, x58, x50, x47);
x61 = (x60 + x48);
fiat_secp256k1_addcarryx_u64(&x62, &x63, 0x0, x39, x53);
fiat_secp256k1_addcarryx_u64(&x64, &x65, x63, x41, x55);
fiat_secp256k1_addcarryx_u64(&x66, &x67, x65, x43, x57);
fiat_secp256k1_addcarryx_u64(&x68, &x69, x67, x45, x59);
fiat_secp256k1_addcarryx_u64(&x70, &x71, x69, x46, x61);
fiat_secp256k1_mulx_u64(&x72, &x73, x62, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x74, &x75, x72, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x76, &x77, x72, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x78, &x79, x72, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x80, &x81, x72, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x82, &x83, 0x0, x81, x78);
fiat_secp256k1_addcarryx_u64(&x84, &x85, x83, x79, x76);
fiat_secp256k1_addcarryx_u64(&x86, &x87, x85, x77, x74);
x88 = (x87 + x75);
fiat_secp256k1_addcarryx_u64(&x89, &x90, 0x0, x62, x80);
fiat_secp256k1_addcarryx_u64(&x91, &x92, x90, x64, x82);
fiat_secp256k1_addcarryx_u64(&x93, &x94, x92, x66, x84);
fiat_secp256k1_addcarryx_u64(&x95, &x96, x94, x68, x86);
fiat_secp256k1_addcarryx_u64(&x97, &x98, x96, x70, x88);
x99 = ((uint64_t)x98 + x71);
fiat_secp256k1_mulx_u64(&x100, &x101, x2, (arg2[3]));
fiat_secp256k1_mulx_u64(&x102, &x103, x2, (arg2[2]));
fiat_secp256k1_mulx_u64(&x104, &x105, x2, (arg2[1]));
fiat_secp256k1_mulx_u64(&x106, &x107, x2, (arg2[0]));
fiat_secp256k1_addcarryx_u64(&x108, &x109, 0x0, x107, x104);
fiat_secp256k1_addcarryx_u64(&x110, &x111, x109, x105, x102);
fiat_secp256k1_addcarryx_u64(&x112, &x113, x111, x103, x100);
x114 = (x113 + x101);
fiat_secp256k1_addcarryx_u64(&x115, &x116, 0x0, x91, x106);
fiat_secp256k1_addcarryx_u64(&x117, &x118, x116, x93, x108);
fiat_secp256k1_addcarryx_u64(&x119, &x120, x118, x95, x110);
fiat_secp256k1_addcarryx_u64(&x121, &x122, x120, x97, x112);
fiat_secp256k1_addcarryx_u64(&x123, &x124, x122, x99, x114);
fiat_secp256k1_mulx_u64(&x125, &x126, x115, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x127, &x128, x125, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x129, &x130, x125, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x131, &x132, x125, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x133, &x134, x125, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x135, &x136, 0x0, x134, x131);
fiat_secp256k1_addcarryx_u64(&x137, &x138, x136, x132, x129);
fiat_secp256k1_addcarryx_u64(&x139, &x140, x138, x130, x127);
x141 = (x140 + x128);
fiat_secp256k1_addcarryx_u64(&x142, &x143, 0x0, x115, x133);
fiat_secp256k1_addcarryx_u64(&x144, &x145, x143, x117, x135);
fiat_secp256k1_addcarryx_u64(&x146, &x147, x145, x119, x137);
fiat_secp256k1_addcarryx_u64(&x148, &x149, x147, x121, x139);
fiat_secp256k1_addcarryx_u64(&x150, &x151, x149, x123, x141);
x152 = ((uint64_t)x151 + x124);
fiat_secp256k1_mulx_u64(&x153, &x154, x3, (arg2[3]));
fiat_secp256k1_mulx_u64(&x155, &x156, x3, (arg2[2]));
fiat_secp256k1_mulx_u64(&x157, &x158, x3, (arg2[1]));
fiat_secp256k1_mulx_u64(&x159, &x160, x3, (arg2[0]));
fiat_secp256k1_addcarryx_u64(&x161, &x162, 0x0, x160, x157);
fiat_secp256k1_addcarryx_u64(&x163, &x164, x162, x158, x155);
fiat_secp256k1_addcarryx_u64(&x165, &x166, x164, x156, x153);
x167 = (x166 + x154);
fiat_secp256k1_addcarryx_u64(&x168, &x169, 0x0, x144, x159);
fiat_secp256k1_addcarryx_u64(&x170, &x171, x169, x146, x161);
fiat_secp256k1_addcarryx_u64(&x172, &x173, x171, x148, x163);
fiat_secp256k1_addcarryx_u64(&x174, &x175, x173, x150, x165);
fiat_secp256k1_addcarryx_u64(&x176, &x177, x175, x152, x167);
fiat_secp256k1_mulx_u64(&x178, &x179, x168, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x180, &x181, x178, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x182, &x183, x178, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x184, &x185, x178, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x186, &x187, x178, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x188, &x189, 0x0, x187, x184);
fiat_secp256k1_addcarryx_u64(&x190, &x191, x189, x185, x182);
fiat_secp256k1_addcarryx_u64(&x192, &x193, x191, x183, x180);
x194 = (x193 + x181);
fiat_secp256k1_addcarryx_u64(&x195, &x196, 0x0, x168, x186);
fiat_secp256k1_addcarryx_u64(&x197, &x198, x196, x170, x188);
fiat_secp256k1_addcarryx_u64(&x199, &x200, x198, x172, x190);
fiat_secp256k1_addcarryx_u64(&x201, &x202, x200, x174, x192);
fiat_secp256k1_addcarryx_u64(&x203, &x204, x202, x176, x194);
x205 = ((uint64_t)x204 + x177);
fiat_secp256k1_subborrowx_u64(&x206, &x207, 0x0, x197, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x208, &x209, x207, x199, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x210, &x211, x209, x201, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x212, &x213, x211, x203, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x214, &x215, x213, x205, 0x0);
fiat_secp256k1_cmovznz_u64(&x216, x215, x206, x197);
fiat_secp256k1_cmovznz_u64(&x217, x215, x208, x199);
fiat_secp256k1_cmovznz_u64(&x218, x215, x210, x201);
fiat_secp256k1_cmovznz_u64(&x219, x215, x212, x203);
out1[0] = x216;
out1[1] = x217;
out1[2] = x218;
out1[3] = x219;
}
/*
* The function fiat_secp256k1_square squares a field element in the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* Postconditions:
* eval (from_montgomery out1) mod m = (eval (from_montgomery arg1) * eval (from_montgomery arg1)) mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_square(fiat_secp256k1_montgomery_domain_field_element out1, const fiat_secp256k1_montgomery_domain_field_element arg1) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
uint64_t x5;
uint64_t x6;
uint64_t x7;
uint64_t x8;
uint64_t x9;
uint64_t x10;
uint64_t x11;
uint64_t x12;
uint64_t x13;
fiat_secp256k1_uint1 x14;
uint64_t x15;
fiat_secp256k1_uint1 x16;
uint64_t x17;
fiat_secp256k1_uint1 x18;
uint64_t x19;
uint64_t x20;
uint64_t x21;
uint64_t x22;
uint64_t x23;
uint64_t x24;
uint64_t x25;
uint64_t x26;
uint64_t x27;
uint64_t x28;
uint64_t x29;
uint64_t x30;
fiat_secp256k1_uint1 x31;
uint64_t x32;
fiat_secp256k1_uint1 x33;
uint64_t x34;
fiat_secp256k1_uint1 x35;
uint64_t x36;
uint64_t x37;
fiat_secp256k1_uint1 x38;
uint64_t x39;
fiat_secp256k1_uint1 x40;
uint64_t x41;
fiat_secp256k1_uint1 x42;
uint64_t x43;
fiat_secp256k1_uint1 x44;
uint64_t x45;
fiat_secp256k1_uint1 x46;
uint64_t x47;
uint64_t x48;
uint64_t x49;
uint64_t x50;
uint64_t x51;
uint64_t x52;
uint64_t x53;
uint64_t x54;
uint64_t x55;
fiat_secp256k1_uint1 x56;
uint64_t x57;
fiat_secp256k1_uint1 x58;
uint64_t x59;
fiat_secp256k1_uint1 x60;
uint64_t x61;
uint64_t x62;
fiat_secp256k1_uint1 x63;
uint64_t x64;
fiat_secp256k1_uint1 x65;
uint64_t x66;
fiat_secp256k1_uint1 x67;
uint64_t x68;
fiat_secp256k1_uint1 x69;
uint64_t x70;
fiat_secp256k1_uint1 x71;
uint64_t x72;
uint64_t x73;
uint64_t x74;
uint64_t x75;
uint64_t x76;
uint64_t x77;
uint64_t x78;
uint64_t x79;
uint64_t x80;
uint64_t x81;
uint64_t x82;
fiat_secp256k1_uint1 x83;
uint64_t x84;
fiat_secp256k1_uint1 x85;
uint64_t x86;
fiat_secp256k1_uint1 x87;
uint64_t x88;
uint64_t x89;
fiat_secp256k1_uint1 x90;
uint64_t x91;
fiat_secp256k1_uint1 x92;
uint64_t x93;
fiat_secp256k1_uint1 x94;
uint64_t x95;
fiat_secp256k1_uint1 x96;
uint64_t x97;
fiat_secp256k1_uint1 x98;
uint64_t x99;
uint64_t x100;
uint64_t x101;
uint64_t x102;
uint64_t x103;
uint64_t x104;
uint64_t x105;
uint64_t x106;
uint64_t x107;
uint64_t x108;
fiat_secp256k1_uint1 x109;
uint64_t x110;
fiat_secp256k1_uint1 x111;
uint64_t x112;
fiat_secp256k1_uint1 x113;
uint64_t x114;
uint64_t x115;
fiat_secp256k1_uint1 x116;
uint64_t x117;
fiat_secp256k1_uint1 x118;
uint64_t x119;
fiat_secp256k1_uint1 x120;
uint64_t x121;
fiat_secp256k1_uint1 x122;
uint64_t x123;
fiat_secp256k1_uint1 x124;
uint64_t x125;
uint64_t x126;
uint64_t x127;
uint64_t x128;
uint64_t x129;
uint64_t x130;
uint64_t x131;
uint64_t x132;
uint64_t x133;
uint64_t x134;
uint64_t x135;
fiat_secp256k1_uint1 x136;
uint64_t x137;
fiat_secp256k1_uint1 x138;
uint64_t x139;
fiat_secp256k1_uint1 x140;
uint64_t x141;
uint64_t x142;
fiat_secp256k1_uint1 x143;
uint64_t x144;
fiat_secp256k1_uint1 x145;
uint64_t x146;
fiat_secp256k1_uint1 x147;
uint64_t x148;
fiat_secp256k1_uint1 x149;
uint64_t x150;
fiat_secp256k1_uint1 x151;
uint64_t x152;
uint64_t x153;
uint64_t x154;
uint64_t x155;
uint64_t x156;
uint64_t x157;
uint64_t x158;
uint64_t x159;
uint64_t x160;
uint64_t x161;
fiat_secp256k1_uint1 x162;
uint64_t x163;
fiat_secp256k1_uint1 x164;
uint64_t x165;
fiat_secp256k1_uint1 x166;
uint64_t x167;
uint64_t x168;
fiat_secp256k1_uint1 x169;
uint64_t x170;
fiat_secp256k1_uint1 x171;
uint64_t x172;
fiat_secp256k1_uint1 x173;
uint64_t x174;
fiat_secp256k1_uint1 x175;
uint64_t x176;
fiat_secp256k1_uint1 x177;
uint64_t x178;
uint64_t x179;
uint64_t x180;
uint64_t x181;
uint64_t x182;
uint64_t x183;
uint64_t x184;
uint64_t x185;
uint64_t x186;
uint64_t x187;
uint64_t x188;
fiat_secp256k1_uint1 x189;
uint64_t x190;
fiat_secp256k1_uint1 x191;
uint64_t x192;
fiat_secp256k1_uint1 x193;
uint64_t x194;
uint64_t x195;
fiat_secp256k1_uint1 x196;
uint64_t x197;
fiat_secp256k1_uint1 x198;
uint64_t x199;
fiat_secp256k1_uint1 x200;
uint64_t x201;
fiat_secp256k1_uint1 x202;
uint64_t x203;
fiat_secp256k1_uint1 x204;
uint64_t x205;
uint64_t x206;
fiat_secp256k1_uint1 x207;
uint64_t x208;
fiat_secp256k1_uint1 x209;
uint64_t x210;
fiat_secp256k1_uint1 x211;
uint64_t x212;
fiat_secp256k1_uint1 x213;
uint64_t x214;
fiat_secp256k1_uint1 x215;
uint64_t x216;
uint64_t x217;
uint64_t x218;
uint64_t x219;
x1 = (arg1[1]);
x2 = (arg1[2]);
x3 = (arg1[3]);
x4 = (arg1[0]);
fiat_secp256k1_mulx_u64(&x5, &x6, x4, (arg1[3]));
fiat_secp256k1_mulx_u64(&x7, &x8, x4, (arg1[2]));
fiat_secp256k1_mulx_u64(&x9, &x10, x4, (arg1[1]));
fiat_secp256k1_mulx_u64(&x11, &x12, x4, (arg1[0]));
fiat_secp256k1_addcarryx_u64(&x13, &x14, 0x0, x12, x9);
fiat_secp256k1_addcarryx_u64(&x15, &x16, x14, x10, x7);
fiat_secp256k1_addcarryx_u64(&x17, &x18, x16, x8, x5);
x19 = (x18 + x6);
fiat_secp256k1_mulx_u64(&x20, &x21, x11, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x22, &x23, x20, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x24, &x25, x20, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x26, &x27, x20, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x28, &x29, x20, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x30, &x31, 0x0, x29, x26);
fiat_secp256k1_addcarryx_u64(&x32, &x33, x31, x27, x24);
fiat_secp256k1_addcarryx_u64(&x34, &x35, x33, x25, x22);
x36 = (x35 + x23);
fiat_secp256k1_addcarryx_u64(&x37, &x38, 0x0, x11, x28);
fiat_secp256k1_addcarryx_u64(&x39, &x40, x38, x13, x30);
fiat_secp256k1_addcarryx_u64(&x41, &x42, x40, x15, x32);
fiat_secp256k1_addcarryx_u64(&x43, &x44, x42, x17, x34);
fiat_secp256k1_addcarryx_u64(&x45, &x46, x44, x19, x36);
fiat_secp256k1_mulx_u64(&x47, &x48, x1, (arg1[3]));
fiat_secp256k1_mulx_u64(&x49, &x50, x1, (arg1[2]));
fiat_secp256k1_mulx_u64(&x51, &x52, x1, (arg1[1]));
fiat_secp256k1_mulx_u64(&x53, &x54, x1, (arg1[0]));
fiat_secp256k1_addcarryx_u64(&x55, &x56, 0x0, x54, x51);
fiat_secp256k1_addcarryx_u64(&x57, &x58, x56, x52, x49);
fiat_secp256k1_addcarryx_u64(&x59, &x60, x58, x50, x47);
x61 = (x60 + x48);
fiat_secp256k1_addcarryx_u64(&x62, &x63, 0x0, x39, x53);
fiat_secp256k1_addcarryx_u64(&x64, &x65, x63, x41, x55);
fiat_secp256k1_addcarryx_u64(&x66, &x67, x65, x43, x57);
fiat_secp256k1_addcarryx_u64(&x68, &x69, x67, x45, x59);
fiat_secp256k1_addcarryx_u64(&x70, &x71, x69, x46, x61);
fiat_secp256k1_mulx_u64(&x72, &x73, x62, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x74, &x75, x72, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x76, &x77, x72, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x78, &x79, x72, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x80, &x81, x72, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x82, &x83, 0x0, x81, x78);
fiat_secp256k1_addcarryx_u64(&x84, &x85, x83, x79, x76);
fiat_secp256k1_addcarryx_u64(&x86, &x87, x85, x77, x74);
x88 = (x87 + x75);
fiat_secp256k1_addcarryx_u64(&x89, &x90, 0x0, x62, x80);
fiat_secp256k1_addcarryx_u64(&x91, &x92, x90, x64, x82);
fiat_secp256k1_addcarryx_u64(&x93, &x94, x92, x66, x84);
fiat_secp256k1_addcarryx_u64(&x95, &x96, x94, x68, x86);
fiat_secp256k1_addcarryx_u64(&x97, &x98, x96, x70, x88);
x99 = ((uint64_t)x98 + x71);
fiat_secp256k1_mulx_u64(&x100, &x101, x2, (arg1[3]));
fiat_secp256k1_mulx_u64(&x102, &x103, x2, (arg1[2]));
fiat_secp256k1_mulx_u64(&x104, &x105, x2, (arg1[1]));
fiat_secp256k1_mulx_u64(&x106, &x107, x2, (arg1[0]));
fiat_secp256k1_addcarryx_u64(&x108, &x109, 0x0, x107, x104);
fiat_secp256k1_addcarryx_u64(&x110, &x111, x109, x105, x102);
fiat_secp256k1_addcarryx_u64(&x112, &x113, x111, x103, x100);
x114 = (x113 + x101);
fiat_secp256k1_addcarryx_u64(&x115, &x116, 0x0, x91, x106);
fiat_secp256k1_addcarryx_u64(&x117, &x118, x116, x93, x108);
fiat_secp256k1_addcarryx_u64(&x119, &x120, x118, x95, x110);
fiat_secp256k1_addcarryx_u64(&x121, &x122, x120, x97, x112);
fiat_secp256k1_addcarryx_u64(&x123, &x124, x122, x99, x114);
fiat_secp256k1_mulx_u64(&x125, &x126, x115, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x127, &x128, x125, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x129, &x130, x125, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x131, &x132, x125, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x133, &x134, x125, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x135, &x136, 0x0, x134, x131);
fiat_secp256k1_addcarryx_u64(&x137, &x138, x136, x132, x129);
fiat_secp256k1_addcarryx_u64(&x139, &x140, x138, x130, x127);
x141 = (x140 + x128);
fiat_secp256k1_addcarryx_u64(&x142, &x143, 0x0, x115, x133);
fiat_secp256k1_addcarryx_u64(&x144, &x145, x143, x117, x135);
fiat_secp256k1_addcarryx_u64(&x146, &x147, x145, x119, x137);
fiat_secp256k1_addcarryx_u64(&x148, &x149, x147, x121, x139);
fiat_secp256k1_addcarryx_u64(&x150, &x151, x149, x123, x141);
x152 = ((uint64_t)x151 + x124);
fiat_secp256k1_mulx_u64(&x153, &x154, x3, (arg1[3]));
fiat_secp256k1_mulx_u64(&x155, &x156, x3, (arg1[2]));
fiat_secp256k1_mulx_u64(&x157, &x158, x3, (arg1[1]));
fiat_secp256k1_mulx_u64(&x159, &x160, x3, (arg1[0]));
fiat_secp256k1_addcarryx_u64(&x161, &x162, 0x0, x160, x157);
fiat_secp256k1_addcarryx_u64(&x163, &x164, x162, x158, x155);
fiat_secp256k1_addcarryx_u64(&x165, &x166, x164, x156, x153);
x167 = (x166 + x154);
fiat_secp256k1_addcarryx_u64(&x168, &x169, 0x0, x144, x159);
fiat_secp256k1_addcarryx_u64(&x170, &x171, x169, x146, x161);
fiat_secp256k1_addcarryx_u64(&x172, &x173, x171, x148, x163);
fiat_secp256k1_addcarryx_u64(&x174, &x175, x173, x150, x165);
fiat_secp256k1_addcarryx_u64(&x176, &x177, x175, x152, x167);
fiat_secp256k1_mulx_u64(&x178, &x179, x168, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x180, &x181, x178, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x182, &x183, x178, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x184, &x185, x178, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x186, &x187, x178, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x188, &x189, 0x0, x187, x184);
fiat_secp256k1_addcarryx_u64(&x190, &x191, x189, x185, x182);
fiat_secp256k1_addcarryx_u64(&x192, &x193, x191, x183, x180);
x194 = (x193 + x181);
fiat_secp256k1_addcarryx_u64(&x195, &x196, 0x0, x168, x186);
fiat_secp256k1_addcarryx_u64(&x197, &x198, x196, x170, x188);
fiat_secp256k1_addcarryx_u64(&x199, &x200, x198, x172, x190);
fiat_secp256k1_addcarryx_u64(&x201, &x202, x200, x174, x192);
fiat_secp256k1_addcarryx_u64(&x203, &x204, x202, x176, x194);
x205 = ((uint64_t)x204 + x177);
fiat_secp256k1_subborrowx_u64(&x206, &x207, 0x0, x197, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x208, &x209, x207, x199, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x210, &x211, x209, x201, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x212, &x213, x211, x203, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x214, &x215, x213, x205, 0x0);
fiat_secp256k1_cmovznz_u64(&x216, x215, x206, x197);
fiat_secp256k1_cmovznz_u64(&x217, x215, x208, x199);
fiat_secp256k1_cmovznz_u64(&x218, x215, x210, x201);
fiat_secp256k1_cmovznz_u64(&x219, x215, x212, x203);
out1[0] = x216;
out1[1] = x217;
out1[2] = x218;
out1[3] = x219;
}
/*
* The function fiat_secp256k1_add adds two field elements in the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* 0 ≤ eval arg2 < m
* Postconditions:
* eval (from_montgomery out1) mod m = (eval (from_montgomery arg1) + eval (from_montgomery arg2)) mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_add(fiat_secp256k1_montgomery_domain_field_element out1, const fiat_secp256k1_montgomery_domain_field_element arg1, const fiat_secp256k1_montgomery_domain_field_element arg2) {
uint64_t x1;
fiat_secp256k1_uint1 x2;
uint64_t x3;
fiat_secp256k1_uint1 x4;
uint64_t x5;
fiat_secp256k1_uint1 x6;
uint64_t x7;
fiat_secp256k1_uint1 x8;
uint64_t x9;
fiat_secp256k1_uint1 x10;
uint64_t x11;
fiat_secp256k1_uint1 x12;
uint64_t x13;
fiat_secp256k1_uint1 x14;
uint64_t x15;
fiat_secp256k1_uint1 x16;
uint64_t x17;
fiat_secp256k1_uint1 x18;
uint64_t x19;
uint64_t x20;
uint64_t x21;
uint64_t x22;
fiat_secp256k1_addcarryx_u64(&x1, &x2, 0x0, (arg1[0]), (arg2[0]));
fiat_secp256k1_addcarryx_u64(&x3, &x4, x2, (arg1[1]), (arg2[1]));
fiat_secp256k1_addcarryx_u64(&x5, &x6, x4, (arg1[2]), (arg2[2]));
fiat_secp256k1_addcarryx_u64(&x7, &x8, x6, (arg1[3]), (arg2[3]));
fiat_secp256k1_subborrowx_u64(&x9, &x10, 0x0, x1, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x11, &x12, x10, x3, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x13, &x14, x12, x5, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x15, &x16, x14, x7, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x17, &x18, x16, x8, 0x0);
fiat_secp256k1_cmovznz_u64(&x19, x18, x9, x1);
fiat_secp256k1_cmovznz_u64(&x20, x18, x11, x3);
fiat_secp256k1_cmovznz_u64(&x21, x18, x13, x5);
fiat_secp256k1_cmovznz_u64(&x22, x18, x15, x7);
out1[0] = x19;
out1[1] = x20;
out1[2] = x21;
out1[3] = x22;
}
/*
* The function fiat_secp256k1_sub subtracts two field elements in the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* 0 ≤ eval arg2 < m
* Postconditions:
* eval (from_montgomery out1) mod m = (eval (from_montgomery arg1) - eval (from_montgomery arg2)) mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_sub(fiat_secp256k1_montgomery_domain_field_element out1, const fiat_secp256k1_montgomery_domain_field_element arg1, const fiat_secp256k1_montgomery_domain_field_element arg2) {
uint64_t x1;
fiat_secp256k1_uint1 x2;
uint64_t x3;
fiat_secp256k1_uint1 x4;
uint64_t x5;
fiat_secp256k1_uint1 x6;
uint64_t x7;
fiat_secp256k1_uint1 x8;
uint64_t x9;
uint64_t x10;
fiat_secp256k1_uint1 x11;
uint64_t x12;
fiat_secp256k1_uint1 x13;
uint64_t x14;
fiat_secp256k1_uint1 x15;
uint64_t x16;
fiat_secp256k1_uint1 x17;
fiat_secp256k1_subborrowx_u64(&x1, &x2, 0x0, (arg1[0]), (arg2[0]));
fiat_secp256k1_subborrowx_u64(&x3, &x4, x2, (arg1[1]), (arg2[1]));
fiat_secp256k1_subborrowx_u64(&x5, &x6, x4, (arg1[2]), (arg2[2]));
fiat_secp256k1_subborrowx_u64(&x7, &x8, x6, (arg1[3]), (arg2[3]));
fiat_secp256k1_cmovznz_u64(&x9, x8, 0x0, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_addcarryx_u64(&x10, &x11, 0x0, x1, (x9 & UINT64_C(0xfffffffefffffc2f)));
fiat_secp256k1_addcarryx_u64(&x12, &x13, x11, x3, x9);
fiat_secp256k1_addcarryx_u64(&x14, &x15, x13, x5, x9);
fiat_secp256k1_addcarryx_u64(&x16, &x17, x15, x7, x9);
out1[0] = x10;
out1[1] = x12;
out1[2] = x14;
out1[3] = x16;
}
/*
* The function fiat_secp256k1_opp negates a field element in the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* Postconditions:
* eval (from_montgomery out1) mod m = -eval (from_montgomery arg1) mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_opp(fiat_secp256k1_montgomery_domain_field_element out1, const fiat_secp256k1_montgomery_domain_field_element arg1) {
uint64_t x1;
fiat_secp256k1_uint1 x2;
uint64_t x3;
fiat_secp256k1_uint1 x4;
uint64_t x5;
fiat_secp256k1_uint1 x6;
uint64_t x7;
fiat_secp256k1_uint1 x8;
uint64_t x9;
uint64_t x10;
fiat_secp256k1_uint1 x11;
uint64_t x12;
fiat_secp256k1_uint1 x13;
uint64_t x14;
fiat_secp256k1_uint1 x15;
uint64_t x16;
fiat_secp256k1_uint1 x17;
fiat_secp256k1_subborrowx_u64(&x1, &x2, 0x0, 0x0, (arg1[0]));
fiat_secp256k1_subborrowx_u64(&x3, &x4, x2, 0x0, (arg1[1]));
fiat_secp256k1_subborrowx_u64(&x5, &x6, x4, 0x0, (arg1[2]));
fiat_secp256k1_subborrowx_u64(&x7, &x8, x6, 0x0, (arg1[3]));
fiat_secp256k1_cmovznz_u64(&x9, x8, 0x0, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_addcarryx_u64(&x10, &x11, 0x0, x1, (x9 & UINT64_C(0xfffffffefffffc2f)));
fiat_secp256k1_addcarryx_u64(&x12, &x13, x11, x3, x9);
fiat_secp256k1_addcarryx_u64(&x14, &x15, x13, x5, x9);
fiat_secp256k1_addcarryx_u64(&x16, &x17, x15, x7, x9);
out1[0] = x10;
out1[1] = x12;
out1[2] = x14;
out1[3] = x16;
}
/*
* The function fiat_secp256k1_from_montgomery translates a field element out of the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* Postconditions:
* eval out1 mod m = (eval arg1 * ((2^64)⁻¹ mod m)^4) mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_from_montgomery(fiat_secp256k1_non_montgomery_domain_field_element out1, const fiat_secp256k1_montgomery_domain_field_element arg1) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
uint64_t x5;
uint64_t x6;
uint64_t x7;
uint64_t x8;
uint64_t x9;
uint64_t x10;
uint64_t x11;
uint64_t x12;
fiat_secp256k1_uint1 x13;
uint64_t x14;
fiat_secp256k1_uint1 x15;
uint64_t x16;
fiat_secp256k1_uint1 x17;
uint64_t x18;
fiat_secp256k1_uint1 x19;
uint64_t x20;
fiat_secp256k1_uint1 x21;
uint64_t x22;
fiat_secp256k1_uint1 x23;
uint64_t x24;
fiat_secp256k1_uint1 x25;
uint64_t x26;
fiat_secp256k1_uint1 x27;
uint64_t x28;
fiat_secp256k1_uint1 x29;
uint64_t x30;
fiat_secp256k1_uint1 x31;
uint64_t x32;
fiat_secp256k1_uint1 x33;
uint64_t x34;
fiat_secp256k1_uint1 x35;
uint64_t x36;
uint64_t x37;
uint64_t x38;
uint64_t x39;
uint64_t x40;
uint64_t x41;
uint64_t x42;
uint64_t x43;
uint64_t x44;
uint64_t x45;
uint64_t x46;
fiat_secp256k1_uint1 x47;
uint64_t x48;
fiat_secp256k1_uint1 x49;
uint64_t x50;
fiat_secp256k1_uint1 x51;
uint64_t x52;
fiat_secp256k1_uint1 x53;
uint64_t x54;
fiat_secp256k1_uint1 x55;
uint64_t x56;
fiat_secp256k1_uint1 x57;
uint64_t x58;
fiat_secp256k1_uint1 x59;
uint64_t x60;
fiat_secp256k1_uint1 x61;
uint64_t x62;
fiat_secp256k1_uint1 x63;
uint64_t x64;
fiat_secp256k1_uint1 x65;
uint64_t x66;
fiat_secp256k1_uint1 x67;
uint64_t x68;
fiat_secp256k1_uint1 x69;
uint64_t x70;
uint64_t x71;
uint64_t x72;
uint64_t x73;
uint64_t x74;
uint64_t x75;
uint64_t x76;
uint64_t x77;
uint64_t x78;
uint64_t x79;
uint64_t x80;
fiat_secp256k1_uint1 x81;
uint64_t x82;
fiat_secp256k1_uint1 x83;
uint64_t x84;
fiat_secp256k1_uint1 x85;
uint64_t x86;
fiat_secp256k1_uint1 x87;
uint64_t x88;
fiat_secp256k1_uint1 x89;
uint64_t x90;
fiat_secp256k1_uint1 x91;
uint64_t x92;
fiat_secp256k1_uint1 x93;
uint64_t x94;
fiat_secp256k1_uint1 x95;
uint64_t x96;
fiat_secp256k1_uint1 x97;
uint64_t x98;
fiat_secp256k1_uint1 x99;
uint64_t x100;
fiat_secp256k1_uint1 x101;
uint64_t x102;
fiat_secp256k1_uint1 x103;
uint64_t x104;
uint64_t x105;
uint64_t x106;
uint64_t x107;
uint64_t x108;
uint64_t x109;
uint64_t x110;
uint64_t x111;
uint64_t x112;
uint64_t x113;
uint64_t x114;
fiat_secp256k1_uint1 x115;
uint64_t x116;
fiat_secp256k1_uint1 x117;
uint64_t x118;
fiat_secp256k1_uint1 x119;
uint64_t x120;
fiat_secp256k1_uint1 x121;
uint64_t x122;
fiat_secp256k1_uint1 x123;
uint64_t x124;
fiat_secp256k1_uint1 x125;
uint64_t x126;
fiat_secp256k1_uint1 x127;
uint64_t x128;
fiat_secp256k1_uint1 x129;
uint64_t x130;
fiat_secp256k1_uint1 x131;
uint64_t x132;
fiat_secp256k1_uint1 x133;
uint64_t x134;
fiat_secp256k1_uint1 x135;
uint64_t x136;
fiat_secp256k1_uint1 x137;
uint64_t x138;
fiat_secp256k1_uint1 x139;
uint64_t x140;
uint64_t x141;
uint64_t x142;
uint64_t x143;
x1 = (arg1[0]);
fiat_secp256k1_mulx_u64(&x2, &x3, x1, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x4, &x5, x2, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x6, &x7, x2, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x8, &x9, x2, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x10, &x11, x2, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x12, &x13, 0x0, x11, x8);
fiat_secp256k1_addcarryx_u64(&x14, &x15, x13, x9, x6);
fiat_secp256k1_addcarryx_u64(&x16, &x17, x15, x7, x4);
fiat_secp256k1_addcarryx_u64(&x18, &x19, 0x0, x1, x10);
fiat_secp256k1_addcarryx_u64(&x20, &x21, x19, 0x0, x12);
fiat_secp256k1_addcarryx_u64(&x22, &x23, x21, 0x0, x14);
fiat_secp256k1_addcarryx_u64(&x24, &x25, x23, 0x0, x16);
fiat_secp256k1_addcarryx_u64(&x26, &x27, x25, 0x0, (x17 + x5));
fiat_secp256k1_addcarryx_u64(&x28, &x29, 0x0, x20, (arg1[1]));
fiat_secp256k1_addcarryx_u64(&x30, &x31, x29, x22, 0x0);
fiat_secp256k1_addcarryx_u64(&x32, &x33, x31, x24, 0x0);
fiat_secp256k1_addcarryx_u64(&x34, &x35, x33, x26, 0x0);
fiat_secp256k1_mulx_u64(&x36, &x37, x28, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x38, &x39, x36, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x40, &x41, x36, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x42, &x43, x36, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x44, &x45, x36, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x46, &x47, 0x0, x45, x42);
fiat_secp256k1_addcarryx_u64(&x48, &x49, x47, x43, x40);
fiat_secp256k1_addcarryx_u64(&x50, &x51, x49, x41, x38);
fiat_secp256k1_addcarryx_u64(&x52, &x53, 0x0, x28, x44);
fiat_secp256k1_addcarryx_u64(&x54, &x55, x53, x30, x46);
fiat_secp256k1_addcarryx_u64(&x56, &x57, x55, x32, x48);
fiat_secp256k1_addcarryx_u64(&x58, &x59, x57, x34, x50);
fiat_secp256k1_addcarryx_u64(&x60, &x61, x59, ((uint64_t)x35 + x27), (x51 + x39));
fiat_secp256k1_addcarryx_u64(&x62, &x63, 0x0, x54, (arg1[2]));
fiat_secp256k1_addcarryx_u64(&x64, &x65, x63, x56, 0x0);
fiat_secp256k1_addcarryx_u64(&x66, &x67, x65, x58, 0x0);
fiat_secp256k1_addcarryx_u64(&x68, &x69, x67, x60, 0x0);
fiat_secp256k1_mulx_u64(&x70, &x71, x62, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x72, &x73, x70, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x74, &x75, x70, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x76, &x77, x70, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x78, &x79, x70, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x80, &x81, 0x0, x79, x76);
fiat_secp256k1_addcarryx_u64(&x82, &x83, x81, x77, x74);
fiat_secp256k1_addcarryx_u64(&x84, &x85, x83, x75, x72);
fiat_secp256k1_addcarryx_u64(&x86, &x87, 0x0, x62, x78);
fiat_secp256k1_addcarryx_u64(&x88, &x89, x87, x64, x80);
fiat_secp256k1_addcarryx_u64(&x90, &x91, x89, x66, x82);
fiat_secp256k1_addcarryx_u64(&x92, &x93, x91, x68, x84);
fiat_secp256k1_addcarryx_u64(&x94, &x95, x93, ((uint64_t)x69 + x61), (x85 + x73));
fiat_secp256k1_addcarryx_u64(&x96, &x97, 0x0, x88, (arg1[3]));
fiat_secp256k1_addcarryx_u64(&x98, &x99, x97, x90, 0x0);
fiat_secp256k1_addcarryx_u64(&x100, &x101, x99, x92, 0x0);
fiat_secp256k1_addcarryx_u64(&x102, &x103, x101, x94, 0x0);
fiat_secp256k1_mulx_u64(&x104, &x105, x96, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x106, &x107, x104, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x108, &x109, x104, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x110, &x111, x104, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x112, &x113, x104, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x114, &x115, 0x0, x113, x110);
fiat_secp256k1_addcarryx_u64(&x116, &x117, x115, x111, x108);
fiat_secp256k1_addcarryx_u64(&x118, &x119, x117, x109, x106);
fiat_secp256k1_addcarryx_u64(&x120, &x121, 0x0, x96, x112);
fiat_secp256k1_addcarryx_u64(&x122, &x123, x121, x98, x114);
fiat_secp256k1_addcarryx_u64(&x124, &x125, x123, x100, x116);
fiat_secp256k1_addcarryx_u64(&x126, &x127, x125, x102, x118);
fiat_secp256k1_addcarryx_u64(&x128, &x129, x127, ((uint64_t)x103 + x95), (x119 + x107));
fiat_secp256k1_subborrowx_u64(&x130, &x131, 0x0, x122, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x132, &x133, x131, x124, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x134, &x135, x133, x126, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x136, &x137, x135, x128, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x138, &x139, x137, x129, 0x0);
fiat_secp256k1_cmovznz_u64(&x140, x139, x130, x122);
fiat_secp256k1_cmovznz_u64(&x141, x139, x132, x124);
fiat_secp256k1_cmovznz_u64(&x142, x139, x134, x126);
fiat_secp256k1_cmovznz_u64(&x143, x139, x136, x128);
out1[0] = x140;
out1[1] = x141;
out1[2] = x142;
out1[3] = x143;
}
/*
* The function fiat_secp256k1_to_montgomery translates a field element into the Montgomery domain.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* Postconditions:
* eval (from_montgomery out1) mod m = eval arg1 mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_to_montgomery(fiat_secp256k1_montgomery_domain_field_element out1, const fiat_secp256k1_non_montgomery_domain_field_element arg1) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
uint64_t x5;
uint64_t x6;
uint64_t x7;
fiat_secp256k1_uint1 x8;
uint64_t x9;
uint64_t x10;
uint64_t x11;
uint64_t x12;
uint64_t x13;
uint64_t x14;
uint64_t x15;
uint64_t x16;
uint64_t x17;
uint64_t x18;
uint64_t x19;
fiat_secp256k1_uint1 x20;
uint64_t x21;
fiat_secp256k1_uint1 x22;
uint64_t x23;
fiat_secp256k1_uint1 x24;
uint64_t x25;
fiat_secp256k1_uint1 x26;
uint64_t x27;
fiat_secp256k1_uint1 x28;
uint64_t x29;
fiat_secp256k1_uint1 x30;
uint64_t x31;
fiat_secp256k1_uint1 x32;
uint64_t x33;
fiat_secp256k1_uint1 x34;
uint64_t x35;
uint64_t x36;
uint64_t x37;
fiat_secp256k1_uint1 x38;
uint64_t x39;
fiat_secp256k1_uint1 x40;
uint64_t x41;
fiat_secp256k1_uint1 x42;
uint64_t x43;
fiat_secp256k1_uint1 x44;
uint64_t x45;
fiat_secp256k1_uint1 x46;
uint64_t x47;
uint64_t x48;
uint64_t x49;
uint64_t x50;
uint64_t x51;
uint64_t x52;
uint64_t x53;
uint64_t x54;
uint64_t x55;
uint64_t x56;
uint64_t x57;
fiat_secp256k1_uint1 x58;
uint64_t x59;
fiat_secp256k1_uint1 x60;
uint64_t x61;
fiat_secp256k1_uint1 x62;
uint64_t x63;
fiat_secp256k1_uint1 x64;
uint64_t x65;
fiat_secp256k1_uint1 x66;
uint64_t x67;
fiat_secp256k1_uint1 x68;
uint64_t x69;
fiat_secp256k1_uint1 x70;
uint64_t x71;
fiat_secp256k1_uint1 x72;
uint64_t x73;
uint64_t x74;
uint64_t x75;
fiat_secp256k1_uint1 x76;
uint64_t x77;
fiat_secp256k1_uint1 x78;
uint64_t x79;
fiat_secp256k1_uint1 x80;
uint64_t x81;
fiat_secp256k1_uint1 x82;
uint64_t x83;
fiat_secp256k1_uint1 x84;
uint64_t x85;
uint64_t x86;
uint64_t x87;
uint64_t x88;
uint64_t x89;
uint64_t x90;
uint64_t x91;
uint64_t x92;
uint64_t x93;
uint64_t x94;
uint64_t x95;
fiat_secp256k1_uint1 x96;
uint64_t x97;
fiat_secp256k1_uint1 x98;
uint64_t x99;
fiat_secp256k1_uint1 x100;
uint64_t x101;
fiat_secp256k1_uint1 x102;
uint64_t x103;
fiat_secp256k1_uint1 x104;
uint64_t x105;
fiat_secp256k1_uint1 x106;
uint64_t x107;
fiat_secp256k1_uint1 x108;
uint64_t x109;
fiat_secp256k1_uint1 x110;
uint64_t x111;
uint64_t x112;
uint64_t x113;
fiat_secp256k1_uint1 x114;
uint64_t x115;
fiat_secp256k1_uint1 x116;
uint64_t x117;
fiat_secp256k1_uint1 x118;
uint64_t x119;
fiat_secp256k1_uint1 x120;
uint64_t x121;
fiat_secp256k1_uint1 x122;
uint64_t x123;
uint64_t x124;
uint64_t x125;
uint64_t x126;
uint64_t x127;
uint64_t x128;
uint64_t x129;
uint64_t x130;
uint64_t x131;
uint64_t x132;
uint64_t x133;
fiat_secp256k1_uint1 x134;
uint64_t x135;
fiat_secp256k1_uint1 x136;
uint64_t x137;
fiat_secp256k1_uint1 x138;
uint64_t x139;
fiat_secp256k1_uint1 x140;
uint64_t x141;
fiat_secp256k1_uint1 x142;
uint64_t x143;
fiat_secp256k1_uint1 x144;
uint64_t x145;
fiat_secp256k1_uint1 x146;
uint64_t x147;
fiat_secp256k1_uint1 x148;
uint64_t x149;
fiat_secp256k1_uint1 x150;
uint64_t x151;
fiat_secp256k1_uint1 x152;
uint64_t x153;
fiat_secp256k1_uint1 x154;
uint64_t x155;
fiat_secp256k1_uint1 x156;
uint64_t x157;
fiat_secp256k1_uint1 x158;
uint64_t x159;
uint64_t x160;
uint64_t x161;
uint64_t x162;
x1 = (arg1[1]);
x2 = (arg1[2]);
x3 = (arg1[3]);
x4 = (arg1[0]);
fiat_secp256k1_mulx_u64(&x5, &x6, x4, UINT64_C(0x7a2000e90a1));
fiat_secp256k1_addcarryx_u64(&x7, &x8, 0x0, x6, x4);
fiat_secp256k1_mulx_u64(&x9, &x10, x5, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x11, &x12, x9, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x13, &x14, x9, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x15, &x16, x9, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x17, &x18, x9, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x19, &x20, 0x0, x18, x15);
fiat_secp256k1_addcarryx_u64(&x21, &x22, x20, x16, x13);
fiat_secp256k1_addcarryx_u64(&x23, &x24, x22, x14, x11);
fiat_secp256k1_addcarryx_u64(&x25, &x26, 0x0, x5, x17);
fiat_secp256k1_addcarryx_u64(&x27, &x28, x26, x7, x19);
fiat_secp256k1_addcarryx_u64(&x29, &x30, x28, x8, x21);
fiat_secp256k1_addcarryx_u64(&x31, &x32, x30, 0x0, x23);
fiat_secp256k1_addcarryx_u64(&x33, &x34, x32, 0x0, (x24 + x12));
fiat_secp256k1_mulx_u64(&x35, &x36, x1, UINT64_C(0x7a2000e90a1));
fiat_secp256k1_addcarryx_u64(&x37, &x38, 0x0, x36, x1);
fiat_secp256k1_addcarryx_u64(&x39, &x40, 0x0, x27, x35);
fiat_secp256k1_addcarryx_u64(&x41, &x42, x40, x29, x37);
fiat_secp256k1_addcarryx_u64(&x43, &x44, x42, x31, x38);
fiat_secp256k1_addcarryx_u64(&x45, &x46, x44, x33, 0x0);
fiat_secp256k1_mulx_u64(&x47, &x48, x39, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x49, &x50, x47, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x51, &x52, x47, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x53, &x54, x47, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x55, &x56, x47, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x57, &x58, 0x0, x56, x53);
fiat_secp256k1_addcarryx_u64(&x59, &x60, x58, x54, x51);
fiat_secp256k1_addcarryx_u64(&x61, &x62, x60, x52, x49);
fiat_secp256k1_addcarryx_u64(&x63, &x64, 0x0, x39, x55);
fiat_secp256k1_addcarryx_u64(&x65, &x66, x64, x41, x57);
fiat_secp256k1_addcarryx_u64(&x67, &x68, x66, x43, x59);
fiat_secp256k1_addcarryx_u64(&x69, &x70, x68, x45, x61);
fiat_secp256k1_addcarryx_u64(&x71, &x72, x70, ((uint64_t)x46 + x34), (x62 + x50));
fiat_secp256k1_mulx_u64(&x73, &x74, x2, UINT64_C(0x7a2000e90a1));
fiat_secp256k1_addcarryx_u64(&x75, &x76, 0x0, x74, x2);
fiat_secp256k1_addcarryx_u64(&x77, &x78, 0x0, x65, x73);
fiat_secp256k1_addcarryx_u64(&x79, &x80, x78, x67, x75);
fiat_secp256k1_addcarryx_u64(&x81, &x82, x80, x69, x76);
fiat_secp256k1_addcarryx_u64(&x83, &x84, x82, x71, 0x0);
fiat_secp256k1_mulx_u64(&x85, &x86, x77, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x87, &x88, x85, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x89, &x90, x85, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x91, &x92, x85, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x93, &x94, x85, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x95, &x96, 0x0, x94, x91);
fiat_secp256k1_addcarryx_u64(&x97, &x98, x96, x92, x89);
fiat_secp256k1_addcarryx_u64(&x99, &x100, x98, x90, x87);
fiat_secp256k1_addcarryx_u64(&x101, &x102, 0x0, x77, x93);
fiat_secp256k1_addcarryx_u64(&x103, &x104, x102, x79, x95);
fiat_secp256k1_addcarryx_u64(&x105, &x106, x104, x81, x97);
fiat_secp256k1_addcarryx_u64(&x107, &x108, x106, x83, x99);
fiat_secp256k1_addcarryx_u64(&x109, &x110, x108, ((uint64_t)x84 + x72), (x100 + x88));
fiat_secp256k1_mulx_u64(&x111, &x112, x3, UINT64_C(0x7a2000e90a1));
fiat_secp256k1_addcarryx_u64(&x113, &x114, 0x0, x112, x3);
fiat_secp256k1_addcarryx_u64(&x115, &x116, 0x0, x103, x111);
fiat_secp256k1_addcarryx_u64(&x117, &x118, x116, x105, x113);
fiat_secp256k1_addcarryx_u64(&x119, &x120, x118, x107, x114);
fiat_secp256k1_addcarryx_u64(&x121, &x122, x120, x109, 0x0);
fiat_secp256k1_mulx_u64(&x123, &x124, x115, UINT64_C(0xd838091dd2253531));
fiat_secp256k1_mulx_u64(&x125, &x126, x123, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x127, &x128, x123, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x129, &x130, x123, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_mulx_u64(&x131, &x132, x123, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_addcarryx_u64(&x133, &x134, 0x0, x132, x129);
fiat_secp256k1_addcarryx_u64(&x135, &x136, x134, x130, x127);
fiat_secp256k1_addcarryx_u64(&x137, &x138, x136, x128, x125);
fiat_secp256k1_addcarryx_u64(&x139, &x140, 0x0, x115, x131);
fiat_secp256k1_addcarryx_u64(&x141, &x142, x140, x117, x133);
fiat_secp256k1_addcarryx_u64(&x143, &x144, x142, x119, x135);
fiat_secp256k1_addcarryx_u64(&x145, &x146, x144, x121, x137);
fiat_secp256k1_addcarryx_u64(&x147, &x148, x146, ((uint64_t)x122 + x110), (x138 + x126));
fiat_secp256k1_subborrowx_u64(&x149, &x150, 0x0, x141, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x151, &x152, x150, x143, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x153, &x154, x152, x145, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x155, &x156, x154, x147, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x157, &x158, x156, x148, 0x0);
fiat_secp256k1_cmovznz_u64(&x159, x158, x149, x141);
fiat_secp256k1_cmovznz_u64(&x160, x158, x151, x143);
fiat_secp256k1_cmovznz_u64(&x161, x158, x153, x145);
fiat_secp256k1_cmovznz_u64(&x162, x158, x155, x147);
out1[0] = x159;
out1[1] = x160;
out1[2] = x161;
out1[3] = x162;
}
/*
* The function fiat_secp256k1_nonzero outputs a single non-zero word if the input is non-zero and zero otherwise.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* Postconditions:
* out1 = 0 ↔ eval (from_montgomery arg1) mod m = 0
*
* Input Bounds:
* arg1: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* Output Bounds:
* out1: [0x0 ~> 0xffffffffffffffff]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_nonzero(uint64_t* out1, const uint64_t arg1[4]) {
uint64_t x1;
x1 = ((arg1[0]) | ((arg1[1]) | ((arg1[2]) | (arg1[3]))));
*out1 = x1;
}
/*
* The function fiat_secp256k1_selectznz is a multi-limb conditional select.
*
* Postconditions:
* out1 = (if arg1 = 0 then arg2 else arg3)
*
* Input Bounds:
* arg1: [0x0 ~> 0x1]
* arg2: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* arg3: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* Output Bounds:
* out1: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_selectznz(uint64_t out1[4], fiat_secp256k1_uint1 arg1, const uint64_t arg2[4], const uint64_t arg3[4]) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
fiat_secp256k1_cmovznz_u64(&x1, arg1, (arg2[0]), (arg3[0]));
fiat_secp256k1_cmovznz_u64(&x2, arg1, (arg2[1]), (arg3[1]));
fiat_secp256k1_cmovznz_u64(&x3, arg1, (arg2[2]), (arg3[2]));
fiat_secp256k1_cmovznz_u64(&x4, arg1, (arg2[3]), (arg3[3]));
out1[0] = x1;
out1[1] = x2;
out1[2] = x3;
out1[3] = x4;
}
/*
* The function fiat_secp256k1_to_bytes serializes a field element NOT in the Montgomery domain to bytes in little-endian order.
*
* Preconditions:
* 0 ≤ eval arg1 < m
* Postconditions:
* out1 = map (λ x, ⌊((eval arg1 mod m) mod 2^(8 * (x + 1))) / 2^(8 * x)⌋) [0..31]
*
* Input Bounds:
* arg1: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* Output Bounds:
* out1: [[0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff]]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_to_bytes(uint8_t out1[32], const uint64_t arg1[4]) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
uint8_t x5;
uint64_t x6;
uint8_t x7;
uint64_t x8;
uint8_t x9;
uint64_t x10;
uint8_t x11;
uint64_t x12;
uint8_t x13;
uint64_t x14;
uint8_t x15;
uint64_t x16;
uint8_t x17;
uint8_t x18;
uint8_t x19;
uint64_t x20;
uint8_t x21;
uint64_t x22;
uint8_t x23;
uint64_t x24;
uint8_t x25;
uint64_t x26;
uint8_t x27;
uint64_t x28;
uint8_t x29;
uint64_t x30;
uint8_t x31;
uint8_t x32;
uint8_t x33;
uint64_t x34;
uint8_t x35;
uint64_t x36;
uint8_t x37;
uint64_t x38;
uint8_t x39;
uint64_t x40;
uint8_t x41;
uint64_t x42;
uint8_t x43;
uint64_t x44;
uint8_t x45;
uint8_t x46;
uint8_t x47;
uint64_t x48;
uint8_t x49;
uint64_t x50;
uint8_t x51;
uint64_t x52;
uint8_t x53;
uint64_t x54;
uint8_t x55;
uint64_t x56;
uint8_t x57;
uint64_t x58;
uint8_t x59;
uint8_t x60;
x1 = (arg1[3]);
x2 = (arg1[2]);
x3 = (arg1[1]);
x4 = (arg1[0]);
x5 = (uint8_t)(x4 & UINT8_C(0xff));
x6 = (x4 >> 8);
x7 = (uint8_t)(x6 & UINT8_C(0xff));
x8 = (x6 >> 8);
x9 = (uint8_t)(x8 & UINT8_C(0xff));
x10 = (x8 >> 8);
x11 = (uint8_t)(x10 & UINT8_C(0xff));
x12 = (x10 >> 8);
x13 = (uint8_t)(x12 & UINT8_C(0xff));
x14 = (x12 >> 8);
x15 = (uint8_t)(x14 & UINT8_C(0xff));
x16 = (x14 >> 8);
x17 = (uint8_t)(x16 & UINT8_C(0xff));
x18 = (uint8_t)(x16 >> 8);
x19 = (uint8_t)(x3 & UINT8_C(0xff));
x20 = (x3 >> 8);
x21 = (uint8_t)(x20 & UINT8_C(0xff));
x22 = (x20 >> 8);
x23 = (uint8_t)(x22 & UINT8_C(0xff));
x24 = (x22 >> 8);
x25 = (uint8_t)(x24 & UINT8_C(0xff));
x26 = (x24 >> 8);
x27 = (uint8_t)(x26 & UINT8_C(0xff));
x28 = (x26 >> 8);
x29 = (uint8_t)(x28 & UINT8_C(0xff));
x30 = (x28 >> 8);
x31 = (uint8_t)(x30 & UINT8_C(0xff));
x32 = (uint8_t)(x30 >> 8);
x33 = (uint8_t)(x2 & UINT8_C(0xff));
x34 = (x2 >> 8);
x35 = (uint8_t)(x34 & UINT8_C(0xff));
x36 = (x34 >> 8);
x37 = (uint8_t)(x36 & UINT8_C(0xff));
x38 = (x36 >> 8);
x39 = (uint8_t)(x38 & UINT8_C(0xff));
x40 = (x38 >> 8);
x41 = (uint8_t)(x40 & UINT8_C(0xff));
x42 = (x40 >> 8);
x43 = (uint8_t)(x42 & UINT8_C(0xff));
x44 = (x42 >> 8);
x45 = (uint8_t)(x44 & UINT8_C(0xff));
x46 = (uint8_t)(x44 >> 8);
x47 = (uint8_t)(x1 & UINT8_C(0xff));
x48 = (x1 >> 8);
x49 = (uint8_t)(x48 & UINT8_C(0xff));
x50 = (x48 >> 8);
x51 = (uint8_t)(x50 & UINT8_C(0xff));
x52 = (x50 >> 8);
x53 = (uint8_t)(x52 & UINT8_C(0xff));
x54 = (x52 >> 8);
x55 = (uint8_t)(x54 & UINT8_C(0xff));
x56 = (x54 >> 8);
x57 = (uint8_t)(x56 & UINT8_C(0xff));
x58 = (x56 >> 8);
x59 = (uint8_t)(x58 & UINT8_C(0xff));
x60 = (uint8_t)(x58 >> 8);
out1[0] = x5;
out1[1] = x7;
out1[2] = x9;
out1[3] = x11;
out1[4] = x13;
out1[5] = x15;
out1[6] = x17;
out1[7] = x18;
out1[8] = x19;
out1[9] = x21;
out1[10] = x23;
out1[11] = x25;
out1[12] = x27;
out1[13] = x29;
out1[14] = x31;
out1[15] = x32;
out1[16] = x33;
out1[17] = x35;
out1[18] = x37;
out1[19] = x39;
out1[20] = x41;
out1[21] = x43;
out1[22] = x45;
out1[23] = x46;
out1[24] = x47;
out1[25] = x49;
out1[26] = x51;
out1[27] = x53;
out1[28] = x55;
out1[29] = x57;
out1[30] = x59;
out1[31] = x60;
}
/*
* The function fiat_secp256k1_from_bytes deserializes a field element NOT in the Montgomery domain from bytes in little-endian order.
*
* Preconditions:
* 0 ≤ bytes_eval arg1 < m
* Postconditions:
* eval out1 mod m = bytes_eval arg1 mod m
* 0 ≤ eval out1 < m
*
* Input Bounds:
* arg1: [[0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff], [0x0 ~> 0xff]]
* Output Bounds:
* out1: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_from_bytes(uint64_t out1[4], const uint8_t arg1[32]) {
uint64_t x1;
uint64_t x2;
uint64_t x3;
uint64_t x4;
uint64_t x5;
uint64_t x6;
uint64_t x7;
uint8_t x8;
uint64_t x9;
uint64_t x10;
uint64_t x11;
uint64_t x12;
uint64_t x13;
uint64_t x14;
uint64_t x15;
uint8_t x16;
uint64_t x17;
uint64_t x18;
uint64_t x19;
uint64_t x20;
uint64_t x21;
uint64_t x22;
uint64_t x23;
uint8_t x24;
uint64_t x25;
uint64_t x26;
uint64_t x27;
uint64_t x28;
uint64_t x29;
uint64_t x30;
uint64_t x31;
uint8_t x32;
uint64_t x33;
uint64_t x34;
uint64_t x35;
uint64_t x36;
uint64_t x37;
uint64_t x38;
uint64_t x39;
uint64_t x40;
uint64_t x41;
uint64_t x42;
uint64_t x43;
uint64_t x44;
uint64_t x45;
uint64_t x46;
uint64_t x47;
uint64_t x48;
uint64_t x49;
uint64_t x50;
uint64_t x51;
uint64_t x52;
uint64_t x53;
uint64_t x54;
uint64_t x55;
uint64_t x56;
uint64_t x57;
uint64_t x58;
uint64_t x59;
uint64_t x60;
x1 = ((uint64_t)(arg1[31]) << 56);
x2 = ((uint64_t)(arg1[30]) << 48);
x3 = ((uint64_t)(arg1[29]) << 40);
x4 = ((uint64_t)(arg1[28]) << 32);
x5 = ((uint64_t)(arg1[27]) << 24);
x6 = ((uint64_t)(arg1[26]) << 16);
x7 = ((uint64_t)(arg1[25]) << 8);
x8 = (arg1[24]);
x9 = ((uint64_t)(arg1[23]) << 56);
x10 = ((uint64_t)(arg1[22]) << 48);
x11 = ((uint64_t)(arg1[21]) << 40);
x12 = ((uint64_t)(arg1[20]) << 32);
x13 = ((uint64_t)(arg1[19]) << 24);
x14 = ((uint64_t)(arg1[18]) << 16);
x15 = ((uint64_t)(arg1[17]) << 8);
x16 = (arg1[16]);
x17 = ((uint64_t)(arg1[15]) << 56);
x18 = ((uint64_t)(arg1[14]) << 48);
x19 = ((uint64_t)(arg1[13]) << 40);
x20 = ((uint64_t)(arg1[12]) << 32);
x21 = ((uint64_t)(arg1[11]) << 24);
x22 = ((uint64_t)(arg1[10]) << 16);
x23 = ((uint64_t)(arg1[9]) << 8);
x24 = (arg1[8]);
x25 = ((uint64_t)(arg1[7]) << 56);
x26 = ((uint64_t)(arg1[6]) << 48);
x27 = ((uint64_t)(arg1[5]) << 40);
x28 = ((uint64_t)(arg1[4]) << 32);
x29 = ((uint64_t)(arg1[3]) << 24);
x30 = ((uint64_t)(arg1[2]) << 16);
x31 = ((uint64_t)(arg1[1]) << 8);
x32 = (arg1[0]);
x33 = (x31 + (uint64_t)x32);
x34 = (x30 + x33);
x35 = (x29 + x34);
x36 = (x28 + x35);
x37 = (x27 + x36);
x38 = (x26 + x37);
x39 = (x25 + x38);
x40 = (x23 + (uint64_t)x24);
x41 = (x22 + x40);
x42 = (x21 + x41);
x43 = (x20 + x42);
x44 = (x19 + x43);
x45 = (x18 + x44);
x46 = (x17 + x45);
x47 = (x15 + (uint64_t)x16);
x48 = (x14 + x47);
x49 = (x13 + x48);
x50 = (x12 + x49);
x51 = (x11 + x50);
x52 = (x10 + x51);
x53 = (x9 + x52);
x54 = (x7 + (uint64_t)x8);
x55 = (x6 + x54);
x56 = (x5 + x55);
x57 = (x4 + x56);
x58 = (x3 + x57);
x59 = (x2 + x58);
x60 = (x1 + x59);
out1[0] = x39;
out1[1] = x46;
out1[2] = x53;
out1[3] = x60;
}
/*
* The function fiat_secp256k1_set_one returns the field element one in the Montgomery domain.
*
* Postconditions:
* eval (from_montgomery out1) mod m = 1 mod m
* 0 ≤ eval out1 < m
*
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_set_one(fiat_secp256k1_montgomery_domain_field_element out1) {
out1[0] = UINT64_C(0x1000003d1);
out1[1] = 0x0;
out1[2] = 0x0;
out1[3] = 0x0;
}
/*
* The function fiat_secp256k1_msat returns the saturated representation of the prime modulus.
*
* Postconditions:
* twos_complement_eval out1 = m
* 0 ≤ eval out1 < m
*
* Output Bounds:
* out1: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_msat(uint64_t out1[5]) {
out1[0] = UINT64_C(0xfffffffefffffc2f);
out1[1] = UINT64_C(0xffffffffffffffff);
out1[2] = UINT64_C(0xffffffffffffffff);
out1[3] = UINT64_C(0xffffffffffffffff);
out1[4] = 0x0;
}
/*
* The function fiat_secp256k1_divstep computes a divstep.
*
* Preconditions:
* 0 ≤ eval arg4 < m
* 0 ≤ eval arg5 < m
* Postconditions:
* out1 = (if 0 < arg1 ∧ (twos_complement_eval arg3) is odd then 1 - arg1 else 1 + arg1)
* twos_complement_eval out2 = (if 0 < arg1 ∧ (twos_complement_eval arg3) is odd then twos_complement_eval arg3 else twos_complement_eval arg2)
* twos_complement_eval out3 = (if 0 < arg1 ∧ (twos_complement_eval arg3) is odd then ⌊(twos_complement_eval arg3 - twos_complement_eval arg2) / 2⌋ else ⌊(twos_complement_eval arg3 + (twos_complement_eval arg3 mod 2) * twos_complement_eval arg2) / 2⌋)
* eval (from_montgomery out4) mod m = (if 0 < arg1 ∧ (twos_complement_eval arg3) is odd then (2 * eval (from_montgomery arg5)) mod m else (2 * eval (from_montgomery arg4)) mod m)
* eval (from_montgomery out5) mod m = (if 0 < arg1 ∧ (twos_complement_eval arg3) is odd then (eval (from_montgomery arg4) - eval (from_montgomery arg4)) mod m else (eval (from_montgomery arg5) + (twos_complement_eval arg3 mod 2) * eval (from_montgomery arg4)) mod m)
* 0 ≤ eval out5 < m
* 0 ≤ eval out5 < m
* 0 ≤ eval out2 < m
* 0 ≤ eval out3 < m
*
* Input Bounds:
* arg1: [0x0 ~> 0xffffffffffffffff]
* arg2: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* arg3: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* arg4: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* arg5: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* Output Bounds:
* out1: [0x0 ~> 0xffffffffffffffff]
* out2: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* out3: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* out4: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
* out5: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_divstep(uint64_t* out1, uint64_t out2[5], uint64_t out3[5], uint64_t out4[4], uint64_t out5[4], uint64_t arg1, const uint64_t arg2[5], const uint64_t arg3[5], const uint64_t arg4[4], const uint64_t arg5[4]) {
uint64_t x1;
fiat_secp256k1_uint1 x2;
fiat_secp256k1_uint1 x3;
uint64_t x4;
fiat_secp256k1_uint1 x5;
uint64_t x6;
uint64_t x7;
uint64_t x8;
uint64_t x9;
uint64_t x10;
uint64_t x11;
uint64_t x12;
fiat_secp256k1_uint1 x13;
uint64_t x14;
fiat_secp256k1_uint1 x15;
uint64_t x16;
fiat_secp256k1_uint1 x17;
uint64_t x18;
fiat_secp256k1_uint1 x19;
uint64_t x20;
fiat_secp256k1_uint1 x21;
uint64_t x22;
uint64_t x23;
uint64_t x24;
uint64_t x25;
uint64_t x26;
uint64_t x27;
uint64_t x28;
uint64_t x29;
uint64_t x30;
uint64_t x31;
fiat_secp256k1_uint1 x32;
uint64_t x33;
fiat_secp256k1_uint1 x34;
uint64_t x35;
fiat_secp256k1_uint1 x36;
uint64_t x37;
fiat_secp256k1_uint1 x38;
uint64_t x39;
fiat_secp256k1_uint1 x40;
uint64_t x41;
fiat_secp256k1_uint1 x42;
uint64_t x43;
fiat_secp256k1_uint1 x44;
uint64_t x45;
fiat_secp256k1_uint1 x46;
uint64_t x47;
fiat_secp256k1_uint1 x48;
uint64_t x49;
uint64_t x50;
uint64_t x51;
uint64_t x52;
uint64_t x53;
fiat_secp256k1_uint1 x54;
uint64_t x55;
fiat_secp256k1_uint1 x56;
uint64_t x57;
fiat_secp256k1_uint1 x58;
uint64_t x59;
fiat_secp256k1_uint1 x60;
uint64_t x61;
uint64_t x62;
fiat_secp256k1_uint1 x63;
uint64_t x64;
fiat_secp256k1_uint1 x65;
uint64_t x66;
fiat_secp256k1_uint1 x67;
uint64_t x68;
fiat_secp256k1_uint1 x69;
uint64_t x70;
uint64_t x71;
uint64_t x72;
uint64_t x73;
fiat_secp256k1_uint1 x74;
uint64_t x75;
uint64_t x76;
uint64_t x77;
uint64_t x78;
uint64_t x79;
uint64_t x80;
fiat_secp256k1_uint1 x81;
uint64_t x82;
fiat_secp256k1_uint1 x83;
uint64_t x84;
fiat_secp256k1_uint1 x85;
uint64_t x86;
fiat_secp256k1_uint1 x87;
uint64_t x88;
fiat_secp256k1_uint1 x89;
uint64_t x90;
uint64_t x91;
uint64_t x92;
uint64_t x93;
uint64_t x94;
fiat_secp256k1_uint1 x95;
uint64_t x96;
fiat_secp256k1_uint1 x97;
uint64_t x98;
fiat_secp256k1_uint1 x99;
uint64_t x100;
fiat_secp256k1_uint1 x101;
uint64_t x102;
fiat_secp256k1_uint1 x103;
uint64_t x104;
fiat_secp256k1_uint1 x105;
uint64_t x106;
fiat_secp256k1_uint1 x107;
uint64_t x108;
fiat_secp256k1_uint1 x109;
uint64_t x110;
fiat_secp256k1_uint1 x111;
uint64_t x112;
fiat_secp256k1_uint1 x113;
uint64_t x114;
uint64_t x115;
uint64_t x116;
uint64_t x117;
uint64_t x118;
uint64_t x119;
uint64_t x120;
uint64_t x121;
uint64_t x122;
uint64_t x123;
uint64_t x124;
uint64_t x125;
uint64_t x126;
fiat_secp256k1_addcarryx_u64(&x1, &x2, 0x0, (~arg1), 0x1);
x3 = (fiat_secp256k1_uint1)((fiat_secp256k1_uint1)(x1 >> 63) & (fiat_secp256k1_uint1)((arg3[0]) & 0x1));
fiat_secp256k1_addcarryx_u64(&x4, &x5, 0x0, (~arg1), 0x1);
fiat_secp256k1_cmovznz_u64(&x6, x3, arg1, x4);
fiat_secp256k1_cmovznz_u64(&x7, x3, (arg2[0]), (arg3[0]));
fiat_secp256k1_cmovznz_u64(&x8, x3, (arg2[1]), (arg3[1]));
fiat_secp256k1_cmovznz_u64(&x9, x3, (arg2[2]), (arg3[2]));
fiat_secp256k1_cmovznz_u64(&x10, x3, (arg2[3]), (arg3[3]));
fiat_secp256k1_cmovznz_u64(&x11, x3, (arg2[4]), (arg3[4]));
fiat_secp256k1_addcarryx_u64(&x12, &x13, 0x0, 0x1, (~(arg2[0])));
fiat_secp256k1_addcarryx_u64(&x14, &x15, x13, 0x0, (~(arg2[1])));
fiat_secp256k1_addcarryx_u64(&x16, &x17, x15, 0x0, (~(arg2[2])));
fiat_secp256k1_addcarryx_u64(&x18, &x19, x17, 0x0, (~(arg2[3])));
fiat_secp256k1_addcarryx_u64(&x20, &x21, x19, 0x0, (~(arg2[4])));
fiat_secp256k1_cmovznz_u64(&x22, x3, (arg3[0]), x12);
fiat_secp256k1_cmovznz_u64(&x23, x3, (arg3[1]), x14);
fiat_secp256k1_cmovznz_u64(&x24, x3, (arg3[2]), x16);
fiat_secp256k1_cmovznz_u64(&x25, x3, (arg3[3]), x18);
fiat_secp256k1_cmovznz_u64(&x26, x3, (arg3[4]), x20);
fiat_secp256k1_cmovznz_u64(&x27, x3, (arg4[0]), (arg5[0]));
fiat_secp256k1_cmovznz_u64(&x28, x3, (arg4[1]), (arg5[1]));
fiat_secp256k1_cmovznz_u64(&x29, x3, (arg4[2]), (arg5[2]));
fiat_secp256k1_cmovznz_u64(&x30, x3, (arg4[3]), (arg5[3]));
fiat_secp256k1_addcarryx_u64(&x31, &x32, 0x0, x27, x27);
fiat_secp256k1_addcarryx_u64(&x33, &x34, x32, x28, x28);
fiat_secp256k1_addcarryx_u64(&x35, &x36, x34, x29, x29);
fiat_secp256k1_addcarryx_u64(&x37, &x38, x36, x30, x30);
fiat_secp256k1_subborrowx_u64(&x39, &x40, 0x0, x31, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x41, &x42, x40, x33, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x43, &x44, x42, x35, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x45, &x46, x44, x37, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x47, &x48, x46, x38, 0x0);
x49 = (arg4[3]);
x50 = (arg4[2]);
x51 = (arg4[1]);
x52 = (arg4[0]);
fiat_secp256k1_subborrowx_u64(&x53, &x54, 0x0, 0x0, x52);
fiat_secp256k1_subborrowx_u64(&x55, &x56, x54, 0x0, x51);
fiat_secp256k1_subborrowx_u64(&x57, &x58, x56, 0x0, x50);
fiat_secp256k1_subborrowx_u64(&x59, &x60, x58, 0x0, x49);
fiat_secp256k1_cmovznz_u64(&x61, x60, 0x0, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_addcarryx_u64(&x62, &x63, 0x0, x53, (x61 & UINT64_C(0xfffffffefffffc2f)));
fiat_secp256k1_addcarryx_u64(&x64, &x65, x63, x55, x61);
fiat_secp256k1_addcarryx_u64(&x66, &x67, x65, x57, x61);
fiat_secp256k1_addcarryx_u64(&x68, &x69, x67, x59, x61);
fiat_secp256k1_cmovznz_u64(&x70, x3, (arg5[0]), x62);
fiat_secp256k1_cmovznz_u64(&x71, x3, (arg5[1]), x64);
fiat_secp256k1_cmovznz_u64(&x72, x3, (arg5[2]), x66);
fiat_secp256k1_cmovznz_u64(&x73, x3, (arg5[3]), x68);
x74 = (fiat_secp256k1_uint1)(x22 & 0x1);
fiat_secp256k1_cmovznz_u64(&x75, x74, 0x0, x7);
fiat_secp256k1_cmovznz_u64(&x76, x74, 0x0, x8);
fiat_secp256k1_cmovznz_u64(&x77, x74, 0x0, x9);
fiat_secp256k1_cmovznz_u64(&x78, x74, 0x0, x10);
fiat_secp256k1_cmovznz_u64(&x79, x74, 0x0, x11);
fiat_secp256k1_addcarryx_u64(&x80, &x81, 0x0, x22, x75);
fiat_secp256k1_addcarryx_u64(&x82, &x83, x81, x23, x76);
fiat_secp256k1_addcarryx_u64(&x84, &x85, x83, x24, x77);
fiat_secp256k1_addcarryx_u64(&x86, &x87, x85, x25, x78);
fiat_secp256k1_addcarryx_u64(&x88, &x89, x87, x26, x79);
fiat_secp256k1_cmovznz_u64(&x90, x74, 0x0, x27);
fiat_secp256k1_cmovznz_u64(&x91, x74, 0x0, x28);
fiat_secp256k1_cmovznz_u64(&x92, x74, 0x0, x29);
fiat_secp256k1_cmovznz_u64(&x93, x74, 0x0, x30);
fiat_secp256k1_addcarryx_u64(&x94, &x95, 0x0, x70, x90);
fiat_secp256k1_addcarryx_u64(&x96, &x97, x95, x71, x91);
fiat_secp256k1_addcarryx_u64(&x98, &x99, x97, x72, x92);
fiat_secp256k1_addcarryx_u64(&x100, &x101, x99, x73, x93);
fiat_secp256k1_subborrowx_u64(&x102, &x103, 0x0, x94, UINT64_C(0xfffffffefffffc2f));
fiat_secp256k1_subborrowx_u64(&x104, &x105, x103, x96, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x106, &x107, x105, x98, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x108, &x109, x107, x100, UINT64_C(0xffffffffffffffff));
fiat_secp256k1_subborrowx_u64(&x110, &x111, x109, x101, 0x0);
fiat_secp256k1_addcarryx_u64(&x112, &x113, 0x0, x6, 0x1);
x114 = ((x80 >> 1) | ((x82 << 63) & UINT64_C(0xffffffffffffffff)));
x115 = ((x82 >> 1) | ((x84 << 63) & UINT64_C(0xffffffffffffffff)));
x116 = ((x84 >> 1) | ((x86 << 63) & UINT64_C(0xffffffffffffffff)));
x117 = ((x86 >> 1) | ((x88 << 63) & UINT64_C(0xffffffffffffffff)));
x118 = ((x88 & UINT64_C(0x8000000000000000)) | (x88 >> 1));
fiat_secp256k1_cmovznz_u64(&x119, x48, x39, x31);
fiat_secp256k1_cmovznz_u64(&x120, x48, x41, x33);
fiat_secp256k1_cmovznz_u64(&x121, x48, x43, x35);
fiat_secp256k1_cmovznz_u64(&x122, x48, x45, x37);
fiat_secp256k1_cmovznz_u64(&x123, x111, x102, x94);
fiat_secp256k1_cmovznz_u64(&x124, x111, x104, x96);
fiat_secp256k1_cmovznz_u64(&x125, x111, x106, x98);
fiat_secp256k1_cmovznz_u64(&x126, x111, x108, x100);
*out1 = x112;
out2[0] = x7;
out2[1] = x8;
out2[2] = x9;
out2[3] = x10;
out2[4] = x11;
out3[0] = x114;
out3[1] = x115;
out3[2] = x116;
out3[3] = x117;
out3[4] = x118;
out4[0] = x119;
out4[1] = x120;
out4[2] = x121;
out4[3] = x122;
out5[0] = x123;
out5[1] = x124;
out5[2] = x125;
out5[3] = x126;
}
/*
* The function fiat_secp256k1_divstep_precomp returns the precomputed value for Bernstein-Yang-inversion (in montgomery form).
*
* Postconditions:
* eval (from_montgomery out1) = ⌊(m - 1) / 2⌋^(if ⌊log2 m⌋ + 1 < 46 then ⌊(49 * (⌊log2 m⌋ + 1) + 80) / 17⌋ else ⌊(49 * (⌊log2 m⌋ + 1) + 57) / 17⌋)
* 0 ≤ eval out1 < m
*
* Output Bounds:
* out1: [[0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff], [0x0 ~> 0xffffffffffffffff]]
*/
static FIAT_SECP256K1_FIAT_INLINE void fiat_secp256k1_divstep_precomp(uint64_t out1[4]) {
out1[0] = UINT64_C(0xf201a41831525e0a);
out1[1] = UINT64_C(0x9953f9ddcd648d85);
out1[2] = UINT64_C(0xe86029463db210a9);
out1[3] = UINT64_C(0x24fb8a3104b03709);
}
|
the_stack_data/145248.c | /*En el estacionamiento de un shopping, existe solo un carril en el que entran hasta 20 automóviles. Los
vehículos llegan por el extremo sur del estacionamiento y salen por el extremo norte del mismo. El
empleado de la cochera registra las matrículas que están en el carril. Se solicita escribir un programa que
permita al usuario ingresar las matrículas de los automóviles en una cola hasta que la misma se llene o el
usuario haya decidido no ingresar más elementos (vehículos). Además, se pide generar un listado de todos
los automóviles que están en el carril y se desea saber cuánta disponibilidad hay en ese carril. Utilizar
implementación con frente fijo.*/
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <stdbool.h>
#define MAX 20
typedef char tString[9];
typedef tString tMatricula[MAX];
typedef struct {
tMatricula carril;
int frente,final;
} tCochera;
void inicializar();
bool cocheraVacia( tCochera );
bool cocheraLlena( tCochera );
void agregar ( tString );
void eliminarElementoFF(); //eleminar frente fijo
void visualizarCochera( tCochera );
void ingresarMatricula();
int carrilesDisponibles ( tCochera );
void menu();
tCochera cochera;
int main () {
menu();
return 0;
}
void inicializar(){
cochera.frente = -1;
cochera.final = -1;
printf("\nSe inicializo la cochera\n");
}
bool cocheraVacia( tCochera pCochera ){
return ( pCochera.frente == -1 && pCochera.final == -1 );
} //devuelve true si la cola está vacía
bool cocheraLlena( tCochera pCochera){
return ( pCochera.final == ( MAX - 1) );
} //devuelve true si la cola está llena
void agregar ( tString pMatricula ){
if( !cocheraLlena( cochera ) ){
cochera.final++; //actualiza final
strcpy( cochera.carril[ cochera.final ], pMatricula ); //agrega el elemento al final
if( cochera.final == 0 ){
cochera.frente = 0;
}
} else {
printf("\nLa cochera esta llena\n");
}
int carrilDisponibles;
carrilDisponibles = MAX - cochera.final - 1;
printf("\nCantidad de carriles disponibles: %d\n", carrilDisponibles);
}
void eliminarElementoFF(){
tString matricula = " ";
int i;
if( !cocheraVacia( cochera ) ){
strcpy( matricula, cochera.carril[ cochera.frente ] );
strcpy( cochera.carril[ cochera.frente ], " " );
for( i = cochera.frente; i < cochera.final; i++ ){
strcpy( cochera.carril[ i ], cochera.carril[ i + 1 ] );
}
strcpy( cochera.carril[ cochera.final ], " " );
if( cochera.frente == cochera.final ){
inicializar();
}else{
cochera.final--;
}
printf("\nSe elimino el vehiculo con la matricula: %s\n", matricula );
} else {
printf("\nLa cochera esta vacia\n");
}
}
void visualizarCochera( tCochera pCochera ){
int i;
if( !cocheraVacia( pCochera ) ){
printf("\nCochera:\n");
for( i = pCochera.frente; i <= pCochera.final; i++ ){
printf(" %s |", pCochera.carril[ i ] );
}
} else {
printf("\nLa cochera esta vacia\n");
}
}
void ingresarMatricula(){
tString matricula = " ";
int rts;
do {
printf("\nIngrese la matricula: ");
fflush(stdin);
scanf("%s", matricula);
agregar( matricula );
printf("\nDesea ingresar otra matricula?\n1. Si\n2. No\n");
fflush(stdin);
scanf("%d", &rts);
}while( rts != 2 );
}
int carrilesDisponibles ( tCochera pCochera ){
int carrilesDisponibles;
carrilesDisponibles = MAX - ( pCochera.final - pCochera.frente )- 1;
return printf("\nCantidad de carriles disponibles: %d\n", carrilesDisponibles);
}
void menu(){
int opcion;
do{
printf("\n\t\tMENU\n");
printf("1. Inicializar cochera\n");
printf("2. Agregar matricula\n");
printf("3. Eliminar vehiculo\n");
printf("4. Visualizar cochera\n");
printf("5. Carriles Disponibles\n");
printf("0. Salir\n");
printf("\nIngrese una opcion: ");
fflush(stdin);
scanf("%d", &opcion);
system("cls");
switch( opcion ){
case 1:
inicializar();
break;
case 2:
ingresarMatricula();
break;
case 3:
eliminarElementoFF();
break;
case 4:
visualizarCochera( cochera );
break;
case 5:
carrilesDisponibles( cochera );
break;
case 0:
printf("\nSaliendo del programa\n");
break;
default:
printf("\nOpcion no valida\n");
break;
}
}while ( opcion != 0 );
} |
the_stack_data/61076637.c | #include <stddef.h>
#include <string.h>
size_t get_count(const char *s)
{
int total = 0;
unsigned long i;
for (i = 0; i < strlen(s); i++) {
if (s[i] == 'a' || s[i] == 'e' || s[i] == 'i' || s[i] == 'o' || s[i] == 'u') total +=1;
}
return total;
} |
the_stack_data/89199891.c | #include "stdio.h"
int main ()
{
int i =0, j=2;
printf("%d", i, j);
return 0;
}
|
the_stack_data/165768192.c | // getpid() is implicitly defined. gcc returns unicode quotes around the fn
// name in the error message if LANG is en_US.UTF-8, but ASCII if LANG is
// C.
int foo() {
return getpid();
}
|
the_stack_data/1152853.c | // RUN: %bmc -bound 1 -no-optimize "%s" | FileCheck "%s"
// RUN: %bmc -bound 1 "%s" | FileCheck "%s"
// CHECK: Verification FAILED
// This test checks that the enabled LLVM optimizations do not
// strip away relevant code under an undefined value.
void __VERIFIER_error(void) __attribute__((noreturn));
int main(void)
{
int x;
if (x == 1) {
__VERIFIER_error();
}
return 0;
} |
the_stack_data/163686.c | #include <math.h>
double nan(const char* s) { return NAN; }
|
the_stack_data/67324624.c | typedef struct Foo {
int a;
int b;
int c;
} Foo;
typedef struct Bar {
int x;
int y;
} Bar;
int f(Foo foo) {
return foo.a;
}
int g(Bar bar) {
return bar.y;
}
int main() {
Bar bar = {1, 2};
// Foo foo = {1, 2, 3};
int b = g(bar);
// int a = g(foo);
}
|
the_stack_data/87637892.c | #include <stdio.h>
int str[100000]={0};
int main()
{
int n,i,m,a,k;
scanf("%d",&n);
for(i=0;i<n;i++){
scanf("%d",&a);
str[a]++;}
scanf("%d",&k);
m=0;
for(i=99999;;i--){
if(str[i]!=0){
m++;
}
if(m==k){
break;
}
}
printf("%d %d",i,str[i]);
} |
the_stack_data/68889239.c | // Created by: WestleyR
// email: [email protected]
// Date: Jul 6, 2019
// https://github.com/WestleyR/clean-screen
// version-1.0.3
//
// The Clear BSD License
//
// Copyright (c) 2019 WestleyR
// All rights reserved.
//
// This software is licensed under a Clear BSD License.
//
#include <stdio.h>
#include <unistd.h>
#include <sys/ioctl.h>
#include <string.h>
#define VERSION "version-1.0.3 Jul 6, 2019"
void help_menu(char* script_name) {
printf("Usage: %s [option]\n", script_name);
printf("\n Clear the terminal screen.\n");
printf("\n");
printf("Options:\n");
printf(" -b clean the terminal, leaving the prompt below.\n");
printf("\n");
printf("https://github.com/WestleyR/clean-screen\n");
printf("This software is licensed under a Clear BSD License.\n");
printf("\n%s\n", VERSION);
}
int main(int argc, char** argv) {
int bottom_mode = 0;
if (argc > 1) {
for (int i = 1; i < argc; i++) {
if (strcmp(argv[i], "-b") == 0) {
bottom_mode = 1;
} else if ((strcmp(argv[i], "-h") == 0) || (strcmp(argv[i], "--help") == 0)) {
help_menu(argv[0]);
return(0);
}
}
}
if (bottom_mode != 0) {
struct winsize w;
int rows;
if (ioctl(STDOUT_FILENO, TIOCGWINSZ, &w) != 0) {
perror("ioctl");
rows = 256;
} else {
rows = w.ws_row;
}
for (int l = 0; l < rows; l++) {
printf("\n");
}
} else {
write(STDOUT_FILENO, "\x1b[2J", 4);
write(STDOUT_FILENO, "\x1b[H", 3);
}
return(0);
}
//
// End clean-screen.c
//
|
the_stack_data/156393537.c | #include <stdio.h>
void insertionsort(int *v, int l, int r){
int aux;
for(int i=r; i>l; i--){
if(v[i-1]>v[i]){
aux = v[i];
v[i] = v[i-1];
v[i-1] = aux;
}
}
for(int i = l+2; i<=r; i++){
int j = i; int elemento = v[j];
while(elemento < v[j-1]){
v[j]=v[j-1];
j--;
}
v[j]=elemento;
}
for(int k=0; k<=r; k++){
if(k == r)
printf("%d\n", v[k]);
else
printf("%d ", v[k]);
}
}
int main(){
int num, i=0;
int v[50001];
while(scanf("%d", &num) != EOF){
v[i] = num;
i++;
}
insertionsort(v, 0, i-1);
return 0;
} |
the_stack_data/132946.c | #include<stdio.h>
int main()
{
int i,n,pos;
printf("Enter number of elements\n");
scanf("%d",&n);
int arr[n];
printf("Enter Array elements\n");
for(i=0;i<n;i++)
scanf("%d",&arr[i]);
printf("Enter the position to be deleted\n");
scanf("%d",&pos);
for(i=0;i<n;i++)
{
if(i==pos)
{
while(i<n-1)
{
arr[i]=arr[i+1];
i=i+1;
}
break;
}
}
n--;
printf("The new Array elements are \n");
for(i=0;i<n;i++)
printf("%d\t",arr[i]);
}
|
the_stack_data/654787.c | /*
Процесс сбора и обработки данных на программе, читающей пословно файл и
включающей слова в динамический массив указателей(ДМУ) с сохранением порядка.
*/
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <time.h>
#define SIZE0 100 // Начальная размерность ДМУ
/*
Значения счетчика операций сравнения cnt и «грязного» времени
работы программы clock()-T0 выводятся в консоль
*/
char **loadfile(FILE *fd){
int cnt = 0; // Счетчик сравнений
char str[1000] = {0};
int i, j, n = 0, sz = SIZE0; // Кол-во строк и размерность ДМУ
char **pp = malloc(sizeof(*pp) * sz); // Создать ДМУ
long T0 = clock(); // Начальное значение времени [ms]
while (fscanf(fd, "%s", str) == 1 ) {
for (i = 0; i < n; i++) { // трудоемкость по операциям сравнения имеет вид T=N2
cnt++; // Увеличение счетчика сравнений
if (strcmp(str, pp[i]) < 0) break;
}
for (j = n-1; j >= i; j--) {
pp[j+1] = pp[j];
}
pp[i] = strdup(str); // Копия строки в ДМ
n++; // Вывод статистики на каждые 5000 слов
if (n%5000 == 0) {
printf("%d\t%d\t%ld\n", n, cnt, clock()-T0);
}
if (n+1 == sz) { // Будет переполнение -
sz *= 2; // удвоить размерность
pp = realloc(pp, sizeof(*pp) * sz);
}
}
pp[n] = NULL; // Ограничитель массива указателей
printf("%d\t%d\t%ld\n", n, cnt, clock()-T0);
return pp;
}
/*
Main driver
*/
int main(){
int i = 0;
FILE *fd = fopen("text.txt", "r");
char **pp = loadfile(fd);
// убрать за собой
for (i = 0; pp[i] != NULL; i++) free(pp[i]);
free(pp);
fclose(fd);
return 0;
} |
the_stack_data/220455294.c | /*************************************************************************
*
* file: tilde.c
*
* =======================================================================
* tilde.c -- Tilde expansion code (~/foo := $HOME/foo).
*
* This file was munged from the GNU GDB software. The
* copyright has been retained to identify the origin of this code.
* Copyright (C) 1988,1989, 1991 Free Software Foundation, Inc.
*
* This file is part of GNU Readline, a library for reading lines
* of text with interactive input and history editing.
*
* Readline is free software; you can redistribute it and/or modify
* it under the terms of the GNU General Public License as published by
* the Free Software Foundation; either version 2 of the License, or
* (at your option) any later version.
*
* Readline is distributed in the hope that it will be useful,
* but WITHOUT ANY WARRANTY; without even the implied warranty of
* MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
* GNU General Public License for more details.
*
* You should have received a copy of the GNU General Public License
* along with this program; if not, write to the Free Software
* Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
* =======================================================================
*
* Copyright 1995-2003 Carnegie Mellon University,
* University of Michigan,
* University of Southern California/Information
* Sciences Institute. All rights reserved.
*
* Redistribution and use in source and binary forms, with or without
* modification, are permitted provided that the following conditions are met:
*
* 1. Redistributions of source code must retain the above copyright notice,
* this list of conditions and the following disclaimer.
* 2. Redistributions in binary form must reproduce the above copyright notice,
* this list of conditions and the following disclaimer in the documentation
* and/or other materials provided with the distribution.
*
* THIS SOFTWARE IS PROVIDED BY THE SOAR CONSORTIUM ``AS IS'' AND ANY EXPRESS OR
* IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF
* MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO
* EVENT SHALL THE SOAR CONSORTIUM OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT,
* INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES
* (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES;
* LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND
* ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT
* (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
* SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
* The views and conclusions contained in the software and documentation are
* those of the authors and should not be interpreted as representing official
* policies, either expressed or implied, of Carnegie Mellon University, the
* University of Michigan, the University of Southern California/Information
* Sciences Institute, or the Soar consortium.
* =======================================================================
*/
/* This following 22 lines were included from sysdep-norm.h */
/* System-dependent stuff, for ``normal'' systems */
#ifdef MSDOS
#define __MSDOS__
#endif
#ifdef __POWERPC__ /* This is a hack, but I don't know any better way to know
that we're on a Mac. */
#define MACINTOSH
#endif
#ifdef THINK_C
#define __MSDOS__
#include <string.h>
#include <types.h>
#else
#ifdef __SC__
#define __MSDOS__
#include <string.h>
#include <types.h>
#else
#if !defined(MACINTOSH)
#include <sys/types.h> /* Needed by dirent.h */
#endif
#endif
#endif
#if defined (USG) && defined (TIOCGWINSZ)
#include <sys/stream.h>
#if defined (USGr4) || defined (USGr3)
#include <sys/ptem.h>
#endif /* USGr4 */
#endif /* USG && TIOCGWINSZ */
#ifndef __SC__
#ifndef THINK_C
/* The following dirent checks come from the GNU */
/* autoconf 2.0 documentation */
#if HAVE_DIRENT_H
# include <dirent.h>
# define NAMLEN(dirent) strlen((dirent)->d_name)
#else
# define dirent direct
# define NAMLEN(dirent) (dirent)->d_namlen
# if HAVE_SYS_NDIR_H
# include <sys/ndir.h>
# endif
# if HAVE_SYS_DIR_H
# include <sys/dir.h>
# endif
# if HAVE_NDIR_H
# include <sys/ndir.h>
# endif
#endif
#endif /* THINK_C */
#endif /* __SC__ */
typedef struct dirent dirent;
#ifndef __MSDOS__
#ifdef __hpux
#ifndef _INCLUDE_POSIX_SOURCE
#define _INCLUDE_POSIX_SOURCE
#endif
#endif /* __hpux */
#if !defined(__SC__) && !defined(THINK_C) && !defined(WIN32) && !defined(MACINTOSH)
#include <pwd.h>
#endif /* !__SC__ && !THINK_C && !WIN32 */
#ifdef __hpux
#undef _INCLUDE_POSIX_SOURCE
#endif /* __hpux */
#endif /* __MSDOS__ */
#include <stdlib.h>
#ifndef savestring
#define savestring(x) (char *)strcpy (xmalloc (1 + strlen (x)), (x))
#endif
typedef int Function ();
#if !defined (NULL)
# define NULL 0x0
#endif
/* Changed the order of the following test from the GDB source! */
#if defined (TEST)
extern char *xmalloc (), *xrealloc ();
#else
static char *xmalloc (), *xrealloc ();
#endif /* TEST */
extern int strncmp( const char *string1, const char *string2, size_t count );
extern char *strncpy( char *strDest, const char *strSource, size_t count );
extern void print (char *format, ... );
extern size_t strlen( const char *string );
extern char *strcpy( char *strDestination, const char *strSource );
extern char *strcat( char *strDestination, const char *strSource );
/* The default value of tilde_additional_prefixes. This is set to
whitespace preceding a tilde so that simple programs which do not
perform any word separation get desired behaviour. */
static char *default_prefixes[] =
{ " ~", "\t~", (char *)NULL };
/* The default value of tilde_additional_suffixes. This is set to
whitespace or newline so that simple programs which do not
perform any word separation get desired behaviour. */
static char *default_suffixes[] =
{ " ", "\n", (char *)NULL };
/* If non-null, this contains the address of a function to call if the
standard meaning for expanding a tilde fails. The function is called
with the text (sans tilde, as in "foo"), and returns a malloc()'ed string
which is the expansion, or a NULL pointer if there is no expansion. */
Function *tilde_expansion_failure_hook = (Function *)NULL;
/* When non-null, this is a NULL terminated array of strings which
are duplicates for a tilde prefix. Bash uses this to expand
`=~' and `:~'. */
char **tilde_additional_prefixes = default_prefixes;
/* When non-null, this is a NULL terminated array of strings which match
the end of a username, instead of just "/". Bash sets this to
`:' and `=~'. */
char **tilde_additional_suffixes = default_suffixes;
/* Find the start of a tilde expansion in STRING, and return the index of
the tilde which starts the expansion. Place the length of the text
which identified this tilde starter in LEN, excluding the tilde itself. */
static int tilde_find_prefix (char *string, int *len) {
register int i, j, string_len;
register char **prefixes = tilde_additional_prefixes;
string_len = strlen (string);
*len = 0;
if (!*string || *string == '~')
return (0);
if (prefixes) {
for (i = 0; i < string_len; i++) {
for (j = 0; prefixes[j]; j++) {
if (strncmp (string + i, prefixes[j], strlen (prefixes[j])) == 0) {
*len = strlen (prefixes[j]) - 1;
return (i + *len);
}
}
}
}
return (string_len);
}
/* Find the end of a tilde expansion in STRING, and return the index of
the character which ends the tilde definition. */
static int tilde_find_suffix (char *string) {
register int i, j, string_len;
register char **suffixes = tilde_additional_suffixes;
string_len = strlen (string);
for (i = 0; i < string_len; i++) {
if (string[i] == '/' || !string[i])
break;
for (j = 0; suffixes && suffixes[j]; j++) {
if (strncmp (string + i, suffixes[j], strlen (suffixes[j])) == 0)
return (i);
}
}
return (i);
}
/* Return a new string which is the result of tilde expanding FILENAME. */
char *tilde_expand (char *filename) {
char *result, *tilde_expand_word ();
int result_size, result_index;
result_size = result_index = 0;
result = (char *)NULL;
/* Scan through FILENAME expanding tildes as we come to them. */
while (1) {
register int start, end;
char *tilde_word, *expansion;
int len;
/* Make START point to the tilde which starts the expansion. */
start = tilde_find_prefix (filename, &len);
/* Copy the skipped text into the result. */
/* This test is always true the first time, since result_index
is 0, result_size is 0, and start is >= 0. So we malloc here. */
if ((result_index + start + 1) > result_size) {
result_size += (start + 20);
if (result == NULL)
result = (char *)xmalloc ( 1 + result_size);
else
result = (char *)xrealloc (result, 1 + result_size);
}
strncpy (result + result_index, filename, start);
result_index += start;
/* Advance FILENAME upto the starting tilde. */
filename += start;
/* Make END be the index of one after the last character of the
username. */
end = tilde_find_suffix (filename);
/* If both START and END are zero, we are all done. */
if (!start && !end)
break;
/* Expand the entire tilde word, and copy it into RESULT. */
tilde_word = (char *)xmalloc (1 + end);
strncpy (tilde_word, filename, end);
tilde_word[end] = '\0';
filename += end;
expansion = tilde_expand_word (tilde_word);
free (tilde_word);
len = strlen (expansion);
if ((result_index + len + 1) > result_size)
result = (char *)xrealloc (result, 1 + (result_size += (len + 20)));
strcpy (result + result_index, expansion);
result_index += len;
free (expansion);
}
result[result_index] = '\0';
return (result);
}
/* Do the work of tilde expansion on FILENAME. FILENAME starts with a
tilde. If there is no expansion, call tilde_expansion_failure_hook. */
char *tilde_expand_word (char *filename) {
char *dirname = filename ? savestring (filename) : (char *)NULL;
if (dirname && *dirname == '~') {
char *temp_name;
if (!dirname[1] || dirname[1] == '/') {
/* Prepend $HOME to the rest of the string. */
char *temp_home = (char *)getenv ("HOME");
temp_name = (char *)xmalloc (1 + strlen (&dirname[1])
+ (temp_home? strlen (temp_home) : 0));
temp_name[0] = '\0';
if (temp_home)
strcpy (temp_name, temp_home);
strcat (temp_name, &dirname[1]);
free (dirname);
dirname = savestring (temp_name);
free (temp_name);
} else {
#if !defined(__MSDOS__) && !defined(WIN32) && !defined(MACINTOSH)
struct passwd *getpwnam (), *user_entry;
#endif
char *username = (char *)xmalloc (257);
int i, c;
for (i = 1; c = dirname[i]; i++) {
if (c == '/')
break;
else
username[i - 1] = c;
}
username[i - 1] = '\0';
#if !defined(__MSDOS__) && !defined(WIN32) && !defined(MACINTOSH)
if (!(user_entry = getpwnam (username))) {
/* If the calling program has a special syntax for
expanding tildes, and we couldn't find a standard
expansion, then let them try. */
#endif
if (tilde_expansion_failure_hook) {
char *expansion;
expansion = (char *)(*tilde_expansion_failure_hook) (username);
if (expansion) {
temp_name = (char *)xmalloc (1 + strlen (expansion)
+ strlen (&dirname[i]));
strcpy (temp_name, expansion);
strcat (temp_name, &dirname[i]);
free (expansion);
goto return_name;
}
}
/* We shouldn't report errors. */
#if !defined(__MSDOS__) && !defined(WIN32) && !defined(MACINTOSH)
} else {
temp_name = (char *)xmalloc(1 + strlen (user_entry->pw_dir)
+ strlen (&dirname[i]));
strcpy (temp_name, user_entry->pw_dir);
strcat (temp_name, &dirname[i]);
#endif
return_name:
free (dirname);
dirname = savestring (temp_name);
free (temp_name);
#if !defined(__MSDOS__) && !defined(WIN32) && !defined(MACINTOSH)
}
endpwent ();
#endif
free(username);
}
}
return (dirname);
}
#if defined (TEST)
#undef NULL
#include <stdio.h>
main (int argc, char **argv) {
char *result, line[512];
int done = 0;
while (!done) {
printf ("~expand: ");
fflush (stdout);
if (!gets (line))
strcpy (line, "done");
if ((strcmp (line, "done") == 0) ||
(strcmp (line, "quit") == 0) ||
(strcmp (line, "exit") == 0)) {
done = 1;
break;
}
result = tilde_expand (line);
printf (" --> %s\n", result);
free (result);
}
exit (0);
}
/* Moved the following #endif up from the end of the file in GDB! */
#endif /* TEST */
static void memory_error_and_abort ();
static char *xmalloc (int bytes) {
char *temp = (char *)malloc ((size_t)bytes);
if (!temp)
memory_error_and_abort ();
return (temp);
}
static char *xrealloc (char *pointer, int bytes) {
char *temp;
if (!pointer)
temp = (char *)malloc ((size_t)bytes);
else
temp = (char *)realloc (pointer, (size_t)bytes);
if (!temp)
memory_error_and_abort ();
return (temp);
}
static void memory_error_and_abort () {
/* was: fprintf (stderr, "readline: Out of virtual memory!\n"); */
print ("readline: Out of virtual memory!\n");
abort ();
}
/*
* Local variables:
* compile-command: "gcc -g -DTEST -o tilde tilde.c"
* end:
*/
|
the_stack_data/51925.c | int main(void){
return 0;
}
|
Subsets and Splits
No community queries yet
The top public SQL queries from the community will appear here once available.