file
stringlengths 18
26
| data
stringlengths 3
1.04M
|
---|---|
the_stack_data/211956.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 integer c__1 = 1;
static doublereal c_b11 = 1.;
/* > \brief \b DPTRFS */
/* =========== DOCUMENTATION =========== */
/* Online html documentation available at */
/* http://www.netlib.org/lapack/explore-html/ */
/* > \htmlonly */
/* > Download DPTRFS + dependencies */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/dptrfs.
f"> */
/* > [TGZ]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/dptrfs.
f"> */
/* > [ZIP]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/dptrfs.
f"> */
/* > [TXT]</a> */
/* > \endhtmlonly */
/* Definition: */
/* =========== */
/* SUBROUTINE DPTRFS( N, NRHS, D, E, DF, EF, B, LDB, X, LDX, FERR, */
/* BERR, WORK, INFO ) */
/* INTEGER INFO, LDB, LDX, N, NRHS */
/* DOUBLE PRECISION B( LDB, * ), BERR( * ), D( * ), DF( * ), */
/* $ E( * ), EF( * ), FERR( * ), WORK( * ), */
/* $ X( LDX, * ) */
/* > \par Purpose: */
/* ============= */
/* > */
/* > \verbatim */
/* > */
/* > DPTRFS improves the computed solution to a system of linear */
/* > equations when the coefficient matrix is symmetric positive definite */
/* > and tridiagonal, and provides error bounds and backward error */
/* > estimates for the solution. */
/* > \endverbatim */
/* Arguments: */
/* ========== */
/* > \param[in] N */
/* > \verbatim */
/* > N is INTEGER */
/* > The order of the matrix A. N >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in] NRHS */
/* > \verbatim */
/* > NRHS is INTEGER */
/* > The number of right hand sides, i.e., the number of columns */
/* > of the matrix B. NRHS >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in] D */
/* > \verbatim */
/* > D is DOUBLE PRECISION array, dimension (N) */
/* > The n diagonal elements of the tridiagonal matrix A. */
/* > \endverbatim */
/* > */
/* > \param[in] E */
/* > \verbatim */
/* > E is DOUBLE PRECISION array, dimension (N-1) */
/* > The (n-1) subdiagonal elements of the tridiagonal matrix A. */
/* > \endverbatim */
/* > */
/* > \param[in] DF */
/* > \verbatim */
/* > DF is DOUBLE PRECISION array, dimension (N) */
/* > The n diagonal elements of the diagonal matrix D from the */
/* > factorization computed by DPTTRF. */
/* > \endverbatim */
/* > */
/* > \param[in] EF */
/* > \verbatim */
/* > EF is DOUBLE PRECISION array, dimension (N-1) */
/* > The (n-1) subdiagonal elements of the unit bidiagonal factor */
/* > L from the factorization computed by DPTTRF. */
/* > \endverbatim */
/* > */
/* > \param[in] B */
/* > \verbatim */
/* > B is DOUBLE PRECISION array, dimension (LDB,NRHS) */
/* > The right hand side matrix B. */
/* > \endverbatim */
/* > */
/* > \param[in] LDB */
/* > \verbatim */
/* > LDB is INTEGER */
/* > The leading dimension of the array B. LDB >= f2cmax(1,N). */
/* > \endverbatim */
/* > */
/* > \param[in,out] X */
/* > \verbatim */
/* > X is DOUBLE PRECISION array, dimension (LDX,NRHS) */
/* > On entry, the solution matrix X, as computed by DPTTRS. */
/* > On exit, the improved solution matrix X. */
/* > \endverbatim */
/* > */
/* > \param[in] LDX */
/* > \verbatim */
/* > LDX is INTEGER */
/* > The leading dimension of the array X. LDX >= f2cmax(1,N). */
/* > \endverbatim */
/* > */
/* > \param[out] FERR */
/* > \verbatim */
/* > FERR is DOUBLE PRECISION array, dimension (NRHS) */
/* > The forward error bound for each solution vector */
/* > X(j) (the j-th column of the solution matrix X). */
/* > If XTRUE is the true solution corresponding to X(j), FERR(j) */
/* > is an estimated upper bound for the magnitude of the largest */
/* > element in (X(j) - XTRUE) divided by the magnitude of the */
/* > largest element in X(j). */
/* > \endverbatim */
/* > */
/* > \param[out] BERR */
/* > \verbatim */
/* > BERR is DOUBLE PRECISION array, dimension (NRHS) */
/* > The componentwise relative backward error of each solution */
/* > vector X(j) (i.e., the smallest relative change in */
/* > any element of A or B that makes X(j) an exact solution). */
/* > \endverbatim */
/* > */
/* > \param[out] WORK */
/* > \verbatim */
/* > WORK is DOUBLE PRECISION array, dimension (2*N) */
/* > \endverbatim */
/* > */
/* > \param[out] INFO */
/* > \verbatim */
/* > INFO is INTEGER */
/* > = 0: successful exit */
/* > < 0: if INFO = -i, the i-th argument had an illegal value */
/* > \endverbatim */
/* > \par Internal Parameters: */
/* ========================= */
/* > */
/* > \verbatim */
/* > ITMAX is the maximum number of steps of iterative refinement. */
/* > \endverbatim */
/* Authors: */
/* ======== */
/* > \author Univ. of Tennessee */
/* > \author Univ. of California Berkeley */
/* > \author Univ. of Colorado Denver */
/* > \author NAG Ltd. */
/* > \date December 2016 */
/* > \ingroup doublePTcomputational */
/* ===================================================================== */
/* Subroutine */ int dptrfs_(integer *n, integer *nrhs, doublereal *d__,
doublereal *e, doublereal *df, doublereal *ef, doublereal *b, integer
*ldb, doublereal *x, integer *ldx, doublereal *ferr, doublereal *berr,
doublereal *work, integer *info)
{
/* System generated locals */
integer b_dim1, b_offset, x_dim1, x_offset, i__1, i__2;
doublereal d__1, d__2, d__3;
/* Local variables */
doublereal safe1, safe2;
integer i__, j;
doublereal s;
extern /* Subroutine */ int daxpy_(integer *, doublereal *, doublereal *,
integer *, doublereal *, integer *);
integer count;
doublereal bi;
extern doublereal dlamch_(char *);
doublereal cx, dx, ex;
integer ix;
extern integer idamax_(integer *, doublereal *, integer *);
integer nz;
doublereal safmin;
extern /* Subroutine */ int xerbla_(char *, integer *, ftnlen);
doublereal lstres;
extern /* Subroutine */ int dpttrs_(integer *, integer *, doublereal *,
doublereal *, doublereal *, integer *, integer *);
doublereal eps;
/* -- LAPACK computational routine (version 3.7.0) -- */
/* -- LAPACK is a software package provided by Univ. of Tennessee, -- */
/* -- Univ. of California Berkeley, Univ. of Colorado Denver and NAG Ltd..-- */
/* December 2016 */
/* ===================================================================== */
/* Test the input parameters. */
/* Parameter adjustments */
--d__;
--e;
--df;
--ef;
b_dim1 = *ldb;
b_offset = 1 + b_dim1 * 1;
b -= b_offset;
x_dim1 = *ldx;
x_offset = 1 + x_dim1 * 1;
x -= x_offset;
--ferr;
--berr;
--work;
/* Function Body */
*info = 0;
if (*n < 0) {
*info = -1;
} else if (*nrhs < 0) {
*info = -2;
} else if (*ldb < f2cmax(1,*n)) {
*info = -8;
} else if (*ldx < f2cmax(1,*n)) {
*info = -10;
}
if (*info != 0) {
i__1 = -(*info);
xerbla_("DPTRFS", &i__1, (ftnlen)6);
return 0;
}
/* Quick return if possible */
if (*n == 0 || *nrhs == 0) {
i__1 = *nrhs;
for (j = 1; j <= i__1; ++j) {
ferr[j] = 0.;
berr[j] = 0.;
/* L10: */
}
return 0;
}
/* NZ = maximum number of nonzero elements in each row of A, plus 1 */
nz = 4;
eps = dlamch_("Epsilon");
safmin = dlamch_("Safe minimum");
safe1 = nz * safmin;
safe2 = safe1 / eps;
/* Do for each right hand side */
i__1 = *nrhs;
for (j = 1; j <= i__1; ++j) {
count = 1;
lstres = 3.;
L20:
/* Loop until stopping criterion is satisfied. */
/* Compute residual R = B - A * X. Also compute */
/* abs(A)*abs(x) + abs(b) for use in the backward error bound. */
if (*n == 1) {
bi = b[j * b_dim1 + 1];
dx = d__[1] * x[j * x_dim1 + 1];
work[*n + 1] = bi - dx;
work[1] = abs(bi) + abs(dx);
} else {
bi = b[j * b_dim1 + 1];
dx = d__[1] * x[j * x_dim1 + 1];
ex = e[1] * x[j * x_dim1 + 2];
work[*n + 1] = bi - dx - ex;
work[1] = abs(bi) + abs(dx) + abs(ex);
i__2 = *n - 1;
for (i__ = 2; i__ <= i__2; ++i__) {
bi = b[i__ + j * b_dim1];
cx = e[i__ - 1] * x[i__ - 1 + j * x_dim1];
dx = d__[i__] * x[i__ + j * x_dim1];
ex = e[i__] * x[i__ + 1 + j * x_dim1];
work[*n + i__] = bi - cx - dx - ex;
work[i__] = abs(bi) + abs(cx) + abs(dx) + abs(ex);
/* L30: */
}
bi = b[*n + j * b_dim1];
cx = e[*n - 1] * x[*n - 1 + j * x_dim1];
dx = d__[*n] * x[*n + j * x_dim1];
work[*n + *n] = bi - cx - dx;
work[*n] = abs(bi) + abs(cx) + abs(dx);
}
/* Compute componentwise relative backward error from formula */
/* f2cmax(i) ( abs(R(i)) / ( abs(A)*abs(X) + abs(B) )(i) ) */
/* where abs(Z) is the componentwise absolute value of the matrix */
/* or vector Z. If the i-th component of the denominator is less */
/* than SAFE2, then SAFE1 is added to the i-th components of the */
/* numerator and denominator before dividing. */
s = 0.;
i__2 = *n;
for (i__ = 1; i__ <= i__2; ++i__) {
if (work[i__] > safe2) {
/* Computing MAX */
d__2 = s, d__3 = (d__1 = work[*n + i__], abs(d__1)) / work[
i__];
s = f2cmax(d__2,d__3);
} else {
/* Computing MAX */
d__2 = s, d__3 = ((d__1 = work[*n + i__], abs(d__1)) + safe1)
/ (work[i__] + safe1);
s = f2cmax(d__2,d__3);
}
/* L40: */
}
berr[j] = s;
/* Test stopping criterion. Continue iterating if */
/* 1) The residual BERR(J) is larger than machine epsilon, and */
/* 2) BERR(J) decreased by at least a factor of 2 during the */
/* last iteration, and */
/* 3) At most ITMAX iterations tried. */
if (berr[j] > eps && berr[j] * 2. <= lstres && count <= 5) {
/* Update solution and try again. */
dpttrs_(n, &c__1, &df[1], &ef[1], &work[*n + 1], n, info);
daxpy_(n, &c_b11, &work[*n + 1], &c__1, &x[j * x_dim1 + 1], &c__1)
;
lstres = berr[j];
++count;
goto L20;
}
/* Bound error from formula */
/* norm(X - XTRUE) / norm(X) .le. FERR = */
/* norm( abs(inv(A))* */
/* ( abs(R) + NZ*EPS*( abs(A)*abs(X)+abs(B) ))) / norm(X) */
/* where */
/* norm(Z) is the magnitude of the largest component of Z */
/* inv(A) is the inverse of A */
/* abs(Z) is the componentwise absolute value of the matrix or */
/* vector Z */
/* NZ is the maximum number of nonzeros in any row of A, plus 1 */
/* EPS is machine epsilon */
/* The i-th component of abs(R)+NZ*EPS*(abs(A)*abs(X)+abs(B)) */
/* is incremented by SAFE1 if the i-th component of */
/* abs(A)*abs(X) + abs(B) is less than SAFE2. */
i__2 = *n;
for (i__ = 1; i__ <= i__2; ++i__) {
if (work[i__] > safe2) {
work[i__] = (d__1 = work[*n + i__], abs(d__1)) + nz * eps *
work[i__];
} else {
work[i__] = (d__1 = work[*n + i__], abs(d__1)) + nz * eps *
work[i__] + safe1;
}
/* L50: */
}
ix = idamax_(n, &work[1], &c__1);
ferr[j] = work[ix];
/* Estimate the norm of inv(A). */
/* Solve M(A) * x = e, where M(A) = (m(i,j)) is given by */
/* m(i,j) = abs(A(i,j)), i = j, */
/* m(i,j) = -abs(A(i,j)), i .ne. j, */
/* and e = [ 1, 1, ..., 1 ]**T. Note M(A) = M(L)*D*M(L)**T. */
/* Solve M(L) * x = e. */
work[1] = 1.;
i__2 = *n;
for (i__ = 2; i__ <= i__2; ++i__) {
work[i__] = work[i__ - 1] * (d__1 = ef[i__ - 1], abs(d__1)) + 1.;
/* L60: */
}
/* Solve D * M(L)**T * x = b. */
work[*n] /= df[*n];
for (i__ = *n - 1; i__ >= 1; --i__) {
work[i__] = work[i__] / df[i__] + work[i__ + 1] * (d__1 = ef[i__],
abs(d__1));
/* L70: */
}
/* Compute norm(inv(A)) = f2cmax(x(i)), 1<=i<=n. */
ix = idamax_(n, &work[1], &c__1);
ferr[j] *= (d__1 = work[ix], abs(d__1));
/* Normalize error. */
lstres = 0.;
i__2 = *n;
for (i__ = 1; i__ <= i__2; ++i__) {
/* Computing MAX */
d__2 = lstres, d__3 = (d__1 = x[i__ + j * x_dim1], abs(d__1));
lstres = f2cmax(d__2,d__3);
/* L80: */
}
if (lstres != 0.) {
ferr[j] /= lstres;
}
/* L90: */
}
return 0;
/* End of DPTRFS */
} /* dptrfs_ */
|
the_stack_data/38482.c | #include <stdio.h>
#include <dlfcn.h>
#include <pthread.h>
#include <fcntl.h>
#include <unistd.h>
#include <dlfcn.h>
//int hacked_method(int p)
//{
// p=p*2;
// p=p+3;
// p=p*3;
// p=p-5;
// return p%100;
//}
typedef int (*HackedMethod)(int);
int main()
{
void *handle = dlopen("/data/local/tmp/libtarget.so", RTLD_NOW);
if(!handle)
{
fprintf(stderr,"dlopen error:%s\n",dlerror());
return -1;
}
dlerror();
void * sym = dlsym(handle,"hacked_method");
if (sym==NULL)
{
fprintf(stderr,"dlsym error:%s\n",dlerror());
return -1;
}
HackedMethod hacked_method=(HackedMethod)(sym);
int count=1;
while (1)
{
printf("hacked_method() return:%d.\n\n", (*hacked_method)(count));
count++;
sleep(5);
}
return 0;
}
|
the_stack_data/117675.c | // https://github.com/KubaO/stackoverflown/tree/master/questions/cstr-alloc-32379663
#include <string.h>
#include <stdlib.h>
/// Returns a newly allocated "foo". The user must free it.
char* func2(void) {
return strdup("foo");
}
/// Returns a newly allocated "foobar". The user must free it.
char* func1(void) {
char* str1 = func2();
const char str2[] = "bar";
char* str = malloc(strlen(str1) + sizeof(str2));
strcat(strcpy(str, str1), str2);
free(str1);
return str;
}
int main() {
char* str = func1();
printf("%s\n", str);
free(str);
}
|
the_stack_data/130133.c | #include <stdio.h>
double sqrt(double S) {
double S2;//Variable for optimization. Number for square root calculation multiplied to 2
double x; //Variable of axis x
double c; //Correction of variable x
//Initial value of x
if (S > 1000000) {x = 1000;} else {
if (S > 10000) {x = 100;} else {
if (S > 100) {x = 10;} else {x = 1;}
}
}
//S2 variable for optimization, we don't need multiply S to 2 every time
S2 = S * 2;
c = 2.0;
while (c > 1.0000001) { //Accuracy
c = S2 / (S+x*x);
x = x * c;
if(c < 1.0) {
c = 2.0 - c;
}
}
return x;
}
int main() {
double S;
S = 2.0;
printf("%f\n", S);
double result;
result = sqrt(S);
printf("%f\n", result);
return 0;
}
|
the_stack_data/23574088.c | /*
* pr_pset15_05.c
* rbits() -- the function that rotates the bits of an unsigned int by
* a specified number of bits to the left.
* Created by gres.cher on 08/02/19.
*/
#include <limits.h>
#include <stdio.h>
#include <stdlib.h>
void print_bin(const unsigned int num);
unsigned int rbits(unsigned int num, short nbits);
int main(void)
{
unsigned int num = 0;
short nbits;
printf("Enter the unsigned integer: ");
if (scanf("%u", &num) != 1)
exit(EXIT_FAILURE);
printf("Enter the number of bits to rotate: ");
if (scanf("%hu", &nbits) != 1 || (nbits < 0 || nbits > 31))
exit(EXIT_FAILURE);
printf("Your number is: %u\n", num);
print_bin(num);
num = rbits(num, nbits);
printf("\nNew number is: %u\n", num);
print_bin(num);
puts("\nBye.");
return 0;
}
// Print the binary string
void print_bin(const unsigned int num)
{
// Initialize the mask with '1' in the high-order bit
// For a 4-byte integer it will be 0x80000000
unsigned int mask = 0x1 << (CHAR_BIT * sizeof(int) - 1);
for (int i = 1; mask > 0; i++, mask >>= 1)
{
if ((num & mask) == mask)
putchar('1');
else
putchar('0');
// Brake the bits into groups of 4
if (i % 4 == 0 && mask != 0x1)
putchar(' ');
}
}
// Rotates the bits of an unsigned int by a specified number of bits to the left
unsigned int rbits(unsigned int num, short nbits)
{
unsigned int mask = 0x1 << (CHAR_BIT * sizeof(unsigned int) - 1);
num = num % (CHAR_BIT * sizeof(unsigned int));
while (nbits--)
{
if ((num & mask) == mask)
{
// The high-order bit is 1
num <<= 1;
num |= 0x1; // Change the low-order bit to 1
}
else
// The high-order bit is 0
num <<= 1;
}
return num;
}
|
the_stack_data/154826952.c | /* hw11_19 */
#include <stdio.h>
#include <stdlib.h>
int main(void)
{
char key;
enum color
{
red=114,
RED=82,
green=103,
GREEN=71,
blue=98,
BLUE=66
}shirt;
do
{
printf("請輸入r,g或b(大小寫沒有區別): ");
scanf("%c",&key);
fflush(stdin);
}while((key!=red)&&(key!=RED)&&(key!=green)&&(key!=GREEN)&&(key!=blue)&&(key!=BLUE));
shirt=key;
switch(shirt)
{
case red:
case RED:
printf("您選擇了紅色\n");
break;
case green:
case GREEN:
printf("您選擇了綠色\n");
break;
case blue:
case BLUE:
printf("您選擇了藍色\n");
break;
}
system("pause");
return 0;
}
/*
請輸入r,g或b(大小寫沒有區別): g
您選擇了綠色
Press any key to continue . . .
*/
|
the_stack_data/150142220.c | extern void __VERIFIER_error() __attribute__ ((__noreturn__));
extern int __VERIFIER_nondet_int(void);
extern int printf (__const char *__restrict __format, ...);
/* Generated by CIL v. 1.3.7 */
/* print_CIL_Input is true */
struct JoinPoint {
void **(*fp)(struct JoinPoint * ) ;
void **args ;
int argsCount ;
char const **argsType ;
void *(*arg)(int , struct JoinPoint * ) ;
char const *(*argType)(int , struct JoinPoint * ) ;
void **retValue ;
char const *retType ;
char const *funcName ;
char const *targetName ;
char const *fileName ;
char const *kind ;
void *excep_return ;
};
struct __UTAC__CFLOW_FUNC {
int (*func)(int , int ) ;
int val ;
struct __UTAC__CFLOW_FUNC *next ;
};
struct __UTAC__EXCEPTION {
void *jumpbuf ;
unsigned long long prtValue ;
int pops ;
struct __UTAC__CFLOW_FUNC *cflowfuncs ;
};
typedef unsigned int size_t;
struct __ACC__ERR {
void *v ;
struct __ACC__ERR *next ;
};
#pragma merger(0,"Test.i","")
int cleanupTimeShifts = 4;
void timeShift(void) ;
void cleanup(void)
{ int i ;
int __cil_tmp2 ;
{
{
timeShift();
i = 0;
}
{
while (1) {
while_0_continue: /* CIL Label */ ;
{
__cil_tmp2 = cleanupTimeShifts - 1;
if (i < __cil_tmp2) {
} else {
goto while_0_break;
}
}
{
timeShift();
i = i + 1;
}
}
while_0_break: /* CIL Label */ ;
}
return;
}
}
void printPump(void) ;
void waterRise(void) ;
void changeMethaneLevel(void) ;
void Specification2(void)
{
{
{
timeShift();
printPump();
timeShift();
printPump();
timeShift();
printPump();
waterRise();
printPump();
timeShift();
printPump();
changeMethaneLevel();
printPump();
timeShift();
printPump();
cleanup();
}
return;
}
}
void setup(void)
{
{
return;
}
}
void test(void) ;
void runTest(void)
{
{
{
test();
}
return;
}
}
void select_helpers(void) ;
void select_features(void) ;
int valid_product(void) ;
int main(void)
{ int retValue_acc ;
int tmp ;
{
{
select_helpers();
select_features();
tmp = valid_product();
}
if (tmp) {
{
setup();
runTest();
}
} else {
}
retValue_acc = 0;
return (retValue_acc);
return (retValue_acc);
}
}
#pragma merger(0,"featureselect.i","")
int select_one(void) ;
int select_one(void)
{ int retValue_acc ;
int choice = __VERIFIER_nondet_int();
{
retValue_acc = choice;
return (retValue_acc);
return (retValue_acc);
}
}
void select_features(void)
{
{
return;
}
}
void select_helpers(void)
{
{
return;
}
}
int valid_product(void)
{ int retValue_acc ;
{
retValue_acc = 1;
return (retValue_acc);
return (retValue_acc);
}
}
#pragma merger(0,"Environment.i","")
void lowerWaterLevel(void) ;
int isMethaneLevelCritical(void) ;
int getWaterLevel(void) ;
void printEnvironment(void) ;
int isLowWaterSensorDry(void) ;
int waterLevel = 1;
int methaneLevelCritical = 0;
void lowerWaterLevel(void)
{
{
if (waterLevel > 0) {
waterLevel = waterLevel - 1;
} else {
}
return;
}
}
void waterRise(void)
{
{
if (waterLevel < 2) {
waterLevel = waterLevel + 1;
} else {
}
return;
}
}
void changeMethaneLevel(void)
{
{
if (methaneLevelCritical) {
methaneLevelCritical = 0;
} else {
methaneLevelCritical = 1;
}
return;
}
}
int isMethaneLevelCritical(void)
{ int retValue_acc ;
{
retValue_acc = methaneLevelCritical;
return (retValue_acc);
return (retValue_acc);
}
}
void printEnvironment(void)
{
{
{
printf("Env(Water:%i", waterLevel);
printf(",Meth:");
}
if (methaneLevelCritical) {
{
printf("CRIT");
}
} else {
{
printf("OK");
}
}
{
printf(")");
}
return;
}
}
int getWaterLevel(void)
{ int retValue_acc ;
{
retValue_acc = waterLevel;
return (retValue_acc);
return (retValue_acc);
}
}
int isLowWaterSensorDry(void)
{ int retValue_acc ;
{
retValue_acc = waterLevel == 0;
return (retValue_acc);
return (retValue_acc);
}
}
#pragma merger(0,"libacc.i","")
extern __attribute__((__nothrow__, __noreturn__)) void __assert_fail(char const *__assertion ,
char const *__file ,
unsigned int __line ,
char const *__function ) ;
extern __attribute__((__nothrow__)) void *malloc(size_t __size ) __attribute__((__malloc__)) ;
extern __attribute__((__nothrow__)) void free(void *__ptr ) ;
void __utac__exception__cf_handler_set(void *exception , int (*cflow_func)(int ,
int ) ,
int val )
{ struct __UTAC__EXCEPTION *excep ;
struct __UTAC__CFLOW_FUNC *cf ;
void *tmp ;
unsigned long __cil_tmp7 ;
unsigned long __cil_tmp8 ;
unsigned long __cil_tmp9 ;
unsigned long __cil_tmp10 ;
unsigned long __cil_tmp11 ;
unsigned long __cil_tmp12 ;
unsigned long __cil_tmp13 ;
unsigned long __cil_tmp14 ;
int (**mem_15)(int , int ) ;
int *mem_16 ;
struct __UTAC__CFLOW_FUNC **mem_17 ;
struct __UTAC__CFLOW_FUNC **mem_18 ;
struct __UTAC__CFLOW_FUNC **mem_19 ;
{
{
excep = (struct __UTAC__EXCEPTION *)exception;
tmp = malloc(24UL);
cf = (struct __UTAC__CFLOW_FUNC *)tmp;
mem_15 = (int (**)(int , int ))cf;
*mem_15 = cflow_func;
__cil_tmp7 = (unsigned long )cf;
__cil_tmp8 = __cil_tmp7 + 8;
mem_16 = (int *)__cil_tmp8;
*mem_16 = val;
__cil_tmp9 = (unsigned long )cf;
__cil_tmp10 = __cil_tmp9 + 16;
__cil_tmp11 = (unsigned long )excep;
__cil_tmp12 = __cil_tmp11 + 24;
mem_17 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp10;
mem_18 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp12;
*mem_17 = *mem_18;
__cil_tmp13 = (unsigned long )excep;
__cil_tmp14 = __cil_tmp13 + 24;
mem_19 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp14;
*mem_19 = cf;
}
return;
}
}
void __utac__exception__cf_handler_free(void *exception )
{ struct __UTAC__EXCEPTION *excep ;
struct __UTAC__CFLOW_FUNC *cf ;
struct __UTAC__CFLOW_FUNC *tmp ;
unsigned long __cil_tmp5 ;
unsigned long __cil_tmp6 ;
struct __UTAC__CFLOW_FUNC *__cil_tmp7 ;
unsigned long __cil_tmp8 ;
unsigned long __cil_tmp9 ;
unsigned long __cil_tmp10 ;
unsigned long __cil_tmp11 ;
void *__cil_tmp12 ;
unsigned long __cil_tmp13 ;
unsigned long __cil_tmp14 ;
struct __UTAC__CFLOW_FUNC **mem_15 ;
struct __UTAC__CFLOW_FUNC **mem_16 ;
struct __UTAC__CFLOW_FUNC **mem_17 ;
{
excep = (struct __UTAC__EXCEPTION *)exception;
__cil_tmp5 = (unsigned long )excep;
__cil_tmp6 = __cil_tmp5 + 24;
mem_15 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp6;
cf = *mem_15;
{
while (1) {
while_1_continue: /* CIL Label */ ;
{
__cil_tmp7 = (struct __UTAC__CFLOW_FUNC *)0;
__cil_tmp8 = (unsigned long )__cil_tmp7;
__cil_tmp9 = (unsigned long )cf;
if (__cil_tmp9 != __cil_tmp8) {
} else {
goto while_1_break;
}
}
{
tmp = cf;
__cil_tmp10 = (unsigned long )cf;
__cil_tmp11 = __cil_tmp10 + 16;
mem_16 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp11;
cf = *mem_16;
__cil_tmp12 = (void *)tmp;
free(__cil_tmp12);
}
}
while_1_break: /* CIL Label */ ;
}
__cil_tmp13 = (unsigned long )excep;
__cil_tmp14 = __cil_tmp13 + 24;
mem_17 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp14;
*mem_17 = (struct __UTAC__CFLOW_FUNC *)0;
return;
}
}
void __utac__exception__cf_handler_reset(void *exception )
{ struct __UTAC__EXCEPTION *excep ;
struct __UTAC__CFLOW_FUNC *cf ;
unsigned long __cil_tmp5 ;
unsigned long __cil_tmp6 ;
struct __UTAC__CFLOW_FUNC *__cil_tmp7 ;
unsigned long __cil_tmp8 ;
unsigned long __cil_tmp9 ;
int (*__cil_tmp10)(int , int ) ;
unsigned long __cil_tmp11 ;
unsigned long __cil_tmp12 ;
int __cil_tmp13 ;
unsigned long __cil_tmp14 ;
unsigned long __cil_tmp15 ;
struct __UTAC__CFLOW_FUNC **mem_16 ;
int (**mem_17)(int , int ) ;
int *mem_18 ;
struct __UTAC__CFLOW_FUNC **mem_19 ;
{
excep = (struct __UTAC__EXCEPTION *)exception;
__cil_tmp5 = (unsigned long )excep;
__cil_tmp6 = __cil_tmp5 + 24;
mem_16 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp6;
cf = *mem_16;
{
while (1) {
while_2_continue: /* CIL Label */ ;
{
__cil_tmp7 = (struct __UTAC__CFLOW_FUNC *)0;
__cil_tmp8 = (unsigned long )__cil_tmp7;
__cil_tmp9 = (unsigned long )cf;
if (__cil_tmp9 != __cil_tmp8) {
} else {
goto while_2_break;
}
}
{
mem_17 = (int (**)(int , int ))cf;
__cil_tmp10 = *mem_17;
__cil_tmp11 = (unsigned long )cf;
__cil_tmp12 = __cil_tmp11 + 8;
mem_18 = (int *)__cil_tmp12;
__cil_tmp13 = *mem_18;
(*__cil_tmp10)(4, __cil_tmp13);
__cil_tmp14 = (unsigned long )cf;
__cil_tmp15 = __cil_tmp14 + 16;
mem_19 = (struct __UTAC__CFLOW_FUNC **)__cil_tmp15;
cf = *mem_19;
}
}
while_2_break: /* CIL Label */ ;
}
{
__utac__exception__cf_handler_free(exception);
}
return;
}
}
void *__utac__error_stack_mgt(void *env , int mode , int count ) ;
static struct __ACC__ERR *head = (struct __ACC__ERR *)0;
void *__utac__error_stack_mgt(void *env , int mode , int count )
{ void *retValue_acc ;
struct __ACC__ERR *new ;
void *tmp ;
struct __ACC__ERR *temp ;
struct __ACC__ERR *next ;
void *excep ;
unsigned long __cil_tmp10 ;
unsigned long __cil_tmp11 ;
unsigned long __cil_tmp12 ;
unsigned long __cil_tmp13 ;
void *__cil_tmp14 ;
unsigned long __cil_tmp15 ;
unsigned long __cil_tmp16 ;
void *__cil_tmp17 ;
void **mem_18 ;
struct __ACC__ERR **mem_19 ;
struct __ACC__ERR **mem_20 ;
void **mem_21 ;
struct __ACC__ERR **mem_22 ;
void **mem_23 ;
void **mem_24 ;
{
if (count == 0) {
return (retValue_acc);
} else {
}
if (mode == 0) {
{
tmp = malloc(16UL);
new = (struct __ACC__ERR *)tmp;
mem_18 = (void **)new;
*mem_18 = env;
__cil_tmp10 = (unsigned long )new;
__cil_tmp11 = __cil_tmp10 + 8;
mem_19 = (struct __ACC__ERR **)__cil_tmp11;
*mem_19 = head;
head = new;
retValue_acc = (void *)new;
}
return (retValue_acc);
} else {
}
if (mode == 1) {
temp = head;
{
while (1) {
while_3_continue: /* CIL Label */ ;
if (count > 1) {
} else {
goto while_3_break;
}
{
__cil_tmp12 = (unsigned long )temp;
__cil_tmp13 = __cil_tmp12 + 8;
mem_20 = (struct __ACC__ERR **)__cil_tmp13;
next = *mem_20;
mem_21 = (void **)temp;
excep = *mem_21;
__cil_tmp14 = (void *)temp;
free(__cil_tmp14);
__utac__exception__cf_handler_reset(excep);
temp = next;
count = count - 1;
}
}
while_3_break: /* CIL Label */ ;
}
{
__cil_tmp15 = (unsigned long )temp;
__cil_tmp16 = __cil_tmp15 + 8;
mem_22 = (struct __ACC__ERR **)__cil_tmp16;
head = *mem_22;
mem_23 = (void **)temp;
excep = *mem_23;
__cil_tmp17 = (void *)temp;
free(__cil_tmp17);
__utac__exception__cf_handler_reset(excep);
retValue_acc = excep;
}
return (retValue_acc);
} else {
}
if (mode == 2) {
if (head) {
mem_24 = (void **)head;
retValue_acc = *mem_24;
return (retValue_acc);
} else {
retValue_acc = (void *)0;
return (retValue_acc);
}
} else {
}
return (retValue_acc);
}
}
void *__utac__get_this_arg(int i , struct JoinPoint *this )
{ void *retValue_acc ;
unsigned long __cil_tmp4 ;
unsigned long __cil_tmp5 ;
int __cil_tmp6 ;
int __cil_tmp7 ;
unsigned long __cil_tmp8 ;
unsigned long __cil_tmp9 ;
void **__cil_tmp10 ;
void **__cil_tmp11 ;
int *mem_12 ;
void ***mem_13 ;
{
if (i > 0) {
{
__cil_tmp4 = (unsigned long )this;
__cil_tmp5 = __cil_tmp4 + 16;
mem_12 = (int *)__cil_tmp5;
__cil_tmp6 = *mem_12;
if (i <= __cil_tmp6) {
} else {
{
__assert_fail("i > 0 && i <= this->argsCount", "libacc.c",
123U, "__utac__get_this_arg");
}
}
}
} else {
{
__assert_fail("i > 0 && i <= this->argsCount", "libacc.c",
123U, "__utac__get_this_arg");
}
}
__cil_tmp7 = i - 1;
__cil_tmp8 = (unsigned long )this;
__cil_tmp9 = __cil_tmp8 + 8;
mem_13 = (void ***)__cil_tmp9;
__cil_tmp10 = *mem_13;
__cil_tmp11 = __cil_tmp10 + __cil_tmp7;
retValue_acc = *__cil_tmp11;
return (retValue_acc);
return (retValue_acc);
}
}
char const *__utac__get_this_argtype(int i , struct JoinPoint *this )
{ char const *retValue_acc ;
unsigned long __cil_tmp4 ;
unsigned long __cil_tmp5 ;
int __cil_tmp6 ;
int __cil_tmp7 ;
unsigned long __cil_tmp8 ;
unsigned long __cil_tmp9 ;
char const **__cil_tmp10 ;
char const **__cil_tmp11 ;
int *mem_12 ;
char const ***mem_13 ;
{
if (i > 0) {
{
__cil_tmp4 = (unsigned long )this;
__cil_tmp5 = __cil_tmp4 + 16;
mem_12 = (int *)__cil_tmp5;
__cil_tmp6 = *mem_12;
if (i <= __cil_tmp6) {
} else {
{
__assert_fail("i > 0 && i <= this->argsCount", "libacc.c",
131U, "__utac__get_this_argtype");
}
}
}
} else {
{
__assert_fail("i > 0 && i <= this->argsCount", "libacc.c",
131U, "__utac__get_this_argtype");
}
}
__cil_tmp7 = i - 1;
__cil_tmp8 = (unsigned long )this;
__cil_tmp9 = __cil_tmp8 + 24;
mem_13 = (char const ***)__cil_tmp9;
__cil_tmp10 = *mem_13;
__cil_tmp11 = __cil_tmp10 + __cil_tmp7;
retValue_acc = *__cil_tmp11;
return (retValue_acc);
return (retValue_acc);
}
}
#pragma merger(0,"wsllib_check.i","")
void __automaton_fail(void)
{
{
ERROR: __VERIFIER_error();
return;
}
}
#pragma merger(0,"MinePump.i","")
void activatePump(void) ;
void deactivatePump(void) ;
int isPumpRunning(void) ;
void startSystem(void) ;
int pumpRunning = 0;
int systemActive = 1;
void __utac_acc__Specification3_spec__1(void) ;
void processEnvironment(void) ;
void timeShift(void)
{
{
if (pumpRunning) {
{
lowerWaterLevel();
}
} else {
}
if (systemActive) {
{
processEnvironment();
}
} else {
}
{
__utac_acc__Specification3_spec__1();
}
return;
}
}
void processEnvironment__wrappee__base(void)
{
{
return;
}
}
int isLowWaterLevel(void) ;
void processEnvironment(void)
{ int tmp ;
{
if (pumpRunning) {
{
tmp = isLowWaterLevel();
}
if (tmp) {
{
deactivatePump();
}
} else {
{
processEnvironment__wrappee__base();
}
}
} else {
{
processEnvironment__wrappee__base();
}
}
return;
}
}
void activatePump__wrappee__lowWaterSensor(void)
{
{
pumpRunning = 1;
return;
}
}
int isMethaneAlarm(void) ;
void activatePump(void)
{ int tmp ;
{
{
tmp = isMethaneAlarm();
}
if (tmp) {
} else {
{
activatePump__wrappee__lowWaterSensor();
}
}
return;
}
}
void deactivatePump(void)
{
{
pumpRunning = 0;
return;
}
}
int isMethaneAlarm(void)
{ int retValue_acc ;
{
{
retValue_acc = isMethaneLevelCritical();
}
return (retValue_acc);
return (retValue_acc);
}
}
int isPumpRunning(void)
{ int retValue_acc ;
{
retValue_acc = pumpRunning;
return (retValue_acc);
return (retValue_acc);
}
}
void printPump(void)
{
{
{
printf("Pump(System:");
}
if (systemActive) {
{
printf("On");
}
} else {
{
printf("Off");
}
}
{
printf(",Pump:");
}
if (pumpRunning) {
{
printf("On");
}
} else {
{
printf("Off");
}
}
{
printf(") ");
printEnvironment();
printf("\n");
}
return;
}
}
int isLowWaterLevel(void)
{ int retValue_acc ;
int tmp ;
int tmp___0 ;
{
{
tmp = isLowWaterSensorDry();
}
if (tmp) {
tmp___0 = 0;
} else {
tmp___0 = 1;
}
retValue_acc = tmp___0;
return (retValue_acc);
return (retValue_acc);
}
}
void startSystem(void)
{
{
systemActive = 1;
return;
}
}
#pragma merger(0,"scenario.i","")
void test(void)
{ int splverifierCounter ;
int tmp ;
int tmp___0 ;
int tmp___1 ;
int tmp___2 ;
{
splverifierCounter = 0;
{
while (1) {
while_4_continue: /* CIL Label */ ;
if (splverifierCounter < 4) {
} else {
goto while_4_break;
}
{
tmp = __VERIFIER_nondet_int();
}
if (tmp) {
{
waterRise();
}
} else {
}
{
tmp___0 = __VERIFIER_nondet_int();
}
if (tmp___0) {
{
changeMethaneLevel();
}
} else {
}
{
tmp___2 = __VERIFIER_nondet_int();
}
if (tmp___2) {
{
startSystem();
}
} else {
{
tmp___1 = __VERIFIER_nondet_int();
}
if (tmp___1) {
} else {
}
}
{
timeShift();
}
}
while_4_break: /* CIL Label */ ;
}
{
cleanup();
}
return;
}
}
#pragma merger(0,"Specification3_spec.i","")
void __utac_acc__Specification3_spec__1(void)
{ int tmp ;
int tmp___0 ;
int tmp___1 ;
{
{
tmp = isMethaneLevelCritical();
}
if (tmp) {
} else {
{
tmp___0 = getWaterLevel();
}
if (tmp___0 == 2) {
{
tmp___1 = isPumpRunning();
}
if (tmp___1) {
} else {
{
__automaton_fail();
}
}
} else {
}
}
return;
}
}
|
the_stack_data/212642227.c | // RUN: rm -rf %t*
// RUN: 3c -base-dir=%S -addcr -alltypes -output-dir=%t.checkedALL %s %S/arrstructcallermulti2.c --
// RUN: 3c -base-dir=%S -addcr -output-dir=%t.checkedNOALL %s %S/arrstructcallermulti2.c --
// RUN: %clang -working-directory=%t.checkedNOALL -c arrstructcallermulti1.c arrstructcallermulti2.c
// RUN: FileCheck -match-full-lines -check-prefixes="CHECK_NOALL","CHECK" --input-file %t.checkedNOALL/arrstructcallermulti1.c %s
// RUN: FileCheck -match-full-lines -check-prefixes="CHECK_ALL","CHECK" --input-file %t.checkedALL/arrstructcallermulti1.c %s
// RUN: 3c -base-dir=%S -alltypes -output-dir=%t.checked %S/arrstructcallermulti2.c %s --
// RUN: 3c -base-dir=%t.checked -alltypes -output-dir=%t.convert_again %t.checked/arrstructcallermulti1.c %t.checked/arrstructcallermulti2.c --
// RUN: test ! -f %t.convert_again/arrstructcallermulti1.c
// RUN: test ! -f %t.convert_again/arrstructcallermulti2.c
/******************************************************************************/
/*This file tests three functions: two callers bar and foo, and a callee sus*/
/*In particular, this file tests: arrays and structs, specifically by using an
array to traverse through the values of a struct*/
/*For robustness, this test is identical to
arrstructprotocaller.c and arrstructcaller.c except in that
the callee and callers are split amongst two files to see how
the tool performs conversions*/
/*In this test, foo and sus will treat their return values safely, but bar will
not, through invalid pointer arithmetic, an unsafe cast, etc.*/
/******************************************************************************/
#include <stddef.h>
#include <stdlib.h>
#include <stdio.h>
#include <string.h>
struct general {
int data;
struct general *next;
//CHECK: _Ptr<struct general> next;
};
struct warr {
int data1[5];
//CHECK_NOALL: int data1[5];
//CHECK_ALL: int data1 _Checked[5];
char *name;
//CHECK: _Ptr<char> name;
};
struct fptrarr {
int *values;
//CHECK: _Ptr<int> values;
char *name;
//CHECK: _Ptr<char> name;
int (*mapper)(int);
//CHECK: _Ptr<int (int)> mapper;
};
struct fptr {
int *value;
//CHECK: _Ptr<int> value;
int (*func)(int);
//CHECK: _Ptr<int (int)> func;
};
struct arrfptr {
int args[5];
//CHECK_NOALL: int args[5];
//CHECK_ALL: int args _Checked[5];
int (*funcs[5])(int);
//CHECK_NOALL: int (*funcs[5])(int);
//CHECK_ALL: _Ptr<int (int)> funcs _Checked[5];
};
static int add1(int x) {
//CHECK: static int add1(int x) _Checked {
return x + 1;
}
static int sub1(int x) {
//CHECK: static int sub1(int x) _Checked {
return x - 1;
}
static int fact(int n) {
//CHECK: static int fact(int n) _Checked {
if (n == 0) {
return 1;
}
return n * fact(n - 1);
}
static int fib(int n) {
//CHECK: static int fib(int n) _Checked {
if (n == 0) {
return 0;
}
if (n == 1) {
return 1;
}
return fib(n - 1) + fib(n - 2);
}
static int zerohuh(int n) {
//CHECK: static int zerohuh(int n) _Checked {
return !n;
}
static int *mul2(int *x) {
//CHECK: static _Ptr<int> mul2(_Ptr<int> x) _Checked {
*x *= 2;
return x;
}
int *sus(struct general *, struct general *);
//CHECK_NOALL: int *sus(struct general *x : itype(_Ptr<struct general>), _Ptr<struct general> y) : itype(_Ptr<int>);
//CHECK_ALL: _Array_ptr<int> sus(struct general *x : itype(_Ptr<struct general>), _Ptr<struct general> y) : count(5);
int *foo() {
//CHECK_NOALL: _Ptr<int> foo(void) {
//CHECK_ALL: _Array_ptr<int> foo(void) : count(5) {
struct general *x = malloc(sizeof(struct general));
//CHECK: _Ptr<struct general> x = malloc<struct general>(sizeof(struct general));
struct general *y = malloc(sizeof(struct general));
//CHECK: _Ptr<struct general> y = malloc<struct general>(sizeof(struct general));
struct general *curr = y;
//CHECK: _Ptr<struct general> curr = y;
int i;
for (i = 1; i < 5; i++, curr = curr->next) {
curr->data = i;
curr->next = malloc(sizeof(struct general));
curr->next->data = i + 1;
}
int *z = sus(x, y);
//CHECK_NOALL: _Ptr<int> z = sus(x, y);
//CHECK_ALL: _Array_ptr<int> z : count(5) = sus(x, y);
return z;
}
int *bar() {
//CHECK_NOALL: int *bar(void) : itype(_Ptr<int>) {
//CHECK_ALL: _Array_ptr<int> bar(void) {
struct general *x = malloc(sizeof(struct general));
//CHECK: _Ptr<struct general> x = malloc<struct general>(sizeof(struct general));
struct general *y = malloc(sizeof(struct general));
//CHECK: _Ptr<struct general> y = malloc<struct general>(sizeof(struct general));
struct general *curr = y;
//CHECK: _Ptr<struct general> curr = y;
int i;
for (i = 1; i < 5; i++, curr = curr->next) {
curr->data = i;
curr->next = malloc(sizeof(struct general));
curr->next->data = i + 1;
}
int *z = sus(x, y);
//CHECK_NOALL: int *z = sus(x, y);
//CHECK_ALL: _Array_ptr<int> __3c_lower_bound_z : count(5) = sus(x, y);
//CHECK_ALL: _Array_ptr<int> z : bounds(__3c_lower_bound_z, __3c_lower_bound_z + 5) = __3c_lower_bound_z;
z += 2;
return z;
}
|
the_stack_data/735896.c | /* Fig 9.5: fig09_05c */
/* Printing strings and characters */
#include <stdio.h>
int main( void )
{
char character = 'A'; /* initialize char */
char string[] = "This is a string"; /* initialize char array */
const char *stringPtr = "This is also a string"; /* char pointer */
printf( "%c\n", character );
printf( "%s\n", "This is a string" );
printf( "%s\n", string );
printf( "%s\n", stringPtr );
return 0; /* indicates successful termination */
} /* end main */
/**************************************************************************
* (C) Copyright 1992-2010 by Deitel & Associates, Inc. and *
* Pearson Education, Inc. All Rights Reserved. *
* *
* DISCLAIMER: The authors and publisher of this book have used their *
* best efforts in preparing the book. These efforts include the *
* development, research, and testing of the theories and programs *
* to determine their effectiveness. The authors and publisher make *
* no warranty of any kind, expressed or implied, with regard to these *
* programs or to the documentation contained in these books. The authors *
* and publisher shall not be liable in any event for incidental or *
* consequential damages in connection with, or arising out of, the *
* furnishing, performance, or use of these programs. *
*************************************************************************/ |
the_stack_data/59513838.c | /*
This is a program to run phantasia
David Wells, May, 1986
*/
main(argc, argv)
int argc;
char **argv;
{
char tmp[160];
strcat(tmp,"exec nice /usr/games/lib/phantasia/phantasia ");
if (argc > 1)
strcat(tmp,argv[1]);
system(tmp);
}
|
the_stack_data/156393011.c | /*
sinh(arg) returns the hyperbolic sine of its floating-
point argument.
The exponential function is called for arguments
greater in magnitude than 0.5.
A series is used for arguments smaller in magnitude than 0.5.
The coefficients are #2029 from Hart & Cheney. (20.36D)
cosh(arg) is computed from the exponential function for
all arguments.
*/
#include <math.h>
#include <errno.h>
static double p0 = -0.6307673640497716991184787251e+6;
static double p1 = -0.8991272022039509355398013511e+5;
static double p2 = -0.2894211355989563807284660366e+4;
static double p3 = -0.2630563213397497062819489e+2;
static double q0 = -0.6307673640497716991212077277e+6;
static double q1 = 0.1521517378790019070696485176e+5;
static double q2 = -0.173678953558233699533450911e+3;
double
sinh(double arg)
{
double temp, argsq;
int sign;
sign = 1;
if(arg < 0) {
arg = - arg;
sign = -1;
}
if(arg > 21) {
if(arg >= HUGE_VAL){
errno = ERANGE;
temp = HUGE_VAL;
} else
temp = exp(arg)/2;
if(sign > 0)
return temp;
else
return -temp;
}
if(arg > 0.5)
return sign*(exp(arg) - exp(-arg))/2;
argsq = arg*arg;
temp = (((p3*argsq+p2)*argsq+p1)*argsq+p0)*arg;
temp /= (((argsq+q2)*argsq+q1)*argsq+q0);
return sign*temp;
}
double
cosh(double arg)
{
if(arg < 0)
arg = - arg;
if(arg > 21) {
if(arg >= HUGE_VAL){
errno = ERANGE;
return HUGE_VAL;
} else
return(exp(arg)/2);
}
return (exp(arg) + exp(-arg))/2;
}
|
the_stack_data/1062882.c | /* from Unix 32V /usr/src/cmd/cal.c */
/*
* Copyright(C) Caldera International Inc. 2001-2002. 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 and documentation 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.
* All advertising materials mentioning features or use of this software
* must display the following acknowledgement:
* This product includes software developed or owned by Caldera
* International, Inc.
* Neither the name of Caldera International, Inc. nor the names of
* other contributors may be used to endorse or promote products
* derived from this software without specific prior written permission.
*
* USE OF THE SOFTWARE PROVIDED FOR UNDER THIS LICENSE BY CALDERA
* INTERNATIONAL, INC. 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 CALDERA INTERNATIONAL, INC. 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.
*/
#if __GNUC__ >= 3 && __GNUC_MINOR__ >= 4 || __GNUC__ >= 4
#define USED __attribute__ ((used))
#elif defined __GNUC__
#define USED __attribute__ ((unused))
#else
#define USED
#endif
static const char sccsid[] USED = "@(#)cal.sl 1.12 (gritter) 5/29/05";
#include <unistd.h>
#include <time.h>
#include <stdio.h>
#include <libgen.h>
#include <stdlib.h>
#include <locale.h>
#include <langinfo.h>
#include <string.h>
#include <wchar.h>
#include <limits.h>
static wchar_t dayw[] = {
' ', 'S', ' ', ' ', 'M', ' ', 'T', 'u', ' ', ' ',
'W', ' ', 'T', 'h', ' ', ' ', 'F', ' ', ' ', 'S', 0
};
static char *smon[]= {
"January", "February", "March", "April",
"May", "June", "July", "August",
"September", "October", "November", "December"
};
static char *amon[] = {
"Jan", "Feb", "Mar", "Apr",
"May", "Jun", "Jul", "Aug",
"Sep", "Oct", "Nov", "Dec"
};
static char string[432];
static char *progname;
static void usage(void);
static void bad(void);
static void dolocale(void);
static int number(const char *str);
static void pstr(char *str, int n);
static void cal(int m, int y, char *p, int w);
static int jan1(int yr);
static void wput(const wchar_t *);
int
main(int argc, char **argv)
{
register int y = 1, i, j;
int m = 1;
progname = basename(argv[0]);
dolocale();
if (argc > 1 && argv[1][0] == '-' && argv[1][1] == '-'
&& argv[1][2] == '\0')
argv++, argc--;
if (argc == 2)
goto xlong;
else if (argc == 1) {
time_t t;
struct tm *tp;
time(&t);
tp = localtime(&t);
m = tp->tm_mon + 1;
y = tp->tm_year + 1900;
} else if (argc == 3) {
/*
* print out just month
*/
m = number(argv[optind]);
if(m<1 || m>12)
bad();
y = number(argv[optind + 1]);
if(y<1 || y>9999)
bad();
} else
usage();
printf(" %s %u\n", smon[m-1], y);
wput(dayw);
putchar('\n');
cal(m, y, string, 24);
for(i=0; i<6*24; i+=24)
pstr(string+i, 24);
exit(0);
/*
* print out complete year
*/
xlong:
y = number(argv[optind]);
if(y<1 || y>9999)
bad();
printf("\n\n\n");
printf(" %u\n", y);
printf("\n");
for(i=0; i<12; i+=3) {
for(j=0; j<6*72; j++)
string[j] = '\0';
printf(" %.3s", amon[i]);
printf(" %.3s", amon[i+1]);
printf(" %.3s\n", amon[i+2]);
wput(dayw);
printf(" ");
wput(dayw);
printf(" ");
wput(dayw);
putchar('\n');
cal(i+1, y, string, 72);
cal(i+2, y, string+23, 72);
cal(i+3, y, string+46, 72);
for(j=0; j<6*72; j+=72)
pstr(string+j, 72);
}
printf("\n\n\n");
return 0;
}
static int
number(const char *str)
{
register int n, c;
register const char *s;
n = 0;
s = str;
while((c = *s++) != '\0') {
if(c<'0' || c>'9')
return(0);
n = n*10 + c-'0';
}
return(n);
}
static void
pstr(char *str, int n)
{
register int i;
register char *s;
s = str;
i = n;
while(i--)
if(*s++ == '\0')
s[-1] = ' ';
i = n+1;
while(i--)
if(*--s != ' ')
break;
s[1] = '\0';
printf("%s\n", str);
}
char mon[] = {
0,
31, 29, 31, 30,
31, 30, 31, 31,
30, 31, 30, 31,
};
static void
cal(int m, int y, char *p, int w)
{
register int d, i;
register char *s;
s = p;
d = jan1(y);
mon[2] = 29;
mon[9] = 30;
switch((jan1(y+1)+7-d)%7) {
/*
* non-leap year
*/
case 1:
mon[2] = 28;
break;
/*
* 1752
*/
default:
mon[9] = 19;
break;
/*
* leap year
*/
case 2:
;
}
for(i=1; i<m; i++)
d += mon[i];
d %= 7;
s += 3*d;
for(i=1; i<=mon[m]; i++) {
if(i==3 && mon[m]==19) {
i += 11;
mon[m] += 11;
}
if(i > 9)
*s = i/10+'0';
s++;
*s++ = i%10+'0';
s++;
if(++d == 7) {
d = 0;
s = p+w;
p = s;
}
}
}
/*
* return day of the week
* of jan 1 of given year
*/
static int
jan1(int yr)
{
register int y, d;
/*
* normal gregorian calendar
* one extra day per four years
*/
y = yr;
d = 4+y+(y+3)/4;
/*
* julian calendar
* regular gregorian
* less three days per 400
*/
if(y > 1800) {
d -= (y-1701)/100;
d += (y-1601)/400;
}
/*
* great calendar changeover instant
*/
if(y > 1752)
d += 3;
return(d%7);
}
static void
usage(void)
{
fprintf(stderr, "usage: %s [ [month] year ]\n", progname);
exit(2);
}
static void
bad(void)
{
fprintf(stderr, "Bad argument\n");
exit(1);
}
#define COPY_DAY(d) cp = nl_langinfo(DAY_##d); \
cp += mbtowc(wq++, cp, MB_CUR_MAX); \
cp += mbtowc(wq++, cp, MB_CUR_MAX); \
wq++
#define COPY_MONTH(m) smon[m - 1] = strdup(nl_langinfo(MON_##m))
#define COPY_ABMON(m) amon[m - 1] = strdup(nl_langinfo(ABMON_##m))
static void
dolocale(void)
{
char *cp;
wchar_t *wq;
#ifndef __dietlibc__
setlocale(LC_CTYPE, "");
cp = setlocale(LC_TIME, "");
if (cp && strcmp(cp, "C") && strcmp(cp, "POSIX") && strcmp(cp, "en") &&
strncmp(cp, "en_", 3)) {
#else /* __dietlibc__ */
if (1) {
#endif /* __dietlibc__ */
wq = dayw;
COPY_DAY(1);
COPY_DAY(2);
COPY_DAY(3);
COPY_DAY(4);
COPY_DAY(5);
COPY_DAY(6);
COPY_DAY(7);
COPY_MONTH(1);
COPY_MONTH(2);
COPY_MONTH(3);
COPY_MONTH(4);
COPY_MONTH(5);
COPY_MONTH(6);
COPY_MONTH(7);
COPY_MONTH(8);
COPY_MONTH(9);
COPY_MONTH(10);
COPY_MONTH(11);
COPY_MONTH(12);
COPY_ABMON(1);
COPY_ABMON(2);
COPY_ABMON(3);
COPY_ABMON(4);
COPY_ABMON(5);
COPY_ABMON(6);
COPY_ABMON(7);
COPY_ABMON(8);
COPY_ABMON(9);
COPY_ABMON(10);
COPY_ABMON(11);
COPY_ABMON(12);
}
}
static void
wput(const wchar_t *s)
{
char mb[MB_LEN_MAX];
int i, n;
s--;
while (*++s) {
n = wctomb(mb, *s);
for (i = 0; i < n; i++)
putchar(mb[i] & 0377);
}
}
|
the_stack_data/179831590.c | void __sv_add(int *c, int *a, int *b, int n) {
for (int i = 0; i < n; ++i) c[i] = a[i] + b[i];
}
int main() {
int a[1024], b[1024], c[1024];
for (int i = 0; i < 1024; ++i) {
a[i] = i;
b[i] = i + 1;
c[i] = i + 2;
}
__sv_add(c, a, b, 1024);
return 0;
}
|
the_stack_data/161081659.c | /*****************************************************************
OpenMP-3.0 Example Codes Beta-v1.0
File : parallel-construct-openmp3x.c
Description : Simple example program to demonstrate the use of
OpenMP parallel construct for coarse-grain parallelism
i.e each thread in the parallel region decide which part
of the global vector to work on based on the thread ID.
OpenMP Pragma /
Function Used : - #pragma omp parallel
Input : None
Output : Output Vector after scaling
************************************************************************/
/* Header file inclusion */
#include<stdio.h>
#include<stdlib.h>
/* Macro checking */
#ifdef _OPENMP
#include<omp.h>
#endif
/* global variable declaration */
int vectorSize;
/*
Description: Function perform the vector scaling by using the #pragma omp parllel
directive. where each thread in the parallel region decide which part of the global
vector to work on based on the thread.
@param [tempVector] : Starting address of the vector
@param [totalThreads] : Total number of the threads in the parallel region
@return : None
*/
void parVectScale(double *tempVector,int totalThreads)
{
int myId, istart, iend, partition, index;
/* Set the no. of threads */
omp_set_num_threads(totalThreads);
printf("\n\t\t Vector Scaling using OpenMP(parallel) Coarse Grain approach \n");
/* Coarse grain parallism using openmp parallel construct */
#pragma omp parallel private(myId, istart, iend, index)
{
myId = omp_get_thread_num();
/* Division of the work according to the thread ID */
partition = vectorSize / omp_get_num_threads();
istart = myId * partition;
iend = istart + partition-1;
printf("\n\t\t My Thread Id : %d , Start Index : %d , End Index : %d ",myId,istart,iend);
for ( index = istart ; index <= iend ; index++ )
tempVector[index] = 2 * tempVector[index];
}
} /* End of parVectScale function */
/*
Description : The function perform the vector scaling serially.
If the _OPENMP macro has not been defined the
computation will be performed serially.
@param [tempVector] : Starting address of the vector.
@return : None
*/
void serialVectScale(double *tempVector)
{
int index;
printf("\n\n\n\t Vector Scaling using serial version");
for ( index = 0 ; index < vectorSize ; index++ )
tempVector[index] = 2 * tempVector[index];
}/* End of function */
/* the main function*/
int main(int argc , char **argv)
{
int numThreads,index;
double *vector;
/* Checking for command line arguments */
if( argc != 3 ){
printf("\t\t Very Few Arguments\n ");
printf("\t\t Syntax : exec <vector-size> <No. of Threads>\n");
exit(-1);
}
vectorSize =atoi(argv[1]);
numThreads =atoi(argv[2]);
/* Allocating the Memory to the vector */
if((vector = (double *)malloc (sizeof(double) * vectorSize )) == NULL) {
perror( " Memory allocation for vector ");
exit(-1);
}
/* Initializing the vector */
for ( index = 0 ; index < vectorSize ; index++){
vector[index] = rand()+0.005 ;
// printf(" %lf ",vector[index]);
}
printf("\n\t\t Initializing Vector..........Done \n\t");
/* Function to perform vector scaling using openmp parallel construct */
#ifdef _OPENMP
parVectScale(vector,numThreads);
#else
/* Function to perform vector scaling serially */
serialVectScale(vector);
#endif
/* Uncomment to print the output vector */
/*printf("\n\t Vector after scaling \n\t");
for ( index = 0 ; index <vectorSize ; index++)
printf(" %lf ",vector[index]);*/
printf("\n\n");
return 0;
} /* End of main function */
|
the_stack_data/52393.c | /**
* \file ST7565R.c
* \brief Functions relating to ST7565R.
* \author Andy Gock
* \see glcd.h
*/
#if defined(GLCD_CONTROLLER_ST7565R)
#include "../glcd.h"
void glcd_command(uint8_t c)
{
GLCD_A0_LOW();
glcd_spi_write(c);
}
void glcd_data(uint8_t c)
{
GLCD_A0_HIGH();
glcd_spi_write(c);
}
void glcd_set_contrast(uint8_t val) {
/* Can set a 6-bit value (0 to 63) */
/* Must send this command byte before setting the contrast */
glcd_command(0x81);
/* Set the contrat value ("electronic volumne register") */
if (val > 63) {
glcd_command(63);
} else {
glcd_command(val);
}
return;
}
void glcd_power_down(void)
{
/* Command sequence as in ST7565 datasheet */
glcd_command(0xac); // Static indicator off
glcd_command(0x00); // Static indicator register, not blinking
glcd_command(0xae); // Display OFF
glcd_command(0xa5); // Display all points ON
/* Display is now in sleep mode */
}
void glcd_power_up(void)
{
glcd_command(0xa4); // Display all points OFF
glcd_command(0xad); // Static indicator ON
glcd_command(0x00); // Static indicator register, not Blinking
glcd_command(0xaf);
return;
}
void glcd_set_y_address(uint8_t y)
{
glcd_command(ST7565R_PAGE_ADDRESS_SET | (0x0F & y)); /* 0x0F = 0b00001111 */
}
void glcd_set_x_address(uint8_t x)
{
glcd_set_column_upper(x);
glcd_set_column_lower(x);
}
void glcd_all_on(void)
{
glcd_command(ST7565R_DISPLAY_ALL_ON);
}
void glcd_normal(void)
{
glcd_command(ST7565R_DISPLAY_NORMAL);
}
void glcd_set_column_upper(uint8_t addr)
{
glcd_command(ST7565R_COLUMN_ADDRESS_SET_UPPER | (addr >> 4));
}
void glcd_set_column_lower(uint8_t addr)
{
glcd_command(ST7565R_COLUMN_ADDRESS_SET_LOWER | (0x0f & addr));
}
void glcd_set_start_line(uint8_t addr)
{
glcd_command( ST7565R_SET_START_LINE | (0x3F & addr)); /* 0x3F == 0b00111111 */
}
/** Clear the display immediately, does not buffer */
void glcd_clear_now(void)
{
uint8_t page;
for (page = 0; page < GLCD_NUMBER_OF_BANKS; page++) {
uint8_t col;
glcd_set_y_address(page);
glcd_set_x_address(0);
for (col = 0; col < GLCD_NUMBER_OF_COLS; col++) {
glcd_data(0);
}
}
}
void glcd_pattern(void)
{
uint8_t page;
for (page = 0; page < GLCD_NUMBER_OF_BANKS; page++) {
uint8_t col;
glcd_set_y_address(page);
glcd_set_x_address(0);
for (col = 0; col < GLCD_NUMBER_OF_COLS; col++) {
glcd_data( (col / 8 + 2) % 2 == 1 ? 0xff : 0x00 );
}
}
}
void glcd_write()
{
uint8_t bank;
for (bank = 0; bank < GLCD_NUMBER_OF_BANKS; bank++) {
/* Each bank is a single row 8 bits tall */
uint8_t column;
if (glcd_bbox_selected->y_min >= (bank+1)*8) {
continue; /* Skip the entire bank */
}
if (glcd_bbox_selected->y_max < bank*8) {
break; /* No more banks need updating */
}
glcd_set_y_address(bank);
glcd_set_x_address(glcd_bbox_selected->x_min);
for (column = glcd_bbox_selected->x_min; column <= glcd_bbox_selected->x_max; column++)
{
glcd_data( glcd_buffer_selected[GLCD_NUMBER_OF_COLS * bank + column] );
}
}
glcd_reset_bbox();
}
void glcd_ST7565R_init(void) {
#if defined(GLCD_INIT_NHD_C12832A1Z_FSW_FBW_3V3)
/* Init sequence based on datasheet example code for NHD-C12832A1Z-FSW-FBW-3V3 */
/* Datasheet says max SCK frequency 20MHz for this LCD */
/* We use "reverse direction" for common output mode, as opposed to datasheet specifying "normal direction" */
glcd_command(0xa0); /* ADC select in normal mode */
glcd_command(0xae); /* Display OFF */
glcd_command(0xc8); /* Common output mode select: reverse direction (last 3 bits are ignored) */
glcd_command(0xa2); /* LCD bias set at 1/9 */
glcd_command(0x2f); /* Power control set to operating mode: 7 */
glcd_command(0x21); /* Internal resistor ratio, set to: 1 */
glcd_set_contrast(40); /* Set contrast, value experimentally determined, can set to 6-bit value, 0 to 63 */
glcd_command(0xaf); /* Display on */
#elif defined(GLCD_INIT_NHD_C12864A1Z_FSW_FBW_HTT)
/* Init sequence based on datasheet example code for NHD-C12864A1Z-FSW-FBW-HTT */
/* Datasheet says max SCK frequency 2.5MHz for this LCD */
/* We use "reverse direction" for common output mode, as opposed to datasheet specifying "normal direction" */
glcd_command(0xa0); /* ADC select in normal mode */
glcd_command(0xae); /* Display OFF */
glcd_command(0xc8); /* Common output mode select: reverse direction (last 3 bits are ignored) */
glcd_command(0xa2); /* LCD bias set at 1/9 */
glcd_command(0x2f); /* Power control set to operating mode: 7 */
glcd_command(0x26); /* Internal resistor ratio, set to: 6 */
glcd_set_contrast(20); /* Set contrast, value experimentally determined */
glcd_command(0xaf); /* Display on */
#elif defined(GLCD_INIT_NHD_C12864WC_FSW_FBW_3V3_M)
/* Init sequence for NHD-C12864WC-FSW-FBW-3V3-M */
glcd_command(ST7565R_RESET); /* Internal reset */
glcd_command(0xa2); /* 1/9 bias */
glcd_command(0xa0); /* ADC select, normal */
glcd_command(0xc8); /* Com output reverse */
glcd_command(0xa4); /* Display all points normal */
glcd_command(0x40); /* Display start line set */
glcd_command(0x25); /* Internal resistor ratio */
glcd_set_contrast(45); /* Set contrast value, experimentally determined, value 0 to 63 */
glcd_command(0x2f); /* Power controller set */
glcd_command(0xaf); /* Display on */
#elif defined(GLCD_INIT_ZOLEN_12864_FFSSWE_NAA)
/* Init sequence for Zolen 128x64 module with
* size 40x35mm. Chip ST7567 */
glcd_command(0xa0); /* ADC select in normal mode */
glcd_command(0xae); /* Display OFF */
glcd_command(0xc8); /* Common output mode select: reverse direction (last 3 bits are ignored) */
glcd_command(0xa3); /* LCD bias set at 1/9 */
glcd_command(0x2f); /* Power control set to operating mode: 7 */
glcd_command(0x24); /* Internal resistor ratio, set to: 6 */
glcd_set_contrast(20); /* Set contrast, value experimentally determined, value 0 to 63 */
glcd_command(0xaf); /* Display on */
#else
/* Default init sequence */
/* Currently just set the same as GLCD_INIT_NHD_C12864A1Z_FSW_FBW_HTT */
glcd_command(0xa0); /* ADC select in normal mode */
glcd_command(0xae); /* Display OFF */
glcd_command(0xc8); /* Common output mode select: reverse direction (last 3 bits are ignored) */
glcd_command(0xa2); /* LCD bias set at 1/9 */
glcd_command(0x2f); /* Power control set to operating mode: 7 */
glcd_command(0x26); /* Internal resistor ratio, set to: 6 */
glcd_set_contrast(20); /* Set contrast, value experimentally determined, value 0 to 63 */
glcd_command(0xaf); /* Display on */
#endif
}
#endif /* defined(GLCD_CONTROLLER_ST7565R) */
|
the_stack_data/156392399.c | #include <stdio.h>
#include <stdlib.h>
//int SumOfElements(int A[])
int SumOfElements(int A[])
{
int size=sizeof(A)/sizeof(A[0]);
printf("size of A in SOE:=%d and size of A[0] in SOE:=%d\n", sizeof(A), sizeof(A[0]));
int i, sum=0;
for(i=0; i<size; i++)
sum+=A[i];
return sum;
}
int main()
{
int A[]= {1, 2, 3, 4, 5};
int size=sizeof(A)/sizeof(A[0]);
printf("size of A in main:=%d and size of A[0] in main:=%d\n", sizeof(A), sizeof(A[0]));
int total =SumOfElements(A);
//int total =SumOfElements(A);
printf("Sum of lelements = %d \n", total);
}
|
the_stack_data/68888497.c | /*
* Copyright (c) 2021 Omar Polo <[email protected]>
*
* Permission to use, copy, modify, and 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.
*/
#include <stdlib.h>
int
main(void)
{
return getprogname() == NULL;
}
|
the_stack_data/95193.c | #include <stdio.h>
#include <stdlib.h>
int main(void) {
printf("Hello World");
int a = 5;
printf("%d \n%dfoo", (4 + 6) * 2, a);
if (1 + 2 * 2 * (3 + 8) / 4 - 2 == 12 && 1)
printf("True");
else
printf("False");
printf("\n");
if ((3 * (4 + 11) * 2 == 45) == 0)
printf("True");
else
printf("False");
printf(" ");
if ((2 == 1) == 0)
printf("True");
else
printf("False");
printf(" %d%d", 5 / 3 / 3, 4 * 1 / 3 / 2 * 1);
if (!(!(a == 0) && !(a == 4)))
printf("True");
else
printf("False");
if (1 && !0 && !(1 && 0))
printf("True");
else
printf("False");
printf("\n");
return 0;
}
|
the_stack_data/43886732.c | #include <stdio.h>
#include <math.h>
#include <complex.h>
int main()
{
printf("0 ^ 0 = %f\n", pow(0,0));
double complex c = cpow(0,0);
printf("0+0i ^ 0+0i = %f+%fi\n", creal(c), cimag(c));
return 0;
}
|
the_stack_data/179830618.c | #include <unistd.h>
#include <errno.h>
#include <sys/types.h>
int truncate(const char * path, off_t length) {
errno = EINVAL;
return -1;
}
|
the_stack_data/785198.c | #include <stdio.h>
int add(int a , int b){
if(a > 5)
return a+b;
else
return a;
}
int main()
{
int x = 0; /* Don't forget to declare variables */
int res = 0;
for(int j=0; j < 20; j++){
while ( x < 10 ) { /* While x is less than 10 */
res = add(x, res);
printf( "%d\n", res);
x++; /* Update x so the condition can be met eventually */
}
if(j<x){printf("good\n");}
}
getchar();
}
|
the_stack_data/225144058.c | #include <stdio.h>
int main()
{
printf("\n\t\t\tMemory Management"
" Scheme - Worst Fit");
int i, j, nblocks, nfiles, temp, top = 0;
int frag[10], blocks[10], files[10];
static int block_arr[10], file_arr[10];
printf("\nEnter the Total Number "
"of Blocks: ");
scanf("%d", &nblocks);
printf("Enter the Total Number "
"of Files: ");
scanf("%d", &nfiles);
printf("\nEnter the Size of the "
"Blocks: \n");
for (i = 0; i < nblocks; i++)
{
printf("Block No.%d:\t", i + 1);
scanf("%d", &blocks[i]);
}
printf("Enter the Size of the "
"Files:\n");
for (i = 0; i < nfiles; i++)
{
printf("File No.%d:\t", i + 1);
scanf("%d", &files[i]);
}
for (i = 0; i < nfiles; i++)
{
for (j = 0; j < nblocks; j++)
{
if (block_arr[j] != 1)
{
temp = blocks[j] - files[i];
if (temp >= 0)
{
if (top < temp)
{
file_arr[i] = j;
top = temp;
}
}
}
frag[i] = top;
block_arr[file_arr[i]] = 1;
top = 0;
}
}
printf("\nFile Number\tFile Size\t"
"Block Number\tBlock Size\tFragment");
for (i = 0; i < nfiles; i++)
{
printf("\n%d\t\t%d\t\t%d\t\t%d\t\t%d"
, i, files[i],
file_arr[i], blocks[file_arr[i]], frag[i]);
}
printf("\n");
return 0;
}
|
the_stack_data/743010.c | #include <stdio.h>
void SelectionSort(int *vetor, int N) {
int menor_indice;
int troca = 0;
for (int i = 0; i < N; i++) {
menor_indice = i;
for (int j = i + 1; j < N; j++) {
if (vetor[j] < vetor[menor_indice])
menor_indice = j;
}
if (i != menor_indice) {
troca = vetor[menor_indice];
vetor[menor_indice] = vetor[i];
vetor[i] = troca;
}
}
} |
the_stack_data/117328183.c | #include<stdio.h>
int main(){
int n, x, sim=0, nao=0;
scanf("%d", &n);
do{
scanf("%d", &x);
if(x>=10 && x<=20){
sim++;
}
else{
nao++;
}
n--;
}
while(n>0);
printf("%d in\n%d out\n", sim, nao);
return 0;
}
|
the_stack_data/61076311.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
*/
/* @(#)w_fmod.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.
* ====================================================
*/
#ifdef POK_NEEDS_LIBMATH
/*
* wrapper fmod(x,y)
*/
#include "math_private.h"
#include <libm.h>
double fmod(double x, double y) /* wrapper fmod */
{
#ifdef _IEEE_LIBM
return __ieee754_fmod(x, y);
#else
double z;
z = __ieee754_fmod(x, y);
if (_LIB_VERSION == _IEEE_ || isnan(y) || isnan(x))
return z;
if (y == 0.0) {
return __kernel_standard(x, y, 27); /* fmod(x,0) */
} else
return z;
#endif
}
#endif
|
the_stack_data/67324302.c | /**
* @file char_io.c
* @brief Test PrintChar, ReadChar
* Read a character and print it
*/
#include "syscall.h"
int main()
{
PrintChar(ReadChar());
PrintChar('\n');
Halt();
} |
the_stack_data/26700778.c | //Classification: p/DAM/NP/gS/D(v)/fr/rp+cd
//Written by: Sergey Pomelov
//Reviewed by: Igor Eremeev
//Comment:
#include <stdio.h>
int *func(void)
{
static int q = 1;
int *p = &q;
return p;
};
int a;
int main(void)
{
int c;
int i;
a = 1;
scanf("%d",&c);
for(i=1; i<100; i++) {
if (c==i)
a = *func();
}
printf("%d %d",a,c);
return 0;
}
|
the_stack_data/178265930.c |
#include <stdio.h>
void scilab_rt_grayplot_i2i2i2s0d2i2_(int in00, int in01, int matrixin0[in00][in01],
int in10, int in11, int matrixin1[in10][in11],
int in20, int in21, int matrixin2[in20][in21],
char* scalarin0,
int in30, int in31, double matrixin3[in30][in31],
int in40, int in41, int matrixin4[in40][in41])
{
int i;
int j;
int val0 = 0;
int val1 = 0;
int 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("%d", val0);
for (i = 0; i < in10; ++i) {
for (j = 0; j < in11; ++j) {
val1 += matrixin1[i][j];
}
}
printf("%d", val1);
for (i = 0; i < in20; ++i) {
for (j = 0; j < in21; ++j) {
val2 += matrixin2[i][j];
}
}
printf("%d", val2);
printf("%s", scalarin0);
for (i = 0; i < in30; ++i) {
for (j = 0; j < in31; ++j) {
val3 += matrixin3[i][j];
}
}
printf("%f", val3);
for (i = 0; i < in40; ++i) {
for (j = 0; j < in41; ++j) {
val4 += matrixin4[i][j];
}
}
printf("%d", val4);
}
|
the_stack_data/57949169.c | /**
ch2/ pow2Tester.c
A times power of two test taking program for humans
@author Jeff Cope
*/
#include <stdio.h>
#include <stdlib.h>
#include <unistd.h>
#include <signal.h>
#include <time.h>
void printUsage(char *progName);
void onAlarm(int signo);
void printStats();
int count, correct;
int main(int argc, char **argv)
{
int maxLen = 33;
char *sVal;
int randVal;
int seed = 0;
int timeVal = 30;
int modVal = 17;
count = correct = 0;
if (argc > 1) {
timeVal = atoi(argv[1]);
if (argc > 2) {
seed = atoi(argv[2]);
if (argc > 3)
modVal = atoi(argv[3]);
}
} else {
printUsage(argv[0]);
exit(EXIT_FAILURE);
}
if (seed <= 0)
seed = time(0);
if (modVal <= 0 && modVal >= 32)
modVal = 17;
srandom(seed);
sVal = (char *)malloc(maxLen*sizeof(char));
randVal = (int)(random()%modVal);
if (timeVal > 0) {
if (signal(SIGALRM, onAlarm) == SIG_ERR) {
fprintf(stderr, "Error setting up signal handler\n");
exit(EXIT_FAILURE);
}
alarm(timeVal);
}
fprintf(stdout, "What is the value of 2^%d? > ", randVal);
while (fgets(sVal, maxLen, stdin) && (atoi(sVal) != 0)) {
fprintf(stdout, "You entered %s", sVal);
if (1<<randVal != atoi(sVal)) {
fprintf(stdout, "INCORRECT!\nActual value of 2^%d is %d\n", randVal, 1<<randVal);
} else {
correct++;
fprintf(stdout, "CORRECT!\n");
}
count++;
randVal = (int)(random()%modVal);
fprintf(stdout, "What is the value of 2^%d? > ", randVal);
}
free(sVal);
printStats();
exit(EXIT_SUCCESS);
}
void printUsage(char *progName)
{
fprintf(stdout, "%s usage: %s <test time> [seed value] [ending power range]\n", progName, progName);
fprintf(stdout, "\ntest time == 0, no time limit\n");
fprintf(stdout, "seed value < 1, random seed based on time of day\n");
fprintf(stdout, "ending power range = n, value between 2^0 .. 2^(n-1)\n");
}
void onAlarm(int signo)
{
fprintf(stdout, "\n\n------TIME UP! put down your pencils------\n");
sleep(1);
printStats();
sleep(2);
kill(getpid(), SIGINT);
}
void printStats()
{
if (count > 0)
fprintf(stdout, "\ncorrect answers: %d of %d for %d%%\n\n", correct, count, (int)(((float)correct/(float)count)*100));
else
fprintf(stdout, "\ncorrect answers: 0 of 0 for 0%%\n\n");
}
|
the_stack_data/64607.c | int main() {
// variable declarations
int i;
int j;
// pre-conditions
(i = 1);
(j = 10);
// loop body
while ((j >= i)) {
{
(i = (i + 2));
(j = (j - 1));
}
}
// post-condition
assert( (j == 6) );
}
|
the_stack_data/43141.c | #include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <CL/cl.h>
unsigned char *read_buffer(char *file_name, size_t *size_ptr)
{
FILE *f;
unsigned char *buf;
size_t size;
/* Open file */
f = fopen(file_name, "rb");
if (!f)
return NULL;
/* Obtain file size */
fseek(f, 0, SEEK_END);
size = ftell(f);
fseek(f, 0, SEEK_SET);
/* Allocate and read buffer */
buf = malloc(size + 1);
fread(buf, 1, size, f);
buf[size] = '\0';
/* Return size of buffer */
if (size_ptr)
*size_ptr = size;
/* Return buffer */
return buf;
}
void write_buffer(char *file_name, const char *buffer, size_t buffer_size)
{
FILE *f;
/* Open file */
f = fopen(file_name, "w+");
/* Write buffer */
if(buffer)
fwrite(buffer, 1, buffer_size, f);
/* Close file */
fclose(f);
}
int main(int argc, char const *argv[])
{
/* Get platform */
cl_platform_id platform;
cl_uint num_platforms;
cl_int ret = clGetPlatformIDs(1, &platform, &num_platforms);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clGetPlatformIDs' failed\n");
exit(1);
}
printf("Number of platforms: %d\n", num_platforms);
printf("platform=%p\n", platform);
/* Get platform name */
char platform_name[100];
ret = clGetPlatformInfo(platform, CL_PLATFORM_NAME, sizeof(platform_name), platform_name, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clGetPlatformInfo' failed\n");
exit(1);
}
printf("platform.name='%s'\n\n", platform_name);
/* Get device */
cl_device_id device;
cl_uint num_devices;
ret = clGetDeviceIDs(platform, CL_DEVICE_TYPE_GPU, 1, &device, &num_devices);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clGetDeviceIDs' failed\n");
exit(1);
}
printf("Number of devices: %d\n", num_devices);
printf("device=%p\n", device);
/* Get device name */
char device_name[100];
ret = clGetDeviceInfo(device, CL_DEVICE_NAME, sizeof(device_name),
device_name, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clGetDeviceInfo' failed\n");
exit(1);
}
printf("device.name='%s'\n", device_name);
printf("\n");
/* Create a Context Object */
cl_context context;
context = clCreateContext(NULL, 1, &device, NULL, NULL, &ret);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clCreateContext' failed\n");
exit(1);
}
printf("context=%p\n", context);
/* Create a Command Queue Object*/
cl_command_queue command_queue;
command_queue = clCreateCommandQueue(context, device, 0, &ret);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clCreateCommandQueue' failed\n");
exit(1);
}
printf("command_queue=%p\n", command_queue);
printf("\n");
/* Program source */
unsigned char *source_code;
size_t source_length;
/* Read program from 'mad_hi_shortshortshort.cl' */
source_code = read_buffer("mad_hi_shortshortshort.cl", &source_length);
/* Create a program */
cl_program program;
program = clCreateProgramWithSource(context, 1, (const char **)&source_code, &source_length, &ret);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clCreateProgramWithSource' failed\n");
exit(1);
}
printf("program=%p\n", program);
/* Build program */
ret = clBuildProgram(program, 1, &device, NULL, NULL, NULL);
if (ret != CL_SUCCESS )
{
size_t size;
char *log;
/* Get log size */
clGetProgramBuildInfo(program, device, CL_PROGRAM_BUILD_LOG,0, NULL, &size);
/* Allocate log and print */
log = malloc(size);
clGetProgramBuildInfo(program, device, CL_PROGRAM_BUILD_LOG,size, log, NULL);
printf("error: call to 'clBuildProgram' failed:\n%s\n", log);
/* Free log and exit */
free(log);
exit(1);
}
printf("program built\n");
printf("\n");
/* Create a Kernel Object */
cl_kernel kernel;
kernel = clCreateKernel(program, "mad_hi_shortshortshort", &ret);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clCreateKernel' failed\n");
exit(1);
}
/* Create and allocate host buffers */
size_t num_elem = 10;
/* Create and init host side src buffer 0 */
cl_short *src_0_host_buffer;
src_0_host_buffer = malloc(num_elem * sizeof(cl_short));
for (int i = 0; i < num_elem; i++)
src_0_host_buffer[i] = (cl_short)(2);
/* Create and init device side src buffer 0 */
cl_mem src_0_device_buffer;
src_0_device_buffer = clCreateBuffer(context, CL_MEM_READ_ONLY, num_elem * sizeof(cl_short), NULL, &ret);
if (ret != CL_SUCCESS)
{
printf("error: could not create source buffer\n");
exit(1);
}
ret = clEnqueueWriteBuffer(command_queue, src_0_device_buffer, CL_TRUE, 0, num_elem * sizeof(cl_short), src_0_host_buffer, 0, NULL, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clEnqueueWriteBuffer' failed\n");
exit(1);
}
/* Create and init host side src buffer 1 */
cl_short *src_1_host_buffer;
src_1_host_buffer = malloc(num_elem * sizeof(cl_short));
for (int i = 0; i < num_elem; i++)
src_1_host_buffer[i] = (cl_short)(2);
/* Create and init device side src buffer 1 */
cl_mem src_1_device_buffer;
src_1_device_buffer = clCreateBuffer(context, CL_MEM_READ_ONLY, num_elem * sizeof(cl_short), NULL, &ret);
if (ret != CL_SUCCESS)
{
printf("error: could not create source buffer\n");
exit(1);
}
ret = clEnqueueWriteBuffer(command_queue, src_1_device_buffer, CL_TRUE, 0, num_elem * sizeof(cl_short), src_1_host_buffer, 0, NULL, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clEnqueueWriteBuffer' failed\n");
exit(1);
}
/* Create and init host side src buffer 2 */
cl_short *src_2_host_buffer;
src_2_host_buffer = malloc(num_elem * sizeof(cl_short));
for (int i = 0; i < num_elem; i++)
src_2_host_buffer[i] = (cl_short)(2);
/* Create and init device side src buffer 2 */
cl_mem src_2_device_buffer;
src_2_device_buffer = clCreateBuffer(context, CL_MEM_READ_ONLY, num_elem * sizeof(cl_short), NULL, &ret);
if (ret != CL_SUCCESS)
{
printf("error: could not create source buffer\n");
exit(1);
}
ret = clEnqueueWriteBuffer(command_queue, src_2_device_buffer, CL_TRUE, 0, num_elem * sizeof(cl_short), src_2_host_buffer, 0, NULL, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clEnqueueWriteBuffer' failed\n");
exit(1);
}
/* Create host dst buffer */
cl_short *dst_host_buffer;
dst_host_buffer = malloc(num_elem * sizeof(cl_short));
memset((void *)dst_host_buffer, 1, num_elem * sizeof(cl_short));
/* Create device dst buffer */
cl_mem dst_device_buffer;
dst_device_buffer = clCreateBuffer(context, CL_MEM_WRITE_ONLY, num_elem *sizeof(cl_short), NULL, &ret);
if (ret != CL_SUCCESS)
{
printf("error: could not create dst buffer\n");
exit(1);
}
/* Set kernel arguments */
ret = CL_SUCCESS;
ret |= clSetKernelArg(kernel, 0, sizeof(cl_mem), &src_0_device_buffer);
ret |= clSetKernelArg(kernel, 1, sizeof(cl_mem), &src_1_device_buffer);
ret |= clSetKernelArg(kernel, 2, sizeof(cl_mem), &src_2_device_buffer);
ret |= clSetKernelArg(kernel, 3, sizeof(cl_mem), &dst_device_buffer);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clSetKernelArg' failed\n");
exit(1);
}
/* Launch the kernel */
size_t global_work_size = num_elem;
size_t local_work_size = num_elem;
ret = clEnqueueNDRangeKernel(command_queue, kernel, 1, NULL, &global_work_size, &local_work_size, 0, NULL, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clEnqueueNDRangeKernel' failed\n");
exit(1);
}
/* Wait for it to finish */
clFinish(command_queue);
/* Read results from GPU */
ret = clEnqueueReadBuffer(command_queue, dst_device_buffer, CL_TRUE,0, num_elem * sizeof(cl_short), dst_host_buffer, 0, NULL, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clEnqueueReadBuffer' failed\n");
exit(1);
}
/* Dump dst buffer to file */
char dump_file[100];
sprintf((char *)&dump_file, "%s.result", argv[0]);
write_buffer(dump_file, (const char *)dst_host_buffer, num_elem * sizeof(cl_short));
printf("Result dumped to %s\n", dump_file);
/* Free host dst buffer */
free(dst_host_buffer);
/* Free device dst buffer */
ret = clReleaseMemObject(dst_device_buffer);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseMemObject' failed\n");
exit(1);
}
/* Free host side src buffer 0 */
free(src_0_host_buffer);
/* Free device side src buffer 0 */
ret = clReleaseMemObject(src_0_device_buffer);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseMemObject' failed\n");
exit(1);
}
/* Free host side src buffer 1 */
free(src_1_host_buffer);
/* Free device side src buffer 1 */
ret = clReleaseMemObject(src_1_device_buffer);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseMemObject' failed\n");
exit(1);
}
/* Free host side src buffer 2 */
free(src_2_host_buffer);
/* Free device side src buffer 2 */
ret = clReleaseMemObject(src_2_device_buffer);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseMemObject' failed\n");
exit(1);
}
/* Release kernel */
ret = clReleaseKernel(kernel);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseKernel' failed\n");
exit(1);
}
/* Release program */
ret = clReleaseProgram(program);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseProgram' failed\n");
exit(1);
}
/* Release command queue */
ret = clReleaseCommandQueue(command_queue);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseCommandQueue' failed\n");
exit(1);
}
/* Release context */
ret = clReleaseContext(context);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clReleaseContext' failed\n");
exit(1);
}
return 0;
} |
the_stack_data/957459.c | /**
* Copyright 2020 Huawei Technologies Co., Ltd
*
* 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.
*/
#ifdef ENABLE_AVX
#include <x86intrin.h>
#include "nnacl/fp32/conv_depthwise_fp32.h"
void ConvDwFp32Avx5x5(float *output, float **input, const float *weights, const float *bias, size_t channels,
size_t output_width, size_t input_stride, size_t relu, size_t relu6) {
input_stride /= sizeof(float *);
size_t c8 = UP_DIV(channels, C8NUM) * C8NUM;
size_t c8_mod = channels % C8NUM;
const int kernel = 25;
for (int i = 0; i < output_width; ++i) {
float *in[kernel];
for (int k = 0; k < kernel; k++) {
in[k] = input[k];
}
input += input_stride;
size_t c = c8;
const float *w = weights;
const float *bias1 = bias;
for (; c >= C8NUM; c -= C8NUM) {
__m256 out1 = _mm256_loadu_ps(bias1);
bias1 += 8;
for (int k = 0; k < kernel; k += 5) {
__m256 in1 = _mm256_loadu_ps(in[k]);
__m256 w1 = _mm256_loadu_ps(w);
__m256 in2 = _mm256_loadu_ps(in[k + 1]);
__m256 w2 = _mm256_loadu_ps(w + 8);
out1 = _mm256_fmadd_ps(in1, w1, out1);
__m256 in3 = _mm256_loadu_ps(in[k + 2]);
__m256 w3 = _mm256_loadu_ps(w + 16);
out1 = _mm256_fmadd_ps(in2, w2, out1);
__m256 in4 = _mm256_loadu_ps(in[k + 3]);
__m256 w4 = _mm256_loadu_ps(w + 24);
out1 = _mm256_fmadd_ps(in3, w3, out1);
__m256 in5 = _mm256_loadu_ps(in[k + 4]);
__m256 w5 = _mm256_loadu_ps(w + 32);
out1 = _mm256_fmadd_ps(in4, w4, out1);
w += 40;
in[k] += C8NUM;
in[k + 1] += C8NUM;
in[k + 2] += C8NUM;
in[k + 3] += C8NUM;
in[k + 4] += C8NUM;
out1 = _mm256_fmadd_ps(in5, w5, out1);
}
if (relu6 != 0) {
__m256 relu6_data = _mm256_set1_ps(6.0);
out1 = _mm256_min_ps(out1, relu6_data);
}
if (relu != 0 || relu6 != 0) {
__m256 zero = _mm256_setzero_ps();
out1 = _mm256_max_ps(out1, zero);
}
if (c > C8NUM || c8_mod == 0) {
_mm256_storeu_ps(output, out1);
output += C8NUM;
} else {
__m128 tmp;
switch (c8_mod) {
case 1:
_mm_store_ss(output, _mm256_castps256_ps128(out1));
break;
case 2:
_mm_storel_pi((__m64 *)output, _mm256_castps256_ps128(out1));
break;
case 3:
tmp = _mm256_castps256_ps128(out1);
_mm_storel_pi((__m64 *)output, tmp);
tmp = _mm_unpackhi_ps(tmp, tmp);
_mm_store_ss(output + 2, tmp);
break;
case 4:
_mm_storeu_ps(output, _mm256_castps256_ps128(out1));
break;
case 5:
_mm_storeu_ps(output, _mm256_castps256_ps128(out1));
_mm_store_ss(output + 4, _mm256_extractf128_ps(out1, 1));
break;
case 6:
_mm_storeu_ps(output, _mm256_castps256_ps128(out1));
_mm_storel_pi((__m64 *)(output + 4), _mm256_extractf128_ps(out1, 1));
break;
case 7:
_mm_storeu_ps(output, _mm256_castps256_ps128(out1));
tmp = _mm256_extractf128_ps(out1, 1);
_mm_storel_pi((__m64 *)(output + 4), tmp);
tmp = _mm_unpackhi_ps(tmp, tmp);
_mm_store_ss(output + 6, tmp);
break;
default:
_mm256_storeu_ps(output, out1);
break;
}
output += c8_mod;
}
}
}
}
#endif
|
the_stack_data/90765824.c | #include<stdio.h>
void main(int argc, char** argv)
{
//printf accepts multiple arguments
//first argument is format string
//many programmers assume this is only argument
printf(argv[1]);
}
|
the_stack_data/117327195.c | //usage, $ ./exec < matrix.csv > matrix_out.csv
#include<omp.h>
#include<stdio.h>
#include<stdlib.h>
#include<time.h>
const int CHUNK = 10;
void print_matrix(float *mat, int rows, int cols) {
int i, j;
printf("%d, %d\n", rows, cols);
for (i = 0; i < rows; i++) {
for (j = 0; j < cols; j++)
printf("%f, ", mat[i * cols + j]);
printf("\n");
}
}
void multiply_matrix(float *mat1, int r1, int c1, float *mat2, int r2, int c2, float *res) {
int pos_matrix1, pos_matrix2;
int i, j, k, tid, acc;
for (i = 0; i < r1 * c2; i++) res[i] = 0;
time_t t_init = time(NULL);
double init_t = omp_get_wtime( );
#pragma omp parallel shared(mat1, r1, c1, mat2, r2, c2, res) private(i, j, k, acc, tid)
{
#pragma omp for schedule(dynamic, CHUNK)
for (i = 0; i < r1; i++) {
for (j = 0; j < c2; j++) {
for (k = 0; k < c1; k++) {
res[i * c2 + j] += mat1[i * c1 + k] * mat2[c2 * k + j];
}
}
}
}
time_t t_end = time(NULL);
double end_t = omp_get_wtime( );
printf("{\n");
printf("\"Normal time\": %ld\n", (t_end - t_init));
printf("\"OMP time\" : %lf\n", (end_t - init_t));
printf("}\n");
}
int main() {
float *mat1, *mat2, *it, *res;
int sr1, sr2, sc1, sc2, i, j;
while (scanf("%d, %d", &sr1, &sc1) == 2) {
mat1 = (float *)malloc(sizeof (float) * sr1 * sc1);
for (i = 0, it = mat1; i < sr1 * sc1; i++) scanf("%f,", it++);
scanf("%d, %d", &sr2, &sc2);
mat2 = (float *)malloc(sizeof (float) * sr2 * sc2);
for (i = 0, it = mat2; i < sr2 * sc2; i++) scanf("%f,", it++);
if (sc1 != sr2) {
printf("invalid matrices\n");
break;
}
res = (float *)malloc(sizeof (float) * sr1 * sc2);
multiply_matrix(mat1, sr1, sc1, mat2, sr2, sc2, res);
// print_matrix(res, sr1, sc2);
// printf("\n");
// print_matrix(mat1, sr1, sc1);
}
return 0;
}
|
the_stack_data/811928.c | #include <stdio.h>
/**
* main - print the name.
* @argc: number of argument
* @argv: string of input argument
* Return: Always 0.
*/
int main(int argc, char *argv[])
{
int i;
for (i = 0; i < argc; i++)
printf("%s\n", argv[i]);
return (0);
}
|
the_stack_data/84341.c | void main()
{
char s1[] = "abc";
char s2[] = "defg";
printid(s1);
printid(s2);
STRCPY(&s1, s2);
print(s1);
}
|
the_stack_data/662735.c | /*
* Thread_Semaphore.c
*
* Created on: 2016年11月6日
* Author: morris
* 要求:
* 线程间控制之---信号量
* 编写“消费者-生产者”问题:
* 有一个有限缓冲区和两个线程:生产者和消费者,它们分别不停地把产品放入缓冲区和
* 从缓冲区中拿走产品。一个生产者在缓冲区满的时候必须等待,一个消费者在缓冲区空
* 的时候也必须等待。另外,因为缓冲区是临界资源,所以生产者和消费者之间必须互斥
* 执行。
* 使用有名管道模拟有限缓冲区
* 生产者的速度要比消费者的速度平均快两倍左右
* ********************************************************************
* 1. PV原子操作主要用于进程或线程之间的同步和互斥两种典型情况。
* 2. 当信号量用于互斥,几个进程(或线程)往往只设置一个信号量sem。
* 3. 当信号量用于同步操作,会设置多个信号量,安排不同的初始值来实现它们之间的顺序执行
* ********************************************************************
* int sem_init(sem_t* sem,int pshared,unsigned int value);创建一个信号量
* sem:信号量指针
* pshared:决定信号量能否在几个进程之间共享。
* 由于目前Linux还没有实现进程间共享信号量,所以这个值只能够取0,
* 表示这个信号量时当前进程的局部信号量
* value:信号量初始化值
* 返回:
* 成功:返回0
* 出错:返回-1
* int sem_wait(sem_t* sem);
* 相当于P操作,该函数会阻塞
* int sem_trywait(sem_t* sem);
* 相当于P操作,该函数会立即返回
* int sem_post(sem_t* sem);
* 相当于V操作,它将信号量的值加1,同时发出信号来唤醒等待的进程
* int sem_getvalue(sem_t* sem);
* 用于得到信号量的值
* int sem_destroy(sem_t* sem);
* 用于删除信号量
* sem:信号量指针
* 返回:
* 成功:返回0
* 出错:返回-1
*/
#include <asm-generic/errno-base.h>
#include <errno.h>
#include <fcntl.h>
#include <pthread.h>
#include <semaphore.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <sys/stat.h>
#include <time.h>
#include <unistd.h>
#define MYFIFO "/tmp/myfifo" //有名管道的名字
#define UNIT_COUNT (3) //缓冲区单元数
#define UNIT_SIZE (6) //每个单元的大小
#define RUN_TIME (20) //运行时间/s
#define P_DELAY_TIME_LEVELS (2.0) //生产周期的最大值
#define C_DELAY_TIME_LEVELS (4.0) //消费周期的最大值
static int fd_fifo; //有名管道,临界资源
static sem_t mutex, full, avail; //三个信号量,mutex用于互斥,另两个用于同步
static time_t end_time; //结束时间
/* 生产者线程 */
void* producer(void* arg) {
int real_write;
int delay_time;
/* 有时间限定 */
while (time(NULL) < end_time) {
delay_time = (int) (rand() * P_DELAY_TIME_LEVELS / RAND_MAX) + 1;
sleep(delay_time);
printf("Producer:delay=%d\r\n", delay_time);
/* P操作信号量avail和mutex */
sem_wait(&avail);
sem_wait(&mutex);
/* 向有名管道写入数据 */
real_write = write(fd_fifo, "hello", UNIT_SIZE);
if (real_write < 0) {
if (errno == EAGAIN) {
printf("The fifo has not been read yet,try later.\r\n");
} else {
perror("write");
}
} else {
printf("Write %d bytes to FIFO\r\n", real_write);
}
/* V操作信号量full和mutex */
sem_post(&full);
sem_post(&mutex);
}
pthread_exit(NULL);
}
/* 消费者线程 */
void* customer(void* arg) {
int real_read;
int delay_time;
char buffer[UNIT_SIZE];
/* 有时间限定 */
while (time(NULL) < end_time) {
delay_time = (int) (rand() * C_DELAY_TIME_LEVELS / RAND_MAX) + 1;
sleep(delay_time);
printf("Customer: delay=%d\r\n", delay_time);
/* P操作信号量full和mutex */
sem_wait(&full);
sem_wait(&mutex);
/* 从有名管道读出数据 */
memset(buffer, 0, UNIT_SIZE);
real_read = read(fd_fifo, buffer, UNIT_SIZE);
if (real_read < 0) {
if (errno == EAGAIN) {
printf("No data yet.\r\n");
} else {
perror("read");
}
} else if (real_read == 0) {
printf("FIFO has been closed\r\n");
} else {
printf("read %d bytes from fifo:%s\r\n", real_read, buffer);
}
/* V操作信号量avail和mutex */
sem_post(&avail);
sem_post(&mutex);
}
pthread_exit(NULL);
}
int main(int argc, char **argv) {
pthread_t thrd_prd_id, thrd_cst_id;
int ret;
/* 播种随机数种子 */
srand(time(NULL));
/* 计算结束时间 */
end_time = time(NULL) + RUN_TIME;
/* 判断有名管道是否存在,不存在则创建 */
if (access(MYFIFO, F_OK) == -1) {
if ((mkfifo(MYFIFO, 0666) < 0)) {
perror("mkfifo");
exit(1);
}
}
/* 以读写方式打开有名管道 */
fd_fifo = open(MYFIFO, O_RDWR);
if (fd_fifo == -1) {
printf("Open fifo error\r\n");
return fd_fifo;
}
/* 初始化互斥信号量为1 */
ret = sem_init(&mutex, 0, 1);
/* 初始化full信号量为0 */
ret += sem_init(&full, 0, 0);
/* 初始化avail信号量为N */
ret += sem_init(&avail, 0, UNIT_COUNT);
if (ret != 0) {
printf("Semaphore initialization error\r\n");
return ret;
}
/* 创建生产者线程,默认属性 */
ret = pthread_create(&thrd_prd_id, NULL, producer, NULL);
if (ret != 0) {
printf("Create producer thread error\r\n");
return ret;
}
/* 创建消费者线程,默认属性 */
ret = pthread_create(&thrd_cst_id, NULL, customer, NULL);
if (ret != 0) {
printf("Create customer thread error\r\n");
return ret;
}
/* 等待子线程退出,回收资源 */
pthread_join(thrd_prd_id, NULL);
pthread_join(thrd_cst_id, NULL);
/* 关闭有名管道 */
close(fd_fifo);
/* 删除有名管道 */
unlink(MYFIFO);
return 0;
}
|
the_stack_data/68887481.c | /*
* Copyright (c) 2006-2021, RT-Thread Development Team
*
* SPDX-License-Identifier: Apache-2.0
*
* Change Logs:
* Date Author Notes
* 2021-04-27 peterfan Add copyright header.
*/
/* ===---------- emutls.c - Implements __emutls_get_address ---------------===
*
* The LLVM Compiler Infrastructure
*
* This file is dual licensed under the MIT and the University of Illinois Open
* Source Licenses. See LICENSE.TXT for details.
*
* ===----------------------------------------------------------------------===
*/
#include <pthread.h>
#include <stdint.h>
#include <stdlib.h>
#include <string.h>
#define COMPILE_TIME_ASSERT(x)
extern int pthread_key_create(pthread_key_t *key, void (*destructor)(void *));
extern int pthread_key_delete(pthread_key_t key);
extern void *pthread_getspecific(pthread_key_t key);
extern int pthread_setspecific(pthread_key_t key, const void *value);
/* Default is not to use posix_memalign, so systems like Android
* can use thread local data without heavier POSIX memory allocators.
*/
#ifndef EMUTLS_USE_POSIX_MEMALIGN
#define EMUTLS_USE_POSIX_MEMALIGN 0
#endif
/* For every TLS variable xyz,
* there is one __emutls_control variable named __emutls_v.xyz.
* If xyz has non-zero initial value, __emutls_v.xyz's "value"
* will point to __emutls_t.xyz, which has the initial value.
*/
typedef struct __emutls_control
{
size_t size; /* size of the object in bytes */
size_t align; /* alignment of the object in bytes */
union
{
uintptr_t index; /* data[index-1] is the object address */
void *address; /* object address, when in single thread env */
} object;
void *value; /* null or non-zero initial value for the object */
} __emutls_control;
static __inline void *emutls_memalign_alloc(size_t align, size_t size)
{
void *base;
#if EMUTLS_USE_POSIX_MEMALIGN
if (posix_memalign(&base, align, size) != 0)
abort();
#else
#define EXTRA_ALIGN_PTR_BYTES (align - 1 + sizeof(void *))
char *object;
if ((object = malloc(EXTRA_ALIGN_PTR_BYTES + size)) == NULL)
abort();
base = (void *)(((uintptr_t)(object + EXTRA_ALIGN_PTR_BYTES)) & ~(uintptr_t)(align - 1));
((void **)base)[-1] = object;
#endif
return base;
}
static __inline void emutls_memalign_free(void *base)
{
#if EMUTLS_USE_POSIX_MEMALIGN
free(base);
#else
/* The mallocated address is in ((void**)base)[-1] */
free(((void **)base)[-1]);
#endif
}
/* Emulated TLS objects are always allocated at run-time. */
static __inline void *emutls_allocate_object(__emutls_control *control)
{
/* Use standard C types, check with gcc's emutls.o. */
typedef unsigned int gcc_word __attribute__((mode(word)));
typedef unsigned int gcc_pointer __attribute__((mode(pointer)));
COMPILE_TIME_ASSERT(sizeof(size_t) == sizeof(gcc_word));
COMPILE_TIME_ASSERT(sizeof(uintptr_t) == sizeof(gcc_pointer));
COMPILE_TIME_ASSERT(sizeof(uintptr_t) == sizeof(void *));
size_t size = control->size;
size_t align = control->align;
if (align < sizeof(void *))
align = sizeof(void *);
/* Make sure that align is power of 2. */
if ((align & (align - 1)) != 0)
abort();
void *base = emutls_memalign_alloc(align, size);
if (control->value)
memcpy(base, control->value, size);
else
memset(base, 0, size);
return base;
}
static pthread_mutex_t emutls_mutex = PTHREAD_MUTEX_INITIALIZER;
static size_t emutls_num_object = 0; /* number of allocated TLS objects */
typedef struct emutls_address_array
{
uintptr_t size; /* number of elements in the 'data' array */
void *data[];
} emutls_address_array;
static pthread_key_t emutls_pthread_key;
static void emutls_key_destructor(void *ptr)
{
emutls_address_array *array = (emutls_address_array *)ptr;
uintptr_t i;
for (i = 0; i < array->size; ++i)
{
if (array->data[i])
emutls_memalign_free(array->data[i]);
}
free(ptr);
}
static void emutls_init(void)
{
if (pthread_key_create(&emutls_pthread_key, emutls_key_destructor) != 0)
abort();
}
/* Returns control->object.index; set index if not allocated yet. */
static __inline uintptr_t emutls_get_index(__emutls_control *control)
{
uintptr_t index = __atomic_load_n(&control->object.index, __ATOMIC_ACQUIRE);
if (!index)
{
static pthread_once_t once = PTHREAD_ONCE_INIT;
pthread_once(&once, emutls_init);
pthread_mutex_lock(&emutls_mutex);
index = control->object.index;
if (!index)
{
index = ++emutls_num_object;
__atomic_store_n(&control->object.index, index, __ATOMIC_RELEASE);
}
pthread_mutex_unlock(&emutls_mutex);
}
return index;
}
/* Updates newly allocated thread local emutls_address_array. */
static __inline void emutls_check_array_set_size(emutls_address_array *array,
uintptr_t size)
{
if (array == NULL)
abort();
array->size = size;
pthread_setspecific(emutls_pthread_key, (void *)array);
}
/* Returns the new 'data' array size, number of elements,
* which must be no smaller than the given index.
*/
static __inline uintptr_t emutls_new_data_array_size(uintptr_t index)
{
/* Need to allocate emutls_address_array with one extra slot
* to store the data array size.
* Round up the emutls_address_array size to multiple of 16.
*/
return ((index + 1 + 15) & ~((uintptr_t)15)) - 1;
}
/* Returns the thread local emutls_address_array.
* Extends its size if necessary to hold address at index.
*/
static __inline emutls_address_array *
emutls_get_address_array(uintptr_t index)
{
emutls_address_array *array = pthread_getspecific(emutls_pthread_key);
if (array == NULL)
{
uintptr_t new_size = emutls_new_data_array_size(index);
array = calloc(new_size + 1, sizeof(void *));
emutls_check_array_set_size(array, new_size);
}
else if (index > array->size)
{
uintptr_t orig_size = array->size;
uintptr_t new_size = emutls_new_data_array_size(index);
array = realloc(array, (new_size + 1) * sizeof(void *));
if (array)
memset(array->data + orig_size, 0,
(new_size - orig_size) * sizeof(void *));
emutls_check_array_set_size(array, new_size);
}
return array;
}
void *__emutls_get_address(void *control)
{
uintptr_t index = emutls_get_index((__emutls_control *)control);
emutls_address_array *array = emutls_get_address_array(index);
if (array->data[index - 1] == NULL)
array->data[index - 1] = emutls_allocate_object((__emutls_control *)control);
return array->data[index - 1];
}
|
the_stack_data/68886709.c | /* The Computer Language Benchmarks Game
* http://benchmarksgame.alioth.debian.org/
*
* contributed by Christoph Bauer
*
*/
#ifdef WEBASSEMBLY
#include <webassembly.h>
#else
#include <math.h>
#include <stdio.h>
#include <stdlib.h>
#endif
#define pi 3.141592653589793
#define solar_mass (4 * pi * pi)
#define days_per_year 365.24
struct planet {
double x, y, z;
double vx, vy, vz;
double mass;
};
void advance(int nbodies, struct planet * bodies, double dt)
{
int i, j;
for (i = 0; i < nbodies; i++) {
struct planet * b = &(bodies[i]);
for (j = i + 1; j < nbodies; j++) {
struct planet * b2 = &(bodies[j]);
double dx = b->x - b2->x;
double dy = b->y - b2->y;
double dz = b->z - b2->z;
double distance = sqrt(dx * dx + dy * dy + dz * dz);
double mag = dt / (distance * distance * distance);
b->vx -= dx * b2->mass * mag;
b->vy -= dy * b2->mass * mag;
b->vz -= dz * b2->mass * mag;
b2->vx += dx * b->mass * mag;
b2->vy += dy * b->mass * mag;
b2->vz += dz * b->mass * mag;
}
}
for (i = 0; i < nbodies; i++) {
struct planet * b = &(bodies[i]);
b->x += dt * b->vx;
b->y += dt * b->vy;
b->z += dt * b->vz;
}
}
double energy(int nbodies, struct planet * bodies)
{
double e;
int i, j;
e = 0.0;
for (i = 0; i < nbodies; i++) {
struct planet * b = &(bodies[i]);
e += 0.5 * b->mass * (b->vx * b->vx + b->vy * b->vy + b->vz * b->vz);
for (j = i + 1; j < nbodies; j++) {
struct planet * b2 = &(bodies[j]);
double dx = b->x - b2->x;
double dy = b->y - b2->y;
double dz = b->z - b2->z;
double distance = sqrt(dx * dx + dy * dy + dz * dz);
e -= (b->mass * b2->mass) / distance;
}
}
return e;
}
void offset_momentum(int nbodies, struct planet * bodies)
{
double px = 0.0, py = 0.0, pz = 0.0;
int i;
for (i = 0; i < nbodies; i++) {
px += bodies[i].vx * bodies[i].mass;
py += bodies[i].vy * bodies[i].mass;
pz += bodies[i].vz * bodies[i].mass;
}
bodies[0].vx = - px / solar_mass;
bodies[0].vy = - py / solar_mass;
bodies[0].vz = - pz / solar_mass;
}
#define NBODIES 5
struct planet bodies[NBODIES] = {
{ /* sun */
0, 0, 0, 0, 0, 0, solar_mass
},
{ /* jupiter */
4.84143144246472090e+00,
-1.16032004402742839e+00,
-1.03622044471123109e-01,
1.66007664274403694e-03 * days_per_year,
7.69901118419740425e-03 * days_per_year,
-6.90460016972063023e-05 * days_per_year,
9.54791938424326609e-04 * solar_mass
},
{ /* saturn */
8.34336671824457987e+00,
4.12479856412430479e+00,
-4.03523417114321381e-01,
-2.76742510726862411e-03 * days_per_year,
4.99852801234917238e-03 * days_per_year,
2.30417297573763929e-05 * days_per_year,
2.85885980666130812e-04 * solar_mass
},
{ /* uranus */
1.28943695621391310e+01,
-1.51111514016986312e+01,
-2.23307578892655734e-01,
2.96460137564761618e-03 * days_per_year,
2.37847173959480950e-03 * days_per_year,
-2.96589568540237556e-05 * days_per_year,
4.36624404335156298e-05 * solar_mass
},
{ /* neptune */
1.53796971148509165e+01,
-2.59193146099879641e+01,
1.79258772950371181e-01,
2.68067772490389322e-03 * days_per_year,
1.62824170038242295e-03 * days_per_year,
-9.51592254519715870e-05 * days_per_year,
5.15138902046611451e-05 * solar_mass
}
};
int main(int argc, char ** argv)
{
int n = atoi(argv[1]);
int i;
offset_momentum(NBODIES, bodies);
printf ("%.9f\n", energy(NBODIES, bodies));
for (i = 1; i <= n; i++)
advance(NBODIES, bodies, 0.01);
printf ("%.9f\n", energy(NBODIES, bodies));
return 0;
}
|
the_stack_data/3261792.c | #include <stdio.h>
#include <stdlib.h>
struct Node {
char data;
struct Node *next;
};
/*--------------- PROTOTYPES ---------------*/
void push(struct Node **top, char data);
char pop(struct Node **top);
char getTop(struct Node *stack);
void display(struct Node *stack);
int isBalanced(struct Node *stack, char *exp);
int checkMatch(char open, char close);
/*--------------- FUNCTIONS ---------------*/
void push(struct Node **top, char data) {
struct Node *temp = malloc(sizeof(struct Node));
if (temp == NULL) {
printf("Stack overflow.\n");
} else {
temp->data = data;
temp->next = *top;
(*top) = temp;
}
}
char pop(struct Node **top) {
struct Node *aux;
char value = -1;
if (*top != NULL) {
value = (*top)->data;
aux = *top;
*top = (*top)->next;
free(aux);
} else {
printf("Stack empty.\n");
}
return value;
}
char getTop(struct Node *stack) {
char value = -1;
if (stack != NULL) {
value = stack->data;
} else {
printf("The stack is empty.\n");
}
return value;
}
void display(struct Node *stack) {
struct Node *aux = stack;
while (aux != NULL) {
printf("%c ", aux->data);
aux = aux->next;
}
printf("\n");
}
int isBalanced(struct Node *stack, char *exp) {
int i;
char open;
for (i = 0; exp[i] != '\0'; i++) {
if (exp[i] == '{' || exp[i] == '(' || exp[i] == '[') {
push(&stack, exp[i]);
} else if (exp[i] == '}' || exp[i] == ')' || exp[i] == ']') {
if (stack == NULL) {
return 0;
}
open = pop(&stack);
if (!checkMatch(open, exp[i])) {
return 0;
}
}
}
if (stack == NULL) {
return 1;
}
return 0;
}
int checkMatch(char open, char close) {
int result = 1;
switch (close) {
case '}':
if (open != '{') {
result = 0;
}
break;
case ')':
if (open != '(') {
result = 0;
}
break;
case ']':
if (open != '[') {
result = 0;
}
break;
}
return result;
}
/*--------------- MAIN ---------------*/
int main() {
char *exp = "{([a+b]*[c-d])/e}";
struct Node *newStack = NULL;
if (isBalanced(newStack, exp)) {
printf("The stack is balanced.\n");
} else {
printf("The stack is not balanced.\n");
}
return 0;
}
|
the_stack_data/5282.c | //@ ltl invariant negative: (<> (AP(x_34 - x_19 > -8) || ([] AP(x_30 - x_13 >= -11))));
float x_0;
float x_1;
float x_2;
float x_3;
float x_4;
float x_5;
float x_6;
float x_7;
float x_8;
float x_9;
float x_10;
float x_11;
float x_12;
float x_13;
float x_14;
float x_15;
float x_16;
float x_17;
float x_18;
float x_19;
float x_20;
float x_21;
float x_22;
float x_23;
float x_24;
float x_25;
float x_26;
float x_27;
float x_28;
float x_29;
float x_30;
float x_31;
float x_32;
float x_33;
float x_34;
float x_35;
int main()
{
float x_0_;
float x_1_;
float x_2_;
float x_3_;
float x_4_;
float x_5_;
float x_6_;
float x_7_;
float x_8_;
float x_9_;
float x_10_;
float x_11_;
float x_12_;
float x_13_;
float x_14_;
float x_15_;
float x_16_;
float x_17_;
float x_18_;
float x_19_;
float x_20_;
float x_21_;
float x_22_;
float x_23_;
float x_24_;
float x_25_;
float x_26_;
float x_27_;
float x_28_;
float x_29_;
float x_30_;
float x_31_;
float x_32_;
float x_33_;
float x_34_;
float x_35_;
while(1) {
x_0_ = (((((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) > ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))? ((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) : ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))) > (((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) > ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16)))? ((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) : ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))))? (((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) > ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))? ((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) : ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))) : (((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) > ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16)))? ((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) : ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))))) > ((((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) > ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))? ((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) : ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))) > (((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) > ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35)))? ((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) : ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))))? (((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) > ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))? ((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) : ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))) : (((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) > ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35)))? ((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) : ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35)))))? ((((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) > ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))? ((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) : ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))) > (((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) > ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16)))? ((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) : ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))))? (((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) > ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))? ((4.0 + x_0) > (6.0 + x_1)? (4.0 + x_0) : (6.0 + x_1)) : ((18.0 + x_4) > (17.0 + x_7)? (18.0 + x_4) : (17.0 + x_7))) : (((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) > ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16)))? ((2.0 + x_9) > (1.0 + x_10)? (2.0 + x_9) : (1.0 + x_10)) : ((5.0 + x_11) > ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))? (5.0 + x_11) : ((16.0 + x_14) > (3.0 + x_16)? (16.0 + x_14) : (3.0 + x_16))))) : ((((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) > ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))? ((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) : ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))) > (((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) > ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35)))? ((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) : ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))))? (((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) > ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))? ((4.0 + x_17) > (4.0 + x_19)? (4.0 + x_17) : (4.0 + x_19)) : ((16.0 + x_21) > (6.0 + x_22)? (16.0 + x_21) : (6.0 + x_22))) : (((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) > ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35)))? ((5.0 + x_27) > (2.0 + x_29)? (5.0 + x_27) : (2.0 + x_29)) : ((14.0 + x_30) > ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))? (14.0 + x_30) : ((15.0 + x_32) > (1.0 + x_35)? (15.0 + x_32) : (1.0 + x_35))))));
x_1_ = (((((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) > ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))? ((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) : ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))) > (((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) > ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10)))? ((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) : ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))))? (((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) > ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))? ((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) : ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))) : (((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) > ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10)))? ((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) : ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))))) > ((((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) > ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))? ((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) : ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))) > (((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) > ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34)))? ((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) : ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))))? (((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) > ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))? ((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) : ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))) : (((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) > ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34)))? ((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) : ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34)))))? ((((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) > ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))? ((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) : ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))) > (((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) > ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10)))? ((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) : ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))))? (((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) > ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))? ((16.0 + x_0) > (3.0 + x_1)? (16.0 + x_0) : (3.0 + x_1)) : ((5.0 + x_2) > (7.0 + x_3)? (5.0 + x_2) : (7.0 + x_3))) : (((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) > ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10)))? ((16.0 + x_4) > (15.0 + x_6)? (16.0 + x_4) : (15.0 + x_6)) : ((19.0 + x_8) > ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))? (19.0 + x_8) : ((12.0 + x_9) > (15.0 + x_10)? (12.0 + x_9) : (15.0 + x_10))))) : ((((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) > ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))? ((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) : ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))) > (((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) > ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34)))? ((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) : ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))))? (((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) > ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))? ((18.0 + x_13) > (8.0 + x_14)? (18.0 + x_13) : (8.0 + x_14)) : ((5.0 + x_19) > (18.0 + x_22)? (5.0 + x_19) : (18.0 + x_22))) : (((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) > ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34)))? ((20.0 + x_26) > (14.0 + x_27)? (20.0 + x_26) : (14.0 + x_27)) : ((10.0 + x_30) > ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))? (10.0 + x_30) : ((8.0 + x_32) > (7.0 + x_34)? (8.0 + x_32) : (7.0 + x_34))))));
x_2_ = (((((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) > ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))? ((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) : ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))) > (((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) > ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22)))? ((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) : ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))))? (((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) > ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))? ((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) : ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))) : (((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) > ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22)))? ((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) : ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))))) > ((((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) > ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))? ((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) : ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))) > (((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) > ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34)))? ((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) : ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))))? (((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) > ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))? ((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) : ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))) : (((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) > ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34)))? ((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) : ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34)))))? ((((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) > ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))? ((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) : ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))) > (((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) > ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22)))? ((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) : ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))))? (((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) > ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))? ((3.0 + x_0) > (2.0 + x_1)? (3.0 + x_0) : (2.0 + x_1)) : ((17.0 + x_3) > (15.0 + x_4)? (17.0 + x_3) : (15.0 + x_4))) : (((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) > ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22)))? ((19.0 + x_7) > (17.0 + x_9)? (19.0 + x_7) : (17.0 + x_9)) : ((17.0 + x_16) > ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))? (17.0 + x_16) : ((2.0 + x_21) > (3.0 + x_22)? (2.0 + x_21) : (3.0 + x_22))))) : ((((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) > ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))? ((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) : ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))) > (((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) > ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34)))? ((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) : ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))))? (((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) > ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))? ((16.0 + x_23) > (8.0 + x_24)? (16.0 + x_23) : (8.0 + x_24)) : ((7.0 + x_26) > (8.0 + x_27)? (7.0 + x_26) : (8.0 + x_27))) : (((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) > ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34)))? ((17.0 + x_28) > (11.0 + x_30)? (17.0 + x_28) : (11.0 + x_30)) : ((9.0 + x_31) > ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))? (9.0 + x_31) : ((6.0 + x_33) > (3.0 + x_34)? (6.0 + x_33) : (3.0 + x_34))))));
x_3_ = (((((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) > ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))? ((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) : ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))) > (((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) > ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18)))? ((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) : ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))))? (((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) > ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))? ((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) : ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))) : (((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) > ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18)))? ((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) : ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))))) > ((((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) > ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))? ((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) : ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))) > (((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) > ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35)))? ((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) : ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))))? (((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) > ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))? ((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) : ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))) : (((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) > ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35)))? ((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) : ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35)))))? ((((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) > ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))? ((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) : ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))) > (((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) > ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18)))? ((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) : ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))))? (((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) > ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))? ((17.0 + x_1) > (10.0 + x_2)? (17.0 + x_1) : (10.0 + x_2)) : ((14.0 + x_3) > (13.0 + x_7)? (14.0 + x_3) : (13.0 + x_7))) : (((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) > ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18)))? ((1.0 + x_10) > (3.0 + x_12)? (1.0 + x_10) : (3.0 + x_12)) : ((14.0 + x_14) > ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))? (14.0 + x_14) : ((10.0 + x_17) > (18.0 + x_18)? (10.0 + x_17) : (18.0 + x_18))))) : ((((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) > ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))? ((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) : ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))) > (((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) > ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35)))? ((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) : ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))))? (((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) > ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))? ((8.0 + x_22) > (13.0 + x_24)? (8.0 + x_22) : (13.0 + x_24)) : ((3.0 + x_25) > (2.0 + x_26)? (3.0 + x_25) : (2.0 + x_26))) : (((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) > ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35)))? ((2.0 + x_27) > (8.0 + x_28)? (2.0 + x_27) : (8.0 + x_28)) : ((7.0 + x_30) > ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))? (7.0 + x_30) : ((14.0 + x_31) > (15.0 + x_35)? (14.0 + x_31) : (15.0 + x_35))))));
x_4_ = (((((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) > ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))? ((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) : ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))) > (((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) > ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15)))? ((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) : ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))))? (((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) > ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))? ((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) : ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))) : (((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) > ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15)))? ((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) : ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))))) > ((((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) > ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))? ((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) : ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))) > (((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) > ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35)))? ((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) : ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))))? (((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) > ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))? ((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) : ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))) : (((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) > ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35)))? ((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) : ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35)))))? ((((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) > ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))? ((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) : ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))) > (((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) > ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15)))? ((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) : ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))))? (((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) > ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))? ((1.0 + x_2) > (4.0 + x_3)? (1.0 + x_2) : (4.0 + x_3)) : ((15.0 + x_4) > (16.0 + x_5)? (15.0 + x_4) : (16.0 + x_5))) : (((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) > ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15)))? ((7.0 + x_8) > (13.0 + x_9)? (7.0 + x_8) : (13.0 + x_9)) : ((18.0 + x_11) > ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))? (18.0 + x_11) : ((20.0 + x_12) > (2.0 + x_15)? (20.0 + x_12) : (2.0 + x_15))))) : ((((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) > ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))? ((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) : ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))) > (((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) > ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35)))? ((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) : ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))))? (((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) > ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))? ((9.0 + x_17) > (15.0 + x_19)? (9.0 + x_17) : (15.0 + x_19)) : ((5.0 + x_20) > (7.0 + x_21)? (5.0 + x_20) : (7.0 + x_21))) : (((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) > ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35)))? ((7.0 + x_24) > (13.0 + x_26)? (7.0 + x_24) : (13.0 + x_26)) : ((19.0 + x_31) > ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))? (19.0 + x_31) : ((3.0 + x_32) > (19.0 + x_35)? (3.0 + x_32) : (19.0 + x_35))))));
x_5_ = (((((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) > ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))? ((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) : ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))) > (((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) > ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17)))? ((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) : ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))))? (((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) > ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))? ((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) : ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))) : (((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) > ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17)))? ((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) : ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))))) > ((((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) > ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))? ((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) : ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))) > (((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) > ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35)))? ((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) : ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))))? (((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) > ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))? ((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) : ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))) : (((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) > ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35)))? ((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) : ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35)))))? ((((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) > ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))? ((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) : ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))) > (((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) > ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17)))? ((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) : ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))))? (((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) > ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))? ((12.0 + x_2) > (19.0 + x_7)? (12.0 + x_2) : (19.0 + x_7)) : ((16.0 + x_8) > (6.0 + x_9)? (16.0 + x_8) : (6.0 + x_9))) : (((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) > ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17)))? ((11.0 + x_10) > (9.0 + x_11)? (11.0 + x_10) : (9.0 + x_11)) : ((2.0 + x_12) > ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))? (2.0 + x_12) : ((9.0 + x_16) > (4.0 + x_17)? (9.0 + x_16) : (4.0 + x_17))))) : ((((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) > ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))? ((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) : ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))) > (((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) > ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35)))? ((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) : ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))))? (((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) > ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))? ((12.0 + x_20) > (17.0 + x_23)? (12.0 + x_20) : (17.0 + x_23)) : ((16.0 + x_24) > (18.0 + x_25)? (16.0 + x_24) : (18.0 + x_25))) : (((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) > ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35)))? ((11.0 + x_27) > (13.0 + x_30)? (11.0 + x_27) : (13.0 + x_30)) : ((12.0 + x_32) > ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))? (12.0 + x_32) : ((6.0 + x_34) > (4.0 + x_35)? (6.0 + x_34) : (4.0 + x_35))))));
x_6_ = (((((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) > ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))? ((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) : ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))) > (((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) > ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16)))? ((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) : ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))))? (((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) > ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))? ((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) : ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))) : (((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) > ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16)))? ((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) : ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))))) > ((((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) > ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))? ((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) : ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))) > (((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) > ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35)))? ((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) : ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))))? (((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) > ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))? ((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) : ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))) : (((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) > ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35)))? ((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) : ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35)))))? ((((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) > ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))? ((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) : ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))) > (((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) > ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16)))? ((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) : ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))))? (((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) > ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))? ((20.0 + x_1) > (3.0 + x_3)? (20.0 + x_1) : (3.0 + x_3)) : ((6.0 + x_4) > (18.0 + x_5)? (6.0 + x_4) : (18.0 + x_5))) : (((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) > ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16)))? ((1.0 + x_6) > (4.0 + x_8)? (1.0 + x_6) : (4.0 + x_8)) : ((12.0 + x_9) > ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))? (12.0 + x_9) : ((12.0 + x_12) > (9.0 + x_16)? (12.0 + x_12) : (9.0 + x_16))))) : ((((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) > ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))? ((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) : ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))) > (((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) > ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35)))? ((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) : ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))))? (((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) > ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))? ((6.0 + x_17) > (4.0 + x_18)? (6.0 + x_17) : (4.0 + x_18)) : ((4.0 + x_19) > (20.0 + x_20)? (4.0 + x_19) : (20.0 + x_20))) : (((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) > ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35)))? ((11.0 + x_22) > (11.0 + x_29)? (11.0 + x_22) : (11.0 + x_29)) : ((14.0 + x_31) > ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))? (14.0 + x_31) : ((8.0 + x_34) > (3.0 + x_35)? (8.0 + x_34) : (3.0 + x_35))))));
x_7_ = (((((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) > ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))? ((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) : ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))) > (((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) > ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16)))? ((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) : ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))))? (((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) > ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))? ((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) : ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))) : (((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) > ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16)))? ((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) : ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))))) > ((((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) > ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))? ((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) : ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))) > (((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) > ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34)))? ((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) : ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))))? (((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) > ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))? ((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) : ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))) : (((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) > ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34)))? ((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) : ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34)))))? ((((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) > ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))? ((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) : ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))) > (((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) > ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16)))? ((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) : ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))))? (((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) > ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))? ((1.0 + x_0) > (13.0 + x_2)? (1.0 + x_0) : (13.0 + x_2)) : ((15.0 + x_3) > (19.0 + x_7)? (15.0 + x_3) : (19.0 + x_7))) : (((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) > ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16)))? ((4.0 + x_11) > (1.0 + x_13)? (4.0 + x_11) : (1.0 + x_13)) : ((6.0 + x_14) > ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))? (6.0 + x_14) : ((8.0 + x_15) > (9.0 + x_16)? (8.0 + x_15) : (9.0 + x_16))))) : ((((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) > ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))? ((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) : ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))) > (((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) > ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34)))? ((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) : ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))))? (((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) > ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))? ((7.0 + x_18) > (16.0 + x_20)? (7.0 + x_18) : (16.0 + x_20)) : ((17.0 + x_22) > (15.0 + x_23)? (17.0 + x_22) : (15.0 + x_23))) : (((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) > ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34)))? ((13.0 + x_27) > (19.0 + x_29)? (13.0 + x_27) : (19.0 + x_29)) : ((7.0 + x_30) > ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))? (7.0 + x_30) : ((1.0 + x_33) > (15.0 + x_34)? (1.0 + x_33) : (15.0 + x_34))))));
x_8_ = (((((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) > ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))? ((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) : ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))) > (((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) > ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14)))? ((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) : ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))))? (((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) > ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))? ((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) : ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))) : (((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) > ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14)))? ((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) : ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))))) > ((((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) > ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))? ((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) : ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))) > (((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) > ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35)))? ((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) : ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))))? (((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) > ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))? ((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) : ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))) : (((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) > ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35)))? ((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) : ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35)))))? ((((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) > ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))? ((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) : ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))) > (((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) > ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14)))? ((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) : ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))))? (((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) > ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))? ((8.0 + x_1) > (1.0 + x_2)? (8.0 + x_1) : (1.0 + x_2)) : ((4.0 + x_3) > (15.0 + x_6)? (4.0 + x_3) : (15.0 + x_6))) : (((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) > ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14)))? ((6.0 + x_9) > (3.0 + x_10)? (6.0 + x_9) : (3.0 + x_10)) : ((17.0 + x_11) > ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))? (17.0 + x_11) : ((1.0 + x_13) > (7.0 + x_14)? (1.0 + x_13) : (7.0 + x_14))))) : ((((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) > ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))? ((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) : ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))) > (((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) > ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35)))? ((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) : ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))))? (((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) > ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))? ((1.0 + x_15) > (12.0 + x_16)? (1.0 + x_15) : (12.0 + x_16)) : ((8.0 + x_17) > (17.0 + x_21)? (8.0 + x_17) : (17.0 + x_21))) : (((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) > ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35)))? ((3.0 + x_24) > (5.0 + x_27)? (3.0 + x_24) : (5.0 + x_27)) : ((15.0 + x_29) > ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))? (15.0 + x_29) : ((17.0 + x_33) > (3.0 + x_35)? (17.0 + x_33) : (3.0 + x_35))))));
x_9_ = (((((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) > ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))? ((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) : ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))) > (((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) > ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16)))? ((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) : ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))))? (((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) > ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))? ((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) : ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))) : (((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) > ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16)))? ((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) : ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))))) > ((((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) > ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))? ((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) : ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))) > (((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) > ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35)))? ((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) : ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))))? (((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) > ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))? ((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) : ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))) : (((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) > ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35)))? ((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) : ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35)))))? ((((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) > ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))? ((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) : ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))) > (((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) > ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16)))? ((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) : ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))))? (((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) > ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))? ((16.0 + x_0) > (17.0 + x_2)? (16.0 + x_0) : (17.0 + x_2)) : ((17.0 + x_4) > (1.0 + x_8)? (17.0 + x_4) : (1.0 + x_8))) : (((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) > ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16)))? ((11.0 + x_11) > (10.0 + x_12)? (11.0 + x_11) : (10.0 + x_12)) : ((19.0 + x_13) > ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))? (19.0 + x_13) : ((4.0 + x_15) > (1.0 + x_16)? (4.0 + x_15) : (1.0 + x_16))))) : ((((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) > ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))? ((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) : ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))) > (((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) > ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35)))? ((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) : ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))))? (((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) > ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))? ((7.0 + x_22) > (10.0 + x_23)? (7.0 + x_22) : (10.0 + x_23)) : ((5.0 + x_26) > (14.0 + x_27)? (5.0 + x_26) : (14.0 + x_27))) : (((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) > ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35)))? ((13.0 + x_28) > (14.0 + x_32)? (13.0 + x_28) : (14.0 + x_32)) : ((9.0 + x_33) > ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))? (9.0 + x_33) : ((11.0 + x_34) > (3.0 + x_35)? (11.0 + x_34) : (3.0 + x_35))))));
x_10_ = (((((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) > ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))? ((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) : ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))) > (((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) > ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12)))? ((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) : ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))))? (((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) > ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))? ((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) : ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))) : (((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) > ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12)))? ((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) : ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))))) > ((((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) > ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))? ((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) : ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))) > (((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) > ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34)))? ((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) : ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))))? (((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) > ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))? ((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) : ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))) : (((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) > ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34)))? ((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) : ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34)))))? ((((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) > ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))? ((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) : ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))) > (((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) > ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12)))? ((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) : ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))))? (((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) > ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))? ((19.0 + x_0) > (16.0 + x_2)? (19.0 + x_0) : (16.0 + x_2)) : ((7.0 + x_3) > (15.0 + x_5)? (7.0 + x_3) : (15.0 + x_5))) : (((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) > ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12)))? ((1.0 + x_6) > (5.0 + x_7)? (1.0 + x_6) : (5.0 + x_7)) : ((17.0 + x_9) > ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))? (17.0 + x_9) : ((14.0 + x_11) > (15.0 + x_12)? (14.0 + x_11) : (15.0 + x_12))))) : ((((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) > ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))? ((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) : ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))) > (((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) > ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34)))? ((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) : ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))))? (((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) > ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))? ((4.0 + x_13) > (10.0 + x_14)? (4.0 + x_13) : (10.0 + x_14)) : ((17.0 + x_18) > (8.0 + x_24)? (17.0 + x_18) : (8.0 + x_24))) : (((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) > ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34)))? ((1.0 + x_27) > (2.0 + x_29)? (1.0 + x_27) : (2.0 + x_29)) : ((2.0 + x_30) > ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))? (2.0 + x_30) : ((4.0 + x_31) > (4.0 + x_34)? (4.0 + x_31) : (4.0 + x_34))))));
x_11_ = (((((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) > ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))? ((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) : ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))) > (((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) > ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15)))? ((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) : ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))))? (((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) > ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))? ((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) : ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))) : (((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) > ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15)))? ((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) : ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))))) > ((((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) > ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))? ((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) : ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))) > (((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) > ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32)))? ((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) : ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))))? (((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) > ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))? ((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) : ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))) : (((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) > ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32)))? ((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) : ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32)))))? ((((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) > ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))? ((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) : ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))) > (((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) > ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15)))? ((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) : ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))))? (((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) > ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))? ((6.0 + x_0) > (1.0 + x_3)? (6.0 + x_0) : (1.0 + x_3)) : ((9.0 + x_6) > (15.0 + x_7)? (9.0 + x_6) : (15.0 + x_7))) : (((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) > ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15)))? ((1.0 + x_9) > (7.0 + x_12)? (1.0 + x_9) : (7.0 + x_12)) : ((11.0 + x_13) > ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))? (11.0 + x_13) : ((10.0 + x_14) > (18.0 + x_15)? (10.0 + x_14) : (18.0 + x_15))))) : ((((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) > ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))? ((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) : ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))) > (((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) > ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32)))? ((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) : ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))))? (((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) > ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))? ((20.0 + x_16) > (10.0 + x_17)? (20.0 + x_16) : (10.0 + x_17)) : ((18.0 + x_18) > (3.0 + x_23)? (18.0 + x_18) : (3.0 + x_23))) : (((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) > ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32)))? ((14.0 + x_24) > (18.0 + x_25)? (14.0 + x_24) : (18.0 + x_25)) : ((20.0 + x_27) > ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))? (20.0 + x_27) : ((3.0 + x_31) > (16.0 + x_32)? (3.0 + x_31) : (16.0 + x_32))))));
x_12_ = (((((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) > ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))? ((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) : ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))) > (((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) > ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22)))? ((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) : ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))))? (((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) > ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))? ((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) : ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))) : (((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) > ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22)))? ((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) : ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))))) > ((((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) > ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))? ((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) : ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))) > (((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) > ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35)))? ((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) : ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))))? (((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) > ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))? ((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) : ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))) : (((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) > ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35)))? ((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) : ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35)))))? ((((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) > ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))? ((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) : ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))) > (((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) > ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22)))? ((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) : ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))))? (((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) > ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))? ((1.0 + x_0) > (10.0 + x_2)? (1.0 + x_0) : (10.0 + x_2)) : ((2.0 + x_7) > (10.0 + x_12)? (2.0 + x_7) : (10.0 + x_12))) : (((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) > ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22)))? ((8.0 + x_14) > (19.0 + x_15)? (8.0 + x_14) : (19.0 + x_15)) : ((8.0 + x_16) > ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))? (8.0 + x_16) : ((4.0 + x_17) > (15.0 + x_22)? (4.0 + x_17) : (15.0 + x_22))))) : ((((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) > ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))? ((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) : ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))) > (((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) > ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35)))? ((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) : ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))))? (((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) > ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))? ((8.0 + x_25) > (6.0 + x_26)? (8.0 + x_25) : (6.0 + x_26)) : ((10.0 + x_28) > (14.0 + x_29)? (10.0 + x_28) : (14.0 + x_29))) : (((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) > ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35)))? ((18.0 + x_31) > (7.0 + x_32)? (18.0 + x_31) : (7.0 + x_32)) : ((2.0 + x_33) > ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))? (2.0 + x_33) : ((8.0 + x_34) > (6.0 + x_35)? (8.0 + x_34) : (6.0 + x_35))))));
x_13_ = (((((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) > ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))? ((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) : ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))) > (((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) > ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18)))? ((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) : ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))))? (((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) > ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))? ((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) : ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))) : (((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) > ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18)))? ((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) : ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))))) > ((((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) > ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))? ((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) : ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))) > (((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) > ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35)))? ((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) : ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))))? (((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) > ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))? ((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) : ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))) : (((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) > ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35)))? ((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) : ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35)))))? ((((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) > ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))? ((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) : ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))) > (((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) > ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18)))? ((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) : ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))))? (((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) > ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))? ((7.0 + x_0) > (13.0 + x_5)? (7.0 + x_0) : (13.0 + x_5)) : ((14.0 + x_6) > (1.0 + x_7)? (14.0 + x_6) : (1.0 + x_7))) : (((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) > ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18)))? ((7.0 + x_8) > (3.0 + x_11)? (7.0 + x_8) : (3.0 + x_11)) : ((20.0 + x_14) > ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))? (20.0 + x_14) : ((13.0 + x_16) > (10.0 + x_18)? (13.0 + x_16) : (10.0 + x_18))))) : ((((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) > ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))? ((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) : ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))) > (((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) > ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35)))? ((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) : ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))))? (((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) > ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))? ((6.0 + x_19) > (4.0 + x_20)? (6.0 + x_19) : (4.0 + x_20)) : ((6.0 + x_21) > (13.0 + x_22)? (6.0 + x_21) : (13.0 + x_22))) : (((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) > ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35)))? ((19.0 + x_28) > (16.0 + x_29)? (19.0 + x_28) : (16.0 + x_29)) : ((10.0 + x_31) > ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))? (10.0 + x_31) : ((20.0 + x_32) > (2.0 + x_35)? (20.0 + x_32) : (2.0 + x_35))))));
x_14_ = (((((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) > ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))? ((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) : ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))) > (((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) > ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20)))? ((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) : ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))))? (((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) > ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))? ((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) : ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))) : (((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) > ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20)))? ((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) : ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))))) > ((((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) > ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))? ((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) : ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))) > (((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) > ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35)))? ((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) : ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))))? (((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) > ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))? ((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) : ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))) : (((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) > ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35)))? ((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) : ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35)))))? ((((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) > ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))? ((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) : ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))) > (((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) > ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20)))? ((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) : ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))))? (((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) > ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))? ((16.0 + x_0) > (3.0 + x_6)? (16.0 + x_0) : (3.0 + x_6)) : ((11.0 + x_11) > (6.0 + x_12)? (11.0 + x_11) : (6.0 + x_12))) : (((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) > ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20)))? ((20.0 + x_13) > (12.0 + x_16)? (20.0 + x_13) : (12.0 + x_16)) : ((8.0 + x_18) > ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))? (8.0 + x_18) : ((8.0 + x_19) > (3.0 + x_20)? (8.0 + x_19) : (3.0 + x_20))))) : ((((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) > ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))? ((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) : ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))) > (((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) > ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35)))? ((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) : ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))))? (((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) > ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))? ((11.0 + x_21) > (18.0 + x_22)? (11.0 + x_21) : (18.0 + x_22)) : ((4.0 + x_23) > (11.0 + x_24)? (4.0 + x_23) : (11.0 + x_24))) : (((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) > ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35)))? ((18.0 + x_28) > (12.0 + x_31)? (18.0 + x_28) : (12.0 + x_31)) : ((4.0 + x_32) > ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))? (4.0 + x_32) : ((1.0 + x_34) > (15.0 + x_35)? (1.0 + x_34) : (15.0 + x_35))))));
x_15_ = (((((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) > ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))? ((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) : ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))) > (((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) > ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18)))? ((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) : ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))))? (((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) > ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))? ((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) : ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))) : (((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) > ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18)))? ((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) : ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))))) > ((((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) > ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))? ((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) : ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))) > (((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) > ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35)))? ((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) : ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))))? (((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) > ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))? ((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) : ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))) : (((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) > ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35)))? ((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) : ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35)))))? ((((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) > ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))? ((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) : ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))) > (((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) > ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18)))? ((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) : ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))))? (((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) > ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))? ((2.0 + x_0) > (9.0 + x_4)? (2.0 + x_0) : (9.0 + x_4)) : ((15.0 + x_6) > (5.0 + x_8)? (15.0 + x_6) : (5.0 + x_8))) : (((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) > ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18)))? ((16.0 + x_9) > (19.0 + x_13)? (16.0 + x_9) : (19.0 + x_13)) : ((3.0 + x_15) > ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))? (3.0 + x_15) : ((18.0 + x_17) > (18.0 + x_18)? (18.0 + x_17) : (18.0 + x_18))))) : ((((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) > ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))? ((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) : ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))) > (((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) > ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35)))? ((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) : ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))))? (((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) > ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))? ((18.0 + x_21) > (10.0 + x_25)? (18.0 + x_21) : (10.0 + x_25)) : ((3.0 + x_26) > (14.0 + x_27)? (3.0 + x_26) : (14.0 + x_27))) : (((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) > ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35)))? ((8.0 + x_30) > (6.0 + x_31)? (8.0 + x_30) : (6.0 + x_31)) : ((18.0 + x_33) > ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))? (18.0 + x_33) : ((12.0 + x_34) > (17.0 + x_35)? (12.0 + x_34) : (17.0 + x_35))))));
x_16_ = (((((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) > ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))? ((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) : ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))) > (((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) > ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10)))? ((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) : ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))))? (((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) > ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))? ((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) : ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))) : (((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) > ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10)))? ((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) : ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))))) > ((((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) > ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))? ((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) : ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))) > (((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) > ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32)))? ((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) : ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))))? (((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) > ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))? ((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) : ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))) : (((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) > ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32)))? ((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) : ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32)))))? ((((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) > ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))? ((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) : ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))) > (((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) > ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10)))? ((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) : ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))))? (((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) > ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))? ((12.0 + x_1) > (10.0 + x_3)? (12.0 + x_1) : (10.0 + x_3)) : ((15.0 + x_4) > (18.0 + x_5)? (15.0 + x_4) : (18.0 + x_5))) : (((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) > ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10)))? ((4.0 + x_6) > (11.0 + x_7)? (4.0 + x_6) : (11.0 + x_7)) : ((18.0 + x_8) > ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))? (18.0 + x_8) : ((6.0 + x_9) > (6.0 + x_10)? (6.0 + x_9) : (6.0 + x_10))))) : ((((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) > ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))? ((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) : ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))) > (((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) > ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32)))? ((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) : ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))))? (((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) > ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))? ((9.0 + x_12) > (8.0 + x_17)? (9.0 + x_12) : (8.0 + x_17)) : ((1.0 + x_19) > (20.0 + x_20)? (1.0 + x_19) : (20.0 + x_20))) : (((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) > ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32)))? ((4.0 + x_22) > (5.0 + x_25)? (4.0 + x_22) : (5.0 + x_25)) : ((12.0 + x_26) > ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))? (12.0 + x_26) : ((10.0 + x_28) > (3.0 + x_32)? (10.0 + x_28) : (3.0 + x_32))))));
x_17_ = (((((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) > ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))? ((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) : ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))) > (((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) > ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17)))? ((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) : ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))))? (((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) > ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))? ((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) : ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))) : (((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) > ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17)))? ((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) : ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))))) > ((((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) > ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))? ((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) : ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))) > (((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) > ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35)))? ((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) : ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))))? (((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) > ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))? ((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) : ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))) : (((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) > ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35)))? ((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) : ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35)))))? ((((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) > ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))? ((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) : ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))) > (((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) > ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17)))? ((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) : ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))))? (((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) > ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))? ((11.0 + x_4) > (16.0 + x_5)? (11.0 + x_4) : (16.0 + x_5)) : ((16.0 + x_7) > (17.0 + x_9)? (16.0 + x_7) : (17.0 + x_9))) : (((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) > ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17)))? ((3.0 + x_10) > (10.0 + x_12)? (3.0 + x_10) : (10.0 + x_12)) : ((1.0 + x_13) > ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))? (1.0 + x_13) : ((18.0 + x_15) > (6.0 + x_17)? (18.0 + x_15) : (6.0 + x_17))))) : ((((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) > ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))? ((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) : ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))) > (((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) > ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35)))? ((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) : ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))))? (((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) > ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))? ((15.0 + x_18) > (6.0 + x_21)? (15.0 + x_18) : (6.0 + x_21)) : ((19.0 + x_22) > (4.0 + x_24)? (19.0 + x_22) : (4.0 + x_24))) : (((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) > ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35)))? ((8.0 + x_25) > (5.0 + x_26)? (8.0 + x_25) : (5.0 + x_26)) : ((2.0 + x_27) > ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))? (2.0 + x_27) : ((2.0 + x_32) > (1.0 + x_35)? (2.0 + x_32) : (1.0 + x_35))))));
x_18_ = (((((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) > ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))? ((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) : ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))) > (((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) > ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17)))? ((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) : ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))))? (((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) > ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))? ((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) : ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))) : (((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) > ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17)))? ((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) : ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))))) > ((((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) > ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))? ((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) : ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))) > (((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) > ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35)))? ((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) : ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))))? (((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) > ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))? ((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) : ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))) : (((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) > ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35)))? ((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) : ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35)))))? ((((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) > ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))? ((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) : ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))) > (((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) > ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17)))? ((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) : ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))))? (((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) > ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))? ((8.0 + x_2) > (17.0 + x_5)? (8.0 + x_2) : (17.0 + x_5)) : ((17.0 + x_9) > (14.0 + x_11)? (17.0 + x_9) : (14.0 + x_11))) : (((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) > ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17)))? ((9.0 + x_12) > (11.0 + x_13)? (9.0 + x_12) : (11.0 + x_13)) : ((2.0 + x_14) > ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))? (2.0 + x_14) : ((20.0 + x_16) > (7.0 + x_17)? (20.0 + x_16) : (7.0 + x_17))))) : ((((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) > ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))? ((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) : ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))) > (((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) > ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35)))? ((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) : ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))))? (((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) > ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))? ((19.0 + x_18) > (15.0 + x_22)? (19.0 + x_18) : (15.0 + x_22)) : ((18.0 + x_24) > (4.0 + x_25)? (18.0 + x_24) : (4.0 + x_25))) : (((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) > ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35)))? ((11.0 + x_28) > (8.0 + x_30)? (11.0 + x_28) : (8.0 + x_30)) : ((10.0 + x_32) > ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))? (10.0 + x_32) : ((3.0 + x_34) > (7.0 + x_35)? (3.0 + x_34) : (7.0 + x_35))))));
x_19_ = (((((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) > ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))? ((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) : ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))) > (((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) > ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17)))? ((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) : ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))))? (((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) > ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))? ((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) : ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))) : (((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) > ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17)))? ((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) : ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))))) > ((((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) > ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))? ((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) : ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))) > (((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) > ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35)))? ((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) : ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))))? (((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) > ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))? ((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) : ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))) : (((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) > ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35)))? ((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) : ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35)))))? ((((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) > ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))? ((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) : ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))) > (((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) > ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17)))? ((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) : ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))))? (((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) > ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))? ((6.0 + x_1) > (4.0 + x_2)? (6.0 + x_1) : (4.0 + x_2)) : ((6.0 + x_4) > (3.0 + x_7)? (6.0 + x_4) : (3.0 + x_7))) : (((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) > ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17)))? ((1.0 + x_8) > (10.0 + x_12)? (1.0 + x_8) : (10.0 + x_12)) : ((12.0 + x_13) > ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))? (12.0 + x_13) : ((17.0 + x_16) > (20.0 + x_17)? (17.0 + x_16) : (20.0 + x_17))))) : ((((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) > ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))? ((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) : ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))) > (((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) > ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35)))? ((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) : ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))))? (((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) > ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))? ((13.0 + x_19) > (11.0 + x_22)? (13.0 + x_19) : (11.0 + x_22)) : ((12.0 + x_23) > (2.0 + x_25)? (12.0 + x_23) : (2.0 + x_25))) : (((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) > ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35)))? ((8.0 + x_26) > (3.0 + x_28)? (8.0 + x_26) : (3.0 + x_28)) : ((2.0 + x_30) > ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))? (2.0 + x_30) : ((14.0 + x_31) > (3.0 + x_35)? (14.0 + x_31) : (3.0 + x_35))))));
x_20_ = (((((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) > ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))? ((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) : ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))) > (((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) > ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13)))? ((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) : ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))))? (((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) > ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))? ((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) : ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))) : (((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) > ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13)))? ((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) : ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))))) > ((((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) > ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))? ((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) : ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))) > (((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) > ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32)))? ((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) : ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))))? (((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) > ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))? ((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) : ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))) : (((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) > ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32)))? ((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) : ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32)))))? ((((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) > ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))? ((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) : ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))) > (((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) > ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13)))? ((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) : ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))))? (((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) > ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))? ((19.0 + x_3) > (2.0 + x_4)? (19.0 + x_3) : (2.0 + x_4)) : ((20.0 + x_5) > (10.0 + x_6)? (20.0 + x_5) : (10.0 + x_6))) : (((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) > ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13)))? ((20.0 + x_7) > (17.0 + x_9)? (20.0 + x_7) : (17.0 + x_9)) : ((4.0 + x_11) > ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))? (4.0 + x_11) : ((17.0 + x_12) > (14.0 + x_13)? (17.0 + x_12) : (14.0 + x_13))))) : ((((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) > ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))? ((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) : ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))) > (((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) > ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32)))? ((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) : ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))))? (((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) > ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))? ((10.0 + x_14) > (3.0 + x_15)? (10.0 + x_14) : (3.0 + x_15)) : ((8.0 + x_19) > (19.0 + x_20)? (8.0 + x_19) : (19.0 + x_20))) : (((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) > ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32)))? ((11.0 + x_26) > (1.0 + x_27)? (11.0 + x_26) : (1.0 + x_27)) : ((18.0 + x_28) > ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))? (18.0 + x_28) : ((20.0 + x_31) > (14.0 + x_32)? (20.0 + x_31) : (14.0 + x_32))))));
x_21_ = (((((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) > ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))? ((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) : ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))) > (((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) > ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16)))? ((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) : ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))))? (((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) > ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))? ((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) : ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))) : (((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) > ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16)))? ((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) : ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))))) > ((((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) > ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))? ((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) : ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))) > (((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) > ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34)))? ((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) : ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))))? (((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) > ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))? ((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) : ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))) : (((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) > ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34)))? ((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) : ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34)))))? ((((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) > ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))? ((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) : ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))) > (((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) > ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16)))? ((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) : ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))))? (((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) > ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))? ((3.0 + x_1) > (20.0 + x_2)? (3.0 + x_1) : (20.0 + x_2)) : ((17.0 + x_5) > (19.0 + x_6)? (17.0 + x_5) : (19.0 + x_6))) : (((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) > ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16)))? ((19.0 + x_10) > (20.0 + x_11)? (19.0 + x_10) : (20.0 + x_11)) : ((4.0 + x_13) > ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))? (4.0 + x_13) : ((8.0 + x_14) > (11.0 + x_16)? (8.0 + x_14) : (11.0 + x_16))))) : ((((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) > ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))? ((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) : ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))) > (((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) > ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34)))? ((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) : ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))))? (((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) > ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))? ((8.0 + x_17) > (7.0 + x_19)? (8.0 + x_17) : (7.0 + x_19)) : ((16.0 + x_23) > (2.0 + x_25)? (16.0 + x_23) : (2.0 + x_25))) : (((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) > ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34)))? ((11.0 + x_26) > (5.0 + x_28)? (11.0 + x_26) : (5.0 + x_28)) : ((14.0 + x_29) > ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))? (14.0 + x_29) : ((1.0 + x_30) > (8.0 + x_34)? (1.0 + x_30) : (8.0 + x_34))))));
x_22_ = (((((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) > ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))? ((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) : ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))) > (((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) > ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19)))? ((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) : ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))))? (((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) > ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))? ((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) : ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))) : (((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) > ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19)))? ((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) : ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))))) > ((((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) > ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))? ((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) : ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))) > (((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) > ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35)))? ((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) : ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))))? (((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) > ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))? ((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) : ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))) : (((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) > ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35)))? ((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) : ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35)))))? ((((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) > ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))? ((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) : ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))) > (((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) > ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19)))? ((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) : ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))))? (((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) > ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))? ((8.0 + x_0) > (18.0 + x_3)? (8.0 + x_0) : (18.0 + x_3)) : ((10.0 + x_6) > (18.0 + x_7)? (10.0 + x_6) : (18.0 + x_7))) : (((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) > ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19)))? ((15.0 + x_13) > (3.0 + x_14)? (15.0 + x_13) : (3.0 + x_14)) : ((3.0 + x_15) > ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))? (3.0 + x_15) : ((10.0 + x_18) > (10.0 + x_19)? (10.0 + x_18) : (10.0 + x_19))))) : ((((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) > ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))? ((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) : ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))) > (((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) > ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35)))? ((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) : ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))))? (((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) > ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))? ((8.0 + x_20) > (18.0 + x_25)? (8.0 + x_20) : (18.0 + x_25)) : ((20.0 + x_26) > (16.0 + x_29)? (20.0 + x_26) : (16.0 + x_29))) : (((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) > ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35)))? ((4.0 + x_30) > (6.0 + x_32)? (4.0 + x_30) : (6.0 + x_32)) : ((20.0 + x_33) > ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))? (20.0 + x_33) : ((20.0 + x_34) > (10.0 + x_35)? (20.0 + x_34) : (10.0 + x_35))))));
x_23_ = (((((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) > ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))? ((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) : ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))) > (((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) > ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17)))? ((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) : ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))))? (((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) > ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))? ((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) : ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))) : (((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) > ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17)))? ((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) : ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))))) > ((((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) > ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))? ((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) : ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))) > (((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) > ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35)))? ((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) : ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))))? (((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) > ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))? ((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) : ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))) : (((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) > ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35)))? ((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) : ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35)))))? ((((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) > ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))? ((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) : ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))) > (((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) > ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17)))? ((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) : ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))))? (((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) > ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))? ((8.0 + x_4) > (18.0 + x_5)? (8.0 + x_4) : (18.0 + x_5)) : ((8.0 + x_7) > (14.0 + x_8)? (8.0 + x_7) : (14.0 + x_8))) : (((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) > ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17)))? ((2.0 + x_11) > (2.0 + x_14)? (2.0 + x_11) : (2.0 + x_14)) : ((13.0 + x_15) > ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))? (13.0 + x_15) : ((18.0 + x_16) > (9.0 + x_17)? (18.0 + x_16) : (9.0 + x_17))))) : ((((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) > ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))? ((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) : ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))) > (((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) > ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35)))? ((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) : ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))))? (((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) > ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))? ((14.0 + x_20) > (1.0 + x_22)? (14.0 + x_20) : (1.0 + x_22)) : ((6.0 + x_23) > (13.0 + x_24)? (6.0 + x_23) : (13.0 + x_24))) : (((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) > ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35)))? ((5.0 + x_26) > (10.0 + x_29)? (5.0 + x_26) : (10.0 + x_29)) : ((10.0 + x_32) > ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (16.0 + x_35)? (2.0 + x_33) : (16.0 + x_35))))));
x_24_ = (((((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) > ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))? ((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) : ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))) > (((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) > ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18)))? ((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) : ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))))? (((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) > ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))? ((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) : ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))) : (((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) > ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18)))? ((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) : ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))))) > ((((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) > ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))? ((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) : ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))) > (((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) > ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35)))? ((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) : ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))))? (((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) > ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))? ((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) : ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))) : (((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) > ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35)))? ((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) : ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35)))))? ((((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) > ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))? ((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) : ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))) > (((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) > ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18)))? ((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) : ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))))? (((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) > ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))? ((1.0 + x_3) > (16.0 + x_4)? (1.0 + x_3) : (16.0 + x_4)) : ((10.0 + x_7) > (1.0 + x_9)? (10.0 + x_7) : (1.0 + x_9))) : (((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) > ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18)))? ((2.0 + x_11) > (20.0 + x_13)? (2.0 + x_11) : (20.0 + x_13)) : ((8.0 + x_15) > ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))? (8.0 + x_15) : ((20.0 + x_17) > (14.0 + x_18)? (20.0 + x_17) : (14.0 + x_18))))) : ((((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) > ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))? ((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) : ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))) > (((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) > ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35)))? ((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) : ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))))? (((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) > ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))? ((2.0 + x_21) > (7.0 + x_23)? (2.0 + x_21) : (7.0 + x_23)) : ((10.0 + x_27) > (1.0 + x_30)? (10.0 + x_27) : (1.0 + x_30))) : (((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) > ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35)))? ((7.0 + x_31) > (11.0 + x_32)? (7.0 + x_31) : (11.0 + x_32)) : ((20.0 + x_33) > ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))? (20.0 + x_33) : ((6.0 + x_34) > (6.0 + x_35)? (6.0 + x_34) : (6.0 + x_35))))));
x_25_ = (((((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) > ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))? ((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) : ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))) > (((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) > ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12)))? ((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) : ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))))? (((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) > ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))? ((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) : ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))) : (((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) > ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12)))? ((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) : ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))))) > ((((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) > ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))? ((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) : ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))) > (((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) > ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33)))? ((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) : ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))))? (((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) > ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))? ((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) : ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))) : (((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) > ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33)))? ((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) : ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33)))))? ((((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) > ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))? ((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) : ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))) > (((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) > ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12)))? ((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) : ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))))? (((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) > ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))? ((4.0 + x_0) > (8.0 + x_2)? (4.0 + x_0) : (8.0 + x_2)) : ((5.0 + x_3) > (4.0 + x_4)? (5.0 + x_3) : (4.0 + x_4))) : (((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) > ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12)))? ((12.0 + x_5) > (19.0 + x_6)? (12.0 + x_5) : (19.0 + x_6)) : ((2.0 + x_8) > ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))? (2.0 + x_8) : ((20.0 + x_9) > (12.0 + x_12)? (20.0 + x_9) : (12.0 + x_12))))) : ((((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) > ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))? ((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) : ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))) > (((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) > ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33)))? ((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) : ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))))? (((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) > ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))? ((9.0 + x_13) > (15.0 + x_14)? (9.0 + x_13) : (15.0 + x_14)) : ((8.0 + x_15) > (18.0 + x_18)? (8.0 + x_15) : (18.0 + x_18))) : (((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) > ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33)))? ((12.0 + x_23) > (6.0 + x_25)? (12.0 + x_23) : (6.0 + x_25)) : ((15.0 + x_27) > ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))? (15.0 + x_27) : ((20.0 + x_29) > (16.0 + x_33)? (20.0 + x_29) : (16.0 + x_33))))));
x_26_ = (((((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) > ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))? ((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) : ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))) > (((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) > ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17)))? ((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) : ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))))? (((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) > ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))? ((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) : ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))) : (((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) > ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17)))? ((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) : ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))))) > ((((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) > ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))? ((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) : ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))) > (((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) > ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35)))? ((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) : ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))))? (((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) > ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))? ((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) : ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))) : (((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) > ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35)))? ((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) : ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35)))))? ((((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) > ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))? ((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) : ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))) > (((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) > ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17)))? ((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) : ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))))? (((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) > ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))? ((4.0 + x_3) > (5.0 + x_8)? (4.0 + x_3) : (5.0 + x_8)) : ((11.0 + x_9) > (16.0 + x_11)? (11.0 + x_9) : (16.0 + x_11))) : (((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) > ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17)))? ((1.0 + x_12) > (15.0 + x_13)? (1.0 + x_12) : (15.0 + x_13)) : ((1.0 + x_15) > ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))? (1.0 + x_15) : ((4.0 + x_16) > (6.0 + x_17)? (4.0 + x_16) : (6.0 + x_17))))) : ((((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) > ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))? ((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) : ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))) > (((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) > ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35)))? ((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) : ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))))? (((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) > ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))? ((7.0 + x_22) > (9.0 + x_23)? (7.0 + x_22) : (9.0 + x_23)) : ((4.0 + x_24) > (7.0 + x_27)? (4.0 + x_24) : (7.0 + x_27))) : (((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) > ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35)))? ((7.0 + x_29) > (6.0 + x_30)? (7.0 + x_29) : (6.0 + x_30)) : ((10.0 + x_32) > ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))? (10.0 + x_32) : ((2.0 + x_33) > (12.0 + x_35)? (2.0 + x_33) : (12.0 + x_35))))));
x_27_ = (((((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) > ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))? ((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) : ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))) > (((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) > ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14)))? ((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) : ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))))? (((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) > ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))? ((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) : ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))) : (((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) > ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14)))? ((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) : ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))))) > ((((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) > ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))? ((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) : ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))) > (((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) > ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34)))? ((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) : ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))))? (((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) > ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))? ((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) : ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))) : (((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) > ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34)))? ((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) : ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34)))))? ((((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) > ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))? ((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) : ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))) > (((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) > ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14)))? ((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) : ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))))? (((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) > ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))? ((16.0 + x_0) > (2.0 + x_2)? (16.0 + x_0) : (2.0 + x_2)) : ((1.0 + x_4) > (20.0 + x_5)? (1.0 + x_4) : (20.0 + x_5))) : (((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) > ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14)))? ((12.0 + x_7) > (2.0 + x_8)? (12.0 + x_7) : (2.0 + x_8)) : ((20.0 + x_11) > ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))? (20.0 + x_11) : ((18.0 + x_13) > (10.0 + x_14)? (18.0 + x_13) : (10.0 + x_14))))) : ((((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) > ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))? ((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) : ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))) > (((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) > ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34)))? ((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) : ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))))? (((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) > ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))? ((10.0 + x_19) > (19.0 + x_20)? (10.0 + x_19) : (19.0 + x_20)) : ((4.0 + x_22) > (5.0 + x_23)? (4.0 + x_22) : (5.0 + x_23))) : (((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) > ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34)))? ((18.0 + x_24) > (18.0 + x_27)? (18.0 + x_24) : (18.0 + x_27)) : ((4.0 + x_32) > ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))? (4.0 + x_32) : ((8.0 + x_33) > (13.0 + x_34)? (8.0 + x_33) : (13.0 + x_34))))));
x_28_ = (((((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) > ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))? ((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) : ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))) > (((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) > ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17)))? ((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) : ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))))? (((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) > ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))? ((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) : ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))) : (((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) > ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17)))? ((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) : ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))))) > ((((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) > ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))? ((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) : ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))) > (((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) > ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35)))? ((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) : ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))))? (((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) > ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))? ((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) : ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))) : (((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) > ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35)))? ((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) : ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35)))))? ((((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) > ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))? ((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) : ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))) > (((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) > ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17)))? ((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) : ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))))? (((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) > ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))? ((12.0 + x_0) > (9.0 + x_1)? (12.0 + x_0) : (9.0 + x_1)) : ((15.0 + x_5) > (5.0 + x_8)? (15.0 + x_5) : (5.0 + x_8))) : (((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) > ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17)))? ((2.0 + x_10) > (18.0 + x_11)? (2.0 + x_10) : (18.0 + x_11)) : ((15.0 + x_12) > ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))? (15.0 + x_12) : ((15.0 + x_14) > (16.0 + x_17)? (15.0 + x_14) : (16.0 + x_17))))) : ((((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) > ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))? ((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) : ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))) > (((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) > ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35)))? ((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) : ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))))? (((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) > ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))? ((6.0 + x_18) > (4.0 + x_19)? (6.0 + x_18) : (4.0 + x_19)) : ((12.0 + x_22) > (3.0 + x_24)? (12.0 + x_22) : (3.0 + x_24))) : (((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) > ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35)))? ((15.0 + x_25) > (9.0 + x_28)? (15.0 + x_25) : (9.0 + x_28)) : ((6.0 + x_32) > ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))? (6.0 + x_32) : ((15.0 + x_34) > (10.0 + x_35)? (15.0 + x_34) : (10.0 + x_35))))));
x_29_ = (((((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) > ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))? ((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) : ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))) > (((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) > ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20)))? ((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) : ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))))? (((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) > ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))? ((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) : ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))) : (((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) > ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20)))? ((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) : ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))))) > ((((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) > ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))? ((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) : ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))) > (((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) > ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35)))? ((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) : ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))))? (((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) > ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))? ((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) : ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))) : (((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) > ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35)))? ((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) : ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35)))))? ((((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) > ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))? ((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) : ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))) > (((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) > ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20)))? ((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) : ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))))? (((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) > ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))? ((3.0 + x_1) > (19.0 + x_4)? (3.0 + x_1) : (19.0 + x_4)) : ((4.0 + x_5) > (8.0 + x_7)? (4.0 + x_5) : (8.0 + x_7))) : (((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) > ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20)))? ((2.0 + x_10) > (3.0 + x_12)? (2.0 + x_10) : (3.0 + x_12)) : ((4.0 + x_15) > ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))? (4.0 + x_15) : ((19.0 + x_17) > (20.0 + x_20)? (19.0 + x_17) : (20.0 + x_20))))) : ((((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) > ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))? ((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) : ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))) > (((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) > ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35)))? ((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) : ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))))? (((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) > ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))? ((17.0 + x_21) > (19.0 + x_22)? (17.0 + x_21) : (19.0 + x_22)) : ((4.0 + x_25) > (2.0 + x_27)? (4.0 + x_25) : (2.0 + x_27))) : (((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) > ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35)))? ((17.0 + x_29) > (19.0 + x_30)? (17.0 + x_29) : (19.0 + x_30)) : ((6.0 + x_31) > ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))? (6.0 + x_31) : ((19.0 + x_34) > (11.0 + x_35)? (19.0 + x_34) : (11.0 + x_35))))));
x_30_ = (((((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) > ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))? ((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) : ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))) > (((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) > ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19)))? ((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) : ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))))? (((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) > ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))? ((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) : ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))) : (((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) > ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19)))? ((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) : ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))))) > ((((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) > ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))? ((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) : ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))) > (((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) > ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34)))? ((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) : ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))))? (((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) > ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))? ((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) : ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))) : (((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) > ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34)))? ((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) : ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34)))))? ((((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) > ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))? ((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) : ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))) > (((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) > ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19)))? ((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) : ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))))? (((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) > ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))? ((12.0 + x_0) > (10.0 + x_1)? (12.0 + x_0) : (10.0 + x_1)) : ((4.0 + x_8) > (1.0 + x_9)? (4.0 + x_8) : (1.0 + x_9))) : (((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) > ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19)))? ((18.0 + x_10) > (1.0 + x_11)? (18.0 + x_10) : (1.0 + x_11)) : ((12.0 + x_12) > ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))? (12.0 + x_12) : ((20.0 + x_16) > (13.0 + x_19)? (20.0 + x_16) : (13.0 + x_19))))) : ((((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) > ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))? ((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) : ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))) > (((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) > ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34)))? ((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) : ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))))? (((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) > ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))? ((18.0 + x_22) > (19.0 + x_23)? (18.0 + x_22) : (19.0 + x_23)) : ((8.0 + x_24) > (1.0 + x_27)? (8.0 + x_24) : (1.0 + x_27))) : (((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) > ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34)))? ((10.0 + x_28) > (2.0 + x_30)? (10.0 + x_28) : (2.0 + x_30)) : ((12.0 + x_31) > ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))? (12.0 + x_31) : ((12.0 + x_33) > (10.0 + x_34)? (12.0 + x_33) : (10.0 + x_34))))));
x_31_ = (((((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) > ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))? ((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) : ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))) > (((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) > ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20)))? ((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) : ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))))? (((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) > ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))? ((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) : ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))) : (((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) > ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20)))? ((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) : ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))))) > ((((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) > ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))? ((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) : ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))) > (((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) > ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34)))? ((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) : ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))))? (((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) > ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))? ((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) : ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))) : (((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) > ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34)))? ((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) : ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34)))))? ((((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) > ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))? ((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) : ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))) > (((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) > ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20)))? ((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) : ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))))? (((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) > ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))? ((20.0 + x_0) > (16.0 + x_2)? (20.0 + x_0) : (16.0 + x_2)) : ((9.0 + x_4) > (18.0 + x_5)? (9.0 + x_4) : (18.0 + x_5))) : (((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) > ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20)))? ((4.0 + x_11) > (16.0 + x_14)? (4.0 + x_11) : (16.0 + x_14)) : ((12.0 + x_16) > ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))? (12.0 + x_16) : ((5.0 + x_19) > (1.0 + x_20)? (5.0 + x_19) : (1.0 + x_20))))) : ((((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) > ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))? ((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) : ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))) > (((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) > ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34)))? ((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) : ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))))? (((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) > ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))? ((10.0 + x_21) > (6.0 + x_22)? (10.0 + x_21) : (6.0 + x_22)) : ((17.0 + x_24) > (2.0 + x_25)? (17.0 + x_24) : (2.0 + x_25))) : (((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) > ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34)))? ((3.0 + x_26) > (5.0 + x_27)? (3.0 + x_26) : (5.0 + x_27)) : ((19.0 + x_28) > ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))? (19.0 + x_28) : ((18.0 + x_31) > (11.0 + x_34)? (18.0 + x_31) : (11.0 + x_34))))));
x_32_ = (((((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) > ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))? ((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) : ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))) > (((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) > ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15)))? ((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) : ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))))? (((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) > ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))? ((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) : ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))) : (((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) > ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15)))? ((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) : ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))))) > ((((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) > ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))? ((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) : ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))) > (((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) > ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35)))? ((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) : ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))))? (((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) > ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))? ((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) : ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))) : (((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) > ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35)))? ((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) : ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35)))))? ((((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) > ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))? ((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) : ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))) > (((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) > ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15)))? ((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) : ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))))? (((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) > ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))? ((17.0 + x_2) > (4.0 + x_4)? (17.0 + x_2) : (4.0 + x_4)) : ((6.0 + x_6) > (2.0 + x_8)? (6.0 + x_6) : (2.0 + x_8))) : (((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) > ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15)))? ((3.0 + x_9) > (3.0 + x_10)? (3.0 + x_9) : (3.0 + x_10)) : ((9.0 + x_12) > ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))? (9.0 + x_12) : ((8.0 + x_14) > (15.0 + x_15)? (8.0 + x_14) : (15.0 + x_15))))) : ((((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) > ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))? ((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) : ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))) > (((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) > ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35)))? ((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) : ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))))? (((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) > ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))? ((13.0 + x_19) > (9.0 + x_24)? (13.0 + x_19) : (9.0 + x_24)) : ((15.0 + x_26) > (10.0 + x_27)? (15.0 + x_26) : (10.0 + x_27))) : (((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) > ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35)))? ((10.0 + x_28) > (2.0 + x_29)? (10.0 + x_28) : (2.0 + x_29)) : ((1.0 + x_30) > ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))? (1.0 + x_30) : ((11.0 + x_34) > (4.0 + x_35)? (11.0 + x_34) : (4.0 + x_35))))));
x_33_ = (((((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) > ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))? ((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) : ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))) > (((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) > ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17)))? ((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) : ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))))? (((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) > ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))? ((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) : ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))) : (((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) > ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17)))? ((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) : ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))))) > ((((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) > ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))? ((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) : ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))) > (((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) > ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34)))? ((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) : ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))))? (((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) > ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))? ((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) : ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))) : (((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) > ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34)))? ((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) : ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34)))))? ((((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) > ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))? ((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) : ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))) > (((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) > ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17)))? ((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) : ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))))? (((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) > ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))? ((18.0 + x_1) > (18.0 + x_5)? (18.0 + x_1) : (18.0 + x_5)) : ((12.0 + x_9) > (14.0 + x_10)? (12.0 + x_9) : (14.0 + x_10))) : (((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) > ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17)))? ((14.0 + x_12) > (17.0 + x_13)? (14.0 + x_12) : (17.0 + x_13)) : ((3.0 + x_14) > ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))? (3.0 + x_14) : ((9.0 + x_15) > (7.0 + x_17)? (9.0 + x_15) : (7.0 + x_17))))) : ((((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) > ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))? ((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) : ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))) > (((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) > ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34)))? ((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) : ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))))? (((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) > ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))? ((8.0 + x_18) > (5.0 + x_21)? (8.0 + x_18) : (5.0 + x_21)) : ((15.0 + x_23) > (14.0 + x_24)? (15.0 + x_23) : (14.0 + x_24))) : (((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) > ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34)))? ((3.0 + x_26) > (4.0 + x_28)? (3.0 + x_26) : (4.0 + x_28)) : ((7.0 + x_29) > ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))? (7.0 + x_29) : ((6.0 + x_32) > (7.0 + x_34)? (6.0 + x_32) : (7.0 + x_34))))));
x_34_ = (((((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) > ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))? ((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) : ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))) > (((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) > ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21)))? ((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) : ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))))? (((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) > ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))? ((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) : ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))) : (((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) > ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21)))? ((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) : ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))))) > ((((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) > ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))? ((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) : ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))) > (((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) > ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35)))? ((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) : ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))))? (((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) > ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))? ((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) : ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))) : (((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) > ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35)))? ((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) : ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35)))))? ((((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) > ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))? ((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) : ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))) > (((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) > ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21)))? ((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) : ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))))? (((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) > ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))? ((18.0 + x_0) > (7.0 + x_4)? (18.0 + x_0) : (7.0 + x_4)) : ((6.0 + x_5) > (6.0 + x_7)? (6.0 + x_5) : (6.0 + x_7))) : (((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) > ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21)))? ((1.0 + x_10) > (13.0 + x_13)? (1.0 + x_10) : (13.0 + x_13)) : ((5.0 + x_14) > ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))? (5.0 + x_14) : ((11.0 + x_20) > (12.0 + x_21)? (11.0 + x_20) : (12.0 + x_21))))) : ((((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) > ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))? ((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) : ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))) > (((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) > ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35)))? ((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) : ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))))? (((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) > ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))? ((8.0 + x_25) > (9.0 + x_26)? (8.0 + x_25) : (9.0 + x_26)) : ((12.0 + x_27) > (17.0 + x_29)? (12.0 + x_27) : (17.0 + x_29))) : (((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) > ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35)))? ((19.0 + x_30) > (4.0 + x_31)? (19.0 + x_30) : (4.0 + x_31)) : ((10.0 + x_32) > ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))? (10.0 + x_32) : ((10.0 + x_33) > (20.0 + x_35)? (10.0 + x_33) : (20.0 + x_35))))));
x_35_ = (((((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) > ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))? ((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) : ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))) > (((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) > ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16)))? ((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) : ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))))? (((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) > ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))? ((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) : ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))) : (((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) > ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16)))? ((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) : ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))))) > ((((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) > ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))? ((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) : ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))) > (((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) > ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35)))? ((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) : ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))))? (((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) > ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))? ((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) : ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))) : (((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) > ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35)))? ((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) : ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35)))))? ((((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) > ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))? ((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) : ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))) > (((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) > ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16)))? ((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) : ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))))? (((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) > ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))? ((10.0 + x_0) > (12.0 + x_2)? (10.0 + x_0) : (12.0 + x_2)) : ((11.0 + x_4) > (9.0 + x_5)? (11.0 + x_4) : (9.0 + x_5))) : (((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) > ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16)))? ((2.0 + x_8) > (16.0 + x_9)? (2.0 + x_8) : (16.0 + x_9)) : ((8.0 + x_11) > ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))? (8.0 + x_11) : ((3.0 + x_13) > (1.0 + x_16)? (3.0 + x_13) : (1.0 + x_16))))) : ((((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) > ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))? ((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) : ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))) > (((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) > ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35)))? ((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) : ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))))? (((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) > ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))? ((11.0 + x_17) > (2.0 + x_19)? (11.0 + x_17) : (2.0 + x_19)) : ((18.0 + x_21) > (2.0 + x_22)? (18.0 + x_21) : (2.0 + x_22))) : (((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) > ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35)))? ((19.0 + x_24) > (15.0 + x_26)? (19.0 + x_24) : (15.0 + x_26)) : ((16.0 + x_32) > ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))? (16.0 + x_32) : ((2.0 + x_34) > (3.0 + x_35)? (2.0 + x_34) : (3.0 + x_35))))));
x_0 = x_0_;
x_1 = x_1_;
x_2 = x_2_;
x_3 = x_3_;
x_4 = x_4_;
x_5 = x_5_;
x_6 = x_6_;
x_7 = x_7_;
x_8 = x_8_;
x_9 = x_9_;
x_10 = x_10_;
x_11 = x_11_;
x_12 = x_12_;
x_13 = x_13_;
x_14 = x_14_;
x_15 = x_15_;
x_16 = x_16_;
x_17 = x_17_;
x_18 = x_18_;
x_19 = x_19_;
x_20 = x_20_;
x_21 = x_21_;
x_22 = x_22_;
x_23 = x_23_;
x_24 = x_24_;
x_25 = x_25_;
x_26 = x_26_;
x_27 = x_27_;
x_28 = x_28_;
x_29 = x_29_;
x_30 = x_30_;
x_31 = x_31_;
x_32 = x_32_;
x_33 = x_33_;
x_34 = x_34_;
x_35 = x_35_;
}
return 0;
}
|
the_stack_data/97011902.c | #include <stdio.h>
#include <math.h>
#include <string.h>
#include <stdlib.h>
#define N 288 /* frame dimension for QCIF format */
#define M 352 /* frame dimension for QCIF format */
#define filename "flower_cif_150_yuv444.yuv"
#define file_y "flower_cif_150_yuv444y.yuv"
/* code for armulator*/
int current_y[N][M];
int A[N+2][M+2];
int newA[N+2][M+2];
#pragma arm section zidata="sram"
int block[3][3];
#pragma arm section
/*Me ton parakatw pinaka tha ginei to filtrarisma stin fotografia
int Laplacianfilter [3][3] = {
{0, 1, 0} ,
{1,-4, 1} ,
{0, 1, 0}
}; */
int i,j,k;
void read()
{
FILE *frame_c;
if((frame_c=fopen(filename,"rb"))==NULL)
{
printf("current frame doesn't exist\n");
exit(-1);
}
for(i=0;i<N;i++)
{
for(j=0;j<M;j++)
{
current_y[i][j]=fgetc(frame_c);
}
}
fclose(frame_c);
}
void filtering()
{
/*Arxikopoioume enan pinaka me dio parapanw grammes kai stiles etsi wste na min prokipsei mikroteros pinakas(apo ta M,N) meta to convolution*/
for(i=0;i<N+2;i++)
for(j=0;j<M+2;j++)
A[i][j]=0;
/*Oi dio extra grammes kai stiles periexoun tin timi 0, oi ypoloipes theseis tou pinaka, dexontai times apo ton pinaka y*/
for(i=1;i<N+1;i++)
for(j=1;j<M+1;j++)
A[i][j]=current_y[i-1][j-1];
for (i=1; i<N+1; i++){
for (j=1; j<M+1; j++){
if (j==1){
for (k=0; k<3; k++){
block[0][k]=A[0][k];
block[1][k]=A[1][k];
block[2][k]=A[2][k];
}
}else{
for (k=0; k<3; k++){
block[k+i-1][j-1]=block[k+i-1][j];
block[k+i-1][j]=block[k+i-1][j+1];
block[k+i-1][j+1]=A[k+i-1][j+2];
}
}
newA[i][j]=(block[i][j] * (-4) + // kentro
block[i-1][j-1] *(0) + // panw aristera
block[i][j-1] *(1) + // aristera
block[i+1][j-1] *(0) + // katw aristera
block[i][j+1] *(1) + // kentro panw
block[i+1][j] *(1) + // kentro katw
block[i-1][j+1]*(0) + // panw deksia
block[i-1][j] *(1) + // deksia
block[i+1][j+1] *(0) // katw deksia
);
}
}
for (i=1;i<M+1;i++){
for (j=1;j<M+1;j++){
current_y[i-1][j-1]=newA[i][j] + 127;
if (current_y[i-1][j-1] > 255) current_y[i-1][j-1] = 255;
if (current_y[i-1][j-1] < 0) current_y[i-1][j-1] = 0;
}
}
}
void write()
{
FILE *frame_y;
frame_y=fopen(file_y,"wb");
for(i=0;i<N;i++)
{
for(j=0;j<M;j++)
{
fputc(current_y[i][j],frame_y);
}
}
fclose(frame_y);
}
int main()
{
read();
filtering();
write();
}
|
the_stack_data/907811.c | /*
* Copyright (c) 2011, 2012, 2013 Jonas 'Sortie' Termansen.
*
* Permission to use, copy, modify, and 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.
*
* sys/time/gettimeofday.c
* Get date and time.
*/
#include <sys/time.h>
#include <time.h>
int gettimeofday(struct timeval* tp, void* tzp)
{
(void) tzp;
struct timespec now;
if ( clock_gettime(CLOCK_REALTIME, &now) < 0 )
return -1;
tp->tv_sec = now.tv_sec;
tp->tv_usec = now.tv_nsec / 1000;
return 0;
}
|
the_stack_data/118663.c | /////////////////include///////////////////////
#define _GNU_SOURCE
#include <dlfcn.h>
#include <errno.h>
#include <stddef.h>
#include <stdlib.h>
#include <stdio.h>
#include <execinfo.h>
#include <signal.h>
#include <string.h>
#include <time.h>
#include <unistd.h>
#include <pthread.h>
#include <sys/prctl.h>
////////////////pre-defines///////////////////////
#define RPT_SIGNAL 64
#define MAX_STACK_LEN 32
#define RPT_DIR "/var/log/msv"
#define BKT_CNT (0xffff+1)
#define VID_MV_CNT 48
#define MSV_RPT_INTERVAL 2 // sleep 2s to checker g_rptFlag
#define MSV_INLINE __attribute__ ((always_inline)) inline
#define DBG(fmt, ...) //{printf("debug %s:%d %s => ", __FILE__, __LINE__, __func__);printf(fmt, ##__VA_ARGS__);printf("\n");}
#define INFO(fmt, ...) // {printf("info %s:%d %s => ", __FILE__, __LINE__, __func__);printf(fmt, ##__VA_ARGS__);printf("\n");}
#define ERR(fmt, ...) //{printf("error %s:%d %s => ", __FILE__, __LINE__, __func__);printf(fmt, ##__VA_ARGS__);printf("\n");}
#define RPT(fp, fmt, ...) {fprintf(fp, fmt, ##__VA_ARGS__);fprintf(fp, "\n");}
///////////////pfn type defines///////////////////////
typedef void* (*PFN_Malloc)(size_t);
typedef void (*PFN_Free)(void*);
typedef void* (*PFN_Calloc)(size_t, size_t);
typedef void* (*PFN_Realloc)(void*, size_t);
typedef void* (*PFN_Valloc)(size_t);
typedef void* (*PFN_PValloc)(size_t);
typedef void* (*PFN_MemAlign)(size_t, size_t);
typedef void* (*PFN_LibcMemAlign)(size_t, size_t);
typedef int (*PFN_PosixMemAlign)(void**, size_t, size_t);
typedef void* (*PFN_AlignedAlloc)(size_t, size_t);
typedef void (*PFN_SignalHandler)(int);
typedef PFN_SignalHandler (*PFN_Signal)(int, PFN_SignalHandler);
typedef size_t (*PFN_MallocUsableSize)(void*);
/////////////stack struct defines///////////////////
typedef struct tagMemBt
{
struct tagMemBt* next;
unsigned long count;
unsigned long total;
unsigned long depth;
unsigned long vid;
void* bt[MAX_STACK_LEN];
} MemBt;
typedef struct tagPtrHdr
{
MemBt* stack;
unsigned long size;
unsigned long vid;
unsigned long hdrlen;
} PtrHdr;
#define MSV_ALIGNMENT sizeof(PtrHdr)
#define MIN_ALIGNMENT (sizeof(PtrHdr) + sizeof(unsigned long))
#define ADD_HDR(ptr) ((unsigned char*)ptr - *((unsigned long*)ptr - 1))
#define CUT_HDR(ptr) ((unsigned char*)ptr + ((PtrHdr*)ptr)->hdrlen)
//////////////////global values///////////////////
static int g_init = 0;
static __thread int g_innerCall = 0;
static MemBt* g_list[BKT_CNT] = {0};
static unsigned long g_count = 0;
static unsigned long g_total = 0;
static unsigned long g_chc = 0; // crc hint count
static int g_rptFlag = 0;
static int g_rptRunning = 0;
static pthread_t g_rptThread = 0;
static PFN_Malloc g_pfnMalloc = 0;
static PFN_Free g_pfnFree = 0;
static PFN_Calloc g_pfnCalloc = 0;
static PFN_Realloc g_pfnRealloc = 0;
static PFN_Valloc g_pfnValloc = 0;
static PFN_PValloc g_pfnPValloc = 0;
static PFN_MemAlign g_pfnMemAlign = 0;
static PFN_LibcMemAlign g_pfnLibcMemAlign = 0;
static PFN_PosixMemAlign g_pfnPosixMemAlign = 0;
static PFN_AlignedAlloc g_pfnAlignedAlloc = 0;
static PFN_Signal g_pfnSignal = 0;
static PFN_MallocUsableSize g_pfnMallocUsableSize = 0;
static PFN_SignalHandler g_pfnRptSigOutHdr = SIG_DFL;
static char g_pidCmd[1024] = {0};
static unsigned long g_pageSize = 4096;
static const unsigned long long g_crc64Table[256] = {
0x0000000000000000ULL, 0x7ad870c830358979ULL,
0xf5b0e190606b12f2ULL, 0x8f689158505e9b8bULL,
0xc038e5739841b68fULL, 0xbae095bba8743ff6ULL,
0x358804e3f82aa47dULL, 0x4f50742bc81f2d04ULL,
0xab28ecb46814fe75ULL, 0xd1f09c7c5821770cULL,
0x5e980d24087fec87ULL, 0x24407dec384a65feULL,
0x6b1009c7f05548faULL, 0x11c8790fc060c183ULL,
0x9ea0e857903e5a08ULL, 0xe478989fa00bd371ULL,
0x7d08ff3b88be6f81ULL, 0x07d08ff3b88be6f8ULL,
0x88b81eabe8d57d73ULL, 0xf2606e63d8e0f40aULL,
0xbd301a4810ffd90eULL, 0xc7e86a8020ca5077ULL,
0x4880fbd87094cbfcULL, 0x32588b1040a14285ULL,
0xd620138fe0aa91f4ULL, 0xacf86347d09f188dULL,
0x2390f21f80c18306ULL, 0x594882d7b0f40a7fULL,
0x1618f6fc78eb277bULL, 0x6cc0863448deae02ULL,
0xe3a8176c18803589ULL, 0x997067a428b5bcf0ULL,
0xfa11fe77117cdf02ULL, 0x80c98ebf2149567bULL,
0x0fa11fe77117cdf0ULL, 0x75796f2f41224489ULL,
0x3a291b04893d698dULL, 0x40f16bccb908e0f4ULL,
0xcf99fa94e9567b7fULL, 0xb5418a5cd963f206ULL,
0x513912c379682177ULL, 0x2be1620b495da80eULL,
0xa489f35319033385ULL, 0xde51839b2936bafcULL,
0x9101f7b0e12997f8ULL, 0xebd98778d11c1e81ULL,
0x64b116208142850aULL, 0x1e6966e8b1770c73ULL,
0x8719014c99c2b083ULL, 0xfdc17184a9f739faULL,
0x72a9e0dcf9a9a271ULL, 0x08719014c99c2b08ULL,
0x4721e43f0183060cULL, 0x3df994f731b68f75ULL,
0xb29105af61e814feULL, 0xc849756751dd9d87ULL,
0x2c31edf8f1d64ef6ULL, 0x56e99d30c1e3c78fULL,
0xd9810c6891bd5c04ULL, 0xa3597ca0a188d57dULL,
0xec09088b6997f879ULL, 0x96d1784359a27100ULL,
0x19b9e91b09fcea8bULL, 0x636199d339c963f2ULL,
0xdf7adabd7a6e2d6fULL, 0xa5a2aa754a5ba416ULL,
0x2aca3b2d1a053f9dULL, 0x50124be52a30b6e4ULL,
0x1f423fcee22f9be0ULL, 0x659a4f06d21a1299ULL,
0xeaf2de5e82448912ULL, 0x902aae96b271006bULL,
0x74523609127ad31aULL, 0x0e8a46c1224f5a63ULL,
0x81e2d7997211c1e8ULL, 0xfb3aa75142244891ULL,
0xb46ad37a8a3b6595ULL, 0xceb2a3b2ba0eececULL,
0x41da32eaea507767ULL, 0x3b024222da65fe1eULL,
0xa2722586f2d042eeULL, 0xd8aa554ec2e5cb97ULL,
0x57c2c41692bb501cULL, 0x2d1ab4dea28ed965ULL,
0x624ac0f56a91f461ULL, 0x1892b03d5aa47d18ULL,
0x97fa21650afae693ULL, 0xed2251ad3acf6feaULL,
0x095ac9329ac4bc9bULL, 0x7382b9faaaf135e2ULL,
0xfcea28a2faafae69ULL, 0x8632586aca9a2710ULL,
0xc9622c4102850a14ULL, 0xb3ba5c8932b0836dULL,
0x3cd2cdd162ee18e6ULL, 0x460abd1952db919fULL,
0x256b24ca6b12f26dULL, 0x5fb354025b277b14ULL,
0xd0dbc55a0b79e09fULL, 0xaa03b5923b4c69e6ULL,
0xe553c1b9f35344e2ULL, 0x9f8bb171c366cd9bULL,
0x10e3202993385610ULL, 0x6a3b50e1a30ddf69ULL,
0x8e43c87e03060c18ULL, 0xf49bb8b633338561ULL,
0x7bf329ee636d1eeaULL, 0x012b592653589793ULL,
0x4e7b2d0d9b47ba97ULL, 0x34a35dc5ab7233eeULL,
0xbbcbcc9dfb2ca865ULL, 0xc113bc55cb19211cULL,
0x5863dbf1e3ac9decULL, 0x22bbab39d3991495ULL,
0xadd33a6183c78f1eULL, 0xd70b4aa9b3f20667ULL,
0x985b3e827bed2b63ULL, 0xe2834e4a4bd8a21aULL,
0x6debdf121b863991ULL, 0x1733afda2bb3b0e8ULL,
0xf34b37458bb86399ULL, 0x8993478dbb8deae0ULL,
0x06fbd6d5ebd3716bULL, 0x7c23a61ddbe6f812ULL,
0x3373d23613f9d516ULL, 0x49aba2fe23cc5c6fULL,
0xc6c333a67392c7e4ULL, 0xbc1b436e43a74e9dULL,
0x95ac9329ac4bc9b5ULL, 0xef74e3e19c7e40ccULL,
0x601c72b9cc20db47ULL, 0x1ac40271fc15523eULL,
0x5594765a340a7f3aULL, 0x2f4c0692043ff643ULL,
0xa02497ca54616dc8ULL, 0xdafce7026454e4b1ULL,
0x3e847f9dc45f37c0ULL, 0x445c0f55f46abeb9ULL,
0xcb349e0da4342532ULL, 0xb1eceec59401ac4bULL,
0xfebc9aee5c1e814fULL, 0x8464ea266c2b0836ULL,
0x0b0c7b7e3c7593bdULL, 0x71d40bb60c401ac4ULL,
0xe8a46c1224f5a634ULL, 0x927c1cda14c02f4dULL,
0x1d148d82449eb4c6ULL, 0x67ccfd4a74ab3dbfULL,
0x289c8961bcb410bbULL, 0x5244f9a98c8199c2ULL,
0xdd2c68f1dcdf0249ULL, 0xa7f41839ecea8b30ULL,
0x438c80a64ce15841ULL, 0x3954f06e7cd4d138ULL,
0xb63c61362c8a4ab3ULL, 0xcce411fe1cbfc3caULL,
0x83b465d5d4a0eeceULL, 0xf96c151de49567b7ULL,
0x76048445b4cbfc3cULL, 0x0cdcf48d84fe7545ULL,
0x6fbd6d5ebd3716b7ULL, 0x15651d968d029fceULL,
0x9a0d8ccedd5c0445ULL, 0xe0d5fc06ed698d3cULL,
0xaf85882d2576a038ULL, 0xd55df8e515432941ULL,
0x5a3569bd451db2caULL, 0x20ed197575283bb3ULL,
0xc49581ead523e8c2ULL, 0xbe4df122e51661bbULL,
0x3125607ab548fa30ULL, 0x4bfd10b2857d7349ULL,
0x04ad64994d625e4dULL, 0x7e7514517d57d734ULL,
0xf11d85092d094cbfULL, 0x8bc5f5c11d3cc5c6ULL,
0x12b5926535897936ULL, 0x686de2ad05bcf04fULL,
0xe70573f555e26bc4ULL, 0x9ddd033d65d7e2bdULL,
0xd28d7716adc8cfb9ULL, 0xa85507de9dfd46c0ULL,
0x273d9686cda3dd4bULL, 0x5de5e64efd965432ULL,
0xb99d7ed15d9d8743ULL, 0xc3450e196da80e3aULL,
0x4c2d9f413df695b1ULL, 0x36f5ef890dc31cc8ULL,
0x79a59ba2c5dc31ccULL, 0x037deb6af5e9b8b5ULL,
0x8c157a32a5b7233eULL, 0xf6cd0afa9582aa47ULL,
0x4ad64994d625e4daULL, 0x300e395ce6106da3ULL,
0xbf66a804b64ef628ULL, 0xc5bed8cc867b7f51ULL,
0x8aeeace74e645255ULL, 0xf036dc2f7e51db2cULL,
0x7f5e4d772e0f40a7ULL, 0x05863dbf1e3ac9deULL,
0xe1fea520be311aafULL, 0x9b26d5e88e0493d6ULL,
0x144e44b0de5a085dULL, 0x6e963478ee6f8124ULL,
0x21c640532670ac20ULL, 0x5b1e309b16452559ULL,
0xd476a1c3461bbed2ULL, 0xaeaed10b762e37abULL,
0x37deb6af5e9b8b5bULL, 0x4d06c6676eae0222ULL,
0xc26e573f3ef099a9ULL, 0xb8b627f70ec510d0ULL,
0xf7e653dcc6da3dd4ULL, 0x8d3e2314f6efb4adULL,
0x0256b24ca6b12f26ULL, 0x788ec2849684a65fULL,
0x9cf65a1b368f752eULL, 0xe62e2ad306bafc57ULL,
0x6946bb8b56e467dcULL, 0x139ecb4366d1eea5ULL,
0x5ccebf68aecec3a1ULL, 0x2616cfa09efb4ad8ULL,
0xa97e5ef8cea5d153ULL, 0xd3a62e30fe90582aULL,
0xb0c7b7e3c7593bd8ULL, 0xca1fc72bf76cb2a1ULL,
0x45775673a732292aULL, 0x3faf26bb9707a053ULL,
0x70ff52905f188d57ULL, 0x0a2722586f2d042eULL,
0x854fb3003f739fa5ULL, 0xff97c3c80f4616dcULL,
0x1bef5b57af4dc5adULL, 0x61372b9f9f784cd4ULL,
0xee5fbac7cf26d75fULL, 0x9487ca0fff135e26ULL,
0xdbd7be24370c7322ULL, 0xa10fceec0739fa5bULL,
0x2e675fb4576761d0ULL, 0x54bf2f7c6752e8a9ULL,
0xcdcf48d84fe75459ULL, 0xb71738107fd2dd20ULL,
0x387fa9482f8c46abULL, 0x42a7d9801fb9cfd2ULL,
0x0df7adabd7a6e2d6ULL, 0x772fdd63e7936bafULL,
0xf8474c3bb7cdf024ULL, 0x829f3cf387f8795dULL,
0x66e7a46c27f3aa2cULL, 0x1c3fd4a417c62355ULL,
0x935745fc4798b8deULL, 0xe98f353477ad31a7ULL,
0xa6df411fbfb21ca3ULL, 0xdc0731d78f8795daULL,
0x536fa08fdfd90e51ULL, 0x29b7d047efec8728ULL
};
//////////////////time pid cmd crc/////////////////
static void getCurTime(char* out, int len)
{
time_t cur = time(0);
struct tm now = {0};
localtime_r(&cur, &now);
now.tm_year += 1900;
now.tm_mon += 1;
snprintf(out, len, "time_%d%s%d%s%d_%s%d%s%d%s%d"
, now.tm_year
, (now.tm_mon < 10 ? "0" : "")
, now.tm_mon
, (now.tm_mday < 10 ? "0" : "")
, now.tm_mday
, (now.tm_hour < 10 ? "0" : "")
, now.tm_hour
, (now.tm_min < 10 ? "0" : "")
, now.tm_min
, (now.tm_sec < 10 ? "0" : "")
, now.tm_sec
);
}
static void initPidCmd()
{
if (g_pidCmd[0] != 0) return;
pid_t pid = getpid();
char file[100] = {0};
snprintf(file, sizeof(file), "/proc/%lu/cmdline", (unsigned long)pid);
FILE* fp = fopen(file, "r");
if (fp == 0)
{
return;
}
char cmd[1024] = {0};
fread(cmd, sizeof(cmd), 1, fp);
fclose(fp);
int i = 0;
for (i = 0; i < sizeof(cmd) && cmd[i] != 0; i++)
{
if ('0' <= cmd[i] && cmd[i] <= '9') continue;
if ('a' <= cmd[i] && cmd[i] <= 'z') continue;
if ('A' <= cmd[i] && cmd[i] <= 'Z') continue;
cmd[i] = '_';
}
snprintf(g_pidCmd, sizeof(g_pidCmd), "pid_%lu_cmdline_%s", (unsigned long)pid, cmd);
}
static unsigned long long getVid(void** bt, unsigned long depth)
{
unsigned long long crc = 0;
int i = 0;
for (i = 0; i < depth; i++)
{
unsigned long ptrVal = (unsigned long)bt[i];
unsigned char* ptrTmp = (unsigned char*)&ptrVal;
int j = 0;
for (j = 0; j < sizeof(ptrVal); j++)
{
unsigned char byte = ptrTmp[j];
crc = g_crc64Table[(crc ^ byte) & 0xff] ^ (crc >> 8);
}
}
return crc;
}
//////////////////stack functions//////////////////////
static void reportCurrent()
{
initPidCmd();
char time[100] = {0};
getCurTime(time, sizeof(time));
char file[1024] = {0};
snprintf(file, sizeof(file), "%s/%s_%s.bt", RPT_DIR, time, g_pidCmd);
FILE* fp = fopen(file, "at+");
if (fp == 0)
{
ERR("open file[%s] fail[%s]", file, strerror(errno));
return;
}
INFO("open file[%s] success", file);
RPT(fp,
"%s\n" // time
"%s\n" // pid and cmdline
"count: %lu, total: %lu\n" // whole count and whole total
, time
, g_pidCmd
, g_count, g_total);
int i = 0;
unsigned long totalBtCnt = 0;
unsigned long usingBtCnt = 0;
unsigned long selfUseMem = 0;
unsigned long maxBtCnt = 0;
unsigned long maxUsingBtCnt = 0;
for (i = 0; i < BKT_CNT; i++)
{
MemBt* tmp = 0;
unsigned long tmpBtCnt = 0;
unsigned long tmpUsingBtCnt = 0;
for (tmp = g_list[i]; tmp != 0; tmp = tmp->next)
{
DBG("vid: %lu", tmp->vid);
totalBtCnt++;
tmpBtCnt++;
if (tmp->count == 0 || tmp->total == 0) continue;
usingBtCnt++;
tmpUsingBtCnt++;
RPT(fp, "\ncount: %lu, total: %lu", tmp->count, tmp->total);
int j = 0;
for (j = 0; j < tmp->depth; j++)
{
void* ptr = tmp->bt[j];
Dl_info info = {0};
if (dladdr(ptr, &info) == 0)
{
RPT(fp, "? ?");
continue;
}
unsigned long diff = (unsigned long)ptr;
if (diff >> 32 != 0 && info.dli_fbase != 0) diff -= (unsigned long)info.dli_fbase;
RPT(fp,
"%s 0x%x"
, ((info.dli_fname != 0 && *info.dli_fname != 0) ? info.dli_fname : "?")
, diff
);
}
}
if (tmpBtCnt > maxBtCnt) maxBtCnt = tmpBtCnt;
if (tmpUsingBtCnt > maxUsingBtCnt) maxUsingBtCnt = tmpUsingBtCnt;
}
selfUseMem = totalBtCnt * sizeof(MemBt) + sizeof(g_list);
RPT(fp,
"\n\ntotal bt count: %lu"
"\nusing bt count: %lu"
"\nself use memory: %lu"
"\ncrc hit count: %lu"
"\nmax bucket bt count: %lu"
"\nmax bucket using bt count: %lu"
, totalBtCnt
, usingBtCnt
, selfUseMem
, g_chc
, maxBtCnt
, maxUsingBtCnt);
fclose(fp);
}
static void* rptThreadEntry(void* arg)
{
prctl(PR_SET_NAME, "msvReport");
g_rptRunning = 1;
while (g_rptRunning)
{
sleep(MSV_RPT_INTERVAL);
if (!g_rptFlag) continue;
g_rptFlag = 0;
reportCurrent();
}
}
static void rptSigHdr(int sigNum)
{
if (sigNum != RPT_SIGNAL) return;
if (g_pfnRptSigOutHdr != SIG_ERR && g_pfnRptSigOutHdr != 0) g_pfnRptSigOutHdr(sigNum);
g_rptFlag = 1;
if (g_rptThread != 0) return;
//create thread
int ret = pthread_create(&g_rptThread, 0, rptThreadEntry, 0);
if (ret != 0)
{
g_rptThread = 0;
ERR("pthread_create fail: ret=%d", ret);
}
}
MSV_INLINE
static MemBt* stackGetCurrent(size_t size)
{
MemBt* ret = (MemBt*)malloc(sizeof(MemBt));
if (ret == 0) return 0;
ret->next = 0;
ret->count = 1;
ret->total = size;
ret->depth = backtrace(ret->bt, MAX_STACK_LEN);
ret->vid = getVid(ret->bt, ret->depth);
return ret;
}
static int stackEqual(MemBt* bt1, MemBt* bt2)
{
if (bt1->vid != bt2->vid) return 0;
if (bt1->depth != bt2->depth)
{
DBG("crc hit when diff depth");
__sync_add_and_fetch(&g_chc, 1);
return 0;
}
int i = 0;
for (i = 0; i < bt1->depth; i++)
{
if (bt1->bt[i] != bt2->bt[i])
{
__sync_add_and_fetch(&g_chc, 1);
DBG("crc hit when diff bt");
return 0;
}
}
return 1;
}
MSV_INLINE
static void* stackMalloc(void* ptr, size_t alignment, size_t size)
{
PtrHdr* hdr = (PtrHdr*)ptr;
hdr->size = size - alignment;
hdr->stack = 0;
hdr->vid = 0;
hdr->hdrlen = alignment;
*(unsigned long*)((unsigned char*)ptr + alignment - sizeof(unsigned long)) = alignment;
void* ret = CUT_HDR(ptr);
__sync_add_and_fetch(&g_count, 1);
__sync_add_and_fetch(&g_total, hdr->size);
MemBt* stack = stackGetCurrent(hdr->size);
if (stack == 0) return ret;
unsigned long bktId = stack->vid >> VID_MV_CNT;
MemBt* tmp = __sync_val_compare_and_swap(&g_list[bktId], 0, stack);
if (tmp == 0)
{
hdr->stack = stack;
return ret;
}
while(1)
{
if (stackEqual(tmp, stack))
{
__sync_add_and_fetch(&tmp->count, stack->count);
__sync_add_and_fetch(&tmp->total, stack->total);
free(stack);
hdr->stack = tmp;
return ret;
}
tmp = __sync_val_compare_and_swap(&tmp->next, 0, stack);
if (tmp == 0)
{
hdr->stack = stack;
return ret;
}
}
}
static void stackFree(void* ptr)
{
PtrHdr* hdr = (PtrHdr*)ptr;
__sync_sub_and_fetch(&g_count, 1);
__sync_sub_and_fetch(&g_total, hdr->size);
if (hdr->stack == 0) return;
__sync_sub_and_fetch(&hdr->stack->count, 1);
__sync_sub_and_fetch(&hdr->stack->total, hdr->size);
}
//////////////////outter functions/////////////////////
__attribute__((constructor))
static void init()
{
if (!g_init)
{
g_init = 1;
// do here
g_pfnMalloc = (PFN_Malloc)dlsym(RTLD_NEXT, "malloc");
g_pfnFree = (PFN_Free)dlsym(RTLD_NEXT, "free");
g_pfnCalloc = (PFN_Calloc)dlsym(RTLD_NEXT, "calloc");
g_pfnRealloc = (PFN_Realloc)dlsym(RTLD_NEXT, "realloc");
g_pfnValloc = (PFN_Valloc)dlsym(RTLD_NEXT, "valloc");
g_pfnPValloc = (PFN_PValloc)dlsym(RTLD_NEXT, "pvalloc");
g_pfnMemAlign = (PFN_MemAlign)dlsym(RTLD_NEXT, "memalign");
g_pfnLibcMemAlign = (PFN_LibcMemAlign)dlsym(RTLD_NEXT, "libc_memalign");
g_pfnPosixMemAlign = (PFN_PosixMemAlign)dlsym(RTLD_NEXT, "posix_memalign");
g_pfnAlignedAlloc = (PFN_AlignedAlloc)dlsym(RTLD_NEXT, "aligned_alloc");
g_pfnSignal = (PFN_Signal)dlsym(RTLD_NEXT, "signal");
g_pfnMallocUsableSize = (PFN_MallocUsableSize)dlsym(RTLD_NEXT, "malloc_usable_size");
g_pageSize = (unsigned long)getpagesize();
PFN_SignalHandler ret = SIG_ERR;
if (g_pfnSignal) ret = g_pfnSignal(RPT_SIGNAL, rptSigHdr);
if (ret == SIG_ERR) ERR("report signal[%d] install fail", RPT_SIGNAL);
DBG("init success");
}
}
__attribute__((destructor))
static void uninit()
{
if (g_init)
{
// do here
DBG("uninit success");
}
}
size_t malloc_usable_size(void* ptr)
{
init();
if (ptr == 0) return 0;
if (g_innerCall) return (g_pfnMallocUsableSize == 0 ? 0 : g_pfnMallocUsableSize(ptr));
size_t ret = 0;
g_innerCall = 1;
INFO("malloc_usable_size start, ptr = %p", ptr);
void* temp = ADD_HDR(ptr);
ret = malloc_usable_size(temp);
unsigned long hdrLen = (unsigned long)ptr - (unsigned long)temp;
if (ret >= hdrLen) ret -= hdrLen;
else ret = 0; // error
INFO("malloc_usable_size success, ptr = %p, ret = %lu", ptr, ret);
g_innerCall = 0;
return ret;
}
void* malloc(size_t size)
{
init();
if (g_innerCall) return (g_pfnMalloc == 0 ? 0 : g_pfnMalloc(size));
void* ret = 0;
g_innerCall = 1;
size += MSV_ALIGNMENT;
ret = malloc(size);
if (ret != 0) ret = stackMalloc(ret, MSV_ALIGNMENT, size);
DBG("malloc success, size = %lu, ret = %p", size, ret);
g_innerCall = 0;
return ret;
}
void free(void* ptr)
{
init();
if (ptr == 0) return;
if (g_innerCall) { if (g_pfnFree) g_pfnFree(ptr); return; }
g_innerCall = 1;
DBG("free start, ptr = %p", ptr);
ptr = ADD_HDR(ptr);
stackFree(ptr);
free(ptr);
DBG("free success, ptr = %p", ptr);
g_innerCall = 0;
}
void* calloc(size_t cnt, size_t size)
{
init();
if (g_innerCall) return (g_pfnCalloc == 0 ? 0 : g_pfnCalloc(cnt, size));
void* ret = 0;
g_innerCall = 1;
cnt *= size;
cnt += MSV_ALIGNMENT;
ret = calloc(cnt, 1);
if (ret != 0) ret = stackMalloc(ret, MSV_ALIGNMENT, cnt);
DBG("calloc success, cnt(nmemb) = %lu, size = %lu, ret=%p", cnt, size, ret);
g_innerCall = 0;
return ret;
}
void* realloc(void* ptr, size_t size)
{
init();
if (ptr == 0) return malloc(size);
if (size == 0) { free(ptr); return 0; }
if (g_innerCall) return (g_pfnRealloc == 0 ? 0 : g_pfnRealloc(ptr, size));
void* ret = 0;
g_innerCall = 1;
ptr = ADD_HDR(ptr);
size += MSV_ALIGNMENT;
PtrHdr oldHdr = {0};
oldHdr = *(PtrHdr*)ptr;
ret = realloc(ptr, size);
if (ret != 0) { stackFree((void*)&oldHdr); ret = stackMalloc(ret, MSV_ALIGNMENT, size); }
DBG("realloc success, ptr = %p, size = %lu, ret = %p", ptr, size, ret);
g_innerCall = 0;
return ret;
}
void* valloc(size_t size)
{
init();
if (g_pageSize < MIN_ALIGNMENT) return 0;
if (g_innerCall) return (g_pfnValloc == 0 ? 0 : g_pfnValloc(size));
void* ret = 0;
g_innerCall = 1;
size += g_pageSize;
ret = valloc(size);
if (ret != 0) ret = stackMalloc(ret, g_pageSize, size);
INFO("valloc success, size = %lu, ret = %p", size, ret);
g_innerCall = 0;
return ret;
}
void* pvalloc(size_t size)
{
init();
if (g_pageSize < MIN_ALIGNMENT) return 0;
if (g_innerCall) return (g_pfnPValloc == 0 ? 0 : g_pfnPValloc(size));
void* ret = 0;
g_innerCall = 1;
size += g_pageSize;
ret = pvalloc(size);
if (ret != 0) ret = stackMalloc(ret, g_pageSize, size);
INFO("pvalloc success, size = %lu, ret = %p", size, ret);
g_innerCall = 0;
return ret;
}
void* memalign(size_t alignment, size_t size)
{
init();
if (alignment < MIN_ALIGNMENT) return 0;
if (g_innerCall) return (g_pfnMemAlign == 0 ? 0 : g_pfnMemAlign(alignment, size));
void* ret = 0;
g_innerCall = 1;
size += alignment;
ret = memalign(alignment, size);
if (ret != 0) ret = stackMalloc(ret, alignment, size);
INFO("memalign success, alignment = %lu, size = %lu, ret = %p", alignment, size, ret);
g_innerCall = 0;
return ret;
}
void* libc_memalign(size_t alignment, size_t size)
{
init();
if (alignment < MIN_ALIGNMENT) return 0;
if (g_innerCall) return (g_pfnLibcMemAlign == 0 ? 0 : g_pfnLibcMemAlign(alignment, size));
void* ret = 0;
g_innerCall = 1;
size += alignment;
ret = libc_memalign(alignment, size);
if (ret != 0) ret = stackMalloc(ret, alignment, size);
INFO("libc_memalign success, alignment = %lu, size = %lu, ret = %p", alignment, size, ret);
g_innerCall = 0;
return ret;
}
int posix_memalign(void** ptr, size_t alignment, size_t size)
{
init();
if (ptr == 0) return EINVAL;
if (alignment < MIN_ALIGNMENT) { *ptr = 0; return EINVAL; }
if (g_innerCall) return (g_pfnPosixMemAlign == 0 ? 0 : g_pfnPosixMemAlign(ptr, alignment, size));
int ret = EINVAL;
g_innerCall = 1;
INFO("posix_memalign start, ptr = %p, alignment = %lu, size = %lu", ptr, alignment, size);
size += alignment;
ret = posix_memalign(ptr, alignment, size);
void* temp = *ptr;
if (ret != 0) *ptr = 0;
else if (*ptr == 0) ret = EINVAL;
else *ptr = stackMalloc(*ptr, alignment, size);
INFO("posix_memalign success, ptr = %p, alignment = %lu, size = %lu, ret = %d, ret_size = %lu", ptr, alignment, size, ret, malloc_usable_size(temp));
g_innerCall = 0;
return ret;
}
void* aligned_alloc(size_t alignment, size_t size)
{
init();
if (alignment < MIN_ALIGNMENT) return 0;
if (g_innerCall) return (g_pfnAlignedAlloc == 0 ? 0 : g_pfnAlignedAlloc(alignment, size));
void* ret = 0;
g_innerCall = 1;
size += alignment;
ret = aligned_alloc(alignment, size);
if (ret != 0) ret = stackMalloc(ret, alignment, size);
INFO("aligned_alloc success, alignment = %lu, size = %lu, ret = %p", alignment, size, ret);
g_innerCall = 0;
return ret;
}
PFN_SignalHandler signal(int sigNum, PFN_SignalHandler sigHdr)
{
init();
if (g_innerCall) return (g_pfnSignal == 0 ? SIG_ERR : g_pfnSignal(sigNum, sigHdr));
PFN_SignalHandler ret = SIG_ERR;
g_innerCall = 1;
if (sigNum != RPT_SIGNAL) ret = signal(sigNum, sigHdr);
else ret = __sync_lock_test_and_set(&g_pfnRptSigOutHdr, sigHdr);
INFO("signal success, sigNum = %d", sigNum);
g_innerCall = 0;
return ret;
}
|
the_stack_data/3262949.c | #include <stdio.h>
int parent[6];
void initParent(int arr[])
{
for (int i=0;i<6;i++){
arr[i]=-1;
}
return;
}
int findParent(int x, int parent[]){
while(parent[x] != -1){
x = parent[x];
}
return x;
}
int unionNode(int x, int y, int parent[]){
int x_root = findParent(x, parent);
int y_root = findParent(y, parent);
if (x_root != y_root) {
parent[x_root] = y_root;
} else {
return 1;
}
return 0;
}
int main()
{
int graph[6][2] = {
{0,1},
{1,2},
{1,3},
{3,4},
{2,4},
{2,5}
};
initParent(parent);
printf("Union & Find \n");
for(int i=0;i<6;i++){
if(unionNode(graph[i][0], graph[i][1], parent) == 1){
printf("have a circle !\n");
break;
}
}
return 0;
} |
the_stack_data/37494.c | #include<stdio.h>
int main()
{
char c;
printf("Enter character: ");
scanf("%c", &c);
printf("Ascii Value of %c is %d\n",c,c);
} |
the_stack_data/358431.c | void fence()
{
asm("sync");
}
void lwfence()
{
asm("lwsync");
}
void isync()
{
asm("isync");
}
int __unbuffered_cnt = 0;
int __unbuffered_p2_EAX = 0;
int __unbuffered_p2_EBX = 0;
int __unbuffered_p3_EAX = 0;
int __unbuffered_p3_EBX = 0;
int a = 0;
int x = 0;
int y = 0;
int z = 0;
void *P0(void *arg)
{
a = 1;
x = 1;
// Instrumentation for CPROVER
fence();
__unbuffered_cnt++;
}
void *P1(void *arg)
{
x = 2;
y = 1;
// Instrumentation for CPROVER
fence();
__unbuffered_cnt++;
}
void *P2(void *arg)
{
y = 2;
__unbuffered_p2_EAX = y;
__unbuffered_p2_EBX = z;
// Instrumentation for CPROVER
fence();
__unbuffered_cnt++;
}
void *P3(void *arg)
{
z = 1;
__unbuffered_p3_EAX = z;
__unbuffered_p3_EBX = a;
// Instrumentation for CPROVER
fence();
__unbuffered_cnt++;
}
int main()
{
__CPROVER_ASYNC_0:
P0(0);
__CPROVER_ASYNC_1:
P1(0);
__CPROVER_ASYNC_2:
P2(0);
__CPROVER_ASYNC_3:
P3(0);
__CPROVER_assume(__unbuffered_cnt == 4);
fence();
// EXPECT:exists
__CPROVER_assert(
!(x == 2 && y == 2 && __unbuffered_p2_EAX == 2 &&
__unbuffered_p2_EBX == 0 && __unbuffered_p3_EAX == 1 &&
__unbuffered_p3_EBX == 0),
"Program proven to be relaxed for X86, model checker says YES.");
return 0;
}
|
the_stack_data/140764696.c | #include <stdio.h>
int main()
{
char char_array[5] = {'a', 'b', 'c', 'd', 'e'};
int int_array[5] = {1, 2, 3, 4, 5};
void *void_pointer;
void_pointer = (void*) char_array;
for(int i = 0; i < 5; ++i)
{
printf("[char pointer] points to %p, which contains the char '%c'\n", void_pointer, *((char*)void_pointer));
void_pointer = (void*)((char*) void_pointer + 1);
}
void_pointer = (void*)int_array;
for(int i = 0; i < 5; ++i)
{
printf("[integer pointer] points to %p, which contains the integer %d\n", void_pointer, *((int*)void_pointer));
void_pointer = (void*)((int*) void_pointer + 1);
}
return 0;
}
|
the_stack_data/154829944.c | #include <stdio.h>
#include <stdlib.h>
#include <stdarg.h>
#include <string.h>
/* List of platform features */
#ifdef _WIN32
#define OS "win32"
#define IS_WINDOWS
#endif
#ifdef __linux
#define OS "linux"
#define IS_LINUX
#endif
#ifdef __APPLE__
#define OS "darwin"
#define IS_MACOS
#endif
/* System, but with string replace */
int run(const char *cmd, ...) {
char buf[512];
va_list args;
va_start(args, cmd);
vsprintf(buf, cmd, args);
va_end(args);
printf("--> %s\n\n", buf);
return system(buf);
}
/* List of Node.js versions */
struct node_version {
char *name;
char *abi;
} versions[] = {
{"v10.17.0", "64"},
{"v11.15.0", "67"},
{"v12.13.0", "72"},
{"v13.1.0", "79"}
};
/* Downloads headers, creates folders */
void prepare() {
if (run("mkdir dist") || run("mkdir targets") || run ("mkdir headers") || run("mkdir objects")) {
return;
}
/* For all versions */
for (unsigned int i = 0; i < sizeof(versions) / sizeof(struct node_version); i++) {
run("cd headers ; curl -OJ https://nodejs.org/dist/%s/node-%s-headers.tar.gz ; cd ../", versions[i].name, versions[i].name);
run("tar xzf headers/node-%s-headers.tar.gz -C targets", versions[i].name);
run("curl https://nodejs.org/dist/%s/win-x64/node.lib > targets/node-%s/node.lib", versions[i].name, versions[i].name);
}
}
/* Build for Unix systems */
void build(char *compiler, char *cpp_compiler, char *cpp_linker, char *os, char *arch) {
char *c_shared = "-DLIBUS_USE_LIBUV -DLIBUS_USE_OPENSSL -flto -O3 -c -fPIC -I ../uWebSockets/uSockets/src ../uWebSockets/uSockets/src/*.c ../uWebSockets/uSockets/src/eventing/*.c ../uWebSockets/uSockets/src/crypto/*.c";
// char *c_shared_c_files[] = {};
char *cpp_shared = "-DLIBUS_USE_LIBUV -DLIBUS_USE_OPENSSL -flto -O3 -c -fPIC -std=c++17 -I ../uWebSockets/uSockets/src -I ../uWebSockets/src ../src/addon.cpp";
for (unsigned int i = 0; i < sizeof(versions) / sizeof(struct node_version); i++) {
run("cd objects ; %s %s -I ../targets/node-%s/include/node ; cd ../", compiler, c_shared, versions[i].name);
run("cd objects ; %s %s -I ../targets/node-%s/include/node ; cd ../", cpp_compiler, cpp_shared, versions[i].name);
run("cd objects ; %s %s %s -o ../dist/uws_%s_%s_%s.node ; cd ../", cpp_compiler, "-flto -O3 *.o -std=c++17 -shared", cpp_linker, os, arch, versions[i].abi);
}
}
void copy_files() {
#ifdef IS_WINDOWS
run("copy \"src\\uws.js\" dist /Y");
#else
run("cp src/uws.js dist/uws.js");
#endif
}
/* Special case for windows */
void build_windows(char *arch) {
/* For all versions */
for (unsigned int i = 0; i < sizeof(versions) / sizeof(struct node_version); i++) {
run("cl /D \"LIBUS_USE_LIBUV\" /D \"LIBUS_USE_OPENSSL\" /std:c++17 /I uWebSockets/uSockets/src uWebSockets/uSockets/src/*.c "
"uWebSockets/uSockets/src/eventing/*.c uWebSockets/uSockets/src/crypto/*.c /I targets/node-%s/include/node /I uWebSockets/src /EHsc "
"/Ox /LD /Fedist/uws_win32_%s_%s.node src/addon.cpp targets/node-%s/node.lib",
versions[i].name, arch, versions[i].abi, versions[i].name);
}
}
int main() {
printf("[Preparing]\n");
prepare();
printf("\n[Building]\n");
#ifdef IS_WINDOWS
build_windows("x64");
#else
#ifdef IS_MACOS
/* Apple special case */
build("clang -mmacosx-version-min=10.7",
"clang++ -stdlib=libc++ -mmacosx-version-min=10.7",
"-undefined dynamic_lookup",
OS,
"x64");
#else
/* Linux */
build("clang",
"clang++",
"-static-libstdc++ -static-libgcc -s",
OS,
"x64");
/* If linux we also want arm64 */
build("aarch64-linux-gnu-gcc", "aarch64-linux-gnu-g++", "-static-libstdc++ -static-libgcc -s", OS, "arm64");
#endif
#endif
copy_files();
}
|
the_stack_data/78990.c | #include <stdio.h>
int main()
{
int num, reverse_num=0, remainder,temp;
printf("Enter an integer: ");
scanf("%d", &num);
temp=num;
while(temp!=0)
{
remainder=temp%10;
reverse_num=reverse_num*10+remainder;
temp/=10;
}
if(reverse_num==num)
printf("%d is a palindrome number",num);
else
printf("%d is not a palindrome number",num);
}
|
the_stack_data/317935.c | #include <stdio.h>
int main()
{
printf("%s", "Here goes infinite loop!");
fflush(stdout);
while (1);
return 0;
}
|
the_stack_data/97013451.c | /*===-- putchar.c ---------------------------------------------------------===//
//
// The KLEE Symbolic Virtual Machine
//
// This file is distributed under the University of Illinois Open Source
// License. See LICENSE.TXT for details.
//
//===----------------------------------------------------------------------===*/
#include <stdio.h>
#include <unistd.h>
/* Some header may #define putchar. */
#undef putchar
int putchar(int c) {
char x = c;
if (1 == write(1, &x, 1))
return c;
return EOF;
}
|
the_stack_data/184519455.c | /*
AUTHOR : Ali Snedden
DATE : 1/24/22
PURPOSE :
1. Create a segmentation fault to test
a) enabling segfaults on a Redhat machine
#) to test `ulimit data`
#. Enabling core files :
a) Tasks
#. Ensure that `ulimit -c unlimited`
#. Ensure both abrtd and abrt-ccpp are running
* service abrtd status
* service abrt-ccpp status
#. In /etc/abrt/abrt-action-save-package-data.conf ensure
`ProcessUnpackaged = yes`
#. Run a test bad code
* Typically the file will be written /var/spool/abrt/
* If you do `cat /proc/sys/kernel/core_pattern`, you'll see some stuff
* If you `echo "core" > /proc/sys/kernel/core_pattern` it will dump
to a local file
#) Refs :
#. https://unix.stackexchange.com/a/277338/128519
#. https://stackoverflow.com/a/42272400/4021436
#. https://access.redhat.com/solutions/4896
#. https://access.redhat.com/solutions/56021
RUN:
./a.out nthreads mem_in_GB
*/
#include <stdio.h>
#include <stdlib.h>
#include <math.h>
#include <unistd.h>
#include <sys/types.h>
#include <omp.h>
/*
ARGS :
string = char[], string to print
DESCRIPTION :
This prints and error and then exits with a non-zero error code
RETURN :
1 = int, b/c it is an error
DEBUG :
FUTURE :
*/
int exit_with_error(char * string){
fprintf(stderr, "%s",string);
return 1;
}
/*
ARGS :
argc = int, number of CL args
argv[] = char[], CL args
DESCRIPTION :
This prints and error and then exits with a non-zero error code
RETURN :
0 = int, b/c it completed w/o error
DEBUG :
FUTURE :
1. Come up with method to check the number of elements in argv
*/
int main(int argc, char *argv[])
{
char errMsg[200]; // Used for error messages
long nThread; // Number of threads, from CL args
long nLoop = 1000; // Number of loops
long i = 0;
long j = 0;
long k = 0;
long mem = 0; // Memory in GB
long n; // Number of array elements, from CL args
long nbytes; // Total bytes
long * array = NULL; // Array to do operations
/************* Parse CL args *************/
// Check for correct number of arguments
if(argc != 3){
sprintf(errMsg, "ERROR!!! %i args passed, only 3 expected\n", argc);
exit_with_error(errMsg);
}
// Number of threads
nThread = atoi(argv[1]);
// Memory
mem = atol(argv[2]);
printf("Running with %ld procs and %ld GB\n", nThread, mem);
printf("pid = %ld; parentid = %ld\n", (long)getpid(), (long)getppid());
// OpenMP creates nThread copies of array, so account
nbytes = mem * pow(10,9);
n = nbytes / (nThread * sizeof(long));
// https://stackoverflow.com/a/12285433/4021436
omp_set_num_threads(nThread);
#pragma omp parallel private(i, array)
{
long tid = omp_get_thread_num();
printf("Hello from Thread : %ld\n",tid);
// Initialize - stop compiler complaints
array = (long *)malloc(n * sizeof(long));
// This loop doesn't do any real work other
#pragma omp for
for(k=0; k<nThread; k++){
for(i=0; i<nLoop; i++){
if(tid == 0 && i%10 == 0){
printf("\ttid: %ld; i=%ld\n",tid,i);
}
fflush(stdout);
for(j=0; j<n; j++){
array[j] = tid;
}
}
}
}
return 0;
}
|
the_stack_data/120069.c | #define _GNU_SOURCE
#include <assert.h>
#include <errno.h>
#include <fcntl.h>
#include <libgen.h>
#include <stdint.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <unistd.h>
#include <sys/mount.h>
#include <sys/stat.h>
#include <sys/types.h>
#include <sys/wait.h>
#include <linux/loop.h>
#ifndef MS_MOVE
#define MS_MOVE 8192
#endif
#ifndef MNT_DETACH
#define MNT_DETACH 0x00000002
#endif
#define MAX_RESIZE2FS_DEV_LEN 256
// To mount / to /mnt/persist:
// #define ROOT_AS_PERSIST
// To disable resizing persist
// #define NO_RESIZE_PERSIST
// To disable the mutable / overlayfs:
// #define NO_MUTABLE_OVERLAY
// To disable the moving mountpoint to /
// #define NO_MOVE_MOUNTPOINT_ROOT
// To disable mounting /proc into the chroot
// #define NO_MOUNT_PROC
// To disable mounting /sys into the chroot
// #define NO_MOUNT_SYS
// To inherit /mnt in the chroot
// #define BIND_ROOT_MNT
// To disable chroot before running init
// #define NO_CHROOT_TARGET
// Override SKIFF_INIT_PROC to control the init process in the chroot
#ifndef SKIFF_INIT_PROC
#define SKIFF_INIT_PROC "/lib/systemd/systemd"
#endif
// To write a PID file for the init proc.
// #define WRITE_SKIFF_INIT_PID
#ifndef SKIFF_INIT_PID
#define SKIFF_INIT_PID "/run/skiff-init/skiff-init.pid"
#endif
const char *init_proc = SKIFF_INIT_PROC;
const char *init_pid_path = SKIFF_INIT_PID;
FILE *logfd;
const char *pid1_log = "/dev/kmsg";
const char *squashfs_file = "/boot/rootfs.squashfs";
const char *resize2fs_path = "/boot/skiff-init/resize2fs";
const char *resize2fs_conf = "/boot/skiff-init/resize2fs.conf";
#ifndef SKIFF_MOUNTS_DIR
#define SKIFF_MOUNTS_DIR "/skiff-overlays"
#define SKIFF_MOUNTPOINT SKIFF_MOUNTS_DIR "/system"
#endif
const char *root_dir = SKIFF_MOUNTS_DIR;
const char *mountpoint = SKIFF_MOUNTPOINT;
const char *dev_mnt = SKIFF_MOUNTPOINT "/dev";
const char *proc_mnt = SKIFF_MOUNTPOINT "/proc";
const char *run_mnt = SKIFF_MOUNTPOINT "/run";
const char *sys_mnt = SKIFF_MOUNTPOINT "/sys";
const char *mnt_mnt = SKIFF_MOUNTPOINT "/mnt";
const char *persist_mnt = SKIFF_MOUNTPOINT "/mnt/persist";
const char *persist_parent_mnt = "/mnt/persist";
const char *image_mountpoint = SKIFF_MOUNTS_DIR "/image";
#ifndef NO_MUTABLE_OVERLAY
const char *overlay_upper_mountpoint = SKIFF_MOUNTS_DIR "/system-upper";
const char *overlay_work_mountpoint = SKIFF_MOUNTS_DIR "/system-tmp";
#endif
// Set BIND_HOST_DIRS to a space-separated list of paths to bind mount:
// Each path should be host-dir:target-dir
// i.e. /mydir:/my-target-dir /my-other-dir:/my-other-target-dir
#ifndef BIND_HOST_DIRS
#define BIND_HOST_DIRS ""
#endif
char *loopdev_find_unused();
int loopdev_setup_device(const char *file, uint64_t offset, const char *device);
void write_skiff_init_pid(pid_t pid);
void do_bind_host_dirs(void);
int main(int argc, char *argv[]) {
int res = 0;
logfd = stderr;
int closeLogFd = 0;
struct stat st = {0};
// log to uart, mount /dev
if (getpid() == 1) {
// mkdir -p /dev
if (stat("/dev", &st) == -1) {
mkdir("/dev", 0755);
if (mount("devtmpfs", "/dev", "devtmpfs", 0, NULL) != 0) {
res = errno;
fprintf(logfd,
"SkiffOS init: failed to mount root /dev devtmpfs: (%d) %s\n",
res, strerror(res));
res = 0; // ignore for now
// return res;
}
}
logfd = fopen(pid1_log, "w");
if (logfd == 0) {
fprintf(logfd, "Failed to open %s as PID 1: %s\n", pid1_log,
strerror(errno));
logfd = stderr;
} else {
setbuf(logfd, NULL);
closeLogFd = 1;
}
}
// clear the init PID early
#ifdef WRITE_SKIFF_INIT_PID
if (stat(init_pid_path, &st) == 0) {
unlink(init_pid_path);
}
#endif
// mkdir -p ${root_dir}
if (stat(root_dir, &st) == -1) {
mkdir(root_dir, 0700);
}
if (stat("/proc", &st) == -1) {
mkdir("/proc", 0555);
}
// if ! mountpoint /proc; mount -t proc proc /proc; fi
if (stat("/proc/stat", &st) != 0) {
if (mount("proc", "/proc", "proc", 0, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS init: failed to mount /proc: (%d) %s\n", res,
strerror(res));
}
}
// mount /etc/mtab
if (stat("/etc", &st) == -1) {
mkdir("/etc", 0755);
}
if (stat("/etc/mtab", &st) != 0) {
/*
int mt = open("/etc/mtab", O_WRONLY|O_CREAT|O_NOCTTY, 0777);
if (mt != -1) {
close(mt);
}
*/
if (symlink("/proc/mounts", "/etc/mtab") != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to create mtab symlink: (%d) %s\n", res,
strerror(res));
res = 0;
}
}
// resize root filesystem if necessary
// it is assumed that root= was set to the "persist" partition and that the
// boot data is stored in /boot. this may be changed later to support more
// exotic setups.
#ifndef NO_RESIZE_PERSIST
if (stat(resize2fs_path, &st) == 0 && stat(resize2fs_conf, &st) == 0) {
// read the path(s) to resize from the conf file.
// all lines not starting with # are assumed to be paths to device files.
// all lines must have a /dev prefix.
FILE *r2conf = fopen(resize2fs_conf, "r");
char *linebuf = (char *)malloc(MAX_RESIZE2FS_DEV_LEN * sizeof(char));
while (fgets(linebuf, MAX_RESIZE2FS_DEV_LEN - 1, r2conf)) {
linebuf[MAX_RESIZE2FS_DEV_LEN - 1] = 0;
if (linebuf[0] == '#') {
continue;
}
linebuf[strcspn(linebuf, "\n")] = 0;
linebuf[strcspn(linebuf, " ")] = 0;
if (strlen(linebuf) < 6) {
fprintf(logfd, "SkiffOS resize2fs: %s: line too short: %s\n",
resize2fs_conf, linebuf);
continue;
}
if (memcmp(linebuf, "/dev/", 5) != 0) {
fprintf(logfd, "SkiffOS resize2fs: %s: expected /dev/ prefix: %s\n",
resize2fs_conf, linebuf);
continue;
}
fprintf(logfd, "SkiffOS resize2fs: resizing persist filesystem: %s\n",
linebuf);
pid_t id1 = fork();
if (id1 == 0) {
// re-use environment (in child process)
char **r2fsargv = (char **)malloc(4 * sizeof(const char *));
r2fsargv[0] = (char *)resize2fs_path;
r2fsargv[1] = (char *)"-F";
r2fsargv[2] = linebuf;
r2fsargv[3] = NULL;
dup2(fileno(logfd), fileno(stdout));
dup2(fileno(logfd), fileno(stderr));
res = execve(resize2fs_path, r2fsargv, environ);
free(r2fsargv);
if (res != 0) {
res = errno;
fprintf(logfd,
"SkiffOS resize2fs: failed to exec resize2fs process on %s: "
"(%d) %s\n",
linebuf, res, strerror(res));
}
return res;
}
// wait for resize2fs
waitpid(id1, NULL, 0);
}
free(linebuf);
fclose(r2conf);
} else {
res = errno;
fprintf(
logfd,
"SkiffOS init: cannot find resize2fs, skipping: %s and %s: (%d) %s\n",
resize2fs_path, resize2fs_conf, res, strerror(res));
res = 0;
}
#endif
// if mountpoint already mounted, skip to chroot
// mkdir -p mountpoint
if (stat(mountpoint, &st) == -1) {
mkdir(mountpoint, 0755);
} else {
#ifdef NO_MOVE_MOUNTPOINT_ROOT
// if already mounted...
// dev_t mtptDev = st.st_dev;
// if (stat("/", &st) != -1 && mtptDev != st.st_dev) {
if (stat(dev_mnt, &st) != -1) {
fprintf(logfd,
"SkiffOS init: mountpoint %s already mounted, skipping mount "
"process.\n",
mountpoint);
#ifdef WRITE_SKIFF_INIT_PID
write_skiff_init_pid(getpid());
#endif
chmod(mountpoint, 0755);
chdir(mountpoint);
#ifndef NO_CHROOT_TARGET
chroot(mountpoint);
chdir("/");
#endif
goto exec_init_proc;
}
#endif
}
#ifdef ROOT_MAKE_SHARED
// ensure that / is shared
if (mount(NULL, "/", NULL, MS_REC | MS_SHARED, NULL) != 0) {
res = errno;
fprintf(
logfd,
"SkiffOS init: cannot ensure / is shared: (%d) %s\n",
res, strerror(res));
res = 0;
}
#endif
char *root_loop = NULL;
fprintf(logfd, "SkiffOS init: finding unused loop device...\n");
if ((root_loop = loopdev_find_unused()) == NULL) {
fprintf(logfd,
"Failed to find a free loop device for the root partition.\n");
return 1;
}
fprintf(logfd, "SkiffOS init: allocating loop device %s...\n", root_loop);
if (loopdev_setup_device(squashfs_file, 0, root_loop) != 0) {
fprintf(logfd, "Failed to associate loop device (%s) to file (%s).\n",
root_loop, squashfs_file);
return 1;
}
// check for loop device
int i = 0;
while (stat(root_loop, &st) == -1) {
fprintf(logfd, "SkiffOS init: warning: loop file %s does not exist\n",
root_loop);
sleep(1);
if (++i >= 10) {
return 1;
}
}
if (stat(image_mountpoint, &st) == -1) {
mkdir(image_mountpoint, 0755);
}
fprintf(logfd, "SkiffOS init: mounting %s on %s to %s...\n", squashfs_file,
root_loop, image_mountpoint);
if (mount(root_loop, image_mountpoint, "squashfs", 0, NULL) != 0) {
res = errno;
fprintf(logfd, "Failed to mount loop device (%s) to mount point (%s): %s\n",
root_loop, image_mountpoint, strerror(res));
return res;
}
// Mount a temporary directory on persist overlayfs over mountpoint
#ifndef NO_MUTABLE_OVERLAY
if (stat(overlay_upper_mountpoint, &st) == -1) {
mkdir(overlay_upper_mountpoint, 0755);
}
if (stat(overlay_work_mountpoint, &st) == -1) {
mkdir(overlay_work_mountpoint, 0755);
}
// move the squashfs to the new lower mountpoint
// TODO better to mount ramfs to upper mountpoint?
// TODO wipe upper and workdir if already exist?
// mount overlayfs for mutable root
char *overlayArgs = (char *)malloc(60 + strlen(image_mountpoint) +
strlen(overlay_upper_mountpoint) +
strlen(overlay_work_mountpoint));
sprintf(overlayArgs, "lowerdir=%s,upperdir=%s,workdir=%s",
image_mountpoint, overlay_upper_mountpoint,
overlay_work_mountpoint);
fprintf(logfd, "SkiffOS init: mounting overlayfs %s to %s...\n", overlayArgs, mountpoint);
if (mount("overlay", mountpoint, "overlay", 0, overlayArgs) < 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount overlay: %s: (%d) %s\n",
overlayArgs, res, strerror(res));
return res;
}
free(overlayArgs);
#endif
// chmod the mountpoint so non-root users can use it
if (chmod(mountpoint, 0755) != 0) {
res = errno;
fprintf(logfd, "SkiffOS init: failed to chmod root to a+rX: %s: (%d) %s\n",
mountpoint, res, strerror(res));
res = 0;
}
// Mount /mnt if set, otherwise, mount / directly to target
// Note: most systems use !BIND_ROOT_MNT
#ifdef BIND_ROOT_MNT
if (stat("/mnt", &st) == -1) {
mkdir("/mnt", 0755);
}
// Bind mount / to /mnt/persist before mounting /mnt to target.
#ifdef ROOT_AS_PERSIST
fprintf(logfd, "SkiffOS init: mounting old / to %s\n", persist_parent_mnt);
if (stat(persist_parent_mnt, &st) == -1) {
mkdir(persist_parent_mnt, 0755);
}
if (mount("/", persist_parent_mnt, NULL, MS_BIND, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: warning: failed to mount old / as %s: (%d) %s\n",
persist_mnt, res, strerror(res));
res = 0; // ignore
}
#endif // ROOT_AS_PERSIST
fprintf(logfd, "SkiffOS init: mounting old /mnt to %s...\n", mnt_mnt);
if (stat(mnt_mnt, &st) == -1) {
mkdir(mnt_mnt, 0755);
}
// rbind /mnt -> target/mnt as shared
if (mount("/mnt", mnt_mnt, NULL, MS_BIND | MS_REC | MS_SHARED, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount /mnt in chroot: (%d) %s\n", res,
strerror(res));
res = 0; // ignore
}
#else // !BIND_ROOT_MNT
// Mount persist into the target chroot only.
#ifdef ROOT_AS_PERSIST
fprintf(logfd, "SkiffOS init: mounting / to %s...\n", persist_mnt);
if (stat(persist_mnt, &st) == -1) {
mkdir(persist_mnt, 0755);
}
// NOTE: MS_SHARED ?
if (mount("/", persist_mnt, NULL, MS_BIND|MS_SHARED, NULL) != 0) { // MS_REC - rbind
res = errno;
fprintf(logfd, "SkiffOS: warning: failed to mount / as %s: (%d) %s\n",
persist_mnt, res, strerror(res));
res = 0; // ignore
}
#endif // ROOT_AS_PERSIST
#endif // !BIND_ROOT_MNT
// mount /dev in target
if (mount("/dev", dev_mnt, NULL, MS_BIND | MS_REC, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount /dev in chroot: (%d) %s\n", res,
strerror(res));
return res;
}
#ifndef NO_MOUNT_PROC
fprintf(logfd, "SkiffOS init: mounting proc to %s...\n", proc_mnt);
if (mount("none", proc_mnt, "proc", 0, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount proc in chroot: (%d) %s\n", res,
strerror(res));
return res;
}
#endif
#ifndef NO_MOUNT_SYS
#ifdef MOUNT_SYS_RBIND
fprintf(logfd, "SkiffOS init: mounting old /sys to %s...\n", sys_mnt);
if (mount("/sys", sys_mnt, NULL, MS_BIND | MS_REC, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount /sys in chroot: (%d) %s\n", res,
strerror(res));
return res;
}
#else
fprintf(logfd, "SkiffOS init: mounting sysfs to %s...\n", sys_mnt);
if (mount("sysfs", sys_mnt, "sysfs", 0, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount sys in chroot: (%d) %s\n", res,
strerror(res));
return res;
}
#endif
#endif
// Bind all of the extra host dirs into the container.
do_bind_host_dirs();
// Write PID file for init
#ifdef WRITE_SKIFF_INIT_PID
write_skiff_init_pid(getpid());
#endif
// Attempt to chroot into it
fprintf(logfd, "SkiffOS init: switching into mountpoint: %s\n", mountpoint);
chdir(mountpoint);
// move the mount to /
int cfd = open("/", O_RDONLY);
if (cfd < 0) {
res = errno;
fprintf(logfd,
"SkiffOS: failed to open / file descriptor, continuing: (%d) %s\n",
res, strerror(res));
res = 0; // ignore
}
// move mountpoint
#ifndef NO_MOVE_MOUNTPOINT_ROOT
if (mount(mountpoint, "/", NULL, MS_MOVE, NULL) < 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to move / mount: (%d) %s\n", res,
strerror(res));
return res;
}
// chroot into / (the mountpoint was moved)
#ifndef NO_CHROOT_TARGET
chroot(".");
#endif
#else
// chroot into mountpoint
#ifndef NO_CHROOT_TARGET
chroot(mountpoint);
#endif
#endif
chdir("/");
if (cfd > 0) {
close(cfd);
cfd = 0;
}
exec_init_proc:
// compute new init argc and argv
if (argc < 1) {
argc = 1;
}
char **initargv = (char **)malloc((argc + 1) * sizeof(char *));
initargv[argc] = NULL;
initargv[0] = strdup(init_proc);
for (i = 1; i < argc; i++) { // skip argv[0]
size_t len = strlen(argv[i]) + 1;
initargv[i] = malloc(len * sizeof(char));
memcpy(initargv[i], argv[i], len);
}
// exec init
fprintf(logfd, "SkiffOS init: executing init process: %s\n", init_proc);
if (closeLogFd) {
fclose(logfd);
logfd = stderr;
}
// re-use environment
if (execve(init_proc, initargv, environ) != 0) {
res = errno;
fprintf(logfd, "Failed to exec init process\n");
fprintf(logfd, "Error (%d) %s\n", res, strerror(res));
return res;
}
for (i = 0; i < argc; i++) {
free(initargv[i]);
}
free(initargv);
return 0;
}
// Based on the following utility:
// https://github.com/alexchamberlain/piimg/blob/master/src/piimg-mount.c
static const char LOOPDEV_PREFIX[] = "/dev/loop";
static int LOOPDEV_PREFIX_LEN =
sizeof(LOOPDEV_PREFIX) / sizeof(LOOPDEV_PREFIX[0]) - 1;
int escalate() {
if (seteuid(0) == -1 || geteuid() != 0) {
fprintf(logfd, "Failed to escalate privileges.\n");
return 1;
}
return 0;
}
char *loopdev_find_unused() {
int control_fd = -1;
int n = -1;
if (escalate())
return NULL;
if ((control_fd = open("/dev/loop-control", O_RDWR)) < 0) {
fprintf(logfd, "Failed to open /dev/loop-control\n");
return NULL;
}
n = ioctl(control_fd, LOOP_CTL_GET_FREE);
if (n < 0) {
fprintf(logfd, "Failed to find a free loop device.\n");
return NULL;
}
int l =
strlen(LOOPDEV_PREFIX) + 1 + 1; /* 1 for first character, 1 for NULL */
{
int m = n;
while (m /= 10) {
++l;
}
}
char *loopdev = (char *)malloc(l * sizeof(char));
assert(sprintf(loopdev, "%s%d", LOOPDEV_PREFIX, n) == l - 1);
return loopdev;
}
int loopdev_setup_device(const char *file, uint64_t offset,
const char *device) {
int file_fd = open(file, O_RDWR);
int device_fd = -1;
struct loop_info64 info;
if (file_fd < 0) {
fprintf(logfd, "Failed to open backing file (%s).\n", file);
goto error;
}
if (escalate())
goto error;
if ((device_fd = open(device, O_RDWR)) < 0) {
fprintf(logfd, "Failed to open device (%s).\n", device);
goto error;
}
if (ioctl(device_fd, LOOP_SET_FD, file_fd) < 0) {
fprintf(logfd, "Failed to set fd.\n");
goto error;
}
close(file_fd);
file_fd = -1;
memset(&info, 0, sizeof(struct loop_info64)); /* Is this necessary? */
info.lo_offset = offset;
/* info.lo_sizelimit = 0 => max available */
/* info.lo_encrypt_type = 0 => none */
if (ioctl(device_fd, LOOP_SET_STATUS64, &info)) {
fprintf(logfd, "Failed to set info.\n");
goto error;
}
close(device_fd);
device_fd = -1;
return 0;
error:
if (file_fd >= 0) {
close(file_fd);
}
if (device_fd >= 0) {
ioctl(device_fd, LOOP_CLR_FD, 0);
close(device_fd);
}
return 1;
}
void write_skiff_init_pid(pid_t pid) {
#ifdef WRITE_SKIFF_INIT_PID
fprintf(logfd, "SkiffOS init: writing PID file: %s: %d\n", init_pid_path, pid);
int pidfd;
FILE *pidf;
struct stat st = {0};
char *init_pid_pathf = strdup(init_pid_path);
char *init_pid_dir = dirname(init_pid_pathf);
if (stat(init_pid_dir, &st) != 0) {
mkdir(init_pid_dir, 0644);
}
free(init_pid_pathf);
if (stat(init_pid_path, &st) == 0) {
unlink(init_pid_path);
}
if ((pidfd = open(init_pid_path, O_WRONLY|O_CREAT|O_TRUNC, 0644)) <= 0 ||
(pidf = fdopen(pidfd, "w")) == NULL) {
fprintf(logfd, "SkiffOS init: failed to write pid file to %s: (%d) %s\n",
init_pid_path, errno, strerror(errno));
if (pidfd > 0) {
close(pidfd);
}
return;
}
if (!fprintf(pidf, "%d\n", pid)) {
fprintf(logfd, "SkiffOS init: failed to write pid file to %s: (%d) %s\n",
init_pid_path, errno, strerror(errno));
}
fflush(pidf);
close(pidfd);
#endif
}
// do_bind_host_dirs binds any extra host dirs defined in BIND_HOST_DIRS.
void do_bind_host_dirs(void) {
struct stat st = {0};
const char* bhd = BIND_HOST_DIRS;
int bhdlen = strlen(bhd);
int mtptlen = strlen(mountpoint);
int res = 0;
int bhdskiptws = 0;
for (int i1 = 0; i1 < bhdlen; i1++) {
nextbhdmatch:
// skip until whitespaces
if (bhdskiptws) {
bhdskiptws = 0;
while (i1 < bhdlen && bhd[i1] != ' ') {
i1++;
}
continue;
}
// skip whitespaces
if (i1 >= bhdlen || bhd[i1] == ' ') {
continue;
}
// evaluate value
const char* mhost_dir = &bhd[i1];
int mhost_len = 1;
const char* mtarget_dir = 0;
int mtarget_len = 0;
int tpath = 0;
i1++;
for (; i1 < bhdlen && bhd[i1] != ' '; i1++) {
if (bhd[i1] == ':') {
if (tpath) {
// ERROR: more than 1 : in the string.
// fast forward to next space and continue.
bhdskiptws = 1;
goto nextbhdmatch;
}
tpath = 1;
mtarget_dir = &bhd[i1+1];
continue;
}
if (!tpath) {
mhost_len++;
} else {
mtarget_len++;
}
}
if (mhost_len == 0 || mtarget_len == 0) {
continue;
}
char* host_dir = malloc((mhost_len+1) * sizeof(char));
memcpy(host_dir, mhost_dir, mhost_len);
host_dir[mhost_len] = 0;
// prefix target dir with the chroot path.
char *target_dir = malloc(mtptlen + (mtarget_len + 1) * sizeof(char));
memcpy(target_dir, mountpoint, mtptlen);
memcpy(target_dir+mtptlen, mtarget_dir, mtarget_len);
target_dir[mtarget_len+mtptlen] = 0;
if (stat(host_dir, &st) != 0) {
fprintf(logfd, "SkiffOS init: extra bind path: %s -> %s: "
"host dir does not exist\n",
host_dir, target_dir);
goto skipbhdmount;
}
if (stat(target_dir, &st) != 0) {
if (mkdir(target_dir, 0755) != 0) {
res = errno;
fprintf(logfd,
"SkiffOS init: extra bind path: %s -> %s: "
"cannot create target dir: (%d) %s\n",
host_dir, target_dir, res, strerror(res));
goto skipbhdmount;
}
}
if (mount(host_dir, target_dir, NULL, MS_BIND | MS_REC, NULL) != 0) {
res = errno;
fprintf(logfd, "SkiffOS: failed to mount extra bind path %s -> %s: (%d) %s\n", host_dir, target_dir, res,
strerror(res));
goto skipbhdmount;
}
fprintf(logfd, "SkiffOS init: mounted extra bind path: %s -> %s\n",
host_dir, target_dir);
skipbhdmount:
free(host_dir);
free(target_dir);
}
}
|
the_stack_data/95449061.c | #include<stdio.h>
int main()
{
printf("Hello World!!");
return 0;
} |
the_stack_data/448276.c | #include <stdio.h>
int main()
{
printf("Hello from C!");
return 0;
} |
the_stack_data/25138542.c | /*
Name - Nikhil Ranjan Nayak
Regd no - 1641012040
Desc - Linear Congruence Solver
*/
#include "stdio.h"
int gcd(int, int);
void main()
{
int x, a, c, m, g;
printf("\n a ≅ c(mod m)");
printf("\n a - ");
scanf("%d", &a);
printf("\n c - ");
scanf("%d", &c);
printf("\n m - ");
scanf("%d", &m);
printf("\n %d ≅ %d(mod %d)", a, c, m);
g = gcd(a, m);
printf("\n GCD - %d", g);
if(m % g == 0)
{
for(x = 0; x < m; x++)
{
if((a*x) % m == c)
printf("\n x ≅ %d(mod %d)", x, m);
}
printf("\n");
}
}
int gcd(int a, int b)
{
if(a == 0)
return b;
return gcd(b%a, a);
}
|
the_stack_data/173578383.c | //
// Created by sergio on 12/05/18.
//
#include <stdio.h>
#include <stdlib.h>
#include <stdint.h>
#include <memory.h>
int main()
{
long file_size,
ptr_buffer = 0;
double coorre[500]; /*correalacion del canal h del angulo 83*/
char *buffer;
int correlacion_pos[8];
int angulos[8];
FILE *filein;
filein = fopen ("./proccess.outln", "rb");
if(filein == NULL)
{
perror("# opening file ERROR");
exit(EXIT_FAILURE);
}
fseek ( filein, 0L, SEEK_END );
file_size = ftell ( filein );
fseek ( filein, 0, SEEK_SET );
buffer = (char *) malloc((size_t)file_size + 1);
if ( buffer == NULL)
{
perror("# Memory error malloc! \n" );
fclose (filein);
exit(EXIT_FAILURE);
}
fread(buffer, (size_t)file_size, 1, filein);
fclose(filein);
for (int i = 0; ptr_buffer < file_size; i++)
{
correlacion_pos[i] = ptr_buffer + sizeof(int);
memmove ( &angulos[i], &buffer[ptr_buffer], sizeof(int));
ptr_buffer += sizeof(int) + 2*500 * sizeof(double);
}
for (int j = 0; j < 8; ++j) {
printf("angulo %i\n",angulos[j]);
}
ptr_buffer = correlacion_pos[0];
for ( int i = 0; i < 500 ; i++)
{
memmove(&coorre[i], &buffer[ptr_buffer], sizeof(double));
ptr_buffer += sizeof(double);
printf("coore = %lf\n",coorre[i]);
}
return 0;
} |
the_stack_data/29650.c | /*
* $Source$
* $State$
*/
#define THREE_PASS /* branch and offset optimization */
#define BYTES_REVERSED /* high order byte has lowest address */
#define WORDS_REVERSED /* high order word has lowest address */
#define LISTING /* enable listing facilities */
#define RELOCATION /* generate relocatable code */
#define DEBUG 0
#undef ADDR_T
#define ADDR_T uint32_t
#undef word_t
#define word_t uint32_t
#undef ALIGNWORD
#define ALIGNWORD 4
#undef ALIGNSECT
#define ALIGNSECT 4
#undef VALWIDTH
#define VALWIDTH 8
#define FIXUPFLAGS (RELBR | RELWR)
/* 6-bit mb (mask begin) or me (mask end) field */
#define MB6(v) (((v) & 0x1F)<<6 | ((v) & 0x20)>>0)
/* 6-bit sh (shift) field */
#define SH6(v) (((v) & 0x1F)<<11 | ((v) & 0x20)>>4)
|
the_stack_data/153267458.c | //Classification: #format_error/n/IVO/FM/aS+aA/printf/float/int
//Written by: Igor Eremeev
//Reviewed by: Sergey Pomelov
//Comment:
#include <stdlib.h>
#include <stdio.h>
int main(void)
{
int c = 1234;
const char buf[5] = "%f";
printf (buf, c);
return 0;
}
|
the_stack_data/145454144.c | // RUN: %clang_cc1 -triple i386-unknown-unknown -O1 -emit-llvm -o - %s | FileCheck %s
// CHECK-LABEL: define i32 @f0()
// CHECK: ret i32 0
// CHECK-LABEL: define i32 @f1()
// CHECK: ret i32 0
// CHECK-LABEL: define i32 @f2()
// CHECK: ret i32 0
// <rdar://problem/6113085>
struct s0 {
int x, y;
};
int f0() {
struct s0 x = {0};
return x.y;
}
int f1() {
struct s0 x[2] = { {0} };
return x[1].x;
}
int f2() {
int x[2] = { 0 };
return x[1];
}
|
the_stack_data/9511536.c | #include <stdio.h>
#include <stdlib.h>
void mergeSort(int *A, int n);
void merge(int *A, int *left, int numL, int *right, int numR);
int main() {
int A[] = {1, 4, 6, 9, 3, 4, 5, 10, 7, 2};
int numElements = sizeof(A) / sizeof(A[0]);
printf("Pre-sorted array: ");
for (int i = 0; i < numElements; i++) printf("%d ", A[i]);
mergeSort(A, numElements);
printf("\nMerge sorted array: ");
for (int i = 0; i < numElements; i++) {
printf("%d ", A[i]);
}
return 0;
}
void mergeSort(int *A, int n) {
/*
* n <- length A[]
* if(n < 2) return
*
* mid <- n/2
* left <- malloc(array[sizeof(mid)])
* right <- malloc(array2[sizeof(other half)]
*
* for i <- 0 to mid - 1
* left[i] <- A[i]
* for i <- mid to n -1
* right[i - mid] <- A[i]
*
* mergeSort(left)
* mergeSort(right)
* merge(left, right, A)
*
*/
if(n < 2) return;
int mid = n/2;
int *left = (int *)malloc(mid * sizeof(int));
int *right = (int *)malloc((n - mid) * sizeof(int));
for(int i = 0; i < mid; i++) {
left[i] = A[i];
}
for(int i = mid; i < n; i++) {
right[i - mid] = A[i];
}
mergeSort(left, mid);
mergeSort(right, n - mid);
merge(A, left, mid, right, n - mid);
free(left);
free(right);
}
void merge(int *A, int *left, int numL, int *right, int numR) {
/* k
* A [2][4][1][6][8][5][3][7]
* 0 1 2 3 4 5 6 7
*
*
* L[2][4][1][6] R[8][5][3][7] //These arrays are created separately in memory from a copy of A
*
* //sort the two arrays
* L[1][2][4][6] R[3][5][7][8]
*
* //pick the smaller of the two elements from L and R and replace the value in A
* L[1][2][4][6] R[3][5][7][8]
* i j
* ---->
* k
* A [1][4][1][6][8][5][3][7]
* 0 1 2 3 4 5 6 7
*
* while (i < numL && j < numR) {
* if(left[i] <= right[j]) {
* A[k] <- left[i];
* i <- i++;
* } else {
* A[k] <- right[j];
* j <- j++;
* }
* k <- k++;
* }
*
* if one array finishes before the other
* while (i < numL) {
* A[k] <- left[i];
* i++;
* k++;
* }
* while (j < numR) {
* A[k] <- right[j];
* j++;
* k++;
* }
*/
int i = 0, j = 0, k = 0;
while (i < numL && j < numR) {
if (left[i] <= right[j]) {
A[k] = left[i];
i++;
} else {
A[k] = right[j];
j++;
}
k++;
}
while (i < numL) {
A[k] = left[i];
i++, k++;
}
while (j < numR) {
A[k] = right[j];
j++, k++;
}
}
|
the_stack_data/645138.c | /**
* srl-sra.c
*
*/
#include <stdio.h>
#include <assert.h>
unsigned srl(unsigned x, int k) {
unsigned xsra = (int) x >> k;
int w = sizeof(int) << 3;
int mask = (int) -1 << (w -k );
return xsra & ~mask;
}
int sra(int x, int k) {
int xsrl = (unsigned) x >> k;
int w = sizeof(int) << 3;
int mask = (int) -1 << (w - k);
//let mask remain unchanged when the first bit of x is 1, otherwise 0.
int m = 1 << (w - 1);
mask &= ! (x & m) - 1;
return xsrl | mask;
}
int main(void) {
unsigned test_unsigned = 0x82345678;
int test_int = 0x87654321;
assert(srl(test_unsigned, 4) == test_unsigned >> 4);
assert(sra(test_int, 4) == test_int >> 4);
} |
the_stack_data/42382.c | /**
******************************************************************************
* File Name : DAC.c
* Date : 18/01/2015 10:00:30
* Description : This file provides code for the configuration
* of the DAC instances.
******************************************************************************
*
* COPYRIGHT(c) 2015 STMicroelectronics
*
* 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 STMicroelectronics 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.
*
******************************************************************************
*/
/* Includes ------------------------------------------------------------------*/
#ifdef USE_GEN
#include "dac.h"
#include "gpio.h"
#include "tim.h"
/* USER CODE BEGIN 0 */
/* USER CODE END 0 */
DAC_HandleTypeDef hdac1;
DMA_HandleTypeDef hdma_dac_ch1;
DMA_HandleTypeDef hdma_dac_ch2;
uint32_t outputBuffEn=DAC_OUTPUTBUFFER_ENABLE;
/* DAC init function */
void MX_DAC1_Init(void)
{
DAC_ChannelConfTypeDef sConfig;
/**DAC Initialization
*/
hdac1.Instance = DAC1;
HAL_DAC_Init(&hdac1);
/**DAC channel OUT1 config
*/
sConfig.DAC_SampleAndHold = DAC_SAMPLEANDHOLD_DISABLE;
sConfig.DAC_Trigger = DAC_TRIGGER_T6_TRGO;
sConfig.DAC_OutputBuffer = outputBuffEn;
sConfig.DAC_ConnectOnChipPeripheral = DAC_CHIPCONNECT_ENABLE;
sConfig.DAC_UserTrimming = DAC_TRIMMING_FACTORY;
HAL_DAC_ConfigChannel(&hdac1, &sConfig, DAC_CHANNEL_1);
/**DAC channel OUT2 config
*/
sConfig.DAC_Trigger = DAC_TRIGGER_T7_TRGO;
sConfig.DAC_ConnectOnChipPeripheral = DAC_CHIPCONNECT_ENABLE;
HAL_DAC_ConfigChannel(&hdac1, &sConfig, DAC_CHANNEL_2);
}
void HAL_DAC_MspInit(DAC_HandleTypeDef* hdac)
{
GPIO_InitTypeDef GPIO_InitStruct;
if(hdac->Instance==DAC1)
{
/* USER CODE BEGIN DAC1_MspInit 0 */
/* USER CODE END DAC1_MspInit 0 */
/* Peripheral clock enable */
__DAC1_CLK_ENABLE();
/**DAC1 GPIO Configuration
PA4 ------> DAC1_OUT1
PA5 ------> DAC1_OUT2
*/
GPIO_InitStruct.Pin = GPIO_PIN_4|GPIO_PIN_5;
GPIO_InitStruct.Mode = GPIO_MODE_ANALOG;
GPIO_InitStruct.Pull = GPIO_NOPULL;
HAL_GPIO_Init(GPIOA, &GPIO_InitStruct);
/* Peripheral DMA init*/
hdma_dac_ch1.Instance = DMA2_Channel4;
hdma_dac_ch1.Init.Request = DMA_REQUEST_3;
hdma_dac_ch1.Init.Direction = DMA_MEMORY_TO_PERIPH;
hdma_dac_ch1.Init.PeriphInc = DMA_PINC_DISABLE;
hdma_dac_ch1.Init.MemInc = DMA_MINC_ENABLE;
hdma_dac_ch1.Init.PeriphDataAlignment = DMA_PDATAALIGN_HALFWORD;
hdma_dac_ch1.Init.MemDataAlignment = DMA_MDATAALIGN_HALFWORD;
hdma_dac_ch1.Init.Mode = DMA_CIRCULAR;
hdma_dac_ch1.Init.Priority = DMA_PRIORITY_MEDIUM;
HAL_DMA_Init(&hdma_dac_ch1);
__HAL_LINKDMA(hdac,DMA_Handle1,hdma_dac_ch1);
hdma_dac_ch2.Instance = DMA2_Channel5;
hdma_dac_ch2.Init.Request = DMA_REQUEST_3;
hdma_dac_ch2.Init.Direction = DMA_MEMORY_TO_PERIPH;
hdma_dac_ch2.Init.PeriphInc = DMA_PINC_DISABLE;
hdma_dac_ch2.Init.MemInc = DMA_MINC_ENABLE;
hdma_dac_ch2.Init.PeriphDataAlignment = DMA_PDATAALIGN_HALFWORD;
hdma_dac_ch2.Init.MemDataAlignment = DMA_MDATAALIGN_HALFWORD;
hdma_dac_ch2.Init.Mode = DMA_CIRCULAR;
hdma_dac_ch2.Init.Priority = DMA_PRIORITY_MEDIUM;
HAL_DMA_Init(&hdma_dac_ch2);
__HAL_LINKDMA(hdac,DMA_Handle2,hdma_dac_ch2);
/* USER CODE BEGIN DAC1_MspInit 1 */
/* USER CODE END DAC1_MspInit 1 */
}
}
void HAL_DAC_MspDeInit(DAC_HandleTypeDef* hdac)
{
if(hdac->Instance==DAC1)
{
/* USER CODE BEGIN DAC1_MspDeInit 0 */
/* USER CODE END DAC1_MspDeInit 0 */
/* Peripheral clock disable */
__DAC1_CLK_DISABLE();
/**DAC1 GPIO Configuration
PA4 ------> DAC1_OUT1
PA5 ------> DAC1_OUT2
*/
HAL_GPIO_DeInit(GPIOA, GPIO_PIN_4|GPIO_PIN_5);
/* Peripheral DMA DeInit*/
HAL_DMA_DeInit(hdac->DMA_Handle1);
HAL_DMA_DeInit(hdac->DMA_Handle2);
}
/* USER CODE BEGIN DAC1_MspDeInit 1 */
/* USER CODE END DAC1_MspDeInit 1 */
}
/* USER CODE BEGIN 1 */
void DAC_DMA_Reconfig(uint8_t chan, uint32_t *buff, uint32_t len){
uint32_t dacChannel=0;
switch(chan){
case 0:
dacChannel=DAC_CHANNEL_1;
break;
case 1:
dacChannel=DAC_CHANNEL_2;
break;
}
HAL_DAC_Stop_DMA(&hdac1,dacChannel);
HAL_DAC_Start_DMA(&hdac1, dacChannel, buff, len, DAC_ALIGN_12B_R);
}
void DACDisableOutput(void){
GPIO_InitTypeDef GPIO_InitStruct;
GPIO_InitStruct.Pin = GPIO_PIN_4|GPIO_PIN_5;
GPIO_InitStruct.Mode = GPIO_MODE_INPUT;
GPIO_InitStruct.Pull = GPIO_NOPULL;
HAL_GPIO_Init(GPIOA, &GPIO_InitStruct);
}
void DACEnableOutput(void){
GPIO_InitTypeDef GPIO_InitStruct;
GPIO_InitStruct.Pin = GPIO_PIN_4|GPIO_PIN_5;
GPIO_InitStruct.Mode = GPIO_MODE_ANALOG;
GPIO_InitStruct.Pull = GPIO_NOPULL;
HAL_GPIO_Init(GPIOA, &GPIO_InitStruct);
}
void DACSetOutputBuffer(void){
outputBuffEn=DAC_OUTPUTBUFFER_ENABLE;
}
void DACUnsetOutputBuffer(void){
outputBuffEn=DAC_OUTPUTBUFFER_DISABLE;
}
/**
* @brief Enable sampling
* @param None
* @retval None
*/
void GeneratingEnable (void){
MX_DAC1_Init();
DACEnableOutput();
TIMGenEnable();
}
/**
* @brief Disable sampling
* @param None
* @retval None
*/
void GeneratingDisable (void){
TIMGenDisable();
HAL_DAC_Stop(&hdac1,DAC_CHANNEL_1);
HAL_DAC_Stop(&hdac1,DAC_CHANNEL_2);
DACDisableOutput();
}
/* USER CODE END 1 */
/**
* @}
*/
/**
* @}
*/
#endif //USE_GEN
/************************ (C) COPYRIGHT STMicroelectronics *****END OF FILE****/
|
the_stack_data/70449525.c | int f(){
int* i;
int* p;
int l = 20;
int d = 7;
i = &d;
p = i;
*p = 123;
return d+d+l + (*p) + (*i);
}
|
the_stack_data/85182.c |
#include <stdlib.h>
int main(int argc, char *argv[])
{
int *n = malloc(13);
*n = 12;
return 0;
}
|
the_stack_data/165766661.c | #include <stdio.h>
#include <stdlib.h>
struct btnode
{
int value;
struct btnode *l;
struct btnode *r;
}*root = NULL, *temp = NULL, *t2, *t1;
void delete1();
void insert();
void delete();
void inorder(struct btnode *t);
void create();
void search(struct btnode *t);
void preorder(struct btnode *t);
void postorder(struct btnode *t);
void search1(struct btnode *t,int data);
int smallest(struct btnode *t);
int largest(struct btnode *t);
int flag = 1;
int main()
{
int ch;
printf("\nOPERATIONS ---");
printf("\n1 - Insert an element into tree\n");
printf("2 - Delete an element from the tree\n");
printf("3 - Inorder Traversal\n");
printf("4 - Preorder Traversal\n");
printf("5 - Postorder Traversal\n");
printf("6 - Exit\n");
while(1)
{
printf("\nEnter your choice : ");
scanf("%d", &ch);
switch (ch)
{
case 1:
insert();
break;
case 2:
delete();
break;
case 3:
inorder(root);
break;
case 4:
preorder(root);
break;
case 5:
postorder(root);
break;
case 6:
exit(0);
default :
printf("Wrong choice, Please enter correct choice ");
break;
}
}
}
/* To insert a node in the tree */
void insert()
{
create();
if (root == NULL)
root = temp;
else
search(root);
}
/* To create a node */
void create()
{
int data;
printf("Enter data of node to be inserted : ");
scanf("%d", &data);
temp = (struct btnode *)malloc(1*sizeof(struct btnode));
temp->value = data;
temp->l = temp->r = NULL;
}
/* Function to search the appropriate position to insert the new node */
void search(struct btnode *t)
{
if ((temp->value > t->value) && (t->r != NULL)) /* value more than root node value insert at right */
search(t->r);
else if ((temp->value > t->value) && (t->r == NULL))
t->r = temp;
else if ((temp->value < t->value) && (t->l != NULL)) /* value less than root node value insert at left */
search(t->l);
else if ((temp->value < t->value) && (t->l == NULL))
t->l = temp;
}
/* recursive function to perform inorder traversal of tree */
void inorder(struct btnode *t)
{
if (root == NULL)
{
printf("No elements in a tree to display");
return;
}
if (t->l != NULL)
inorder(t->l);
printf("%d -> ", t->value);
if (t->r != NULL)
inorder(t->r);
}
/* To check for the deleted node */
void delete()
{
int data;
if (root == NULL)
{
printf("No elements in a tree to delete");
return;
}
printf("Enter the data to be deleted : ");
scanf("%d", &data);
t1 = root;
t2 = root;
search1(root, data);
}
/* To find the preorder traversal */
void preorder(struct btnode *t)
{
if (root == NULL)
{
printf("No elements in a tree to display");
return;
}
printf("%d -> ", t->value);
if (t->l != NULL)
preorder(t->l);
if (t->r != NULL)
preorder(t->r);
}
/* To find the postorder traversal */
void postorder(struct btnode *t)
{
if (root == NULL)
{
printf("No elements in a tree to display ");
return;
}
if (t->l != NULL)
postorder(t->l);
if (t->r != NULL)
postorder(t->r);
printf("%d -> ", t->value);
}
/* Search for the appropriate position to insert the new node */
void search1(struct btnode *t, int data)
{
if ((data>t->value))
{
t1 = t;
search1(t->r, data);
}
else if ((data < t->value))
{
t1 = t;
search1(t->l, data);
}
else if ((data=t->value))
{
delete1(t);
}
}
/* To delete a node */
void delete1(struct btnode *t)
{
int k;
/* To delete leaf node */
if ((t->l == NULL) && (t->r == NULL))
{
if (t1->l == t)
{
t1->l = NULL;
}
else
{
t1->r = NULL;
}
t = NULL;
free(t);
return;
}
/* To delete node having one left hand child */
else if ((t->r = NULL))
{
if (t1 == t)
{
root = t->l;
t1 = root;
}
else if (t1->l == t)
{
t1->l = t->l;
}
else
{
t1->r = t->l;
}
t = NULL;
free(t);
return;
}
/* To delete node having right hand child */
else if (t->l == NULL)
{
if (t1 == t)
{
root = t->r;
t1 = root;
}
else if (t1->r == t)
t1->r = t->r;
else
t1->l = t->r;
t = NULL;
free(t);
return;
}
/* To delete node having two child */
else if ((t->l != NULL) && (t->r != NULL))
{
t2 = root;
if (t->r != NULL)
{
k = smallest(t->r);
flag = 1;
}
else
{
k =largest(t->l);
flag = 2;
}
search1(root, k);
t->value = k;
}
}
/* To find the smallest element in the right sub tree */
int smallest(struct btnode *t)
{
t2 = t;
if (t->l != NULL)
{
t2 = t;
return(smallest(t->l));
}
else
return (t->value);
}
/* To find the largest element in the left sub tree */
int largest(struct btnode *t)
{
if (t->r != NULL)
{
t2 = t;
return(largest(t->r));
}
else
return(t->value);
} |
the_stack_data/57949022.c | #include <stdlib.h>
#include <errno.h>
#include <fcntl.h>
#include <unistd.h>
ssize_t pread(int __fd,void* __buf,size_t __nbytes,off_t __offset)
{
ssize_t ret;
off_t old = lseek(__fd,0,SEEK_CUR);
if(old==(off_t)-1)return -1;
if(-1==lseek(__fd,__offset,SEEK_SET))return -1;
ret=read(__fd,__buf,__nbytes);
lseek(__fd,old,SEEK_SET);
return ret;
}
|
the_stack_data/231392927.c | /* XPM */
const char *vic20_icon_data[] = {
"48 42 4 1",
" c #C000C000C000",
". c #000000000000",
"X c #51445144FBEE",
"o c #FBEE10404103",
" .......... ",
" ....XXXXXXXXX. ",
" ..XXXXXXXXXXXXX. ",
" ..XXXXXXXXXXXXXXX. ",
" ..XXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXX........X. ",
" .XXXXXXXXXXXXX.. .. ",
" .XXXXXXXXXXXX. .............. ",
" .XXXXXXXXXXX. .XXXXXXXXXXX. ",
" .XXXXXXXXXXX. .XXXXXXXXXX. ",
" .XXXXXXXXXXX. .XXXXXXXXX. ",
" .XXXXXXXXXX. .XXXXXXXX. ",
" .XXXXXXXXXXX. .XXXXXXX. ",
" .XXXXXXXXXXX. ........ ",
" .XXXXXXXXXXX. ",
" .XXXXXXXXXXX. ........ ",
" .XXXXXXXXXXX. .ooooooo. ",
" .XXXXXXXXXXX. .oooooooo. ",
" .XXXXXXXXXX. .ooooooooo. ",
" .XXXXXXXXXXX. .oooooooooo. ",
" .XXXXXXXXXXX. .ooooooooooo. ",
" .XXXXXXXXXXX. .............. ",
" .XXXXXXXXXXXX. ",
" .XXXXXXXXXXXXX.. .. .. .. .. .... ",
" .XXXXXXXXXXXXXX........X. .. .. .. .. .. ",
" .XXXXXXXXXXXXXXXXXXXXXXX. .. .. .. .. ",
" .XXXXXXXXXXXXXXXXXXXXXX. .... .. .. ",
" .XXXXXXXXXXXXXXXXXXXXXX. .... .. .. .. ",
" .XXXXXXXXXXXXXXXXXXXXX. .. .. .... ",
" .XXXXXXXXXXXXXXXXXXXX. ",
" .XXXXXXXXXXXXXXXXXXX. .... .... ",
" ..XXXXXXXXXXXXXXXXX. .. .. .. .. ",
" ..XXXXXXXXXXXXXXX. .. .. .. ",
" ..XXXXXXXXXXXXX. .... .. .. ",
" ....XXXXXXXXX. .. .. .. ",
" .......... ...... .... "
};
|
the_stack_data/97011849.c | #include <stdio.h>
#include <stdlib.h>
#include <math.h>
#include <stdbool.h>
struct node
{
int data;
struct node* right;
struct node* left;
};
struct node* get_newnode(int data){
struct node* newnode=(struct node*)malloc(sizeof(struct node));
newnode->data=data;
newnode->right=newnode->left=NULL;
return newnode;
}
struct node* insert(struct node* root, int data){
if (root==NULL)
{
root=get_newnode(data);
}
else if(root->data>=data){
root->left=insert(root->left,data);
}
else {
root->right = insert(root->right,data);
}
return root;
}
int max(int a,int b){
if (a>b)
{
return a;
}
return b;
}
struct stack{
int top;
struct node* items[101];
};
void push(struct stack* ms, struct node* item){
ms->items[++ms->top]=item;
}
struct node* pop(struct stack* ms){
if (ms->top>-1)
{
return ms->items[(ms->top)--];
}
}
struct node* peek(struct stack ms){
if(ms.top < 0){
//printf("Stack empty\n");
return 0;
}
return ms.items[ms.top];
}
int isempty(struct stack ms){
if (ms.top<0)
{
return 1;
}
return 0;
}
void in_order(struct node* root){
struct stack st;
st.top=-1;
struct node* current=root;
struct node* pre=root;
struct node* temp=NULL;
if (root==NULL)
{
return;
}
push(&st,current);
//pre=current;
while(!(isempty(st))){
while(current!=NULL){
push(&st,current);
current=current->left;
}
temp=pop(&st);
current=temp->right;
if (!(isempty(st)))
printf("%d ",temp->data );
}
}
int main(int argc, char const *argv[])
{
struct node* root=(struct node*)malloc(sizeof(struct node));
root=NULL;
root=insert(root,50);
root=insert(root,49);
root=insert(root,25);
root=insert(root,20);
root=insert(root,3);
root=insert(root,99);
in_order(root);
//int h=find_height(root);
//printf("%d\n",h );
return 0;
} |
the_stack_data/72013115.c | // RUN: %clang_analyze_cc1 %s \
// RUN: -analyzer-checker=core \
// RUN: -analyzer-checker=apiModeling.StdCLibraryFunctions \
// RUN: -analyzer-config apiModeling.StdCLibraryFunctions:ModelPOSIX=true \
// RUN: -analyzer-config apiModeling.StdCLibraryFunctions:DisplayLoadedSummaries=true \
// RUN: -analyzer-checker=debug.ExprInspection \
// RUN: -analyzer-config eagerly-assume=false \
// RUN: -triple i686-unknown-linux 2>&1 | FileCheck %s
// CHECK: Loaded summary for: long a64l(const char *str64)
// CHECK: Loaded summary for: char *l64a(long value)
// CHECK: Loaded summary for: int access(const char *pathname, int amode)
// CHECK: Loaded summary for: int faccessat(int dirfd, const char *pathname, int mode, int flags)
// CHECK: Loaded summary for: int dup(int fildes)
// CHECK: Loaded summary for: int dup2(int fildes1, int filedes2)
// CHECK: Loaded summary for: int fdatasync(int fildes)
// CHECK: Loaded summary for: int fnmatch(const char *pattern, const char *string, int flags)
// CHECK: Loaded summary for: int fsync(int fildes)
// CHECK: Loaded summary for: int truncate(const char *path, off_t length)
// CHECK: Loaded summary for: int symlink(const char *oldpath, const char *newpath)
// CHECK: Loaded summary for: int symlinkat(const char *oldpath, int newdirfd, const char *newpath)
// CHECK: Loaded summary for: int lockf(int fd, int cmd, off_t len)
// CHECK: Loaded summary for: int creat(const char *pathname, mode_t mode)
// CHECK: Loaded summary for: unsigned int sleep(unsigned int seconds)
// CHECK: Loaded summary for: int dirfd(DIR *dirp)
// CHECK: Loaded summary for: unsigned int alarm(unsigned int seconds)
// CHECK: Loaded summary for: int closedir(DIR *dir)
// CHECK: Loaded summary for: char *strdup(const char *s)
// CHECK: Loaded summary for: char *strndup(const char *s, size_t n)
// CHECK: Loaded summary for: int mkstemp(char *template)
// CHECK: Loaded summary for: char *mkdtemp(char *template)
// CHECK: Loaded summary for: char *getcwd(char *buf, size_t size)
// CHECK: Loaded summary for: int mkdir(const char *pathname, mode_t mode)
// CHECK: Loaded summary for: int mkdirat(int dirfd, const char *pathname, mode_t mode)
// CHECK: Loaded summary for: int mknod(const char *pathname, mode_t mode, dev_t dev)
// CHECK: Loaded summary for: int mknodat(int dirfd, const char *pathname, mode_t mode, dev_t dev)
// CHECK: Loaded summary for: int chmod(const char *path, mode_t mode)
// CHECK: Loaded summary for: int fchmodat(int dirfd, const char *pathname, mode_t mode, int flags)
// CHECK: Loaded summary for: int fchmod(int fildes, mode_t mode)
// CHECK: Loaded summary for: int fchownat(int dirfd, const char *pathname, uid_t owner, gid_t group, int flags)
// CHECK: Loaded summary for: int chown(const char *path, uid_t owner, gid_t group)
// CHECK: Loaded summary for: int lchown(const char *path, uid_t owner, gid_t group)
// CHECK: Loaded summary for: int fchown(int fildes, uid_t owner, gid_t group)
// CHECK: Loaded summary for: int rmdir(const char *pathname)
// CHECK: Loaded summary for: int chdir(const char *path)
// CHECK: Loaded summary for: int link(const char *oldpath, const char *newpath)
// CHECK: Loaded summary for: int linkat(int fd1, const char *path1, int fd2, const char *path2, int flag)
// CHECK: Loaded summary for: int unlink(const char *pathname)
// CHECK: Loaded summary for: int unlinkat(int fd, const char *path, int flag)
// CHECK: Loaded summary for: int fstat(int fd, struct stat *statbuf)
// CHECK: Loaded summary for: int stat(const char *restrict path, struct stat *restrict buf)
// CHECK: Loaded summary for: int lstat(const char *restrict path, struct stat *restrict buf)
// CHECK: Loaded summary for: int fstatat(int fd, const char *restrict path, struct stat *restrict buf, int flag)
// CHECK: Loaded summary for: DIR *opendir(const char *name)
// CHECK: Loaded summary for: DIR *fdopendir(int fd)
// CHECK: Loaded summary for: int isatty(int fildes)
// CHECK: Loaded summary for: FILE *popen(const char *command, const char *type)
// CHECK: Loaded summary for: int pclose(FILE *stream)
// CHECK: Loaded summary for: int close(int fildes)
// CHECK: Loaded summary for: long fpathconf(int fildes, int name)
// CHECK: Loaded summary for: long pathconf(const char *path, int name)
// CHECK: Loaded summary for: FILE *fdopen(int fd, const char *mode)
// CHECK: Loaded summary for: void rewinddir(DIR *dir)
// CHECK: Loaded summary for: void seekdir(DIR *dirp, long loc)
// CHECK: Loaded summary for: int rand_r(unsigned int *seedp)
// CHECK: Loaded summary for: int strcasecmp(const char *s1, const char *s2)
// CHECK: Loaded summary for: int strncasecmp(const char *s1, const char *s2, size_t n)
// CHECK: Loaded summary for: int fileno(FILE *stream)
// CHECK: Loaded summary for: int fseeko(FILE *stream, off_t offset, int whence)
// CHECK: Loaded summary for: off_t ftello(FILE *stream)
// CHECK: Loaded summary for: void *mmap(void *addr, size_t length, int prot, int flags, int fd, off_t offset)
// CHECK: Loaded summary for: void *mmap64(void *addr, size_t length, int prot, int flags, int fd, off64_t offset)
// CHECK: Loaded summary for: int pipe(int fildes[2])
// CHECK: Loaded summary for: off_t lseek(int fildes, off_t offset, int whence)
// CHECK: Loaded summary for: ssize_t readlink(const char *restrict path, char *restrict buf, size_t bufsize)
// CHECK: Loaded summary for: ssize_t readlinkat(int fd, const char *restrict path, char *restrict buf, size_t bufsize)
// CHECK: Loaded summary for: int renameat(int olddirfd, const char *oldpath, int newdirfd, const char *newpath)
// CHECK: Loaded summary for: char *realpath(const char *restrict file_name, char *restrict resolved_name)
// CHECK: Loaded summary for: int execv(const char *path, char *const argv[])
// CHECK: Loaded summary for: int execvp(const char *file, char *const argv[])
// CHECK: Loaded summary for: int getopt(int argc, char *const argv[], const char *optstring)
// CHECK: Loaded summary for: int accept(int socket, __SOCKADDR_ARG address, socklen_t *restrict address_len)
// CHECK: Loaded summary for: int bind(int socket, __CONST_SOCKADDR_ARG address, socklen_t address_len)
// CHECK: Loaded summary for: int getpeername(int socket, __SOCKADDR_ARG address, socklen_t *restrict address_len)
// CHECK: Loaded summary for: int getsockname(int socket, __SOCKADDR_ARG address, socklen_t *restrict address_len)
// CHECK: Loaded summary for: int connect(int socket, __CONST_SOCKADDR_ARG address, socklen_t address_len)
// CHECK: Loaded summary for: ssize_t recvfrom(int socket, void *restrict buffer, size_t length, int flags, __SOCKADDR_ARG address, socklen_t *restrict address_len)
// CHECK: Loaded summary for: ssize_t sendto(int socket, const void *message, size_t length, int flags, __CONST_SOCKADDR_ARG dest_addr, socklen_t dest_len)
// CHECK: Loaded summary for: int listen(int sockfd, int backlog)
// CHECK: Loaded summary for: ssize_t recv(int sockfd, void *buf, size_t len, int flags)
// CHECK: Loaded summary for: ssize_t recvmsg(int sockfd, struct msghdr *msg, int flags)
// CHECK: Loaded summary for: ssize_t sendmsg(int sockfd, const struct msghdr *msg, int flags)
// CHECK: Loaded summary for: int setsockopt(int socket, int level, int option_name, const void *option_value, socklen_t option_len)
// CHECK: Loaded summary for: int getsockopt(int socket, int level, int option_name, void *restrict option_value, socklen_t *restrict option_len)
// CHECK: Loaded summary for: ssize_t send(int sockfd, const void *buf, size_t len, int flags)
// CHECK: Loaded summary for: int socketpair(int domain, int type, int protocol, int sv[2])
// CHECK: Loaded summary for: int getnameinfo(const struct sockaddr *restrict sa, socklen_t salen, char *restrict node, socklen_t nodelen, char *restrict service, socklen_t servicelen, int flags)
// CHECK: Loaded summary for: int utime(const char *filename, struct utimbuf *buf)
// CHECK: Loaded summary for: int futimens(int fd, const struct timespec times[2])
// CHECK: Loaded summary for: int utimensat(int dirfd, const char *pathname, const struct timespec times[2], int flags)
// CHECK: Loaded summary for: int utimes(const char *filename, const struct timeval times[2])
// CHECK: Loaded summary for: int nanosleep(const struct timespec *rqtp, struct timespec *rmtp)
// CHECK: Loaded summary for: struct tm *localtime(const time_t *tp)
// CHECK: Loaded summary for: struct tm *localtime_r(const time_t *restrict timer, struct tm *restrict result)
// CHECK: Loaded summary for: char *asctime_r(const struct tm *restrict tm, char *restrict buf)
// CHECK: Loaded summary for: char *ctime_r(const time_t *timep, char *buf)
// CHECK: Loaded summary for: struct tm *gmtime_r(const time_t *restrict timer, struct tm *restrict result)
// CHECK: Loaded summary for: struct tm *gmtime(const time_t *tp)
// CHECK: Loaded summary for: int clock_gettime(clockid_t clock_id, struct timespec *tp)
// CHECK: Loaded summary for: int getitimer(int which, struct itimerval *curr_value)
long a64l(const char *str64);
char *l64a(long value);
int access(const char *pathname, int amode);
int faccessat(int dirfd, const char *pathname, int mode, int flags);
int dup(int fildes);
int dup2(int fildes1, int filedes2);
int fdatasync(int fildes);
int fnmatch(const char *pattern, const char *string, int flags);
int fsync(int fildes);
typedef unsigned long off_t;
int truncate(const char *path, off_t length);
int symlink(const char *oldpath, const char *newpath);
int symlinkat(const char *oldpath, int newdirfd, const char *newpath);
int lockf(int fd, int cmd, off_t len);
typedef unsigned mode_t;
int creat(const char *pathname, mode_t mode);
unsigned int sleep(unsigned int seconds);
typedef struct {
int a;
} DIR;
int dirfd(DIR *dirp);
unsigned int alarm(unsigned int seconds);
int closedir(DIR *dir);
char *strdup(const char *s);
typedef typeof(sizeof(int)) size_t;
char *strndup(const char *s, size_t n);
/*FIXME How to define wchar_t in the test?*/
/*typedef __wchar_t wchar_t;*/
/*wchar_t *wcsdup(const wchar_t *s);*/
int mkstemp(char *template);
char *mkdtemp(char *template);
char *getcwd(char *buf, size_t size);
int mkdir(const char *pathname, mode_t mode);
int mkdirat(int dirfd, const char *pathname, mode_t mode);
typedef int dev_t;
int mknod(const char *pathname, mode_t mode, dev_t dev);
int mknodat(int dirfd, const char *pathname, mode_t mode, dev_t dev);
int chmod(const char *path, mode_t mode);
int fchmodat(int dirfd, const char *pathname, mode_t mode, int flags);
int fchmod(int fildes, mode_t mode);
typedef int uid_t;
typedef int gid_t;
int fchownat(int dirfd, const char *pathname, uid_t owner, gid_t group, int flags);
int chown(const char *path, uid_t owner, gid_t group);
int lchown(const char *path, uid_t owner, gid_t group);
int fchown(int fildes, uid_t owner, gid_t group);
int rmdir(const char *pathname);
int chdir(const char *path);
int link(const char *oldpath, const char *newpath);
int linkat(int fd1, const char *path1, int fd2, const char *path2, int flag);
int unlink(const char *pathname);
int unlinkat(int fd, const char *path, int flag);
struct stat;
int fstat(int fd, struct stat *statbuf);
int stat(const char *restrict path, struct stat *restrict buf);
int lstat(const char *restrict path, struct stat *restrict buf);
int fstatat(int fd, const char *restrict path, struct stat *restrict buf, int flag);
DIR *opendir(const char *name);
DIR *fdopendir(int fd);
int isatty(int fildes);
typedef struct {
int x;
} FILE;
FILE *popen(const char *command, const char *type);
int pclose(FILE *stream);
int close(int fildes);
long fpathconf(int fildes, int name);
long pathconf(const char *path, int name);
FILE *fdopen(int fd, const char *mode);
void rewinddir(DIR *dir);
void seekdir(DIR *dirp, long loc);
int rand_r(unsigned int *seedp);
int strcasecmp(const char *s1, const char *s2);
int strncasecmp(const char *s1, const char *s2, size_t n);
int fileno(FILE *stream);
int fseeko(FILE *stream, off_t offset, int whence);
off_t ftello(FILE *stream);
void *mmap(void *addr, size_t length, int prot, int flags, int fd, off_t offset);
typedef off_t off64_t;
void *mmap64(void *addr, size_t length, int prot, int flags, int fd, off64_t offset);
int pipe(int fildes[2]);
off_t lseek(int fildes, off_t offset, int whence);
typedef size_t ssize_t;
ssize_t readlink(const char *restrict path, char *restrict buf, size_t bufsize);
ssize_t readlinkat(int fd, const char *restrict path, char *restrict buf, size_t bufsize);
int renameat(int olddirfd, const char *oldpath, int newdirfd, const char *newpath);
char *realpath(const char *restrict file_name, char *restrict resolved_name);
int execv(const char *path, char *const argv[]);
int execvp(const char *file, char *const argv[]);
int getopt(int argc, char *const argv[], const char *optstring);
// In some libc implementations, sockaddr parameter is a transparent
// union of the underlying sockaddr_ pointers instead of being a
// pointer to struct sockaddr.
// We match that with the joker Irrelevant type.
struct sockaddr;
struct sockaddr_at;
#define __SOCKADDR_ALLTYPES \
__SOCKADDR_ONETYPE(sockaddr) \
__SOCKADDR_ONETYPE(sockaddr_at)
#define __SOCKADDR_ONETYPE(type) struct type *__restrict __##type##__;
typedef union {
__SOCKADDR_ALLTYPES
} __SOCKADDR_ARG __attribute__((__transparent_union__));
#undef __SOCKADDR_ONETYPE
#define __SOCKADDR_ONETYPE(type) const struct type *__restrict __##type##__;
typedef union {
__SOCKADDR_ALLTYPES
} __CONST_SOCKADDR_ARG __attribute__((__transparent_union__));
#undef __SOCKADDR_ONETYPE
typedef unsigned socklen_t;
int accept(int socket, __SOCKADDR_ARG address, socklen_t *restrict address_len);
int bind(int socket, __CONST_SOCKADDR_ARG address, socklen_t address_len);
int getpeername(int socket, __SOCKADDR_ARG address, socklen_t *restrict address_len);
int getsockname(int socket, __SOCKADDR_ARG address, socklen_t *restrict address_len);
int connect(int socket, __CONST_SOCKADDR_ARG address, socklen_t address_len);
ssize_t recvfrom(int socket, void *restrict buffer, size_t length, int flags, __SOCKADDR_ARG address, socklen_t *restrict address_len);
ssize_t sendto(int socket, const void *message, size_t length, int flags, __CONST_SOCKADDR_ARG dest_addr, socklen_t dest_len);
int listen(int sockfd, int backlog);
ssize_t recv(int sockfd, void *buf, size_t len, int flags);
struct msghdr;
ssize_t recvmsg(int sockfd, struct msghdr *msg, int flags);
ssize_t sendmsg(int sockfd, const struct msghdr *msg, int flags);
int setsockopt(int socket, int level, int option_name, const void *option_value, socklen_t option_len);
int getsockopt(int socket, int level, int option_name, void *restrict option_value, socklen_t *restrict option_len);
ssize_t send(int sockfd, const void *buf, size_t len, int flags);
int socketpair(int domain, int type, int protocol, int sv[2]);
int getnameinfo(const struct sockaddr *restrict sa, socklen_t salen, char *restrict node, socklen_t nodelen, char *restrict service, socklen_t servicelen, int flags);
struct utimbuf;
struct timespec { int x; };
struct timeval { int x; };
int utime(const char *filename, struct utimbuf *buf);
int futimens(int fd, const struct timespec times[2]);
int utimensat(int dirfd, const char *pathname, const struct timespec times[2], int flags);
int utimes(const char *filename, const struct timeval times[2]);
int nanosleep(const struct timespec *rqtp, struct timespec *rmtp);
typedef unsigned long time_t;
struct tm *localtime(const time_t *tp);
struct tm *localtime_r(const time_t *restrict timer, struct tm *restrict result);
char *asctime_r(const struct tm *restrict tm, char *restrict buf);
char *ctime_r(const time_t *timep, char *buf);
struct tm *gmtime_r(const time_t *restrict timer, struct tm *restrict result);
struct tm *gmtime(const time_t *tp);
typedef unsigned long clockid_t;
int clock_gettime(clockid_t clock_id, struct timespec *tp);
struct itimerval;
int getitimer(int which, struct itimerval *curr_value);
// Must have at least one call expression to initialize the summary map.
int bar(void);
void foo() {
bar();
}
|
the_stack_data/1244247.c | #include <stdio.h>
#include <string.h>
#include <fcntl.h>
#include <errno.h>
int smd_main(int argc, char **argv)
{
int fd, len, r, port = 0;
char devname[32];
argc--;
argv++;
if((argc > 0) && (argv[0][0] == '-')) {
port = atoi(argv[0] + 1);
argc--;
argv++;
}
sprintf(devname,"/dev/smd%d",port);
fd = open(devname, O_WRONLY);
if(fd < 0) {
fprintf(stderr,"failed to open smd0 - %s\n",
strerror(errno));
return -1;
}
while(argc > 0) {
len = strlen(argv[0]);
r = write(fd, argv[0], len);
if(r != len) {
fprintf(stderr,"failed to write smd0 (%d) %s\n",
r, strerror(errno));
return -1;
}
argc--;
argv++;
write(fd, argc ? " " : "\r", 1);
}
close(fd);
return 0;
}
|
the_stack_data/534515.c | #include <stdlib.h>
typedef ushort cross_item_t;
// #define CROSSOVER_MUTATE_DBG 1
#ifdef CROSSOVER_MUTATE_DBG
#define cprintf(...) printf(__VA_ARGS__)
#else
#define cprintf(...) (__VA_ARGS__);
#endif
void crossover_sorted(
cross_item_t *p1, // parent 1
cross_item_t *p2, // parent 2
cross_item_t *child1, // child 1
cross_item_t *child2, // child 2
// int ival1, // value to insert into child 1
// int ival2, // value to insert into child 2
// uint dp1, // index of child 1 item to delete
// uint dp2, // index of child 1 item to delete
uint n // number of items in individual
) {
// Crossover two parents and return point-mutated children.
// Perform few sanity checks
// if (dp1 >= n || dp2 >= n) {
// cprintf("Error, dp1/dp2 is out of range.\n");
// return;
// }
int p1_c = 0;
int p2_c = 0;
cross_item_t *child1_head = child1;
cross_item_t *child2_head = child2;
int child1_c = 0;
int child2_c = 0;
int turn = 0;
// int is_inserted_1 = 0; // 1 iff ival1 has been inserted in child 1
// int is_inserted_2 = 0; // 1 iff ival2 has been inserted in child 2
// cprintf("Deletion point 1 : %d\n", dp1);
// cprintf("Deletion point 2 : %d\n", dp2);
for (int i=0; i<n*2; i++) {
int item;
if (p1_c == n) {
// Processed all items in p1, pick next from p2 ...
item = p2[p2_c++];
} else if (p2_c == n) {
// Processed all items in p2, pick next from p1 ...
item = p1[p1_c++];
} else {
// Pick largest item from p1[p1_c] and p2[p2_c] ...
if (p1[p1_c] > p2[p2_c]) {
item = p1[p1_c];
p1_c++;
} else {
item = p2[p2_c];
p2_c++;
}
}
// Add picked item to a child ...
if (turn == 0) {
// Add to child 1
// if (child1_c != dp1) {
// if (item > ival1 && is_inserted_1 == 0) {
// cprintf("Inserting %2d in child 1\n", ival1);
// *(child1_head++) = ival1;
// is_inserted_1 = 1;
// }
*(child1_head++) = item;
cprintf("Assigning %2d to child 1\n", item);
// } else {
// cprintf("Skipping assigning %d to child 1\n", item);
// }
child1_c++;
} else {
// Add to child 2
// if (child2_c != dp2) {
// if (item > ival2 && is_inserted_2 == 0) {
// cprintf("Inserting %2d in child 2\n", ival2);
// *(child2_head++) = ival2;
// is_inserted_2 = 1;
// }
*(child2_head++) = item;
cprintf("Assigning %2d to child 2\n", item);
// } else {
// cprintf("Skipping assigning %d to child 2\n", item);
// }
child2_c++;
}
turn = 1 - turn;
}
// Append ival1/ival2 if they haven't been inserted already
// if (is_inserted_1 == 0) {
// *(child1_head++) = ival1;
// cprintf("Inserting %2d in child 1\n", ival1);
// }
// if (is_inserted_2 == 0) {
// *(child2_head++) = ival2;
// cprintf("Inserting %2d in child 2\n", ival2);
// }
}
int rand_range(int mn, int mx) {
// Return random number in [mn, mx].
if (mn == mx) {
cprintf("Error, mn is equal to mx");
return -1;
}
return mn + rand() % (mx - mn + 1);
}
int check_sorted(cross_item_t* arr, int n) {
int result = 0;
for (int i=0; i<n-1;i++) {
if (arr[i] < arr[i+1]) {
printf("sort error: node[%d] = %d but node[%d] = %d\n",
i, arr[i], i+1, arr[i+1]);
result = 1;
}
}
return result;
}
void point_mutate_sorted(cross_item_t* arr, int n, int max_val) {
while (1) {
int pos = rand() % n;
int mn, mx;
if (pos == 0) {
// first item in array
mx = max_val;
mn = arr[1] + 1;
} else if (pos == n-1) {
// last element in array
mx = arr[n-2] - 1;
mn = 0;
} else {
mn = arr[pos+1] + 1;
mx = arr[pos-1] - 1;
}
if (mx == mn) continue;
cross_item_t new_val = rand_range(mn, mx);
arr[pos] = new_val;
cprintf("Finding a value in [%d, %d]\n", mn, mx);
cprintf("Successfully inserted %d at pos %d\n", new_val, pos);
return;
}
}
|
the_stack_data/68886642.c | /*
* Copyright 2017, Data61
* Commonwealth Scientific and Industrial Research Organisation (CSIRO)
* ABN 41 687 119 230.
*
* This software may be distributed and modified according to the terms of
* the BSD 2-Clause license. Note that NO WARRANTY is provided.
* See "LICENSE_BSD2.txt" for details.
*
* @TAG(DATA61_BSD)
*/
int p_increment(int x) {
return x + 1;
}
|
the_stack_data/4041.c | #include <stdio.h>
int main(void)
{
printf("%d", 5/2);
printf(" %d", 5%2);
printf(" %d", 4/2);
printf(" %d", 4%2);
return 0;
} |
the_stack_data/159514827.c | #include<stdio.h>
void main()
{
int a[101][101];//定义一个足够大的数组
int n,i,j,min,max,sf=0;//sf=0不存在鞍点
puts("输入方正的阶数n:");
scanf("%d",&n);
//用户输入矩阵元素值
for(i=0;i<n;i++)
{
for(j=0;j<n;j++)
/*BLANK*/scanf("%d",&a[i][j]);/*BLANK*/
}
for(i=0;i<n;i++)
{
max=0;
//找出i行的最大元素所在的列号
for(j=1;j<n;j++)
{
if(a[i][max]<a[i][j])
/*BLANK*/max=j;/*BLANK*/
}
//在max列找最小元素所在的行号
min=0;
for(j=1;j<n;j++)
{
/*BLANK*/if(a[j][max]<a[min][max])
min=j;/*BLANK*/
}
if(min==i)
{
sf=1;//存在鞍点标识
printf("%d(%d,%d)\n",a[min][max],min,max);
}
}
if(!sf)
printf("没有鞍点\n");
}
|
the_stack_data/140765455.c | #include <string.h>
size_t strlen(const char *s)
{
int i = 0;
while (s[i] != '\0')
i++;
return (size_t) i;
}
|
the_stack_data/250687.c | /*
* Downloadable microcode for Advanced Systems Inc. SCSI controllers
*
* $Id: advmcode.c,v 1.5 1998/09/20 05:04:05 gibbs Exp $
*
* Obtained from:
* advansys.c - Linux Host Driver for AdvanSys SCSI Adapters
*
* Copyright (c) 1995-1997 Advanced System Products, Inc.
* All Rights Reserved.
*
* Redistribution and use in source and binary forms, with or without
* modification, are permitted provided that redistributions of source
* code retain the above copyright notice and this comment without
* modification.
*
*/
#include <sys/param.h>
u_int8_t adv_mcode[] =
{
0x01, 0x03, 0x01, 0x19, 0x0F, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x00, 0x00, 0x00, 0x00, 0x00, 0x0F, 0x0F, 0x0F, 0x0F, 0x0F, 0x0F,
0x0F, 0x0F, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x00, 0x00, 0x91, 0x10, 0x0A, 0x05, 0x01, 0x00, 0x00, 0x00, 0x00,
0xFF, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0xFF, 0x80, 0xFF, 0xFF,
0x01, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x23, 0x00, 0x24, 0x00, 0x00, 0x00, 0x07, 0x00, 0xFF, 0x00, 0x00,
0x00, 0x00, 0xFF, 0xFF, 0xFF, 0x00, 0x00, 0x00, 0x00, 0x00, 0x00,
0x00, 0xE2, 0x88, 0x00, 0x00, 0x00, 0x00, 0x80, 0x73, 0x48, 0x04,
0x36, 0x00, 0x00, 0xA2, 0xC2, 0x00, 0x80, 0x73, 0x03, 0x23, 0x36,
0x40, 0xB6, 0x00, 0x36, 0x00, 0x05, 0xD6, 0x0C, 0xD2, 0x12, 0xDA,
0x00, 0xA2, 0xC2, 0x00, 0x92, 0x80, 0x1E, 0x98, 0x50, 0x00, 0xF5,
0x00, 0x48, 0x98, 0xDF, 0x23, 0x36, 0x60, 0xB6, 0x00, 0x92, 0x80,
0x4F, 0x00, 0xF5, 0x00, 0x48, 0x98, 0xEF, 0x23, 0x36, 0x60, 0xB6,
0x00, 0x92, 0x80, 0x80, 0x62, 0x92, 0x80, 0x00, 0x46, 0x17, 0xEE,
0x13, 0xEA, 0x02, 0x01, 0x09, 0xD8, 0xCD, 0x04, 0x4D, 0x00, 0x00,
0xA3, 0xD6, 0x00, 0xA6, 0x97, 0x7F, 0x23, 0x04, 0x61, 0x84, 0x01,
0xE6, 0x84, 0xD2, 0xC1, 0x80, 0x73, 0xCD, 0x04, 0x4D, 0x00, 0x00,
0xA3, 0xE2, 0x01, 0xA6, 0x97, 0xCE, 0x81, 0x00, 0x33, 0x02, 0x00,
0xC0, 0x88, 0x80, 0x73, 0x80, 0x77, 0x00, 0x01, 0x01, 0xA1, 0x02,
0x01, 0x4F, 0x00, 0x84, 0x97, 0x07, 0xA6, 0x0C, 0x01, 0x00, 0x33,
0x03, 0x00, 0xC0, 0x88, 0x03, 0x03, 0x03, 0xDE, 0x00, 0x33, 0x05,
0x00, 0xC0, 0x88, 0xCE, 0x00, 0x69, 0x60, 0xCE, 0x00, 0x02, 0x03,
0x4A, 0x60, 0x00, 0xA2, 0x80, 0x01, 0x80, 0x63, 0x07, 0xA6, 0x2C,
0x01, 0x80, 0x81, 0x03, 0x03, 0x80, 0x63, 0xE2, 0x00, 0x07, 0xA6,
0x3C, 0x01, 0x00, 0x33, 0x04, 0x00, 0xC0, 0x88, 0x03, 0x07, 0x02,
0x01, 0x04, 0xCA, 0x0D, 0x23, 0x68, 0x98, 0x4D, 0x04, 0x04, 0x85,
0x05, 0xD8, 0x0D, 0x23, 0x68, 0x98, 0xCD, 0x04, 0x15, 0x23, 0xF6,
0x88, 0xFB, 0x23, 0x02, 0x61, 0x82, 0x01, 0x80, 0x63, 0x02, 0x03,
0x06, 0xA3, 0x6A, 0x01, 0x00, 0x33, 0x0A, 0x00, 0xC0, 0x88, 0x4E,
0x00, 0x07, 0xA3, 0x76, 0x01, 0x00, 0x33, 0x0B, 0x00, 0xC0, 0x88,
0xCD, 0x04, 0x36, 0x2D, 0x00, 0x33, 0x1A, 0x00, 0xC0, 0x88, 0x50,
0x04, 0x90, 0x81, 0x06, 0xAB, 0x8A, 0x01, 0x90, 0x81, 0x4E, 0x00,
0x07, 0xA3, 0x9A, 0x01, 0x50, 0x00, 0x00, 0xA3, 0x44, 0x01, 0x00,
0x05, 0x84, 0x81, 0x46, 0x97, 0x02, 0x01, 0x05, 0xC6, 0x04, 0x23,
0xA0, 0x01, 0x15, 0x23, 0xA1, 0x01, 0xC6, 0x81, 0xFD, 0x23, 0x02,
0x61, 0x82, 0x01, 0x0A, 0xDA, 0x4A, 0x00, 0x06, 0x61, 0x00, 0xA0,
0xBC, 0x01, 0x80, 0x63, 0xCD, 0x04, 0x36, 0x2D, 0x00, 0x33, 0x1B,
0x00, 0xC0, 0x88, 0x06, 0x23, 0x68, 0x98, 0xCD, 0x04, 0xE6, 0x84,
0x06, 0x01, 0x00, 0xA2, 0xDC, 0x01, 0x57, 0x60, 0x00, 0xA0, 0xE2,
0x01, 0xE6, 0x84, 0x80, 0x23, 0xA0, 0x01, 0xE6, 0x84, 0x80, 0x73,
0x4B, 0x00, 0x06, 0x61, 0x00, 0xA2, 0x08, 0x02, 0x04, 0x01, 0x0C,
0xDE, 0x02, 0x01, 0x03, 0xCC, 0x4F, 0x00, 0x84, 0x97, 0x04, 0x82,
0x08, 0x23, 0x02, 0x41, 0x82, 0x01, 0x4F, 0x00, 0x62, 0x97, 0x48,
0x04, 0x84, 0x80, 0xF0, 0x97, 0x00, 0x46, 0x56, 0x00, 0x03, 0xC0,
0x01, 0x23, 0xE8, 0x00, 0x81, 0x73, 0x06, 0x29, 0x03, 0x42, 0x06,
0xE2, 0x03, 0xEE, 0x67, 0xEB, 0x11, 0x23, 0xF6, 0x88, 0x04, 0x98,
0xF4, 0x80, 0x80, 0x73, 0x80, 0x77, 0x07, 0xA4, 0x32, 0x02, 0x7C,
0x95, 0x06, 0xA6, 0x3C, 0x02, 0x03, 0xA6, 0x4C, 0x04, 0xC0, 0x88,
0x04, 0x01, 0x03, 0xD8, 0xB2, 0x98, 0x6A, 0x96, 0x4E, 0x82, 0xFE,
0x95, 0x80, 0x67, 0x83, 0x03, 0x80, 0x63, 0xB6, 0x2D, 0x02, 0xA6,
0x78, 0x02, 0x07, 0xA6, 0x66, 0x02, 0x06, 0xA6, 0x6A, 0x02, 0x03,
0xA6, 0x6E, 0x02, 0x00, 0x33, 0x10, 0x00, 0xC0, 0x88, 0x7C, 0x95,
0x50, 0x82, 0x60, 0x96, 0x50, 0x82, 0x04, 0x23, 0xA0, 0x01, 0x14,
0x23, 0xA1, 0x01, 0x3C, 0x84, 0x04, 0x01, 0x0C, 0xDC, 0xE0, 0x23,
0x25, 0x61, 0xEF, 0x00, 0x14, 0x01, 0x4F, 0x04, 0xA8, 0x01, 0x6F,
0x00, 0xA5, 0x01, 0x03, 0x23, 0xA4, 0x01, 0x06, 0x23, 0x9C, 0x01,
0x24, 0x2B, 0x1C, 0x01, 0x02, 0xA6, 0xB6, 0x02, 0x07, 0xA6, 0x66,
0x02, 0x06, 0xA6, 0x6A, 0x02, 0x03, 0xA6, 0x20, 0x04, 0x01, 0xA6,
0xC0, 0x02, 0x00, 0xA6, 0xC0, 0x02, 0x00, 0x33, 0x12, 0x00, 0xC0,
0x88, 0x00, 0x0E, 0x80, 0x63, 0x00, 0x43, 0x00, 0xA0, 0x98, 0x02,
0x4D, 0x04, 0x04, 0x01, 0x0B, 0xDC, 0xE7, 0x23, 0x04, 0x61, 0x84,
0x01, 0x10, 0x31, 0x12, 0x35, 0x14, 0x01, 0xEC, 0x00, 0x6C, 0x38,
0x00, 0x3F, 0x00, 0x00, 0xF6, 0x82, 0x18, 0x23, 0x04, 0x61, 0x18,
0xA0, 0xEE, 0x02, 0x04, 0x01, 0x9C, 0xC8, 0x00, 0x33, 0x1F, 0x00,
0xC0, 0x88, 0x08, 0x31, 0x0A, 0x35, 0x0C, 0x39, 0x0E, 0x3D, 0x7E,
0x98, 0xB6, 0x2D, 0x01, 0xA6, 0x20, 0x03, 0x00, 0xA6, 0x20, 0x03,
0x07, 0xA6, 0x18, 0x03, 0x06, 0xA6, 0x1C, 0x03, 0x03, 0xA6, 0x20,
0x04, 0x02, 0xA6, 0x78, 0x02, 0x00, 0x33, 0x33, 0x00, 0xC0, 0x88,
0x7C, 0x95, 0xFA, 0x82, 0x60, 0x96, 0xFA, 0x82, 0x82, 0x98, 0x80,
0x42, 0x7E, 0x98, 0x60, 0xE4, 0x04, 0x01, 0x29, 0xC8, 0x31, 0x05,
0x07, 0x01, 0x00, 0xA2, 0x60, 0x03, 0x00, 0x43, 0x87, 0x01, 0x05,
0x05, 0x86, 0x98, 0x7E, 0x98, 0x00, 0xA6, 0x22, 0x03, 0x07, 0xA6,
0x58, 0x03, 0x03, 0xA6, 0x3C, 0x04, 0x06, 0xA6, 0x5C, 0x03, 0x01,
0xA6, 0x22, 0x03, 0x00, 0x33, 0x25, 0x00, 0xC0, 0x88, 0x7C, 0x95,
0x3E, 0x83, 0x60, 0x96, 0x3E, 0x83, 0x04, 0x01, 0x0C, 0xCE, 0x03,
0xC8, 0x00, 0x33, 0x42, 0x00, 0xC0, 0x88, 0x00, 0x01, 0x05, 0x05,
0xFF, 0xA2, 0x7E, 0x03, 0xB1, 0x01, 0x08, 0x23, 0xB2, 0x01, 0x3A,
0x83, 0x05, 0x05, 0x15, 0x01, 0x00, 0xA2, 0x9E, 0x03, 0xEC, 0x00,
0x6E, 0x00, 0x95, 0x01, 0x6C, 0x38, 0x00, 0x3F, 0x00, 0x00, 0x01,
0xA6, 0x9A, 0x03, 0x00, 0xA6, 0x9A, 0x03, 0x12, 0x84, 0x80, 0x42,
0x7E, 0x98, 0x01, 0xA6, 0xA8, 0x03, 0x00, 0xA6, 0xC0, 0x03, 0x12,
0x84, 0xA6, 0x98, 0x80, 0x42, 0x01, 0xA6, 0xA8, 0x03, 0x07, 0xA6,
0xB6, 0x03, 0xD8, 0x83, 0x7C, 0x95, 0xAC, 0x83, 0x00, 0x33, 0x2F,
0x00, 0xC0, 0x88, 0xA6, 0x98, 0x80, 0x42, 0x00, 0xA6, 0xC0, 0x03,
0x07, 0xA6, 0xCE, 0x03, 0xD8, 0x83, 0x7C, 0x95, 0xC4, 0x83, 0x00,
0x33, 0x26, 0x00, 0xC0, 0x88, 0x38, 0x2B, 0x80, 0x32, 0x80, 0x36,
0x04, 0x23, 0xA0, 0x01, 0x12, 0x23, 0xA1, 0x01, 0x12, 0x84, 0x06,
0xF0, 0x06, 0xA4, 0xF6, 0x03, 0x80, 0x6B, 0x05, 0x23, 0x83, 0x03,
0x80, 0x63, 0x03, 0xA6, 0x10, 0x04, 0x07, 0xA6, 0x08, 0x04, 0x06,
0xA6, 0x0C, 0x04, 0x00, 0x33, 0x17, 0x00, 0xC0, 0x88, 0x7C, 0x95,
0xF6, 0x83, 0x60, 0x96, 0xF6, 0x83, 0x20, 0x84, 0x06, 0xF0, 0x06,
0xA4, 0x20, 0x04, 0x80, 0x6B, 0x05, 0x23, 0x83, 0x03, 0x80, 0x63,
0xB6, 0x2D, 0x03, 0xA6, 0x3C, 0x04, 0x07, 0xA6, 0x34, 0x04, 0x06,
0xA6, 0x38, 0x04, 0x00, 0x33, 0x30, 0x00, 0xC0, 0x88, 0x7C, 0x95,
0x20, 0x84, 0x60, 0x96, 0x20, 0x84, 0x1D, 0x01, 0x06, 0xCC, 0x00,
0x33, 0x00, 0x84, 0xC0, 0x20, 0x00, 0x23, 0xEA, 0x00, 0x81, 0x62,
0xA2, 0x0D, 0x80, 0x63, 0x07, 0xA6, 0x5A, 0x04, 0x00, 0x33, 0x18,
0x00, 0xC0, 0x88, 0x03, 0x03, 0x80, 0x63, 0xA3, 0x01, 0x07, 0xA4,
0x64, 0x04, 0x23, 0x01, 0x00, 0xA2, 0x86, 0x04, 0x0A, 0xA0, 0x76,
0x04, 0xE0, 0x00, 0x00, 0x33, 0x1D, 0x00, 0xC0, 0x88, 0x0B, 0xA0,
0x82, 0x04, 0xE0, 0x00, 0x00, 0x33, 0x1E, 0x00, 0xC0, 0x88, 0x42,
0x23, 0xF6, 0x88, 0x00, 0x23, 0x22, 0xA3, 0xE6, 0x04, 0x08, 0x23,
0x22, 0xA3, 0xA2, 0x04, 0x28, 0x23, 0x22, 0xA3, 0xAE, 0x04, 0x02,
0x23, 0x22, 0xA3, 0xC4, 0x04, 0x42, 0x23, 0xF6, 0x88, 0x4A, 0x00,
0x06, 0x61, 0x00, 0xA0, 0xAE, 0x04, 0x45, 0x23, 0xF6, 0x88, 0x04,
0x98, 0x00, 0xA2, 0xC0, 0x04, 0xB2, 0x98, 0x00, 0x33, 0x00, 0x82,
0xC0, 0x20, 0x81, 0x62, 0xF0, 0x81, 0x47, 0x23, 0xF6, 0x88, 0x04,
0x01, 0x0B, 0xDE, 0x04, 0x98, 0xB2, 0x98, 0x00, 0x33, 0x00, 0x81,
0xC0, 0x20, 0x81, 0x62, 0x14, 0x01, 0x00, 0xA0, 0x08, 0x02, 0x43,
0x23, 0xF6, 0x88, 0x04, 0x23, 0xA0, 0x01, 0x44, 0x23, 0xA1, 0x01,
0x80, 0x73, 0x4D, 0x00, 0x03, 0xA3, 0xF4, 0x04, 0x00, 0x33, 0x27,
0x00, 0xC0, 0x88, 0x04, 0x01, 0x04, 0xDC, 0x02, 0x23, 0xA2, 0x01,
0x04, 0x23, 0xA0, 0x01, 0x04, 0x98, 0x26, 0x95, 0x4B, 0x00, 0xF6,
0x00, 0x4F, 0x04, 0x4F, 0x00, 0x00, 0xA3, 0x22, 0x05, 0x00, 0x05,
0x76, 0x00, 0x06, 0x61, 0x00, 0xA2, 0x1C, 0x05, 0x0A, 0x85, 0x46,
0x97, 0xCD, 0x04, 0x24, 0x85, 0x48, 0x04, 0x84, 0x80, 0x02, 0x01,
0x03, 0xDA, 0x80, 0x23, 0x82, 0x01, 0x34, 0x85, 0x02, 0x23, 0xA0,
0x01, 0x4A, 0x00, 0x06, 0x61, 0x00, 0xA2, 0x40, 0x05, 0x1D, 0x01,
0x04, 0xD6, 0xFF, 0x23, 0x86, 0x41, 0x4B, 0x60, 0xCB, 0x00, 0xFF,
0x23, 0x80, 0x01, 0x49, 0x00, 0x81, 0x01, 0x04, 0x01, 0x02, 0xC8,
0x30, 0x01, 0x80, 0x01, 0xF7, 0x04, 0x03, 0x01, 0x49, 0x04, 0x80,
0x01, 0xC9, 0x00, 0x00, 0x05, 0x00, 0x01, 0xFF, 0xA0, 0x60, 0x05,
0x77, 0x04, 0x01, 0x23, 0xEA, 0x00, 0x5D, 0x00, 0xFE, 0xC7, 0x00,
0x62, 0x00, 0x23, 0xEA, 0x00, 0x00, 0x63, 0x07, 0xA4, 0xF8, 0x05,
0x03, 0x03, 0x02, 0xA0, 0x8E, 0x05, 0xF4, 0x85, 0x00, 0x33, 0x2D,
0x00, 0xC0, 0x88, 0x04, 0xA0, 0xB8, 0x05, 0x80, 0x63, 0x00, 0x23,
0xDF, 0x00, 0x4A, 0x00, 0x06, 0x61, 0x00, 0xA2, 0xA4, 0x05, 0x1D,
0x01, 0x06, 0xD6, 0x02, 0x23, 0x02, 0x41, 0x82, 0x01, 0x50, 0x00,
0x62, 0x97, 0x04, 0x85, 0x04, 0x23, 0x02, 0x41, 0x82, 0x01, 0x04,
0x85, 0x08, 0xA0, 0xBE, 0x05, 0xF4, 0x85, 0x03, 0xA0, 0xC4, 0x05,
0xF4, 0x85, 0x01, 0xA0, 0xCE, 0x05, 0x88, 0x00, 0x80, 0x63, 0xCC,
0x86, 0x07, 0xA0, 0xEE, 0x05, 0x5F, 0x00, 0x00, 0x2B, 0xDF, 0x08,
0x00, 0xA2, 0xE6, 0x05, 0x80, 0x67, 0x80, 0x63, 0x01, 0xA2, 0x7A,
0x06, 0x7C, 0x85, 0x06, 0x23, 0x68, 0x98, 0x48, 0x23, 0xF6, 0x88,
0x07, 0x23, 0x80, 0x00, 0x06, 0x87, 0x80, 0x63, 0x7C, 0x85, 0x00,
0x23, 0xDF, 0x00, 0x00, 0x63, 0x4A, 0x00, 0x06, 0x61, 0x00, 0xA2,
0x36, 0x06, 0x1D, 0x01, 0x16, 0xD4, 0xC0, 0x23, 0x07, 0x41, 0x83,
0x03, 0x80, 0x63, 0x06, 0xA6, 0x1C, 0x06, 0x00, 0x33, 0x37, 0x00,
0xC0, 0x88, 0x1D, 0x01, 0x01, 0xD6, 0x20, 0x23, 0x63, 0x60, 0x83,
0x03, 0x80, 0x63, 0x02, 0x23, 0xDF, 0x00, 0x07, 0xA6, 0x7C, 0x05,
0xEF, 0x04, 0x6F, 0x00, 0x00, 0x63, 0x4B, 0x00, 0x06, 0x41, 0xCB,
0x00, 0x52, 0x00, 0x06, 0x61, 0x00, 0xA2, 0x4E, 0x06, 0x1D, 0x01,
0x03, 0xCA, 0xC0, 0x23, 0x07, 0x41, 0x00, 0x63, 0x1D, 0x01, 0x04,
0xCC, 0x00, 0x33, 0x00, 0x83, 0xC0, 0x20, 0x81, 0x62, 0x80, 0x23,
0x07, 0x41, 0x00, 0x63, 0x80, 0x67, 0x08, 0x23, 0x83, 0x03, 0x80,
0x63, 0x00, 0x63, 0x01, 0x23, 0xDF, 0x00, 0x06, 0xA6, 0x84, 0x06,
0x07, 0xA6, 0x7C, 0x05, 0x80, 0x67, 0x80, 0x63, 0x00, 0x33, 0x00,
0x40, 0xC0, 0x20, 0x81, 0x62, 0x00, 0x63, 0x00, 0x00, 0xFE, 0x95,
0x83, 0x03, 0x80, 0x63, 0x06, 0xA6, 0x94, 0x06, 0x07, 0xA6, 0x7C,
0x05, 0x00, 0x00, 0x01, 0xA0, 0x14, 0x07, 0x00, 0x2B, 0x40, 0x0E,
0x80, 0x63, 0x01, 0x00, 0x06, 0xA6, 0xAA, 0x06, 0x07, 0xA6, 0x7C,
0x05, 0x40, 0x0E, 0x80, 0x63, 0x00, 0x43, 0x00, 0xA0, 0xA2, 0x06,
0x06, 0xA6, 0xBC, 0x06, 0x07, 0xA6, 0x7C, 0x05, 0x80, 0x67, 0x40,
0x0E, 0x80, 0x63, 0x07, 0xA6, 0x7C, 0x05, 0x00, 0x23, 0xDF, 0x00,
0x00, 0x63, 0x07, 0xA6, 0xD6, 0x06, 0x00, 0x33, 0x2A, 0x00, 0xC0,
0x88, 0x03, 0x03, 0x80, 0x63, 0x89, 0x00, 0x0A, 0x2B, 0x07, 0xA6,
0xE8, 0x06, 0x00, 0x33, 0x29, 0x00, 0xC0, 0x88, 0x00, 0x43, 0x00,
0xA2, 0xF4, 0x06, 0xC0, 0x0E, 0x80, 0x63, 0xDE, 0x86, 0xC0, 0x0E,
0x00, 0x33, 0x00, 0x80, 0xC0, 0x20, 0x81, 0x62, 0x04, 0x01, 0x02,
0xDA, 0x80, 0x63, 0x7C, 0x85, 0x80, 0x7B, 0x80, 0x63, 0x06, 0xA6,
0x8C, 0x06, 0x00, 0x33, 0x2C, 0x00, 0xC0, 0x88, 0x0C, 0xA2, 0x2E,
0x07, 0xFE, 0x95, 0x83, 0x03, 0x80, 0x63, 0x06, 0xA6, 0x2C, 0x07,
0x07, 0xA6, 0x7C, 0x05, 0x00, 0x33, 0x3D, 0x00, 0xC0, 0x88, 0x00,
0x00, 0x80, 0x67, 0x83, 0x03, 0x80, 0x63, 0x0C, 0xA0, 0x44, 0x07,
0x07, 0xA6, 0x7C, 0x05, 0xBF, 0x23, 0x04, 0x61, 0x84, 0x01, 0xE6,
0x84, 0x00, 0x63, 0xF0, 0x04, 0x01, 0x01, 0xF1, 0x00, 0x00, 0x01,
0xF2, 0x00, 0x01, 0x05, 0x80, 0x01, 0x72, 0x04, 0x71, 0x00, 0x81,
0x01, 0x70, 0x04, 0x80, 0x05, 0x81, 0x05, 0x00, 0x63, 0xF0, 0x04,
0xF2, 0x00, 0x72, 0x04, 0x01, 0x01, 0xF1, 0x00, 0x70, 0x00, 0x81,
0x01, 0x70, 0x04, 0x71, 0x00, 0x81, 0x01, 0x72, 0x00, 0x80, 0x01,
0x71, 0x04, 0x70, 0x00, 0x80, 0x01, 0x70, 0x04, 0x00, 0x63, 0xF0,
0x04, 0xF2, 0x00, 0x72, 0x04, 0x00, 0x01, 0xF1, 0x00, 0x70, 0x00,
0x80, 0x01, 0x70, 0x04, 0x71, 0x00, 0x80, 0x01, 0x72, 0x00, 0x81,
0x01, 0x71, 0x04, 0x70, 0x00, 0x81, 0x01, 0x70, 0x04, 0x00, 0x63,
0x00, 0x23, 0xB3, 0x01, 0x83, 0x05, 0xA3, 0x01, 0xA2, 0x01, 0xA1,
0x01, 0x01, 0x23, 0xA0, 0x01, 0x00, 0x01, 0xC8, 0x00, 0x03, 0xA1,
0xC4, 0x07, 0x00, 0x33, 0x07, 0x00, 0xC0, 0x88, 0x80, 0x05, 0x81,
0x05, 0x04, 0x01, 0x11, 0xC8, 0x48, 0x00, 0xB0, 0x01, 0xB1, 0x01,
0x08, 0x23, 0xB2, 0x01, 0x05, 0x01, 0x48, 0x04, 0x00, 0x43, 0x00,
0xA2, 0xE4, 0x07, 0x00, 0x05, 0xDA, 0x87, 0x00, 0x01, 0xC8, 0x00,
0xFF, 0x23, 0x80, 0x01, 0x05, 0x05, 0x00, 0x63, 0xF7, 0x04, 0x1A,
0x09, 0xF6, 0x08, 0x6E, 0x04, 0x00, 0x02, 0x80, 0x43, 0x76, 0x08,
0x80, 0x02, 0x77, 0x04, 0x00, 0x63, 0xF7, 0x04, 0x1A, 0x09, 0xF6,
0x08, 0x6E, 0x04, 0x00, 0x02, 0x00, 0xA0, 0x14, 0x08, 0x16, 0x88,
0x00, 0x43, 0x76, 0x08, 0x80, 0x02, 0x77, 0x04, 0x00, 0x63, 0xF3,
0x04, 0x00, 0x23, 0xF4, 0x00, 0x74, 0x00, 0x80, 0x43, 0xF4, 0x00,
0xCF, 0x40, 0x00, 0xA2, 0x44, 0x08, 0x74, 0x04, 0x02, 0x01, 0xF7,
0xC9, 0xF6, 0xD9, 0x00, 0x01, 0x01, 0xA1, 0x24, 0x08, 0x04, 0x98,
0x26, 0x95, 0x24, 0x88, 0x73, 0x04, 0x00, 0x63, 0xF3, 0x04, 0x75,
0x04, 0x5A, 0x88, 0x02, 0x01, 0x04, 0xD8, 0x46, 0x97, 0x04, 0x98,
0x26, 0x95, 0x4A, 0x88, 0x75, 0x00, 0x00, 0xA3, 0x64, 0x08, 0x00,
0x05, 0x4E, 0x88, 0x73, 0x04, 0x00, 0x63, 0x80, 0x7B, 0x80, 0x63,
0x06, 0xA6, 0x76, 0x08, 0x00, 0x33, 0x3E, 0x00, 0xC0, 0x88, 0x80,
0x67, 0x83, 0x03, 0x80, 0x63, 0x00, 0x63, 0x38, 0x2B, 0x9C, 0x88,
0x38, 0x2B, 0x92, 0x88, 0x32, 0x09, 0x31, 0x05, 0x92, 0x98, 0x05,
0x05, 0xB2, 0x09, 0x00, 0x63, 0x00, 0x32, 0x00, 0x36, 0x00, 0x3A,
0x00, 0x3E, 0x00, 0x63, 0x80, 0x32, 0x80, 0x36, 0x80, 0x3A, 0x80,
0x3E, 0x00, 0x63, 0x38, 0x2B, 0x40, 0x32, 0x40, 0x36, 0x40, 0x3A,
0x40, 0x3E, 0x00, 0x63, 0x5A, 0x20, 0xC9, 0x40, 0x00, 0xA0, 0xB2,
0x08, 0x5D, 0x00, 0xFE, 0xC3, 0x00, 0x63, 0x80, 0x73, 0xE6, 0x20,
0x02, 0x23, 0xE8, 0x00, 0x82, 0x73, 0xFF, 0xFD, 0x80, 0x73, 0x13,
0x23, 0xF6, 0x88, 0x66, 0x20, 0xC0, 0x20, 0x04, 0x23, 0xA0, 0x01,
0xA1, 0x23, 0xA1, 0x01, 0x81, 0x62, 0xE0, 0x88, 0x80, 0x73, 0x80,
0x77, 0x68, 0x00, 0x00, 0xA2, 0x80, 0x00, 0x03, 0xC2, 0xF1, 0xC7,
0x41, 0x23, 0xF6, 0x88, 0x11, 0x23, 0xA1, 0x01, 0x04, 0x23, 0xA0,
0x01, 0xE6, 0x84
};
u_int16_t adv_mcode_size = sizeof(adv_mcode);
u_int32_t adv_mcode_chksum = 0x012B5442;
|
the_stack_data/242331276.c | # include <stdio.h>
int soma_impares(int,int);
int produto_pares(int,int);
int soma_impares(int a, int b){
int maior, menor, i, res;
if (a>b){maior=a; menor=b;}
else {maior=b; menor=a;}
res=0;
for (i=menor+(menor%2==0); i<=maior; i=i+2){
res+=i;
}
return res;
}
int produto_pares(int a, int b){
int maior, menor, i, res;
if (a>b){maior=a; menor=b;}
else {maior=b; menor=a;}
res=1;
for (i=menor+(menor%2!=0); i<=maior; i=i+2){
res=res*i;
}
return res;
}
int main(){
int a, b;
printf("Diga 2 números: ");
scanf("%d", &a);
scanf("%d", &b);
printf("Soma de todos os impares entre %d e %d: %d\n",a,b,soma_impares(a,b));
printf("Produto de todos os pares entre %d e %d: %d\n",a,b,produto_pares(a,b));
return 0;
}
|
the_stack_data/11111.c | #include <stdio.h>
void write_array(
int nSizeWidth,
int nSizeHeight,
float dest[nSizeHeight][nSizeWidth],
float source[nSizeHeight][nSizeWidth]
)
{
int y, x;
// loop unroll for source == dest (further more, both images have padding, beware of indices
for (y = 0; y < nSizeHeight; ++y) {
for (x = 0; x < nSizeWidth; ++x)
dest[y][x] = source[y][x]; // !! padding source
}
}
/* ----------------------------------------------------------------------- */
int main() {
int nSizeWidth=100;
int nSizeHeight=100;
float src[nSizeHeight][nSizeWidth];
float dest[nSizeHeight][nSizeWidth];
write_array(nSizeWidth,nSizeHeight,
dest,
src);
write_array(nSizeWidth,nSizeHeight,
*((float(*)[nSizeHeight][nSizeWidth])dest[0]),
*((float(*)[nSizeHeight][nSizeWidth])src[0]));
return 0;
}
|
the_stack_data/36657.c | extern void PUT32 ( unsigned int, unsigned int );
extern unsigned int GET32 ( unsigned int );
extern void dummy ( unsigned int );
#define GPFSEL1 0x20200004
#define GPSET0 0x2020001C
#define GPCLR0 0x20200028
#define GPPUD 0x20200094
#define GPPUDCLK0 0x20200098
#define AUX_ENABLES 0x20215004
#define AUX_MU_IO_REG 0x20215040
#define AUX_MU_IER_REG 0x20215044
#define AUX_MU_IIR_REG 0x20215048
#define AUX_MU_LCR_REG 0x2021504C
#define AUX_MU_MCR_REG 0x20215050
#define AUX_MU_LSR_REG 0x20215054
#define AUX_MU_MSR_REG 0x20215058
#define AUX_MU_SCRATCH 0x2021505C
#define AUX_MU_CNTL_REG 0x20215060
#define AUX_MU_STAT_REG 0x20215064
#define AUX_MU_BAUD_REG 0x20215068
#define ESCAPE_SEQ 0x20
#define MAX_WORD_LENGTH 64
#define MAX_INTEGER_LENGTH 10
#define STACK_SIZE 40
//GPIO14 TXD0 and TXD1
//GPIO15 RXD0 and RXD1
//alt function 5 for uart1
//alt function 0 for uart0
//((250,000,000/115200)/8)-1 = 270
static unsigned int si = 0;
static int stack[STACK_SIZE];
static unsigned long long types = 0;
inline char isdigit ( unsigned char c )
{
switch (c){
case 48:
case 49:
case 50:
case 51:
case 52:
case 53:
case 54:
case 55:
case 56:
case 57:
return 1;
break;
default:
return 0;
break;
}
}
void uart_putc ( unsigned int c )
{
while(1)
{
if(GET32(AUX_MU_LSR_REG)&0x20) break;
}
PUT32(AUX_MU_IO_REG,c);
}
//------------------------------------------------------------------------
void uart_puts ( char* str )
{
unsigned int rb = 0;
while(str[rb] != 0)
{
uart_putc(str[rb]);
rb++;
}
}
//------------------------------------------------------------------------
void hexstrings ( unsigned int d )
{
unsigned int rb;
unsigned int rc;
rb=32;
while(1)
{
rb-=4;
rc=(d>>rb)&0xF;
if(rc>9) rc+=0x37; else rc+=0x30;
uart_putc(rc);
if(rb==0) break;
}
uart_putc(0x20);
}
//------------------------------------------------------------------------
void hexstring ( unsigned int d )
{
hexstrings(d);
uart_putc(0x0D);
uart_putc(0x0A);
}
//------------------------------------------------------------------------
void uart_puti ( int n )
{
int a;
if (n < 0) {
uart_putc('-');
n = -n;
}
if( n > 9 ) {
a = n / 10;
n -= 10 * a;
uart_puti(a);
}
uart_putc('0'+n);
}
char isnumber ( unsigned char* buf, unsigned char index )
{
unsigned char scan;
if (!isdigit(buf[0]) && (buf[0] != 43) && (buf[0] != 45)){
return 0;
}
if (index > MAX_INTEGER_LENGTH){
return 0;
}
if ((index == 1) && ((buf[0] == 43) || (buf[0] == 45))){
return 0;
}
for (scan = index - 1; scan > 0 ;scan--)
{
if (!isdigit(buf[scan])) return 0;
}
return 1;
}
int parse(unsigned char * buffer, unsigned char index, unsigned char c) {
if (index > MAX_WORD_LENGTH) {
return -1;
}
if (c == ESCAPE_SEQ) {
return 1;
}
buffer[index] = c;
return 0;
}
void stack_push ( int v, char type )
{
/* if (si >= STACK_SIZE){ */
/* uart_puts("stack full. can't push.\r\n"); */
/* return; */
/* } */
stack[si++] = v;
types ^= (-type ^ types) & (1ULL << si);
}
int stack_pop ( char* type )
{
/* if (si == 0){ */
/* uart_puts("stack empty. can't pop.\r\n"); */
/* return 0; */
/* } */
*type = (types >> si) & 1ULL;
return stack[--si];
}
void handle_number ( unsigned char* buf, unsigned char index ) {
unsigned char i, neg;
int integer=0;
if (buf[0] == '-'){
i = 1;
neg = 1;
} else {
i = 0;
neg = 0;
}
for (; i < index ;i++)
{
integer = 10*integer - (buf[i] - '0');
}
if (!neg) {
integer = -integer;
}
stack_push(integer, 1);
}
void handle_symbol ( unsigned char* buf, unsigned char index ) {
char type, type2;
int v1, v2;
switch(buf[0]){
case '.':
uart_puti(stack_pop(&type));
uart_puts("\r\n");
break;
case '+':
v1 = stack_pop(&type);
stack_push(v1 + stack_pop(&type), 1);
break;
case '-':
v1 = stack_pop(&type);
stack_push(v1 - stack_pop(&type), 1);
break;
case '*':
v1 = stack_pop(&type);
stack_push(v1 * stack_pop(&type), 1);
break;
case '/':
if((v1 = stack_pop(&type)) == 0) {
uart_puts("can't divide by zero\r\n");
return;
}
stack_push(stack_pop(&type) / v1, 1);
break;
case 'd': /* dup */
v1 = stack_pop(&type);
stack_push(v1, type);
stack_push(v1, type);
break;
case 's': /* swap */
v1 = stack_pop(&type);
v2 = stack_pop(&type2);
stack_push(v1, type);
stack_push(v2, type2);
break;
}
}
void handle_word ( unsigned char* buf, unsigned char index )
{
if (isnumber(buf, index)) {
handle_number(buf, index);
} else {
handle_symbol(buf, index);
}
}
int notmain ( unsigned int earlypc )
{
unsigned int ra;
unsigned char word_index = 0;
/* unsigned char i; */
unsigned char word_buf[MAX_WORD_LENGTH];
PUT32(AUX_ENABLES,1);
PUT32(AUX_MU_IER_REG,0);
PUT32(AUX_MU_CNTL_REG,0);
PUT32(AUX_MU_LCR_REG,3);
PUT32(AUX_MU_MCR_REG,0);
PUT32(AUX_MU_IER_REG,0);
PUT32(AUX_MU_IIR_REG,0xC6);
PUT32(AUX_MU_BAUD_REG,270);
ra=GET32(GPFSEL1);
ra&=~(7<<12); //gpio14
ra|=2<<12; //alt5
ra&=~(7<<15); //gpio15
ra|=2<<15; //alt5
PUT32(GPFSEL1,ra);
PUT32(GPPUD,0);
for(ra=0;ra<150;ra++) dummy(ra);
PUT32(GPPUDCLK0,(1<<14)|(1<<15));
for(ra=0;ra<150;ra++) dummy(ra);
PUT32(GPPUDCLK0,0);
PUT32(AUX_MU_CNTL_REG,3);
uart_puts("Forth interpreter ready. Type words to list words.\r\n");
while(1)
{
while(1)
{
if(GET32(AUX_MU_LSR_REG)&0x01) break;
}
ra=GET32(AUX_MU_IO_REG);
uart_putc(ra);
switch (parse(word_buf, word_index, (unsigned char)ra)){
case 0:
/* uart_puts("PUT\r\n"); */
word_index++;
break;
case 1:
/* for (i = 0; i < word_index; i++) { */
/* uart_putc(word_buf[i]); */
/* } */
/* uart_puts("\r\n"); */
handle_word(word_buf, word_index);
word_index = 0;
break;
case -1:
uart_puts("Fatal. Resetting..\r\n");
break;
}
}
return(0);
}
|
the_stack_data/243892921.c | /*
* Simple brainfuck2c converter on pure C
* Coded by Ehsonjon (a.k.a iCoder)
* DATE: 23.07.2020 (18:03) Tajikistan Asia Time =D
* (C) 2020-2021 All rights reversed!
*/
#include <stdio.h>
#include <stdbool.h>
#include <string.h>
#include <stdlib.h>
#define STRING_SIZE 1024
typedef struct CommandOptions
{
bool doCompile;
bool deleteSource;
char * fileName;
char outFileName[STRING_SIZE];
char outFileC[STRING_SIZE];
} CommandOptions;
bool parse_command_line(CommandOptions * options, int argc, char * argv[])
{
//help message
if (argc == 1) {
fprintf(stderr, "\n");
fprintf(stderr, "How to use : %s filename [-o output|-c|-d|-r]\n",argv[0]);
fprintf(stderr, "-o output : Set output file name\n-c : Do not compile\n-d : Do not delete C source file\n");
fprintf(stderr, "[INFO] : You SHOULD type 'export MALLOC_CHECK_=0' manually to remove warning.\n");
fprintf(stderr, "\n");
return false;
}
// set the default options
options->doCompile = true;
options->deleteSource = true;
options->fileName = argv[1];
strncpy(options->outFileName, options->fileName, STRING_SIZE);
strncat(options->outFileName, ".o", STRING_SIZE);
// parse the remaining options
int i;
bool isSetOut = false;
for (i = 0; i < argc; i++)
{
if (isSetOut){
isSetOut = false;
strncpy(options->outFileName, argv[i], STRING_SIZE);
}
else if (strcmp(argv[i],"-c") == 0) {
options->doCompile = false;
}
else if (strcmp(argv[i],"-d") == 0) {
options->deleteSource = false;
}
else if (strcmp(argv[i],"-o") == 0) {
isSetOut = true;
}
}
strncpy(options->outFileC,options->outFileName,STRING_SIZE);
strncat(options->outFileC,".c", STRING_SIZE);
// don't delete the source if we won't compile it
if(!options->doCompile)
{
options->deleteSource = false;
}
return true;
}
void write_header(FILE * cFile)
{
fputs("#include <stdio.h>\n", cFile);
fputs("#include <stdlib.h>\n", cFile);
fputs("int main(){\n", cFile);
fputs("unsigned char* _=(unsigned char*)malloc(32*1024);/*32kB*/if(_==0){printf(\"MEMORY ERROR!\\n\");return 1;}\n",cFile);
}
void write_footer(FILE * cFile)
{
fputs("free(_);\nreturn 0;\n}\n", cFile);
}
int bf_fgetc(FILE * bfFile)
{
int c;
do {
c = fgetc(bfFile);
} while(c != EOF && c != '[' && c != ']' && c != '<' && c != '>' && c != '.'
&& c != ',' && c != '+' && c != '-');
return c;
}
void compile_to_c(FILE * bfFile, FILE * cFile)
{
write_header(cFile);
int add = 0;
char prevC = '\0';
//write codes
char c = bf_fgetc(bfFile);
do {
int movement_counter = 0;
while ( c == '>' || c == '<')
{
movement_counter += c == '>' ? 1 : -1;
c = bf_fgetc(bfFile);
}
if (movement_counter)
{
fprintf(cFile,"_ += %d;", movement_counter);
}
int value_counter = 0;
while ( c == '+' || c == '-')
{
value_counter += c == '+' ? 1 : -1;
c = bf_fgetc(bfFile);
}
if (value_counter)
{
fprintf(cFile,"*_ += %d;",value_counter);
}
if (c == '.')
{
fprintf(cFile, "putchar(*_);\n");
c = bf_fgetc(bfFile);
}
if (c == ',')
{
fprintf(cFile, "*_ = getchar();\n");
c = bf_fgetc(bfFile);
}
if (c == '[')
{
fprintf(cFile, "while(*_) {\n");
c = bf_fgetc(bfFile);
}
if (c == ']')
{
fprintf(cFile, "}\n");
c = bf_fgetc(bfFile);
}
} while(c!=EOF);
write_footer(cFile);
}
void compileCode(CommandOptions * options)
{
printf("Compile with GCC...\n");
char op[2048] = "gcc ";
strncat(op,options->outFileC, 2048);
strncat(op," -o ", 2048);
strncat(op,options->outFileName, 2048);
system(op);
}
int main(int argc, char* argv[]){
CommandOptions options;
if( !parse_command_line(&options, argc, argv) )
{
return 1;
}
printf("[INFO] : You may type 'export MALLOC_CHECK_=0' manually to remove warning.\n");
//bf file
FILE* bfFile = fopen(options.fileName,"r");
if(bfFile==NULL){
fprintf(stderr, "[ERROR] : FILE %s DOES NOT EXIST\n",options.fileName);
return 2;
}
//c source code
FILE* cFile = fopen(options.outFileC, "w");
if(!cFile)
{
fclose(bfFile);
fprintf(stderr, "[ERROR]: COULD NOT OPEN %s FILE FOR WRITING" , options.outFileC);
return 3;
}
compile_to_c(bfFile, cFile);
fclose(bfFile);
fclose(cFile);
if(options.doCompile){
compileCode(&options);
}else{
printf("Output C code : %s\n", options.outFileC);
}
if( options.deleteSource )
{
unlink(options.outFileC);
}
printf("Done.\nOutput file name : %s\n",options.outFileName);
return 0;
} |
the_stack_data/159516574.c | extern const unsigned char Pods_STSLibrary_TestsVersionString[];
extern const double Pods_STSLibrary_TestsVersionNumber;
const unsigned char Pods_STSLibrary_TestsVersionString[] __attribute__ ((used)) = "@(#)PROGRAM:Pods_STSLibrary_Tests PROJECT:Pods-1" "\n";
const double Pods_STSLibrary_TestsVersionNumber __attribute__ ((used)) = (double)1.;
|
the_stack_data/3262802.c | // reads data from "april.txt", and stores each column into an 1D array.
#include <stdio.h>
#include <stdlib.h>
int main(void)
{
int c = 12, r, i = 0, j;
int *arr1, *arr2, *arr3, *arr4;
float temp;
float *arr5, *arr6, *arr7, *arr8, *arr9, *arr10, *arr11, *arr12;
FILE *fp;
fp = fopen("april.txt", "r");
arr1 = (int *)(malloc(4330*sizeof(int)));
arr2 = (int *)(malloc(4330*sizeof(int)));
arr3 = (int *)(malloc(4330*sizeof(int)));
arr4 = (int *)(malloc(4330*sizeof(int)));
arr5 = (float *)(malloc(4330*sizeof(float)));
arr6 = (float *)(malloc(4330*sizeof(float)));
arr7 = (float *)(malloc(4330*sizeof(float)));
arr8 = (float *)(malloc(4330*sizeof(float)));
arr9 = (float *)(malloc(4330*sizeof(float)));
arr10 = (float *)(malloc(4330*sizeof(float)));
arr11 = (float *)(malloc(4330*sizeof(float)));
arr12 = (float *)(malloc(4330*sizeof(float)));
if (fp != NULL)
{
i = 0;
while (fscanf(fp, "%f", &temp) != EOF)
{
switch(i%c)
{
case 0: arr1[i/c] = (int)temp;
break;
case 1: arr2[i/c] = (int)temp;
break;
case 2: arr3[i/c] = (int)temp;
break;
case 3: arr4[i/c] = (int)temp;
break;
case 4: arr5[i/c] = temp;
break;
case 5: arr6[i/c] = temp;
break;
case 6: arr7[i/c] = temp;
break;
case 7: arr8[i/c] = temp;
break;
case 8: arr9[i/c] = temp;
break;
case 9: arr10[i/c] = temp;
break;
case 10: arr11[i/c] = temp;
break;
case 11: arr12[i/c] = temp;
break;
}
i++;
}
}
fclose(fp);
r = i/c;
return 0;
}
|
the_stack_data/118728.c | /*
* @Description: Sq-Queue(存在假溢出)
* @version: 1.0
* @Author: Chandler Lu
* @Date: 2019-08-11 23:44:40
* @LastEditTime: 2019-08-12 00:03:00
*/
#include <stdio.h>
#include <stdlib.h>
#define ERROR 0
#define TRUE 1
#define MAXSIZE 10
typedef struct SqQueue {
int data[MAXSIZE];
int front;
int rear;
} SqQueue;
int EnQueue(SqQueue *, int);
int DeQueue(SqQueue *, int *);
int main(int argc, char *argv[]) {
SqQueue *q = (SqQueue *)malloc(sizeof(SqQueue));
q->front = 0;
q->rear = 0;
int num = 0;
for (int i = 0; i < MAXSIZE; i++) {
EnQueue(q, i * 2);
}
for (int i = 0; i < MAXSIZE; i++) {
DeQueue(q, &num);
printf("%d", num);
if (i != MAXSIZE - 1) {
printf(" ");
}
}
free(q);
}
int EnQueue(SqQueue *q, int e) {
if (q->rear == MAXSIZE) {
return ERROR;
}
q->data[q->rear] = e;
q->rear++;
return TRUE;
}
int DeQueue(SqQueue *q, int *num) {
if (q->front == MAXSIZE) {
return ERROR;
}
*num = q->data[q->front];
q->front++;
return TRUE;
} |
the_stack_data/10299.c | #include <stdio.h>
#include <stdbool.h>
#include <stdint.h>
#include <stdlib.h>
#include <string.h>
#include <unistd.h>
#include <fcntl.h>
#include <sys/mman.h>
#include <sys/types.h>
#include <sys/stat.h>
#define DEBUG
#define ALIGN_UP(VAL, SIZE) (((VAL) + ((SIZE)-1)) & ~((SIZE)-1))
#define vhpi0 2 /* forcing 0 */
#define vhpi1 3 /* forcing 1 */
struct int_bounds
{
int left;
int right;
char dir;
unsigned int len;
};
struct fat_pointer
{
void *base;
struct int_bounds *bounds;
};
static char *from_string(void *__p)
{
struct fat_pointer *p = __p;
unsigned long len = p->bounds->len;
char *m;
m = malloc(len+1);
if (!m) {
perror("malloc");
exit(1);
}
memcpy(m, p->base, len);
m[len] = 0x0;
return m;
}
static uint64_t from_std_logic_vector(unsigned char *p, unsigned long len)
{
unsigned long ret = 0;
if (len > 64) {
fprintf(stderr, "%s: invalid length %lu\n", __func__, len);
exit(1);
}
for (unsigned long i = 0; i < len; i++) {
unsigned char bit;
if (*p == vhpi0) {
bit = 0;
} else if (*p == vhpi1) {
bit = 1;
} else {
fprintf(stderr, "%s: bad bit %d\n", __func__, *p);
bit = 0;
}
ret = (ret << 1) | bit;
p++;
}
return ret;
}
static void to_std_logic_vector(unsigned long val, unsigned char *p,
unsigned long len)
{
if (len > 64) {
fprintf(stderr, "%s: invalid length %lu\n", __func__, len);
exit(1);
}
for (unsigned long i = 0; i < len; i++) {
if ((val >> (len-1-i) & 1))
*p = vhpi1;
else
*p = vhpi0;
p++;
}
}
#define MAX_REGIONS 128
struct ram_behavioural {
char *filename;
unsigned long size;
void *m;
};
static struct ram_behavioural behavioural_regions[MAX_REGIONS];
static unsigned long region_nr;
unsigned long behavioural_initialize(void *__f, unsigned long size)
{
struct ram_behavioural *r;
int fd;
struct stat buf;
unsigned long tmp_size;
void *mem;
if (region_nr == MAX_REGIONS) {
fprintf(stderr, "%s: too many regions, bump MAX_REGIONS\n", __func__);
exit(1);
}
r = &behavioural_regions[region_nr];
r->filename = from_string(__f);
r->size = ALIGN_UP(size, getpagesize());
fd = open(r->filename, O_RDWR);
if (fd == -1) {
fprintf(stderr, "%s: could not open %s\n", __func__,
r->filename);
exit(1);
}
if (fstat(fd, &buf)) {
perror("fstat");
exit(1);
}
/* XXX Do we need to truncate the underlying file? */
tmp_size = ALIGN_UP(buf.st_size, getpagesize());
if (r->size > tmp_size) {
void *m;
/*
* We have to pad the file. Allocate the total size, then
* create a space for the file.
*/
mem = mmap(NULL, r->size, PROT_READ|PROT_WRITE,
MAP_PRIVATE|MAP_ANONYMOUS, -1, 0);
if (mem == MAP_FAILED) {
perror("mmap");
exit(1);
}
if (tmp_size) {
munmap(mem, tmp_size);
m = mmap(mem, tmp_size, PROT_READ|PROT_WRITE,
MAP_PRIVATE|MAP_FIXED, fd, 0);
if (m == MAP_FAILED) {
perror("mmap");
exit(1);
}
if (m != mem) {
fprintf(stderr, "%s: mmap(MAP_FIXED) failed\n",
__func__);
exit(1);
}
}
} else {
mem = mmap(NULL, tmp_size, PROT_READ|PROT_WRITE, MAP_PRIVATE,
fd, 0);
if (mem == MAP_FAILED) {
perror("mmap");
exit(1);
}
}
behavioural_regions[region_nr].m = mem;
return region_nr++;
}
void behavioural_read(unsigned char *__val, unsigned char *__addr,
unsigned long sel, int identifier)
{
struct ram_behavioural *r;
unsigned long val = 0;
unsigned long addr = from_std_logic_vector(__addr, 64);
unsigned char *p;
if (identifier > region_nr) {
fprintf(stderr, "%s: bad index %d\n", __func__, identifier);
exit(1);
}
r = &behavioural_regions[identifier];
for (unsigned long i = 0; i < 8; i++) {
#if 0
/* sel only used on writes */
if (!(sel & (1UL << i)))
continue;
#endif
if ((addr + i) > r->size) {
fprintf(stderr, "%s: bad memory access %lx %lx\n", __func__,
addr+i, r->size);
exit(1);
}
p = (unsigned char *)(((unsigned long)r->m) + addr + i);
val |= (((unsigned long)*p) << (i*8));
}
#ifdef DEBUG
printf("MEM behave %d read %016lx addr %016lx sel %02lx\n", identifier, val,
addr, sel);
#endif
to_std_logic_vector(val, __val, 64);
}
void behavioural_write(unsigned char *__val, unsigned char *__addr,
unsigned int sel, int identifier)
{
struct ram_behavioural *r;
unsigned long val = from_std_logic_vector(__val, 64);
unsigned long addr = from_std_logic_vector(__addr, 64);
unsigned char *p;
if (identifier > region_nr) {
fprintf(stderr, "%s: bad index %d\n", __func__, identifier);
exit(1);
}
r = &behavioural_regions[identifier];
p = (unsigned char *)(((unsigned long)r->m) + addr);
#ifdef DEBUG
printf("MEM behave %d write %016lx addr %016lx sel %02x\n", identifier, val,
addr, sel);
#endif
for (unsigned long i = 0; i < 8; i++) {
if (!(sel & (1UL << i)))
continue;
if ((addr + i) > r->size) {
fprintf(stderr, "%s: bad memory access %lx %lx\n", __func__,
addr+i, r->size);
exit(1);
}
p = (unsigned char *)(((unsigned long)r->m) + addr + i);
*p = (val >> (i*8)) & 0xff;
}
}
|
the_stack_data/97012692.c | #include"stdio.h"
#define N 5
void fun(int a[],int n)
{ int k, tmp;
for (k=0; k<n/2; k++)
{ tmp=a[k];
a[k]=a[n-k-1];
a[n-k-1]=tmp;
}
}
int main()
{ int x[N]={1,3,4,2,5},i;
fun(x,N);
for(i=0;i<N;i++)
printf("%d ",x[i]);
return 0;
}
|
the_stack_data/1140037.c | #include <stdio.h>
struct books
{
int code;
char name[30];
float value;
};
int main()
{
struct books product;
printf("Product Code: ");
fflush(stdin);
scanf("%i", &product.code);
printf("Name: ");
fflush(stdin);
gets(product.name);
printf("Value: ");
fflush(stdin);
scanf("%f", &product.value);
printf("\n\n---------------------------");
printf("\nProduct Registered\n");
printf("\nProduct Code: %i", product.code);
printf("\nProduct Name: %s", product.name);
printf("\nProduct Value: R$%.2f", product.value);
printf("\n---------------------------\n\n");
return 0;
} |
the_stack_data/153267513.c |
#include <stdio.h>
#include <signal.h>
#include <unistd.h>
#include <stdlib.h>
static void sig_fct1(int no);
int main(int argc, const char * argv[])
{
printf("Shot high speed camera: waiting for motion sensor\n");
if(signal(SIGUSR1, sig_fct1) == SIG_ERR)
{
printf("Cant catch SIGUSR1\n");
}
while (1)
pause();
return 0;
}
static void sig_fct1(int no)
{
printf("Module : Highspeed camera\n");
printf("Caught Signal\n");
exit(0);
}
|
the_stack_data/168892897.c | #include <stdio.h>
#define MAXN 31
int nqueens(int n)
{
int q0,q1;
int cols[MAXN], diagl[MAXN], diagr[MAXN], posibs[MAXN]; // Our backtracking 'stack'
int num=0;
//
// The top level is two fors, to save one bit of symmetry in the enumeration by forcing second queen to
// be AFTER the first queen.
//
for (q0=0; q0<n-2; q0++) {
for (q1=q0+2; q1<n; q1++){
int bit0 = 1<<q0;
int bit1 = 1<<q1;
int d=0; // d is our depth in the backtrack stack
cols[0] = bit0 | bit1 | (-1<<n); // The -1 here is used to fill all 'coloumn' bits after n ...
diagl[0]= (bit0<<1 | bit1)<<1;
diagr[0]= (bit0>>1 | bit1)>>1;
// The variable posib contains the bitmask of possibilities we still have to try in a given row ...
int posib = ~(cols[0] | diagl[0] | diagr[0]);
while (d >= 0) {
while(posib) {
int bit = posib & -posib; // The standard trick for getting the rightmost bit in the mask
int ncols= cols[d] | bit;
int ndiagl = (diagl[d] | bit) << 1;
int ndiagr = (diagr[d] | bit) >> 1;
int nposib = ~(ncols | ndiagl | ndiagr);
posib^=bit; // Eliminate the tried possibility.
// The following is the main additional trick here, as recognizing solution can not be done using stack level (d),
// since we save the depth+backtrack time at the end of the enumeration loop. However by noticing all coloumns are
// filled (comparison to -1) we know a solution was reached ...
// Notice also that avoiding an if on the ncols==-1 comparison is more efficient!
num += ncols==-1;
if (nposib) {
if (posib) { // This if saves stack depth + backtrack operations when we passed the last possibility in a row.
posibs[d++] = posib; // Go lower in stack ..
}
cols[d] = ncols;
diagl[d] = ndiagl;
diagr[d] = ndiagr;
posib = nposib;
}
}
posib = posibs[--d]; // backtrack ...
}
}
}
return num*2;
}
main(int ac , char **av)
{
if(ac != 2) {
printf("usage: nq n\n");
return 1;
}
int n = atoi(av[1]);
if(n<1 || n > MAXN) {
printf("n must be between 2 and 31!\n");
}
printf("Number of solution for %d is %d\n",n,nqueens(n));
}
|
the_stack_data/82951065.c |
#include <stdio.h>
#include <stdlib.h>
long long int commonarr[100005], b[100005];
void merge(long long int first, long long int last, long long int mid)
{
long long int p = first, q = mid + 1, r = first;
while (p <= mid && q <= last)
{
if (commonarr[p] <= commonarr[q])
{
b[r] = commonarr[p];
p = p + 1;
r = r + 1;
}
else
{
b[r] = commonarr[q];
q = q + 1;
r = r + 1;
}
}
while (p <= mid)
{
b[r] = commonarr[p];
r = r + 1;
p = p + 1;
}
while (q <= last)
{
b[r] = commonarr[q];
r = r + 1;
q = q + 1;
}
for (int i = first; i <= last; i++)
{
commonarr[i] = b[i];
}
}
void sort(long long int first, long long int last)
{
long long int mid;
if (first < last)
{
mid = (first + last) / 2;
sort(first, mid);
sort(mid + 1, last);
merge(first, last, mid);
}
else
{
return;
}
}
long long int BinarySearch(long long int n, long long int find, int num)
{
printf("%lld ", n);
long long int low = 0, high = n - 1;
long long int ans = -1;
while (low <= high)
{
long long int mid = low + (high - low) / 2;
if (find == commonarr[mid])
{
ans = mid;
if (num == 1)
{
high = mid - 1;
}
else
{
low = mid + 1;
}
}
if (find < commonarr[mid])
{
high = mid - 1;
}
else
{
low = mid + 1;
}
}
return ans;
}
long long int first_occurence(long long int low, long long int high, long long int x, long long int n)
{
if (high >= low)
{
long long int mid = low + (high - low) / 2;
if ((mid == 0 || x > commonarr[mid - 1]) && commonarr[mid] == x)
{
return mid;
}
else if (x > commonarr[mid])
{
return first_occurence((mid + 1), high, x, n);
}
else
{
return first_occurence(low, (mid - 1), x, n);
}
}
return -1;
}
long long int last_occurence(long long int low, long long int high, long long int x, long long int n)
{
if (high >= low)
{
long long int mid = low + (high - low) / 2;
if ((mid == n - 1 || x < commonarr[mid + 1]) && commonarr[mid] == x)
{
return mid;
}
else if (x < commonarr[mid])
{
return last_occurence(low, (mid - 1), x, n);
}
else
{
return last_occurence((mid + 1), high, x, n);
}
}
return -1;
}
int main()
{
long long int N, k;
scanf("%lld%lld", &N, &k);
long long int array[N + 5], unsorted[N + 5];
for (int i = 0; i < N; i++)
{
scanf("%lld", &array[i]);
}
long long int x, count = 0;
scanf("%lld", &x);
long long int prefix_sum = 0;
for (int i = 0; i < k; i++)
{
prefix_sum = prefix_sum + array[i];
}
commonarr[0] = 2 * k * (prefix_sum);
for (int i = 1; i < N - k + 1; i++)
{
commonarr[i] = commonarr[i - 1] + k * (array[k + i - 1] - array[i - 1]);
}
for (int i = 0; i < N - k + 1; i++)
{
unsorted[i] = commonarr[i];
}
long long int first = 0, last = N - k;
sort(first, last);
/*for (int i = 0; i < N - k + 1; i++)
{
printf("%lld ", commonarr[i]);
}*/
for (int i = 0; i < N - k + 1; i++)
{
long long int find = x - unsorted[i] + unsorted[0];
long long int fir, las;
long long int low = 0, high = N - k;
fir = first_occurence(low, high, find, N - k + 1);
las = last_occurence(low, high, find, N - k + 1);
/*for ( int i=0 ;i<N-k+1;i++){
if ( find == commonarr[i]){
count=count+1;
}
}*/
if (fir != -1)
{
count = count + las - fir + 1;
}
}
printf("%lld\n", count);
}
|
the_stack_data/67997.c | #include <stdlib.h>
int main() {
int arg1 = 0;
int not = 0;
__asm__("notl %%eax;" : "=a"(not) : "a"(arg1));
if (not != -1) {
abort();
}
return 0;
}
|
the_stack_data/173579140.c | #ifdef HAVE_CONFIG_H
# include "config.h"
#endif
#include <stdlib.h>
#include <signal.h>
#ifdef ASM_SIGRTMIN
# define RT_0 ASM_SIGRTMIN
#else
/* Linux kernel >= 3.18 defines SIGRTMIN to 32 on all architectures. */
# define RT_0 32
#endif
static void handler(int sig)
{
}
int main(void) {
sigset_t set;
sigemptyset(&set);
sigaddset(&set, SIGUSR2);
sigaddset(&set, SIGCHLD);
sigaddset(&set, RT_0 + 2);
sigaddset(&set, RT_0 + 3);
sigaddset(&set, RT_0 + 4);
sigaddset(&set, RT_0 + 26);
sigaddset(&set, RT_0 + 27);
sigprocmask(SIG_SETMASK, &set, NULL);
signal(SIGUSR1, handler);
raise(SIGUSR1);
return 0;
}
|
the_stack_data/184518696.c | #include <stdio.h>
#include <stdlib.h>
void foo(FILE *f) { fclose(f); }
int main(int argc, char **argv) {
int i;
FILE *f;
f = fopen(argv[1], "r");
foo(f);
while ((i = fgetc(f)) != EOF)
;
return 0;
} |
the_stack_data/9513865.c | #include<stdio.h>
int main()
{
int i,j,n,x;
while(1){
scanf("%d",&n);
if(n==0)break;
for(i=1;i<=n;i++){
for(j=1;j<=n;j++){
x = i;
if(j < x)x = j;
if(n-i+1 < x)x = n-i+1;
if(n-j+1 < x)x = n-j+1;
printf("%3d",x);
if(j < n)printf(" ");
else printf("\n");
}
}
printf("\n");
}
return 0;
} |
the_stack_data/28493.c | #include <stdio.h>
int main(void)
{
float a, b, c, area, perimeter;
scanf("%f %f %f", &a, &b, &c);
if( a < (b + c) && b < (a + c) && c < (b + a))
{
perimeter = a + b + c;
printf("Perimetro = %.1f\n", perimeter);
}
else
{
area = (a + b) * .5 * c;
printf("Area = %.1f\n", area);
}
return 0;
}
|
the_stack_data/107664.c | #include <stdio.h>
int main(void) {
int a, l;
scanf("%d %d", &a, &l);
printf("%d", a * (l - 1) + 1);
return 0;
}
|
the_stack_data/120122.c | #include <stdio.h>
#include <stdlib.h>
int main()
{
printf("INIT\n");
const char* UNEXISTENT_ENVVAR = getenv("UNEXISTENT_ENVVAR");
printf("UNEXISTENT_ENVVAR = %s\n",(UNEXISTENT_ENVVAR!=NULL)? UNEXISTENT_ENVVAR : "[NULL]");
printf("Setting UNEXISTENT_ENVVAR=PUTENV (via putenv)\n");
putenv("UNEXISTENT_ENVVAR=PUTENV");
UNEXISTENT_ENVVAR = getenv("UNEXISTENT_ENVVAR");
printf("UNEXISTENT_ENVVAR = %s\n",(UNEXISTENT_ENVVAR!=NULL)? UNEXISTENT_ENVVAR : "[NULL]");
printf("Setting UNEXISTENT_ENVVAR=SETENV (via setenv, overwrite)\n");
setenv("UNEXISTENT_ENVVAR", "SETENV", 1);
UNEXISTENT_ENVVAR = getenv("UNEXISTENT_ENVVAR");
printf("UNEXISTENT_ENVVAR = %s\n",(UNEXISTENT_ENVVAR!=NULL)? UNEXISTENT_ENVVAR : "[NULL]");
printf("Setting UNEXISTENT_ENVVAR=SETENV_NEW (via setenv, NO overwrite)\n");
setenv("UNEXISTENT_ENVVAR", "SETENV_NEW", 0);
UNEXISTENT_ENVVAR = getenv("UNEXISTENT_ENVVAR");
printf("UNEXISTENT_ENVVAR = %s\n",(UNEXISTENT_ENVVAR!=NULL)? UNEXISTENT_ENVVAR : "[NULL]");
printf("Unsetting UNEXISTENT_ENVVAR\n");
unsetenv("UNEXISTENT_ENVVAR");
UNEXISTENT_ENVVAR = getenv("UNEXISTENT_ENVVAR");
printf("UNEXISTENT_ENVVAR = %s\n",(UNEXISTENT_ENVVAR!=NULL)? UNEXISTENT_ENVVAR : "[NULL]");
printf("END\n");
}
|
the_stack_data/955841.c | /* Using if statmes, relational operators, and equality operators */
#include <stdio.h>
int main()
{
int num1, num2;
printf("Enter two integers, and I will tell you the relationships ");
printf("they satisfty: ");
scanf("%d%d", &num1, &num2);
if (num1 == num2)
printf("%d is equal to %d\n", num1, num2);
if (num1 != num2)
printf("%d is not equal to %d\n", num1, num2);
if (num1 < num2)
printf("%d is less than %d\n", num1, num2);
if (num1 > num2)
printf("%d is greater than %d\n", num1, num2);
if (num1 <= num2)
printf("%d is less than or equal to %d\n", num1, num2);
if (num1 >= num2)
printf("%d is greater than or equal to %d\n", num1, num2);
return 0;
}
|
the_stack_data/25138409.c | /*Exercise 2 - Selection
Write a program to calculate the amount to be paid for a rented vehicle.
• Input the distance the van has travelled
• The first 30 km is at a rate of 50/= per km.
• The remaining distance is calculated at the rate of 40/= per km.
e.g.
Distance -> 20
Amount = 20 x 50 = 1000
Distance -> 50
Amount = 30 x 50 + (50-30) x 40 = 2300*/
#include <stdio.h>
int main() {
float distance, cost;
printf("Enter distance: ");
scanf("%f", &distance);
if(distance <= 30)
cost = 50 * distance;
else
cost = 30 * 50 + (distance - 30) * 40;
printf("Amount: %.2f\n", cost);
return 0;
}
|
Subsets and Splits
No community queries yet
The top public SQL queries from the community will appear here once available.