file
stringlengths 18
26
| data
stringlengths 3
1.04M
|
---|---|
the_stack_data/93887745.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)
*/
/* > \brief \b DLAQSB scales a symmetric/Hermitian band matrix, using scaling factors computed by spbequ. */
/* =========== DOCUMENTATION =========== */
/* Online html documentation available at */
/* http://www.netlib.org/lapack/explore-html/ */
/* > \htmlonly */
/* > Download DLAQSB + dependencies */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/dlaqsb.
f"> */
/* > [TGZ]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/dlaqsb.
f"> */
/* > [ZIP]</a> */
/* > <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/dlaqsb.
f"> */
/* > [TXT]</a> */
/* > \endhtmlonly */
/* Definition: */
/* =========== */
/* SUBROUTINE DLAQSB( UPLO, N, KD, AB, LDAB, S, SCOND, AMAX, EQUED ) */
/* CHARACTER EQUED, UPLO */
/* INTEGER KD, LDAB, N */
/* DOUBLE PRECISION AMAX, SCOND */
/* DOUBLE PRECISION AB( LDAB, * ), S( * ) */
/* > \par Purpose: */
/* ============= */
/* > */
/* > \verbatim */
/* > */
/* > DLAQSB equilibrates a symmetric band matrix A using the scaling */
/* > factors in the vector S. */
/* > \endverbatim */
/* Arguments: */
/* ========== */
/* > \param[in] UPLO */
/* > \verbatim */
/* > UPLO is CHARACTER*1 */
/* > Specifies whether the upper or lower triangular part of the */
/* > symmetric matrix A is stored. */
/* > = 'U': Upper triangular */
/* > = 'L': Lower triangular */
/* > \endverbatim */
/* > */
/* > \param[in] N */
/* > \verbatim */
/* > N is INTEGER */
/* > The order of the matrix A. N >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in] KD */
/* > \verbatim */
/* > KD is INTEGER */
/* > The number of super-diagonals of the matrix A if UPLO = 'U', */
/* > or the number of sub-diagonals if UPLO = 'L'. KD >= 0. */
/* > \endverbatim */
/* > */
/* > \param[in,out] AB */
/* > \verbatim */
/* > AB is DOUBLE PRECISION array, dimension (LDAB,N) */
/* > On entry, the upper or lower triangle of the symmetric band */
/* > matrix A, stored in the first KD+1 rows of the array. The */
/* > j-th column of A is stored in the j-th column of the array AB */
/* > as follows: */
/* > if UPLO = 'U', AB(kd+1+i-j,j) = A(i,j) for f2cmax(1,j-kd)<=i<=j; */
/* > if UPLO = 'L', AB(1+i-j,j) = A(i,j) for j<=i<=f2cmin(n,j+kd). */
/* > */
/* > On exit, if INFO = 0, the triangular factor U or L from the */
/* > Cholesky factorization A = U**T*U or A = L*L**T of the band */
/* > matrix A, in the same storage format as A. */
/* > \endverbatim */
/* > */
/* > \param[in] LDAB */
/* > \verbatim */
/* > LDAB is INTEGER */
/* > The leading dimension of the array AB. LDAB >= KD+1. */
/* > \endverbatim */
/* > */
/* > \param[in] S */
/* > \verbatim */
/* > S is DOUBLE PRECISION array, dimension (N) */
/* > The scale factors for A. */
/* > \endverbatim */
/* > */
/* > \param[in] SCOND */
/* > \verbatim */
/* > SCOND is DOUBLE PRECISION */
/* > Ratio of the smallest S(i) to the largest S(i). */
/* > \endverbatim */
/* > */
/* > \param[in] AMAX */
/* > \verbatim */
/* > AMAX is DOUBLE PRECISION */
/* > Absolute value of largest matrix entry. */
/* > \endverbatim */
/* > */
/* > \param[out] EQUED */
/* > \verbatim */
/* > EQUED is CHARACTER*1 */
/* > Specifies whether or not equilibration was done. */
/* > = 'N': No equilibration. */
/* > = 'Y': Equilibration was done, i.e., A has been replaced by */
/* > diag(S) * A * diag(S). */
/* > \endverbatim */
/* > \par Internal Parameters: */
/* ========================= */
/* > */
/* > \verbatim */
/* > THRESH is a threshold value used to decide if scaling should be done */
/* > based on the ratio of the scaling factors. If SCOND < THRESH, */
/* > scaling is done. */
/* > */
/* > LARGE and SMALL are threshold values used to decide if scaling should */
/* > be done based on the absolute size of the largest matrix element. */
/* > If AMAX > LARGE or AMAX < SMALL, scaling is done. */
/* > \endverbatim */
/* Authors: */
/* ======== */
/* > \author Univ. of Tennessee */
/* > \author Univ. of California Berkeley */
/* > \author Univ. of Colorado Denver */
/* > \author NAG Ltd. */
/* > \date December 2016 */
/* > \ingroup doubleOTHERauxiliary */
/* ===================================================================== */
/* Subroutine */ int dlaqsb_(char *uplo, integer *n, integer *kd, doublereal *
ab, integer *ldab, doublereal *s, doublereal *scond, doublereal *amax,
char *equed)
{
/* System generated locals */
integer ab_dim1, ab_offset, i__1, i__2, i__3, i__4;
/* Local variables */
integer i__, j;
doublereal large;
extern logical lsame_(char *, char *);
doublereal small, cj;
extern doublereal dlamch_(char *);
/* -- LAPACK auxiliary 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 */
/* ===================================================================== */
/* Quick return if possible */
/* Parameter adjustments */
ab_dim1 = *ldab;
ab_offset = 1 + ab_dim1 * 1;
ab -= ab_offset;
--s;
/* Function Body */
if (*n <= 0) {
*(unsigned char *)equed = 'N';
return 0;
}
/* Initialize LARGE and SMALL. */
small = dlamch_("Safe minimum") / dlamch_("Precision");
large = 1. / small;
if (*scond >= .1 && *amax >= small && *amax <= large) {
/* No equilibration */
*(unsigned char *)equed = 'N';
} else {
/* Replace A by diag(S) * A * diag(S). */
if (lsame_(uplo, "U")) {
/* Upper triangle of A is stored in band format. */
i__1 = *n;
for (j = 1; j <= i__1; ++j) {
cj = s[j];
/* Computing MAX */
i__2 = 1, i__3 = j - *kd;
i__4 = j;
for (i__ = f2cmax(i__2,i__3); i__ <= i__4; ++i__) {
ab[*kd + 1 + i__ - j + j * ab_dim1] = cj * s[i__] * ab[*
kd + 1 + i__ - j + j * ab_dim1];
/* L10: */
}
/* L20: */
}
} else {
/* Lower triangle of A is stored. */
i__1 = *n;
for (j = 1; j <= i__1; ++j) {
cj = s[j];
/* Computing MIN */
i__2 = *n, i__3 = j + *kd;
i__4 = f2cmin(i__2,i__3);
for (i__ = j; i__ <= i__4; ++i__) {
ab[i__ + 1 - j + j * ab_dim1] = cj * s[i__] * ab[i__ + 1
- j + j * ab_dim1];
/* L30: */
}
/* L40: */
}
}
*(unsigned char *)equed = 'Y';
}
return 0;
/* End of DLAQSB */
} /* dlaqsb_ */
|
the_stack_data/1240246.c | #include <stdio.h>
#include <math.h>
#include <stdlib.h> // musím vložiť túto knižnicu kvoli použitiu systemového príkazu system(príkaz)
// program, kt zapíše zoznam čisel od -5 po 10 + odpovedajúce hodnoty na obr.
int main() //vypise zoznam cisel s ich hodnotami
{
FILE *f = NULL; // premenná typu FILE slúži k identifikácii súboru (f=názov mojej funkcie)
int i = 0;
f = fopen("./U4.txt", "w"); // otvorenie funkcie. názov+cesta k súboru
// W = režim, kt. vytvorý nový súbor a otvorí ho pre zápis
if (f == NULL) // kontrola
{
printf("Neda sa otvorit!\n");
return 1;
}
fprintf(f, "Zoznam cisel a ich hodnoty\n"); // zápis do funkcie, prvý parameter musí byť názov funkcie
fprintf(f, "i, i*i, i*i*i, exp(i), sin(i), cos(i)\n"); // "ku konkrétnemu zadaniu"
fprintf(f, "--------------------------------------------------\n");
for (i = -5; i <= 10; i++)
{
fprintf(f, "%- 5i %5i %+8i %10.3f %- f %-+1.4f\n", i, i * i, i * i * i, exp(i), sin(i), cos(i));
// FORMATOVANIE VÝSTUPU
// %[príznaky][šírka][.presnost][modifikátor]konverzia]
//Celé číslo, min. 5 zn., zarov. dolava, kladná č. na začiatku s medzerou = %- 5i
//Celé číslo, min.5 znakov, zarov.doprava = %5i
//Celé číslo, min.8 znakov, tiskne vždy znamienko + alebo - = %+8i
//Desatinné číslo, min.10 znakov, 3 desatinné miesta, zarov.doprava = %10.3f
//Desatinné číslo, zarov.dolava, kladné č.na začiatku s medzerou = %- f
//Desatinné číslo, 4 desetinné miesta, zarov.dolava, tiskne vždy + alebo - Stlpce su naviac vždy oddelene jednou medzerou= %-+1.4f
}
system("code U4.txt"); // vyvolanie príkazu systému, kt. je interpretovaný shell systemom/príkaz sa zapisuje rovnako akoby sme ho písali do terminalu
return 0;
} |
the_stack_data/18886580.c | #include <stdio.h>
#define MAXLINE 1000
int main(int argc, char *argv[])
{
FILE *fp;
char *filename, *line;
char content[MAXLINE];
int i, count;
i = 1;
count = 0;
while (i < argc)
{
filename = argv[i];
if ((fp = fopen(filename, "r")) != NULL)
{
++count;
printf("page %d: filename: %s\n", count, filename);
while ((line = fgets(content, MAXLINE, fp)) != NULL)
{
fputs(line, stdout);
}
}
++i;
}
fclose(fp);
return 0;
}
|
the_stack_data/58147.c | /*
================================================================================
Name : 1067.c
Author : Abrantes Araújo Silva Filho
: [email protected]
: https://www.abrantes.pro.br
Description : URI Online Judge: Problems & Contests
: https://www.urionlinejudge.com.br/
Category : Beginner (1)
Problem : 1067: Odd Numbers
URL : https://www.urionlinejudge.com.br/judge/en/problems/view/1067
Summary :
C Standard : C99
Version :
Copyright :
More Info :
================================================================================
*/
/* Headers files includes:
--------------------------
#include <header_file.h>
Important headers: stdio.h, stdlib.h, ctype.h, math.h, string.h, time.h
*/
#include <stdio.h>
/* Preprocessor macros/definitions:
-----------------------------------
#define <name> <value>
#define <name> (arg1, arg2, arg3, ...) (<commands>)
Conditional preprocessor macros: ("gcc -D<name>=<value>" sets a preprocessor define)
#if, #ifdel, #ifndef, #else, #elif #endif
Other preprocessor macros:
#pragma, #error, #warning, #undef
*/
#define rSucesso 0
/* Global variables declarations:
---------------------------------
<type> <name> = <value>;
<type> <name>, <name>, <name> = <value>, <name> = <value>;
<type> <name>;
<name> = <value>;
char, int, float
const
char -> 'a'
string -> "abrantes" (armazena como array de char; null-terminated: '\0')
special characters -> \ ' " \b \t \r \n \ooo \xhh
*/
/* Functions prototypes (declarations):
---------------------------------------
<return_type> <function_name> (<type> arg1, <type> arg2, ...) {}
<return_type> <function_name> (void) {}
*/
/* Main function:
-----------------
<return_type> main (void) {}
<return_type> main (int argc, char **argv) {}
*/
int main(void)
{
// Declara variáveis
int x = 0;
// Pega input:
scanf("%d", &x);
// Imprime:
for (int i = 1; i <= x; i++)
{
if (i % 2 != 0)
printf("%d\n", i);
}
// Retorna:
return rSucesso;
}
/* Functions definitions:
-------------------------
*/
|
the_stack_data/215769438.c | #include <stdio.h>
#include <stdlib.h>
/*
Faça um programa que o usuario insira 3 valores a, b,c verifique se eles podem formar um triangulo. SE caso positivo, o programa tambem deve dizer se o triangulo é equilatero, isosceles ou escaleno.
*/
int main(int argc, char const *argv[])
{
float a,b,c;
printf("\nDigite o 1o. valor: ");
scanf("%f", &a);
printf("Digite o 2o. valor: ");
scanf("%f", &b);
printf("Digite o 3o. valor: ");
scanf("%f", &c);
if( (a + b) > c && (a + c) > b && (c + b) > a){
printf("\n\nO triangulo pode EXISTIR");
}if( a == b && a == c && b == c){
printf("\nTriangulo Equilatero");
}
else if(a == b || a == c || b == c){
printf("\nTriangulo Isoceles");
}
else if(a != b && a != c && b != c){
printf("\nTriangulo Escaleno");
}
else {
printf("\n\nO triangulo NAO PODE EXISTIR");
}
return 0;
}
|
the_stack_data/125141317.c | // Copyright 2015 Jerome Rasky <[email protected]>
//
// 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 expressed or implied. See the
// License for the specific language concerning governing permissions and
// limitations under the License.
#include <termios.h>
#include <unistd.h>
#include <string.h>
#include <sys/ioctl.h>
struct bis_error_info_t {
char *error_str;
char is_errno;
};
struct bis_term_size_t {
unsigned short rows;
unsigned short cols;
};
static char bis_term_info_set = 0;
static struct termios bis_term_info;
struct bis_error_info_t bis_error_info = {
.error_str = (char *) 0,
.is_errno = 0
};
int bis_prepare_terminal() {
struct termios terminfo_p;
// get terminal options
if (tcgetattr(STDOUT_FILENO, &terminfo_p) != 0) {
bis_error_info.error_str = "Error getting terminal attributes";
bis_error_info.is_errno = 1;
return -1;
}
// copy to the global object
memcpy(&bis_term_info, &terminfo_p, sizeof(struct termios));
// update the info variable
bis_term_info_set = 1;
// disable signal delivery
terminfo_p.c_lflag &= ~ISIG;
// disable canonical mode
terminfo_p.c_lflag &= ~ICANON;
// disable echo
terminfo_p.c_lflag &= ~ECHO;
// set terminal options
if (tcsetattr(STDOUT_FILENO, TCSAFLUSH, &terminfo_p) != 0) {
bis_error_info.error_str = "Error setting terminal attributes";
bis_error_info.is_errno = 1;
return -1;
}
// return success
return 0;
}
int bis_restore_terminal() {
if (bis_term_info_set != 1) {
bis_error_info.error_str = "bis_restore_terminal called before bis_prepare_terminal";
bis_error_info.is_errno = 0;
return -1;
}
// set terminal options
if (tcsetattr(STDOUT_FILENO, TCSANOW, &bis_term_info) != 0) {
bis_error_info.error_str = "Error restoring terminal attributes";
bis_error_info.is_errno = 1;
return -1;
}
// return success
return 0;
}
int bis_get_terminal_size(struct bis_term_size_t *size) {
struct winsize term_size;
// request the terminal size
if (ioctl(STDOUT_FILENO, TIOCGWINSZ, &term_size) != 0) {
bis_error_info.error_str = "ioctl call failed";
bis_error_info.is_errno = 1;
return -1;
}
// put the info into size
size->rows = term_size.ws_row;
size->cols = term_size.ws_col;
// return success
return 0;
}
|
the_stack_data/243894473.c | #include <stdio.h>
#include <stdlib.h>
#include <locale.h>
#include <math.h>
int main()
{
setlocale(LC_ALL, "");
//OBS: No caso de não estar utilizando o setlocale no local fda virgula deve-se usar o ponto
int n1 = 10, n2 = 23, sum = n1 + n2, sub = n1 -n2, mul = n1 * n2, div = n1 /n2 , mod = n1 % n2;
printf("A operação de Soma é realizada através do operador +. Exemplo: %d+%d=%d\n", n1,n2, sum);
printf("A operação de Subtração é realizada através do operador -. Exemplo: %d-%d=%d\n", n1,n2, sub);
printf("A operação de Multiplicação é realizada através do operador *. Exemplo: %d*%d=%d\n", n1,n2, mul);
printf("A operação de Divisão é realizada através do operador /. Exemplo: %d/%d=%d\n", n1,n2, div);
//printf("A operação de Módulo é realizada através do operador '%'. Exemplo: %d %d = %d\n", n1,n2, mod);
} |
the_stack_data/790200.c | #include <stdio.h>
#include <stdlib.h>
// пирамидальная сортировка
// для подсчета сравнений и перестановок
int k = 0, comp = 0;
void siftDown (int *arr, int root, int bottom)
{
int maxChild;
int done = 0;
k++;
while ((root * 2 <= bottom) && (!done))
{
k++;
if (root * 2 == bottom)
maxChild = root * 2;
else if (arr[root * 2] > arr[root * 2 + 1])
maxChild = root * 2;
else
maxChild = root * 2 + 1;
k++;
if (arr[root] < arr[maxChild])
{
int temp = arr[root];
arr[root] = arr[maxChild];
arr[maxChild] = temp;
root = maxChild;
comp++;
}
else
done = 1;
k++;
}
}
int sorting_function (int *arr, int len)
{
for (int i = (len / 2) - 1; i >= 0; i--)
siftDown (arr, i, len - 1);
for (int i = len - 1; i >= 1; i--)
{
int temp = arr[0];
arr[0] = arr[i];
arr[i] = temp;
comp++;
siftDown (arr, 0, i - 1);
}
return 0;
}
int main ()
{
int n, i, a;
int *arr = NULL;
scanf ("%d", &n);
// (n * sizeof(int) - сколько байт необходимо выделить
// sizeof(int) - размер одного элемента массива
arr = (int*) malloc (n * sizeof(int));
for (i = 0; i < n; i++)
{
scanf("%d", &a);
arr[i] = a;
}
sorting_function (arr, n);
for (i = 0; i < n; i++)
{
printf("%d", arr[i]);
if (i != n-1)
{
printf (" ");
}
}
printf("\n");
return 0;
}
|
the_stack_data/18887608.c | #include <stdio.h>
int main(){
int n, max = 0, min = 10001;
scanf("%d", &n);
while(n--){
int data;
scanf("%d", &data);
if(data > max)max = data;
if(data < min)min = data;
}
printf("%d %d", max, min);
}
|
the_stack_data/75137657.c | // PARAM: --set ana.activated[+] deadlock
#include <pthread.h>
#include <stdio.h>
int g1, g2;
pthread_mutex_t mutex1 = PTHREAD_MUTEX_INITIALIZER;
pthread_mutex_t mutex2 = PTHREAD_MUTEX_INITIALIZER;
void *t1(void *arg) {
pthread_mutex_lock(&mutex1);
pthread_mutex_lock(&mutex2); // NODEADLOCK
g1 = g2 + 1;
pthread_mutex_unlock(&mutex2);
pthread_mutex_unlock(&mutex1);
return NULL;
}
void *t2(void *arg) {
pthread_mutex_lock(&mutex1);
pthread_mutex_lock(&mutex2); // NODEADLOCK
g2 = g1 + 1;
pthread_mutex_unlock(&mutex2);
pthread_mutex_unlock(&mutex1);
return NULL;
}
int main(void) {
pthread_t id1, id2;
int i;
for (i = 0; i < 10000; i++) {
pthread_create(&id1, NULL, t1, NULL);
pthread_create(&id2, NULL, t2, NULL);
pthread_join (id1, NULL);
pthread_join (id2, NULL);
printf("%d: g1 = %d, g2 = %d.\n", i, g1, g2);
}
return 0;
}
|
the_stack_data/32656.c | /*
* FreeRTOS Kernel V10.4.1
* Copyright (C) 2020 Amazon.com, Inc. or its affiliates. All Rights Reserved.
*
* Permission is hereby granted, free of charge, to any person obtaining a copy of
* this software and associated documentation files (the "Software"), to deal in
* the Software without restriction, including without limitation the rights to
* use, copy, modify, merge, publish, distribute, sublicense, and/or sell copies of
* the Software, and to permit persons to whom the Software is furnished to do so,
* subject to the following conditions:
*
* The above copyright notice and this permission notice shall be included in all
* copies or substantial portions of the Software.
*
* THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR
* IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS
* FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR
* COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER
* IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN
* CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE.
*
* http://www.FreeRTOS.org
* http://aws.amazon.com/freertos
*
* 1 tab == 4 spaces!
*/
#include <stdint.h>
extern uint32_t Image$$ER_IROM_FREERTOS_SYSTEM_CALLS$$Base;
extern uint32_t Image$$ER_IROM_FREERTOS_SYSTEM_CALLS$$Limit;
/* Memory map needed for MPU setup. Must must match the one defined in
* the scatter-loading file (MPUDemo.sct). */
const uint32_t * __FLASH_segment_start__ = ( uint32_t * ) 0x08000000;
const uint32_t * __FLASH_segment_end__ = ( uint32_t * ) 0x08100000;
const uint32_t * __SRAM_segment_start__ = ( uint32_t * ) 0x20000000;
const uint32_t * __SRAM_segment_end__ = ( uint32_t * ) 0x20018000;
const uint32_t * __privileged_functions_start__ = ( uint32_t * ) 0x08000000;
const uint32_t * __privileged_functions_end__ = ( uint32_t * ) 0x08008000;
const uint32_t * __privileged_data_start__ = ( uint32_t * ) 0x20000000;
const uint32_t * __privileged_data_end__ = ( uint32_t * ) 0x20000400;
const uint32_t * __syscalls_flash_start__ = ( uint32_t * ) &( Image$$ER_IROM_FREERTOS_SYSTEM_CALLS$$Base );
const uint32_t * __syscalls_flash_end__ = ( uint32_t * ) &( Image$$ER_IROM_FREERTOS_SYSTEM_CALLS$$Limit );
/*-----------------------------------------------------------*/
/**
* @brief Mem fault handler.
*/
void MemManage_Handler( void ) __attribute__ (( naked ));
/*-----------------------------------------------------------*/
void MemManage_Handler( void )
{
__asm volatile
(
" tst lr, #4 \n"
" ite eq \n"
" mrseq r0, msp \n"
" mrsne r0, psp \n"
" ldr r1, handler_address_const \n"
" bx r1 \n"
" \n"
" handler_address_const: .word vHandleMemoryFault \n"
);
}
/*-----------------------------------------------------------*/
|
the_stack_data/15110.c | #include <stdio.h>
#include <stdlib.h>
//
// 4 files .. same fields but with different packing
// returns smaller of indiv fields
//
// fixed 3/4/2010 - used realloc rather than malloc, use big buffers
// 1/2010 added fflush
// 2/2011 added 4 files
#define SIZE 4096*4
unsigned long int uint8(unsigned char *p);
int main(int argc, char **argv) {
FILE *out, *in1, *in2, *in3, *in4;
unsigned char *buffer1, *buffer2, *buffer3, *buffer4;
int size1, size2, size3, size4;
int i, k, count, smallest, size[5];
if (argc != 6) {
fprintf(stderr,"bad arg: output in-1 in-2 in-3 in-4\n");
fprintf(stderr," selects smallest grib message: 1 of 4\n");
fprintf(stderr," for optimal grib compression\n");
exit(8);
}
if ((out = fopen(argv[1],"wb")) == NULL) {
fprintf(stderr,"bad arg: output=%s\n",argv[1]);
exit(8);
}
if ((in1 = fopen(argv[2],"rb")) == NULL) {
fprintf(stderr,"bad arg: in-1=%s\n",argv[2]);
exit(8);
}
if ((in2 = fopen(argv[3],"rb")) == NULL) {
fprintf(stderr,"bad arg: in-2=%s\n",argv[3]);
exit(8);
}
if ((in3 = fopen(argv[4],"rb")) == NULL) {
fprintf(stderr,"bad arg: in-3=%s\n",argv[4]);
exit(8);
}
if ((in4 = fopen(argv[5],"rb")) == NULL) {
fprintf(stderr,"bad arg: in-4=%s\n",argv[5]);
exit(8);
}
buffer1 = malloc(SIZE);
buffer2 = malloc(SIZE);
buffer3 = malloc(SIZE);
buffer4 = malloc(SIZE);
if (buffer1 == NULL || buffer2 == NULL || buffer3 == NULL || buffer4 == NULL ) {
fprintf(stderr,"not enough memory\n");
exit(8);
}
size1 = size2 = size3 = size4 = SIZE;
count = 0;
while (1 == 1) {
// read message1
i = fread(buffer1, 1, 16, in1);
if (i != 16) break;
if (buffer1[0] != 'G' || buffer1[1] != 'R' || buffer1[2] != 'I' ||
buffer1[3] != 'B') exit(1);
size[1] = uint8(&(buffer1[8]));
if (size1 < size[1]) {
size1 = size[1];
buffer1 = realloc(buffer1, size1);
if (buffer1 == NULL) { fprintf(stderr,"not enough memory\n"); exit(8); }
}
k = fread(buffer1+16,1,size[1]-16,in1);
if (k != size[1]-16) exit(4);
// read message2
i = fread(buffer2, 1, 16, in2);
if (i != 16) break;
if (buffer2[0] != 'G' || buffer2[1] != 'R' || buffer2[2] != 'I' ||
buffer2[3] != 'B') exit(1);
size[2] = uint8(&(buffer2[8]));
if (size2 < size[2]) {
size2 = size[2];
buffer2 = realloc(buffer2, size2);
if (buffer2 == NULL) { fprintf(stderr,"not enough memory\n"); exit(8); }
}
k = fread(buffer2+16,1,size[2]-16,in2);
if (k != size[2]-16) exit(4);
// read message3
i = fread(buffer3, 1, 16, in3);
if (i != 16) break;
if (buffer3[0] != 'G' || buffer3[1] != 'R' || buffer3[2] != 'I' ||
buffer3[3] != 'B') exit(1);
size[3] = uint8(&(buffer3[8]));
if (size3 < size[3]) {
size3 = size[3];
buffer3 = realloc(buffer3, size3);
if (buffer3 == NULL) { fprintf(stderr,"not enough memory\n"); exit(8); }
}
k = fread(buffer3+16,1,size[3]-16,in3);
if (k != size[3]-16) exit(4);
// read message4
i = fread(buffer4, 1, 16, in4);
if (i != 16) break;
if (buffer4[0] != 'G' || buffer4[1] != 'R' || buffer4[2] != 'I' ||
buffer4[3] != 'B') exit(1);
size[4] = uint8(&(buffer4[8]));
if (size4 < size[4]) {
size4 = size[4];
buffer4 = realloc(buffer4, size4);
if (buffer4 == NULL) { fprintf(stderr,"not enough memory\n"); exit(8); }
}
k = fread(buffer4+16,1,size[4]-16,in4);
if (k != size[4]-16) exit(4);
smallest = 1;
if (size[2] < size[smallest]) smallest = 2;
if (size[3] < size[smallest]) smallest = 3;
if (size[4] < size[smallest]) smallest = 4;
printf("code=%d n1 %d n2 %d n3 %d n4 %d\n", smallest, size[1], size[2], size[3], size[4]);
if (smallest == 1) fwrite(buffer1,1,size[1],out);
if (smallest == 2) fwrite(buffer2,1,size[2],out);
if (smallest == 3) fwrite(buffer3,1,size[3],out);
if (smallest == 4) fwrite(buffer4,1,size[4],out);
fflush(out);
count++;
}
printf("records = %d\n", count);
return 0;
}
|
the_stack_data/193893990.c |
/* Checks if type is 'c'/string , 'i'/integer or 'f'/float and if the length
is compatible with the given type */
int checkTypeLength( char type, int length ){
switch( type ){
case 'i':
case 'f':
if ( length != 4 ){
return -1; /* incompatible length */
}
break;
case 'c':
if ( length < 1 || length > 255 ){
return -1; /* incompatible length */
}
break;
default : /* invalid type */
return -1;
}
return 1;
}
/* Check if min <= number <= max */
int checkNumberLimits( int number, int min, int max ){
if( (number >= min) && (number <= max) ){
return 1;
}
else{
return -1;
}
}
|
the_stack_data/29825846.c | /*
* Copyright (C) 2014 Hamburg University of Applied Sciences
* 2014 PHYTEC Messtechnik GmbH
* 2015 Eistec AB
* 2016 Freie Universität Berlin
*
* This file is subject to the terms and conditions of the GNU Lesser
* General Public License v2.1. See the file LICENSE in the top level
* directory for more details.
*/
/**
* @brief SPI bus scaler computation
*
* This helper tool calculates the needed SPI scaler values for a given APB bus
* clock speed. The result of the computation must be placed in a board's
* periph_conf.h for quick reference by the SPI drivers.
*
* @author Peter Kietzmann <[email protected]>
* @author Johann Fischer <[email protected]>
* @author Joakim Nohlgård <[email protected]>
* @author Hauke Petersen <[email protected]>
*
* @}
*/
#include <stdint.h>
#include <stdio.h>
#include <stdlib.h>
/**
* @brief Targeted SPI bus speed values (pre-defined by RIOT)
*/
static uint32_t targets[] = { 100000, 400000, 1000000, 5000000, 10000000 };
/**
* @brief Helper function for finding optimal baud rate scalers.
*
* Find the prescaler and scaler settings that will yield a clock frequency
* as close as possible (but not above) the target frequency, given the module
* runs at module_clock Hz.
*
* Hardware properties (Baud rate configuration):
* Possible prescalers: 2, 3, 5, 7
* Possible scalers: 2, 4, 6 (sic!), 8, 16, 32, 64, 128, 256, 512, 1024, 2048, 4096, 8192, 16384, 32768
*
* SCK baud rate = (f_BUS/PBR) x [(1+DBR)/BR]
*
* where PBR is the prescaler, BR is the scaler, DBR is the Double BaudRate bit.
*
* @note We are not using the DBR bit because it may affect the SCK duty cycle.
*
* @param module_clock Module clock frequency (e.g. F_BUS)
* @param target_clock Desired baud rate
* @param closest_prescaler pointer where to write the optimal prescaler index.
* @param closest_scaler pointer where to write the optimal scaler index.
*
* @return The actual achieved frequency on success
* @return Less than 0 on error.
*/
static long find_closest_baudrate_scalers(const uint32_t module_clock, const long target_clock,
uint8_t *closest_prescaler, uint8_t *closest_scaler)
{
uint8_t i;
uint8_t k;
long freq;
static const uint8_t num_scalers = 16;
static const uint8_t num_prescalers = 4;
static const int br_scalers[16] = {
2, 4, 6, 8, 16, 32, 64, 128,
256, 512, 1024, 2048, 4096, 8192, 16384, 32768
};
static const int br_prescalers[4] = {2, 3, 5, 7};
long closest_frequency = -1;
/* Test all combinations until we arrive close to the target clock */
for (i = 0; i < num_prescalers; ++i) {
for (k = 0; k < num_scalers; ++k) {
freq = module_clock / (br_scalers[k] * br_prescalers[i]);
if (freq <= target_clock) {
/* Found closest lower frequency at this prescaler setting,
* compare to the best result */
if (closest_frequency < freq) {
closest_frequency = freq;
*closest_scaler = k;
*closest_prescaler = i;
}
break;
}
}
}
if (closest_frequency < 0) {
/* Error, no solution found, this line is never reachable with current
* hardware settings unless a _very_ low target clock is requested.
* (scaler_max * prescaler_max) = 229376 => target_min@100MHz = 435 Hz*/
return -1;
}
return closest_frequency;
}
/**
* @brief Helper function for finding optimal delay scalers.
*
* Find the prescaler and scaler settings that will yield a delay timing
* as close as possible (but not shorter than) the target delay, given the
* module runs at module_clock Hz.
*
* Hardware properties (delay configuration):
* Possible prescalers: 1, 3, 5, 7
* Possible scalers: 2, 4, 8, 16, 32, 64, 128, 256, 512, 1024, 2048, 4096, 8192, 16384, 32768, 65536
*
* delay = (1/f_BUS) x prescaler x scaler
*
* Because we want to do this using only integers, the target_freq parameter is
* the reciprocal of the delay time.
*
* @param module_clock Module clock frequency (e.g. F_BUS)
* @param target_freq Reciprocal (i.e. 1/t [Hz], frequency) of the desired delay time.
* @param closest_prescaler pointer where to write the optimal prescaler index.
* @param closest_scaler pointer where to write the optimal scaler index.
*
* @return The actual achieved frequency on success
* @return Less than 0 on error.
*/
static long find_closest_delay_scalers(const uint32_t module_clock, const long target_freq,
uint8_t *closest_prescaler, uint8_t *closest_scaler)
{
uint8_t i;
uint8_t k;
long freq;
int prescaler;
int scaler;
static const uint8_t num_scalers = 16;
static const uint8_t num_prescalers = 4;
long closest_frequency = -1;
/* Test all combinations until we arrive close to the target clock */
for (i = 0; i < num_prescalers; ++i) {
for (k = 0; k < num_scalers; ++k) {
prescaler = (i * 2) + 1;
scaler = (1 << (k + 1)); /* 2^(k+1) */
freq = module_clock / (prescaler * scaler);
if (freq <= target_freq) {
/* Found closest lower frequency at this prescaler setting,
* compare to the best result */
if (closest_frequency < freq) {
closest_frequency = freq;
*closest_scaler = k;
*closest_prescaler = i;
}
break;
}
}
}
if (closest_frequency < 0) {
/* Error, no solution found, this line is never reachable with current
* hardware settings unless a _very_ low target clock is requested.
* (scaler_max * prescaler_max) = 458752 */
return -1;
}
return closest_frequency;
}
int main(int argc, char **argv)
{
uint32_t modclk;
int i;
if (argc != 2) {
printf("usage: %s <module clock>\n", argv[0]);
return 1;
}
modclk = atoi(argv[1]);
if (modclk == 0) {
printf("error: invalid input value\n");
return 1;
}
printf("\nCalculating SPI clock scalers for a module clock of: %iHz\n\n",
(int)modclk);
puts("static const uint32_t spi_clk_config[] = {");
for (i = 0; i < ARRAY_SIZE(targets); i++) {
uint8_t tmp, ptmp;
long res;
/* bus clock */
res = find_closest_baudrate_scalers(modclk, targets[i], &ptmp, &tmp);
if (res < 0) {
puts("error: no applicable bus clock scalers could be found!");
return 1;
}
puts(" (");
printf(" SPI_CTAR_PBR(%i) | SPI_CTAR_BR(%i) | /* -> %iHz */\n",
(int)ptmp, (int)tmp, (int)res);
/* t_csc: chip select to fist clock signal delay */
if (find_closest_delay_scalers(modclk, targets[i], &ptmp, &tmp) < 0) {
puts("error: no applicable delay values for t_csc found\n");
return 1;
}
printf(" SPI_CTAR_PCSSCK(%i) | SPI_CTAR_CSSCK(%i) |\n", (int)ptmp, (int)tmp);
/* t_asc: delay after last clock signal to release of chip select */
if (find_closest_delay_scalers(modclk, targets[i], &ptmp, &tmp) < 0) {
puts("error: no applicable delay values for t_asc found\n");
return 1;
}
printf(" SPI_CTAR_PASC(%i) | SPI_CTAR_ASC(%i) |\n", (int)ptmp, (int)tmp);
/* t_psc: delay between release and next assertion of chip select */
if (find_closest_delay_scalers(modclk, targets[i], &ptmp, &tmp) < 0) {
puts("error: no applicable delay values for t_csc found\n");
return 1;
}
printf(" SPI_CTAR_PDT(%i) | SPI_CTAR_DT(%i)\n", (int)ptmp, (int)tmp);
if (i == ARRAY_SIZE(targets) - 1) {
puts(" )");
}
else {
puts(" ),");
}
}
puts("};");
return 0;
}
|
the_stack_data/14298.c | /*Programmer Chase Singhofen
Date 9/28/2016
Specifications: Convert Fahrenheit to Celcius
*/
#include<stdio.h>
#include<stdlib.h>
main()
{
float celsius, fahrenheit;
// Reads temperature in Fahrenheit from user
printf("Enter temperature in Fahrenheit: ");
scanf_s("%f", &fahrenheit);
// Converts fahrenheit to celsius
celsius = (fahrenheit - 32) * 5 / 9;
printf("\n%.2f Fahrenheit = %.2f Celsius", fahrenheit, celsius);
system("pause");
} |
the_stack_data/1053287.c | //
// main.c
// Exercise 4
//
// Created by Zhehao Li on 2020/2/12.
// Copyright © 2020 Zhehao Li. All rights reserved.
//
#include <stdio.h>
#include <math.h>
void printnumber(int n);
int main(int argc, const char * argv[]) {
int n = -342383102;
printnumber(n);
return 0;
}
void printnumber(int n){
if (n < 0) {
putchar('-');
n = - n;
}
if (n / 10 != 0)
printnumber(n / 10); // recursive
putchar((n % 10) + '0');
}
|
the_stack_data/63996.c | #include <stdio.h>
#include <stdlib.h>
#include <string.h>
/*Este programa abre um arquivo, lê todas as palavras do texto ordenando as mesmas e realiza uma busca indicando a quantidade de aparições da palavra e as três palavras seguintes na ordem*/
#define DEBUG 0
typedef struct texto TEXTO;
struct texto{
char **palavras;
int n;
};
/* função le_palavra: le uma palavra no texto do arquivo;
* @Parâmetros:
* - um ponteiro para arquivo de leitura;
*
* @retorno:
* - uma string com a palavra lida;
* */
char *le_palavra(FILE *fp){
char c;
char *palavra = (char *) malloc(20 * sizeof(char));
c = fgetc(fp);
/*conferir se há caractere especial no começo:*/
int ascii = (int)c;
/*while(c == ' ' || c == ',' || c == '.' || c == ';' || c == '\'' || c == '?' || c == ':' || c == '/' || c == '!' || c == '*'|| c == '"'){
c = fgetc(fp);
ascii = (int)c;
}*/
/*ideia = usar ASCII*/
while((ascii < 65 || (ascii > 90 && ascii < 97) || ascii > 122) && ascii != 45){
c = fgetc(fp);
ascii = (int)c;
}
int i=0;
/*agora confere o final da palavra(ocorrencia de um desses caracteres especias)*/
/*while(c != ' ' && c != ',' && c != '.' && c != ';' && c != '\'' && c != '?' && c != ':' && c != '/' && c != '!' && c != '*' && c != '"'){
if(ascii <= 90){
c = (char)(ascii + 32);
}
palavra[i++] = c;
c = fgetc(fp);
ascii = (int)c;
}*/
while((ascii >= 65 && ascii <= 90) || (ascii >= 97 && ascii <= 122) || ascii == 45){
if(ascii <= 90 && ascii != 45){
c = (char)(ascii + 32);
}
//printf("%c\n", c);
palavra[i++] = c;
c = fgetc(fp);
ascii = (int)c;
}
/*acho que não precisa dar fseek*/
//fseek(fp, -1L, SEEK_CUR);
palavra[i] = '\0'; // fim da string;
//printf("%s\n", palavra);
return palavra;
}
/* função texto_scanner: le todas as palavras de um arquivo;
* @Parâmetros:
* - um ponteiro para arquivo de leitura;
*
* @retorno:
* - um vetor de strings com todas as palavras lidas;
* */
TEXTO *texto_scanner(FILE *fp){
TEXTO *text = (TEXTO*) malloc(sizeof(TEXTO));
//char **leitura = NULL;
text->palavras = NULL;
text->n = 0;
char c;
/*enquanto não estiver no fim do arquivo, lê as palavras e armazena no vetor de strings(char **)...*/
while((c = fgetc(fp))!= EOF){
fseek(fp, -1L, SEEK_CUR);
(text->palavras) = (char **) realloc((text->palavras), ++(text->n) * sizeof(char *)); // O ERRO TÁ AQUI...
//(text->palavras)[(text->n)-1] = (char *) malloc(20 * sizeof(char));
(text->palavras)[(text->n)-1] = le_palavra(fp);/*tem que liberar da heap depois*/
}
//printf("leu todo o texto na função\n");
return text;
}
/* função ordena_palavras: utiliza o algoritmo de 'insertion sort' para ordenar um vetor de strings(usando strcmp(ordem lexicográfica));
* @Parâmetros:
* - um vetor de strings;
* - um inteiro que representa a quantidade de palavras;
*
* @retorno:
* - uma string com a palavra lida;
* */
void ordena_palavras(char **vet, int n){
int i=0, j;
char chave[20];
while(i < n){
/*chave = vet[i]*/
strcpy(chave, vet[i]);
j = i - 1;
while(j >= 0 && strcmp(chave, vet[j]) < 0){
strcpy(vet[j+1] , vet[j]);
j--;
}
strcpy(vet[j+1], chave);
i++;
}
}
int irmaos(char **vet, char *string, int pos, int *depois){
int i = 0;
int pos_or = pos;
char *original = vet[pos];
while(strcmp(original, vet[pos]) == 0){
i++; //depois tem que fazer i-1
pos++;
(*depois)++;
}
while(strcmp(original, vet[pos_or]) == 0){
i++; //depois tem que fazer i-1
pos_or--;
}
//i-2
if(DEBUG){
printf("irmaos deu certo\n");
}
return (i-1);
}
int busca_binaria(char **vet, char *string, int ini, int fim){
int centro = (int)((ini+fim)/2);
if(DEBUG){
printf("%d\n", centro);
printf("%s\n", vet[centro]);
printf("%s\n", string);
printf("str = %d\n", strcmp(vet[centro], string));
}
if(strcmp(vet[centro], string) == 0) return centro;
else{
if(strcmp(vet[centro], string) > 0){
return busca_binaria(vet, string, ini, centro-1);
}
else{
return busca_binaria(vet, string, centro+1, fim);
}
}
}
void resposta_final(char **vet, char *string, int n){
int pos = busca_binaria(vet, string, 0, n);
int depois = 0;
if(DEBUG){
printf("deu certo bb\n");
}
int qtd = irmaos(vet, string, pos, &depois);
printf("%s %d %s %s %s\n", string, qtd, vet[pos+(depois)], vet[pos+(depois+1)], vet[pos+(depois+2)]);
}
int main(int argc, char *argv[]){
/*abertura do arquivo com a leitura do nome*/
char nome[100];
int i;
scanf("%s", nome);
//printf("%s", nome);
FILE *fp;
if((fp = fopen(nome, "r+")) == NULL){
printf("erro ao abrir arquivo de leitura\n");
return 1;
}
//if(DEBUG) printf("abriu o arquivo\n");
/*processo de leitura de todas as palavras do texto para ordená-las posteriormente*/
TEXTO *text;
text = texto_scanner(fp); /* retorna TEXTO* */
if(DEBUG){
printf("leu todo o texto e guardou na struct\n");
}
/*hora de ordenar o vetor de palavras:*/
ordena_palavras(text->palavras, text->n);
/*for(i=0; i<(text->n); i++){
printf("%s\n", (text->palavras)[i]);
}*/
/*leitura das palavras procuradas(CHAVES)*/
int N;
scanf("%d", &N);
//printf("enezao = %d\n", N);
char *chaves[N];
for(i=0; i<N; i++){
/*fgets(chaves[i], 20, stdin);
chaves[i][strlen(chaves[i]) - 1] = '\0';*/
chaves[i] = le_palavra(stdin);
resposta_final(text->palavras ,chaves[i], text->n);
if(DEBUG){
printf("respondeu, finalmente\n");
}
//printf("%s\n", chaves[i]);
free(chaves[i]);
}
/*liberação de memória e de arquivo de leitura*/
free(text->palavras);
for(i=0; i<(text->n); i++) free((text->palavras)[i]);
free(text);
fclose(fp);
return 0;
}
|
the_stack_data/232955545.c | #include<stdio.h>
#include<string.h>
int func(const char *s, int n)
{
int i, j;
int count = 0;
for(i=0; i<n; i++)
{
for(j=0; s[i-j]==s[i+j]; j++)
{
count++;
}
for(j=0; s[i-j]==s[i+j+1]; j++)
{
count++;
}
}
return count;
}
int main()
{
int n;
char s[5000 + 2] = {1};
while(EOF != scanf("%s", s + 1))
{
n = strlen(s + 1);
n = func(s + 1, n);
printf("%d\n", n);
}
return 0;
}
|
the_stack_data/92326141.c | //
// Created by 吴超 on 2020/8/1.
//
#include <stdlib.h>
#include <string.h>
#include <stdio.h>
char base64code[65] = {
'A', 'B', 'C', 'D', 'E', 'F', 'G', 'H', 'I', 'J', 'K', 'L', 'M', 'N', 'O', 'P', 'Q', 'R', 'S', 'T',
'U', 'V', 'W', 'X', 'Y', 'Z', 'a', 'b', 'c', 'd', 'e', 'f', 'g', 'h', 'i', 'j', 'k', 'l', 'm', 'n',
'o', 'p', 'q', 'r', 's', 't', 'u', 'v', 'w', 'x', 'y', 'z', '0', '1', '2', '3', '4', '5', '6', '7',
'8', '9', '+', '/', '='
};
char* base64encode(char* source,char* code);
char* base64encode(char* source,char* code){
size_t length = strlen(source);
if(length<=0) return source;
int resultLen = (length/3)*4+(length%3==0?0:1)*4;
char* result = malloc(sizeof(char)*resultLen);
int k = 0;
for(int i = 0;i<length;i=i+3){
if(length - i<=2){
if(length - i == 1){
result[k]=code[source[i]>>2];
unsigned int s = source[i];
result[k+1] = code[s<<30>>26];
result[k+2] = code[64];
result[k+3] = code[64];
} else if(length - i == 2){
unsigned int word2 = (source[i]<<8) + source[i+1];
result[k] = code[word2>>10];
result[k+1] = code[word2<<22>>26];
result[k+2] = code[word2<<28>>26];
result[k+3] = code[64];
}
k = k+4;
} else {
unsigned int word3 = (source[i]<<16)+(source[i+1]<<8)+source[i+2];
int j=0;
while(j<4){
unsigned int word = word3<<(8+j*6);
unsigned int index = word>>26;
char a = code[index];
result[k] = a;
j++;
k++;
}
}
}
return result;
}
int main() {
char* test = "ManManBC";
printf("Base64:%s",base64encode(test,base64code));
}
|
the_stack_data/231394475.c | // RUN: %clang -target armv6-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX %s
// CHECK-VERSION-OSX: "armv6k-apple-macosx10.5.0"
// RUN: %clang -target armv6-apple-darwin9 -miphoneos-version-min=2.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS2 %s
// CHECK-VERSION-IOS2: "armv6k-apple-ios2.0.0"
// RUN: %clang -target armv6-apple-darwin9 -miphoneos-version-min=2.2 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS22 %s
// CHECK-VERSION-IOS22: "armv6k-apple-ios2.2.0"
// RUN: %clang -target armv6-apple-darwin9 -miphoneos-version-min=3.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS3 %s
// CHECK-VERSION-IOS3: "armv6k-apple-ios3.0.0"
// RUN: env IPHONEOS_DEPLOYMENT_TARGET=11.0 \
// RUN: %clang -target armv7-apple-ios9.0 -c -### %s 2> %t.err
// RUN: FileCheck --input-file=%t.err --check-prefix=CHECK-VERSION-IOS4 %s
// CHECK-VERSION-IOS4: invalid iOS deployment version 'IPHONEOS_DEPLOYMENT_TARGET=11.0'
// RUN: %clang -target armv7-apple-ios9.0 -miphoneos-version-min=11.0 -c -### %s 2> %t.err
// RUN: FileCheck --input-file=%t.err --check-prefix=CHECK-VERSION-IOS5 %s
// CHECK-VERSION-IOS5: invalid iOS deployment version '-miphoneos-version-min=11.0'
// RUN: %clang -target i386-apple-darwin -mios-simulator-version-min=11.0 -c -### %s 2> %t.err
// RUN: FileCheck --input-file=%t.err --check-prefix=CHECK-VERSION-IOS6 %s
// CHECK-VERSION-IOS6: invalid iOS deployment version '-mios-simulator-version-min=11.0'
// RUN: %clang -target armv7-apple-ios11.1 -c -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS7 %s
// RUN: %clang -target armv7-apple-ios9 -Wno-missing-sysroot -isysroot SDKs/iPhoneOS11.0.sdk -c -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS7 %s
// CHECK-VERSION-IOS7: thumbv7-apple-ios10.99.99
// RUN: env IPHONEOS_DEPLOYMENT_TARGET=11.0 \
// RUN: %clang -target arm64-apple-ios11.0 -c -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS8 %s
// CHECK-VERSION-IOS8: arm64-apple-ios11.0.0
// RUN: %clang -target arm64-apple-ios11.0 -miphoneos-version-min=11.0 -c -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS9 %s
// CHECK-VERSION-IOS9: arm64-apple-ios11.0.0
// RUN: %clang -target x86_64-apple-darwin -mios-simulator-version-min=11.0 -c -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS10 %s
// CHECK-VERSION-IOS10: x86_64-apple-ios11.0.0
// RUN: %clang -target arm64-apple-ios11.1 -c -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS11 %s
// CHECK-VERSION-IOS11: arm64-apple-ios11.1.0
// RUN: %clang -target armv7-apple-ios9.0 -miphoneos-version-min=11.0 -c -Wno-invalid-ios-deployment-target -### %s 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS12 %s
// CHECK-VERSION-IOS12: thumbv7-apple-ios11.0.0
// RUN: %clang -target i686-apple-darwin8 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX4 %s
// RUN: %clang -target i686-apple-darwin9 -mmacosx-version-min=10.4 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX4 %s
// CHECK-VERSION-OSX4: "i386-apple-macosx10.4.0"
// RUN: %clang -target i686-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX5 %s
// RUN: %clang -target i686-apple-darwin9 -mmacosx-version-min=10.5 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX5 %s
// CHECK-VERSION-OSX5: "i386-apple-macosx10.5.0"
// RUN: %clang -target i686-apple-darwin10 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX6 %s
// RUN: %clang -target i686-apple-darwin9 -mmacosx-version-min=10.6 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX6 %s
// CHECK-VERSION-OSX6: "i386-apple-macosx10.6.0"
// RUN: %clang -target x86_64-apple-darwin14 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX10 %s
// RUN: %clang -target x86_64-apple-macosx -mmacosx-version-min=10.10 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX10 %s
// RUN: %clang -target x86_64-apple-macosx -mmacos-version-min=10.10 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX10 %s
// CHECK-VERSION-OSX10: "x86_64-apple-macosx10.10.0"
// RUN: %clang -target x86_64-apple-macosx -mmacosx-version-min= -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-MISSING %s
// RUN: %clang -target x86_64-apple-macosx -mmacos-version-min= -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-MISSING %s
// CHECK-VERSION-MISSING: invalid version number
// RUN: %clang -target armv7k-apple-darwin -mwatchos-version-min=2.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-WATCHOS20 %s
// RUN: %clang -target armv7-apple-darwin -mtvos-version-min=8.3 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-TVOS83 %s
// CHECK-VERSION-TVOS83: "thumbv7-apple-tvos8.3.0"
// RUN: %clang -target i386-apple-darwin -mtvos-simulator-version-min=8.3 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-TVSIM83 %s
// CHECK-VERSION-TVSIM83: "i386-apple-tvos8.3.0"
// RUN: %clang -target armv7k-apple-darwin -mwatchos-version-min=2.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-WATCHOS20 %s
// CHECK-VERSION-WATCHOS20: "thumbv7k-apple-watchos2.0.0"
// RUN: %clang -target i386-apple-darwin -mwatchos-simulator-version-min=2.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-WATCHSIM20 %s
// CHECK-VERSION-WATCHSIM20: "i386-apple-watchos2.0.0"
// Check environment variable gets interpreted correctly
// RUN: env MACOSX_DEPLOYMENT_TARGET=10.5 IPHONEOS_DEPLOYMENT_TARGET=2.0 \
// RUN: %clang -target i386-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX5 %s
// RUN: env MACOSX_DEPLOYMENT_TARGET=10.5 IPHONEOS_DEPLOYMENT_TARGET=2.0 \
// RUN: %clang -target armv6-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS2 %s
// RUN: env MACOSX_DEPLOYMENT_TARGET=10.4.10 \
// RUN: %clang -target i386-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-OSX49 %s
// CHECK-VERSION-OSX49: "i386-apple-macosx10.4.10"
// RUN: env IPHONEOS_DEPLOYMENT_TARGET=2.3.1 \
// RUN: %clang -target armv6-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS231 %s
// CHECK-VERSION-IOS231: "armv6k-apple-ios2.3.1"
// RUN: env MACOSX_DEPLOYMENT_TARGET=10.5 TVOS_DEPLOYMENT_TARGET=8.3.1 \
// RUN: %clang -target armv7-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-TVOS %s
// CHECK-VERSION-TVOS: "thumbv7-apple-tvos8.3.1"
// RUN: env TVOS_DEPLOYMENT_TARGET=8.3.1 \
// RUN: %clang -target i386-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-TVOSSIM %s
// CHECK-VERSION-TVOSSIM: "i386-apple-tvos8.3.1"
// RUN: env MACOSX_DEPLOYMENT_TARGET=10.5 WATCHOS_DEPLOYMENT_TARGET=2.0 \
// RUN: %clang -target armv7-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-WATCHOS %s
// CHECK-VERSION-WATCHOS: "thumbv7-apple-watchos2.0.0"
// RUN: env WATCHOS_DEPLOYMENT_TARGET=2.0 \
// RUN: %clang -target i386-apple-darwin9 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-WATCHOSSIM %s
// CHECK-VERSION-WATCHOSSIM: "i386-apple-watchos2.0.0"
// RUN: %clang -target x86_64-apple-ios11.0.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-IOS-TARGET %s
// CHECK-VERSION-IOS-TARGET: "x86_64-apple-ios11.0.0"
// RUN: %clang -target x86_64-apple-tvos11.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-TVOS-TARGET %s
// CHECK-VERSION-TVOS-TARGET: "x86_64-apple-tvos11.0.0"
// RUN: %clang -target x86_64-apple-watchos4.0 -c %s -### 2>&1 | \
// RUN: FileCheck --check-prefix=CHECK-VERSION-WATCHOS-TARGET %s
// CHECK-VERSION-WATCHOS-TARGET: "x86_64-apple-watchos4.0.0"
|
the_stack_data/50136930.c | /*
* System V IPC - message system call stub.
*/
#include <sys/errno.h>
int
umsgsys ()
{
set_user_error (ENOSYS);
}
|
the_stack_data/1094087.c | /*-
* COPYRIGHT (C) 1986 Gary S. Brown. You may use this program, or
* code or tables extracted from it, as desired without restriction.
*
* First, the polynomial itself and its table of feedback terms. The
* polynomial is
* X^32+X^26+X^23+X^22+X^16+X^12+X^11+X^10+X^8+X^7+X^5+X^4+X^2+X^1+X^0
*
* Note that we take it "backwards" and put the highest-order term in
* the lowest-order bit. The X^32 term is "implied"; the LSB is the
* X^31 term, etc. The X^0 term (usually shown as "+1") results in
* the MSB being 1
*
* Note that the usual hardware shift register implementation, which
* is what we're using (we're merely optimizing it by doing eight-bit
* chunks at a time) shifts bits into the lowest-order term. In our
* implementation, that means shifting towards the right. Why do we
* do it this way? Because the calculated CRC must be transmitted in
* order from highest-order term to lowest-order term. UARTs transmit
* characters in order from LSB to MSB. By storing the CRC this way
* we hand it to the UART in the order low-byte to high-byte; the UART
* sends each low-bit to hight-bit; and the result is transmission bit
* by bit from highest- to lowest-order term without requiring any bit
* shuffling on our part. Reception works similarly
*
* The feedback terms table consists of 256, 32-bit entries. Notes
*
* The table can be generated at runtime if desired; code to do so
* is shown later. It might not be obvious, but the feedback
* terms simply represent the results of eight shift/xor opera
* tions for all combinations of data and CRC register values
*
* The values must be right-shifted by eight bits by the "updcrc
* logic; the shift must be unsigned (bring in zeroes). On some
* hardware you could probably optimize the shift in assembler by
* using byte-swap instructions
* polynomial $edb88320
*
*
* CRC32 code derived from work by Gary S. Brown.
*/
#include <stdint.h>
#include <stddef.h>
static uint32_t crc32_tab[] = {
0x00000000, 0x77073096, 0xee0e612c, 0x990951ba, 0x076dc419, 0x706af48f,
0xe963a535, 0x9e6495a3, 0x0edb8832, 0x79dcb8a4, 0xe0d5e91e, 0x97d2d988,
0x09b64c2b, 0x7eb17cbd, 0xe7b82d07, 0x90bf1d91, 0x1db71064, 0x6ab020f2,
0xf3b97148, 0x84be41de, 0x1adad47d, 0x6ddde4eb, 0xf4d4b551, 0x83d385c7,
0x136c9856, 0x646ba8c0, 0xfd62f97a, 0x8a65c9ec, 0x14015c4f, 0x63066cd9,
0xfa0f3d63, 0x8d080df5, 0x3b6e20c8, 0x4c69105e, 0xd56041e4, 0xa2677172,
0x3c03e4d1, 0x4b04d447, 0xd20d85fd, 0xa50ab56b, 0x35b5a8fa, 0x42b2986c,
0xdbbbc9d6, 0xacbcf940, 0x32d86ce3, 0x45df5c75, 0xdcd60dcf, 0xabd13d59,
0x26d930ac, 0x51de003a, 0xc8d75180, 0xbfd06116, 0x21b4f4b5, 0x56b3c423,
0xcfba9599, 0xb8bda50f, 0x2802b89e, 0x5f058808, 0xc60cd9b2, 0xb10be924,
0x2f6f7c87, 0x58684c11, 0xc1611dab, 0xb6662d3d, 0x76dc4190, 0x01db7106,
0x98d220bc, 0xefd5102a, 0x71b18589, 0x06b6b51f, 0x9fbfe4a5, 0xe8b8d433,
0x7807c9a2, 0x0f00f934, 0x9609a88e, 0xe10e9818, 0x7f6a0dbb, 0x086d3d2d,
0x91646c97, 0xe6635c01, 0x6b6b51f4, 0x1c6c6162, 0x856530d8, 0xf262004e,
0x6c0695ed, 0x1b01a57b, 0x8208f4c1, 0xf50fc457, 0x65b0d9c6, 0x12b7e950,
0x8bbeb8ea, 0xfcb9887c, 0x62dd1ddf, 0x15da2d49, 0x8cd37cf3, 0xfbd44c65,
0x4db26158, 0x3ab551ce, 0xa3bc0074, 0xd4bb30e2, 0x4adfa541, 0x3dd895d7,
0xa4d1c46d, 0xd3d6f4fb, 0x4369e96a, 0x346ed9fc, 0xad678846, 0xda60b8d0,
0x44042d73, 0x33031de5, 0xaa0a4c5f, 0xdd0d7cc9, 0x5005713c, 0x270241aa,
0xbe0b1010, 0xc90c2086, 0x5768b525, 0x206f85b3, 0xb966d409, 0xce61e49f,
0x5edef90e, 0x29d9c998, 0xb0d09822, 0xc7d7a8b4, 0x59b33d17, 0x2eb40d81,
0xb7bd5c3b, 0xc0ba6cad, 0xedb88320, 0x9abfb3b6, 0x03b6e20c, 0x74b1d29a,
0xead54739, 0x9dd277af, 0x04db2615, 0x73dc1683, 0xe3630b12, 0x94643b84,
0x0d6d6a3e, 0x7a6a5aa8, 0xe40ecf0b, 0x9309ff9d, 0x0a00ae27, 0x7d079eb1,
0xf00f9344, 0x8708a3d2, 0x1e01f268, 0x6906c2fe, 0xf762575d, 0x806567cb,
0x196c3671, 0x6e6b06e7, 0xfed41b76, 0x89d32be0, 0x10da7a5a, 0x67dd4acc,
0xf9b9df6f, 0x8ebeeff9, 0x17b7be43, 0x60b08ed5, 0xd6d6a3e8, 0xa1d1937e,
0x38d8c2c4, 0x4fdff252, 0xd1bb67f1, 0xa6bc5767, 0x3fb506dd, 0x48b2364b,
0xd80d2bda, 0xaf0a1b4c, 0x36034af6, 0x41047a60, 0xdf60efc3, 0xa867df55,
0x316e8eef, 0x4669be79, 0xcb61b38c, 0xbc66831a, 0x256fd2a0, 0x5268e236,
0xcc0c7795, 0xbb0b4703, 0x220216b9, 0x5505262f, 0xc5ba3bbe, 0xb2bd0b28,
0x2bb45a92, 0x5cb36a04, 0xc2d7ffa7, 0xb5d0cf31, 0x2cd99e8b, 0x5bdeae1d,
0x9b64c2b0, 0xec63f226, 0x756aa39c, 0x026d930a, 0x9c0906a9, 0xeb0e363f,
0x72076785, 0x05005713, 0x95bf4a82, 0xe2b87a14, 0x7bb12bae, 0x0cb61b38,
0x92d28e9b, 0xe5d5be0d, 0x7cdcefb7, 0x0bdbdf21, 0x86d3d2d4, 0xf1d4e242,
0x68ddb3f8, 0x1fda836e, 0x81be16cd, 0xf6b9265b, 0x6fb077e1, 0x18b74777,
0x88085ae6, 0xff0f6a70, 0x66063bca, 0x11010b5c, 0x8f659eff, 0xf862ae69,
0x616bffd3, 0x166ccf45, 0xa00ae278, 0xd70dd2ee, 0x4e048354, 0x3903b3c2,
0xa7672661, 0xd06016f7, 0x4969474d, 0x3e6e77db, 0xaed16a4a, 0xd9d65adc,
0x40df0b66, 0x37d83bf0, 0xa9bcae53, 0xdebb9ec5, 0x47b2cf7f, 0x30b5ffe9,
0xbdbdf21c, 0xcabac28a, 0x53b39330, 0x24b4a3a6, 0xbad03605, 0xcdd70693,
0x54de5729, 0x23d967bf, 0xb3667a2e, 0xc4614ab8, 0x5d681b02, 0x2a6f2b94,
0xb40bbe37, 0xc30c8ea1, 0x5a05df1b, 0x2d02ef8d };
uint32_t crc32(uint32_t crc, const void* buf, size_t size) {
const uint8_t* p;
p = buf;
crc = crc ^ ~0U;
while (size--)
crc = crc32_tab[(crc ^ *p++) & 0xFF] ^ (crc >> 8);
return crc ^ ~0U;
} |
the_stack_data/124123.c | extern float __VERIFIER_nondet_float(void);
extern int __VERIFIER_nondet_int(void);
typedef enum {false, true} bool;
bool __VERIFIER_nondet_bool(void) {
return __VERIFIER_nondet_int() != 0;
}
int main()
{
float _diverge_delta, _x__diverge_delta;
bool t27_evt1, _x_t27_evt1;
bool t27_evt0, _x_t27_evt0;
float delta, _x_delta;
bool gate_l1, _x_gate_l1;
bool gate_l0, _x_gate_l0;
float t11_x, _x_t11_x;
bool t11_l1, _x_t11_l1;
float gate_y, _x_gate_y;
bool t11_l0, _x_t11_l0;
bool t11_evt1, _x_t11_evt1;
bool t11_evt0, _x_t11_evt0;
bool gate_evt1, _x_gate_evt1;
bool gate_evt0, _x_gate_evt0;
float t28_x, _x_t28_x;
bool t28_l1, _x_t28_l1;
bool t28_l0, _x_t28_l0;
bool t28_evt1, _x_t28_evt1;
bool t28_evt0, _x_t28_evt0;
float t12_x, _x_t12_x;
bool t12_l1, _x_t12_l1;
bool t12_l0, _x_t12_l0;
bool controller_l1, _x_controller_l1;
bool t12_evt1, _x_t12_evt1;
bool t12_evt0, _x_t12_evt0;
bool controller_l0, _x_controller_l0;
float controller_z, _x_controller_z;
bool _J3787, _x__J3787;
int controller_cnt, _x_controller_cnt;
bool _J3781, _x__J3781;
bool _J3775, _x__J3775;
bool _J3758, _x__J3758;
bool _EL_U_3721, _x__EL_U_3721;
bool _EL_U_3723, _x__EL_U_3723;
bool _EL_X_3689, _x__EL_X_3689;
float t13_x, _x_t13_x;
bool _EL_X_3691, _x__EL_X_3691;
bool t13_l1, _x_t13_l1;
bool t13_l0, _x_t13_l0;
bool _EL_U_3725, _x__EL_U_3725;
bool t13_evt1, _x_t13_evt1;
bool t13_evt0, _x_t13_evt0;
bool _EL_U_3728, _x__EL_U_3728;
float t14_x, _x_t14_x;
bool t14_l1, _x_t14_l1;
bool t14_l0, _x_t14_l0;
bool t14_evt1, _x_t14_evt1;
bool t14_evt0, _x_t14_evt0;
float t15_x, _x_t15_x;
bool t15_l1, _x_t15_l1;
bool t15_l0, _x_t15_l0;
bool t15_evt1, _x_t15_evt1;
bool t15_evt0, _x_t15_evt0;
bool controller_evt1, _x_controller_evt1;
bool controller_evt0, _x_controller_evt0;
bool controller_evt2, _x_controller_evt2;
float t16_x, _x_t16_x;
bool t16_l1, _x_t16_l1;
bool t16_l0, _x_t16_l0;
bool t16_evt1, _x_t16_evt1;
bool t16_evt0, _x_t16_evt0;
float t0_x, _x_t0_x;
bool t0_l1, _x_t0_l1;
bool t0_l0, _x_t0_l0;
bool t0_evt1, _x_t0_evt1;
bool t0_evt0, _x_t0_evt0;
float t17_x, _x_t17_x;
bool t17_l1, _x_t17_l1;
bool t17_l0, _x_t17_l0;
bool t17_evt1, _x_t17_evt1;
bool t17_evt0, _x_t17_evt0;
float t1_x, _x_t1_x;
bool t1_l1, _x_t1_l1;
bool t1_l0, _x_t1_l0;
bool t1_evt1, _x_t1_evt1;
bool t1_evt0, _x_t1_evt0;
float t18_x, _x_t18_x;
bool t18_l1, _x_t18_l1;
bool t18_l0, _x_t18_l0;
bool t18_evt1, _x_t18_evt1;
bool t18_evt0, _x_t18_evt0;
float t2_x, _x_t2_x;
bool t2_l1, _x_t2_l1;
bool t2_l0, _x_t2_l0;
bool t2_evt1, _x_t2_evt1;
bool t2_evt0, _x_t2_evt0;
float t19_x, _x_t19_x;
bool t19_l1, _x_t19_l1;
bool t19_l0, _x_t19_l0;
bool t19_evt1, _x_t19_evt1;
bool t19_evt0, _x_t19_evt0;
float t3_x, _x_t3_x;
bool t3_l1, _x_t3_l1;
bool t3_l0, _x_t3_l0;
bool t3_evt1, _x_t3_evt1;
bool t3_evt0, _x_t3_evt0;
float t20_x, _x_t20_x;
bool t20_l1, _x_t20_l1;
bool t20_l0, _x_t20_l0;
bool t20_evt1, _x_t20_evt1;
bool t20_evt0, _x_t20_evt0;
float t4_x, _x_t4_x;
bool t4_l1, _x_t4_l1;
bool t4_l0, _x_t4_l0;
bool t4_evt1, _x_t4_evt1;
bool t4_evt0, _x_t4_evt0;
float t21_x, _x_t21_x;
bool t21_l1, _x_t21_l1;
bool t21_l0, _x_t21_l0;
bool t21_evt1, _x_t21_evt1;
bool t21_evt0, _x_t21_evt0;
float t5_x, _x_t5_x;
bool t5_l1, _x_t5_l1;
bool t5_l0, _x_t5_l0;
bool t5_evt1, _x_t5_evt1;
bool t5_evt0, _x_t5_evt0;
float t22_x, _x_t22_x;
bool t22_l1, _x_t22_l1;
bool t22_l0, _x_t22_l0;
bool t22_evt1, _x_t22_evt1;
bool t22_evt0, _x_t22_evt0;
float t6_x, _x_t6_x;
bool t6_l1, _x_t6_l1;
bool t6_l0, _x_t6_l0;
bool t6_evt1, _x_t6_evt1;
bool t6_evt0, _x_t6_evt0;
float t23_x, _x_t23_x;
bool t23_l1, _x_t23_l1;
bool t23_l0, _x_t23_l0;
bool t23_evt1, _x_t23_evt1;
bool t23_evt0, _x_t23_evt0;
float t7_x, _x_t7_x;
bool t7_l1, _x_t7_l1;
bool t7_l0, _x_t7_l0;
bool t7_evt1, _x_t7_evt1;
bool t7_evt0, _x_t7_evt0;
float t24_x, _x_t24_x;
bool t24_l1, _x_t24_l1;
bool t24_l0, _x_t24_l0;
bool t24_evt1, _x_t24_evt1;
bool t24_evt0, _x_t24_evt0;
float t8_x, _x_t8_x;
bool t8_l1, _x_t8_l1;
bool t8_l0, _x_t8_l0;
bool t8_evt1, _x_t8_evt1;
bool t8_evt0, _x_t8_evt0;
float t25_x, _x_t25_x;
bool t25_l1, _x_t25_l1;
bool t25_l0, _x_t25_l0;
bool t25_evt1, _x_t25_evt1;
bool t25_evt0, _x_t25_evt0;
float t9_x, _x_t9_x;
bool t9_l1, _x_t9_l1;
bool t9_l0, _x_t9_l0;
bool t9_evt1, _x_t9_evt1;
bool t9_evt0, _x_t9_evt0;
float t26_x, _x_t26_x;
bool t26_l1, _x_t26_l1;
bool t26_l0, _x_t26_l0;
bool t26_evt1, _x_t26_evt1;
bool t26_evt0, _x_t26_evt0;
float t10_x, _x_t10_x;
bool t10_l1, _x_t10_l1;
bool t10_l0, _x_t10_l0;
bool t10_evt1, _x_t10_evt1;
bool t10_evt0, _x_t10_evt0;
float t27_x, _x_t27_x;
bool t27_l1, _x_t27_l1;
bool t27_l0, _x_t27_l0;
int __steps_to_fair = __VERIFIER_nondet_int();
_diverge_delta = __VERIFIER_nondet_float();
t27_evt1 = __VERIFIER_nondet_bool();
t27_evt0 = __VERIFIER_nondet_bool();
delta = __VERIFIER_nondet_float();
gate_l1 = __VERIFIER_nondet_bool();
gate_l0 = __VERIFIER_nondet_bool();
t11_x = __VERIFIER_nondet_float();
t11_l1 = __VERIFIER_nondet_bool();
gate_y = __VERIFIER_nondet_float();
t11_l0 = __VERIFIER_nondet_bool();
t11_evt1 = __VERIFIER_nondet_bool();
t11_evt0 = __VERIFIER_nondet_bool();
gate_evt1 = __VERIFIER_nondet_bool();
gate_evt0 = __VERIFIER_nondet_bool();
t28_x = __VERIFIER_nondet_float();
t28_l1 = __VERIFIER_nondet_bool();
t28_l0 = __VERIFIER_nondet_bool();
t28_evt1 = __VERIFIER_nondet_bool();
t28_evt0 = __VERIFIER_nondet_bool();
t12_x = __VERIFIER_nondet_float();
t12_l1 = __VERIFIER_nondet_bool();
t12_l0 = __VERIFIER_nondet_bool();
controller_l1 = __VERIFIER_nondet_bool();
t12_evt1 = __VERIFIER_nondet_bool();
t12_evt0 = __VERIFIER_nondet_bool();
controller_l0 = __VERIFIER_nondet_bool();
controller_z = __VERIFIER_nondet_float();
_J3787 = __VERIFIER_nondet_bool();
controller_cnt = __VERIFIER_nondet_int();
_J3781 = __VERIFIER_nondet_bool();
_J3775 = __VERIFIER_nondet_bool();
_J3758 = __VERIFIER_nondet_bool();
_EL_U_3721 = __VERIFIER_nondet_bool();
_EL_U_3723 = __VERIFIER_nondet_bool();
_EL_X_3689 = __VERIFIER_nondet_bool();
t13_x = __VERIFIER_nondet_float();
_EL_X_3691 = __VERIFIER_nondet_bool();
t13_l1 = __VERIFIER_nondet_bool();
t13_l0 = __VERIFIER_nondet_bool();
_EL_U_3725 = __VERIFIER_nondet_bool();
t13_evt1 = __VERIFIER_nondet_bool();
t13_evt0 = __VERIFIER_nondet_bool();
_EL_U_3728 = __VERIFIER_nondet_bool();
t14_x = __VERIFIER_nondet_float();
t14_l1 = __VERIFIER_nondet_bool();
t14_l0 = __VERIFIER_nondet_bool();
t14_evt1 = __VERIFIER_nondet_bool();
t14_evt0 = __VERIFIER_nondet_bool();
t15_x = __VERIFIER_nondet_float();
t15_l1 = __VERIFIER_nondet_bool();
t15_l0 = __VERIFIER_nondet_bool();
t15_evt1 = __VERIFIER_nondet_bool();
t15_evt0 = __VERIFIER_nondet_bool();
controller_evt1 = __VERIFIER_nondet_bool();
controller_evt0 = __VERIFIER_nondet_bool();
controller_evt2 = __VERIFIER_nondet_bool();
t16_x = __VERIFIER_nondet_float();
t16_l1 = __VERIFIER_nondet_bool();
t16_l0 = __VERIFIER_nondet_bool();
t16_evt1 = __VERIFIER_nondet_bool();
t16_evt0 = __VERIFIER_nondet_bool();
t0_x = __VERIFIER_nondet_float();
t0_l1 = __VERIFIER_nondet_bool();
t0_l0 = __VERIFIER_nondet_bool();
t0_evt1 = __VERIFIER_nondet_bool();
t0_evt0 = __VERIFIER_nondet_bool();
t17_x = __VERIFIER_nondet_float();
t17_l1 = __VERIFIER_nondet_bool();
t17_l0 = __VERIFIER_nondet_bool();
t17_evt1 = __VERIFIER_nondet_bool();
t17_evt0 = __VERIFIER_nondet_bool();
t1_x = __VERIFIER_nondet_float();
t1_l1 = __VERIFIER_nondet_bool();
t1_l0 = __VERIFIER_nondet_bool();
t1_evt1 = __VERIFIER_nondet_bool();
t1_evt0 = __VERIFIER_nondet_bool();
t18_x = __VERIFIER_nondet_float();
t18_l1 = __VERIFIER_nondet_bool();
t18_l0 = __VERIFIER_nondet_bool();
t18_evt1 = __VERIFIER_nondet_bool();
t18_evt0 = __VERIFIER_nondet_bool();
t2_x = __VERIFIER_nondet_float();
t2_l1 = __VERIFIER_nondet_bool();
t2_l0 = __VERIFIER_nondet_bool();
t2_evt1 = __VERIFIER_nondet_bool();
t2_evt0 = __VERIFIER_nondet_bool();
t19_x = __VERIFIER_nondet_float();
t19_l1 = __VERIFIER_nondet_bool();
t19_l0 = __VERIFIER_nondet_bool();
t19_evt1 = __VERIFIER_nondet_bool();
t19_evt0 = __VERIFIER_nondet_bool();
t3_x = __VERIFIER_nondet_float();
t3_l1 = __VERIFIER_nondet_bool();
t3_l0 = __VERIFIER_nondet_bool();
t3_evt1 = __VERIFIER_nondet_bool();
t3_evt0 = __VERIFIER_nondet_bool();
t20_x = __VERIFIER_nondet_float();
t20_l1 = __VERIFIER_nondet_bool();
t20_l0 = __VERIFIER_nondet_bool();
t20_evt1 = __VERIFIER_nondet_bool();
t20_evt0 = __VERIFIER_nondet_bool();
t4_x = __VERIFIER_nondet_float();
t4_l1 = __VERIFIER_nondet_bool();
t4_l0 = __VERIFIER_nondet_bool();
t4_evt1 = __VERIFIER_nondet_bool();
t4_evt0 = __VERIFIER_nondet_bool();
t21_x = __VERIFIER_nondet_float();
t21_l1 = __VERIFIER_nondet_bool();
t21_l0 = __VERIFIER_nondet_bool();
t21_evt1 = __VERIFIER_nondet_bool();
t21_evt0 = __VERIFIER_nondet_bool();
t5_x = __VERIFIER_nondet_float();
t5_l1 = __VERIFIER_nondet_bool();
t5_l0 = __VERIFIER_nondet_bool();
t5_evt1 = __VERIFIER_nondet_bool();
t5_evt0 = __VERIFIER_nondet_bool();
t22_x = __VERIFIER_nondet_float();
t22_l1 = __VERIFIER_nondet_bool();
t22_l0 = __VERIFIER_nondet_bool();
t22_evt1 = __VERIFIER_nondet_bool();
t22_evt0 = __VERIFIER_nondet_bool();
t6_x = __VERIFIER_nondet_float();
t6_l1 = __VERIFIER_nondet_bool();
t6_l0 = __VERIFIER_nondet_bool();
t6_evt1 = __VERIFIER_nondet_bool();
t6_evt0 = __VERIFIER_nondet_bool();
t23_x = __VERIFIER_nondet_float();
t23_l1 = __VERIFIER_nondet_bool();
t23_l0 = __VERIFIER_nondet_bool();
t23_evt1 = __VERIFIER_nondet_bool();
t23_evt0 = __VERIFIER_nondet_bool();
t7_x = __VERIFIER_nondet_float();
t7_l1 = __VERIFIER_nondet_bool();
t7_l0 = __VERIFIER_nondet_bool();
t7_evt1 = __VERIFIER_nondet_bool();
t7_evt0 = __VERIFIER_nondet_bool();
t24_x = __VERIFIER_nondet_float();
t24_l1 = __VERIFIER_nondet_bool();
t24_l0 = __VERIFIER_nondet_bool();
t24_evt1 = __VERIFIER_nondet_bool();
t24_evt0 = __VERIFIER_nondet_bool();
t8_x = __VERIFIER_nondet_float();
t8_l1 = __VERIFIER_nondet_bool();
t8_l0 = __VERIFIER_nondet_bool();
t8_evt1 = __VERIFIER_nondet_bool();
t8_evt0 = __VERIFIER_nondet_bool();
t25_x = __VERIFIER_nondet_float();
t25_l1 = __VERIFIER_nondet_bool();
t25_l0 = __VERIFIER_nondet_bool();
t25_evt1 = __VERIFIER_nondet_bool();
t25_evt0 = __VERIFIER_nondet_bool();
t9_x = __VERIFIER_nondet_float();
t9_l1 = __VERIFIER_nondet_bool();
t9_l0 = __VERIFIER_nondet_bool();
t9_evt1 = __VERIFIER_nondet_bool();
t9_evt0 = __VERIFIER_nondet_bool();
t26_x = __VERIFIER_nondet_float();
t26_l1 = __VERIFIER_nondet_bool();
t26_l0 = __VERIFIER_nondet_bool();
t26_evt1 = __VERIFIER_nondet_bool();
t26_evt0 = __VERIFIER_nondet_bool();
t10_x = __VERIFIER_nondet_float();
t10_l1 = __VERIFIER_nondet_bool();
t10_l0 = __VERIFIER_nondet_bool();
t10_evt1 = __VERIFIER_nondet_bool();
t10_evt0 = __VERIFIER_nondet_bool();
t27_x = __VERIFIER_nondet_float();
t27_l1 = __VERIFIER_nondet_bool();
t27_l0 = __VERIFIER_nondet_bool();
bool __ok = ((((((((( !t28_l0) && ( !t28_l1)) && (t28_x == 0.0)) && (((( !t28_l0) && ( !t28_l1)) || (t28_l0 && ( !t28_l1))) || ((t28_l1 && ( !t28_l0)) || (t28_l0 && t28_l1)))) && (((( !t28_evt0) && ( !t28_evt1)) || (t28_evt0 && ( !t28_evt1))) || ((t28_evt1 && ( !t28_evt0)) || (t28_evt0 && t28_evt1)))) && ((( !t28_l0) && ( !t28_l1)) || (t28_x <= 5.0))) && ((((((( !t27_l0) && ( !t27_l1)) && (t27_x == 0.0)) && (((( !t27_l0) && ( !t27_l1)) || (t27_l0 && ( !t27_l1))) || ((t27_l1 && ( !t27_l0)) || (t27_l0 && t27_l1)))) && (((( !t27_evt0) && ( !t27_evt1)) || (t27_evt0 && ( !t27_evt1))) || ((t27_evt1 && ( !t27_evt0)) || (t27_evt0 && t27_evt1)))) && ((( !t27_l0) && ( !t27_l1)) || (t27_x <= 5.0))) && ((((((( !t26_l0) && ( !t26_l1)) && (t26_x == 0.0)) && (((( !t26_l0) && ( !t26_l1)) || (t26_l0 && ( !t26_l1))) || ((t26_l1 && ( !t26_l0)) || (t26_l0 && t26_l1)))) && (((( !t26_evt0) && ( !t26_evt1)) || (t26_evt0 && ( !t26_evt1))) || ((t26_evt1 && ( !t26_evt0)) || (t26_evt0 && t26_evt1)))) && ((( !t26_l0) && ( !t26_l1)) || (t26_x <= 5.0))) && ((((((( !t25_l0) && ( !t25_l1)) && (t25_x == 0.0)) && (((( !t25_l0) && ( !t25_l1)) || (t25_l0 && ( !t25_l1))) || ((t25_l1 && ( !t25_l0)) || (t25_l0 && t25_l1)))) && (((( !t25_evt0) && ( !t25_evt1)) || (t25_evt0 && ( !t25_evt1))) || ((t25_evt1 && ( !t25_evt0)) || (t25_evt0 && t25_evt1)))) && ((( !t25_l0) && ( !t25_l1)) || (t25_x <= 5.0))) && ((((((( !t24_l0) && ( !t24_l1)) && (t24_x == 0.0)) && (((( !t24_l0) && ( !t24_l1)) || (t24_l0 && ( !t24_l1))) || ((t24_l1 && ( !t24_l0)) || (t24_l0 && t24_l1)))) && (((( !t24_evt0) && ( !t24_evt1)) || (t24_evt0 && ( !t24_evt1))) || ((t24_evt1 && ( !t24_evt0)) || (t24_evt0 && t24_evt1)))) && ((( !t24_l0) && ( !t24_l1)) || (t24_x <= 5.0))) && ((((((( !t23_l0) && ( !t23_l1)) && (t23_x == 0.0)) && (((( !t23_l0) && ( !t23_l1)) || (t23_l0 && ( !t23_l1))) || ((t23_l1 && ( !t23_l0)) || (t23_l0 && t23_l1)))) && (((( !t23_evt0) && ( !t23_evt1)) || (t23_evt0 && ( !t23_evt1))) || ((t23_evt1 && ( !t23_evt0)) || (t23_evt0 && t23_evt1)))) && ((( !t23_l0) && ( !t23_l1)) || (t23_x <= 5.0))) && ((((((( !t22_l0) && ( !t22_l1)) && (t22_x == 0.0)) && (((( !t22_l0) && ( !t22_l1)) || (t22_l0 && ( !t22_l1))) || ((t22_l1 && ( !t22_l0)) || (t22_l0 && t22_l1)))) && (((( !t22_evt0) && ( !t22_evt1)) || (t22_evt0 && ( !t22_evt1))) || ((t22_evt1 && ( !t22_evt0)) || (t22_evt0 && t22_evt1)))) && ((( !t22_l0) && ( !t22_l1)) || (t22_x <= 5.0))) && ((((((( !t21_l0) && ( !t21_l1)) && (t21_x == 0.0)) && (((( !t21_l0) && ( !t21_l1)) || (t21_l0 && ( !t21_l1))) || ((t21_l1 && ( !t21_l0)) || (t21_l0 && t21_l1)))) && (((( !t21_evt0) && ( !t21_evt1)) || (t21_evt0 && ( !t21_evt1))) || ((t21_evt1 && ( !t21_evt0)) || (t21_evt0 && t21_evt1)))) && ((( !t21_l0) && ( !t21_l1)) || (t21_x <= 5.0))) && ((((((( !t20_l0) && ( !t20_l1)) && (t20_x == 0.0)) && (((( !t20_l0) && ( !t20_l1)) || (t20_l0 && ( !t20_l1))) || ((t20_l1 && ( !t20_l0)) || (t20_l0 && t20_l1)))) && (((( !t20_evt0) && ( !t20_evt1)) || (t20_evt0 && ( !t20_evt1))) || ((t20_evt1 && ( !t20_evt0)) || (t20_evt0 && t20_evt1)))) && ((( !t20_l0) && ( !t20_l1)) || (t20_x <= 5.0))) && ((((((( !t19_l0) && ( !t19_l1)) && (t19_x == 0.0)) && (((( !t19_l0) && ( !t19_l1)) || (t19_l0 && ( !t19_l1))) || ((t19_l1 && ( !t19_l0)) || (t19_l0 && t19_l1)))) && (((( !t19_evt0) && ( !t19_evt1)) || (t19_evt0 && ( !t19_evt1))) || ((t19_evt1 && ( !t19_evt0)) || (t19_evt0 && t19_evt1)))) && ((( !t19_l0) && ( !t19_l1)) || (t19_x <= 5.0))) && ((((((( !t18_l0) && ( !t18_l1)) && (t18_x == 0.0)) && (((( !t18_l0) && ( !t18_l1)) || (t18_l0 && ( !t18_l1))) || ((t18_l1 && ( !t18_l0)) || (t18_l0 && t18_l1)))) && (((( !t18_evt0) && ( !t18_evt1)) || (t18_evt0 && ( !t18_evt1))) || ((t18_evt1 && ( !t18_evt0)) || (t18_evt0 && t18_evt1)))) && ((( !t18_l0) && ( !t18_l1)) || (t18_x <= 5.0))) && ((((((( !t17_l0) && ( !t17_l1)) && (t17_x == 0.0)) && (((( !t17_l0) && ( !t17_l1)) || (t17_l0 && ( !t17_l1))) || ((t17_l1 && ( !t17_l0)) || (t17_l0 && t17_l1)))) && (((( !t17_evt0) && ( !t17_evt1)) || (t17_evt0 && ( !t17_evt1))) || ((t17_evt1 && ( !t17_evt0)) || (t17_evt0 && t17_evt1)))) && ((( !t17_l0) && ( !t17_l1)) || (t17_x <= 5.0))) && ((((((( !t16_l0) && ( !t16_l1)) && (t16_x == 0.0)) && (((( !t16_l0) && ( !t16_l1)) || (t16_l0 && ( !t16_l1))) || ((t16_l1 && ( !t16_l0)) || (t16_l0 && t16_l1)))) && (((( !t16_evt0) && ( !t16_evt1)) || (t16_evt0 && ( !t16_evt1))) || ((t16_evt1 && ( !t16_evt0)) || (t16_evt0 && t16_evt1)))) && ((( !t16_l0) && ( !t16_l1)) || (t16_x <= 5.0))) && ((((((( !t15_l0) && ( !t15_l1)) && (t15_x == 0.0)) && (((( !t15_l0) && ( !t15_l1)) || (t15_l0 && ( !t15_l1))) || ((t15_l1 && ( !t15_l0)) || (t15_l0 && t15_l1)))) && (((( !t15_evt0) && ( !t15_evt1)) || (t15_evt0 && ( !t15_evt1))) || ((t15_evt1 && ( !t15_evt0)) || (t15_evt0 && t15_evt1)))) && ((( !t15_l0) && ( !t15_l1)) || (t15_x <= 5.0))) && ((((((( !t14_l0) && ( !t14_l1)) && (t14_x == 0.0)) && (((( !t14_l0) && ( !t14_l1)) || (t14_l0 && ( !t14_l1))) || ((t14_l1 && ( !t14_l0)) || (t14_l0 && t14_l1)))) && (((( !t14_evt0) && ( !t14_evt1)) || (t14_evt0 && ( !t14_evt1))) || ((t14_evt1 && ( !t14_evt0)) || (t14_evt0 && t14_evt1)))) && ((( !t14_l0) && ( !t14_l1)) || (t14_x <= 5.0))) && ((((((( !t13_l0) && ( !t13_l1)) && (t13_x == 0.0)) && (((( !t13_l0) && ( !t13_l1)) || (t13_l0 && ( !t13_l1))) || ((t13_l1 && ( !t13_l0)) || (t13_l0 && t13_l1)))) && (((( !t13_evt0) && ( !t13_evt1)) || (t13_evt0 && ( !t13_evt1))) || ((t13_evt1 && ( !t13_evt0)) || (t13_evt0 && t13_evt1)))) && ((( !t13_l0) && ( !t13_l1)) || (t13_x <= 5.0))) && ((((((( !t12_l0) && ( !t12_l1)) && (t12_x == 0.0)) && (((( !t12_l0) && ( !t12_l1)) || (t12_l0 && ( !t12_l1))) || ((t12_l1 && ( !t12_l0)) || (t12_l0 && t12_l1)))) && (((( !t12_evt0) && ( !t12_evt1)) || (t12_evt0 && ( !t12_evt1))) || ((t12_evt1 && ( !t12_evt0)) || (t12_evt0 && t12_evt1)))) && ((( !t12_l0) && ( !t12_l1)) || (t12_x <= 5.0))) && ((((((( !t11_l0) && ( !t11_l1)) && (t11_x == 0.0)) && (((( !t11_l0) && ( !t11_l1)) || (t11_l0 && ( !t11_l1))) || ((t11_l1 && ( !t11_l0)) || (t11_l0 && t11_l1)))) && (((( !t11_evt0) && ( !t11_evt1)) || (t11_evt0 && ( !t11_evt1))) || ((t11_evt1 && ( !t11_evt0)) || (t11_evt0 && t11_evt1)))) && ((( !t11_l0) && ( !t11_l1)) || (t11_x <= 5.0))) && ((((((( !t10_l0) && ( !t10_l1)) && (t10_x == 0.0)) && (((( !t10_l0) && ( !t10_l1)) || (t10_l0 && ( !t10_l1))) || ((t10_l1 && ( !t10_l0)) || (t10_l0 && t10_l1)))) && (((( !t10_evt0) && ( !t10_evt1)) || (t10_evt0 && ( !t10_evt1))) || ((t10_evt1 && ( !t10_evt0)) || (t10_evt0 && t10_evt1)))) && ((( !t10_l0) && ( !t10_l1)) || (t10_x <= 5.0))) && ((((((( !t9_l0) && ( !t9_l1)) && (t9_x == 0.0)) && (((( !t9_l0) && ( !t9_l1)) || (t9_l0 && ( !t9_l1))) || ((t9_l1 && ( !t9_l0)) || (t9_l0 && t9_l1)))) && (((( !t9_evt0) && ( !t9_evt1)) || (t9_evt0 && ( !t9_evt1))) || ((t9_evt1 && ( !t9_evt0)) || (t9_evt0 && t9_evt1)))) && ((( !t9_l0) && ( !t9_l1)) || (t9_x <= 5.0))) && ((((((( !t8_l0) && ( !t8_l1)) && (t8_x == 0.0)) && (((( !t8_l0) && ( !t8_l1)) || (t8_l0 && ( !t8_l1))) || ((t8_l1 && ( !t8_l0)) || (t8_l0 && t8_l1)))) && (((( !t8_evt0) && ( !t8_evt1)) || (t8_evt0 && ( !t8_evt1))) || ((t8_evt1 && ( !t8_evt0)) || (t8_evt0 && t8_evt1)))) && ((( !t8_l0) && ( !t8_l1)) || (t8_x <= 5.0))) && ((((((( !t7_l0) && ( !t7_l1)) && (t7_x == 0.0)) && (((( !t7_l0) && ( !t7_l1)) || (t7_l0 && ( !t7_l1))) || ((t7_l1 && ( !t7_l0)) || (t7_l0 && t7_l1)))) && (((( !t7_evt0) && ( !t7_evt1)) || (t7_evt0 && ( !t7_evt1))) || ((t7_evt1 && ( !t7_evt0)) || (t7_evt0 && t7_evt1)))) && ((( !t7_l0) && ( !t7_l1)) || (t7_x <= 5.0))) && ((((((( !t6_l0) && ( !t6_l1)) && (t6_x == 0.0)) && (((( !t6_l0) && ( !t6_l1)) || (t6_l0 && ( !t6_l1))) || ((t6_l1 && ( !t6_l0)) || (t6_l0 && t6_l1)))) && (((( !t6_evt0) && ( !t6_evt1)) || (t6_evt0 && ( !t6_evt1))) || ((t6_evt1 && ( !t6_evt0)) || (t6_evt0 && t6_evt1)))) && ((( !t6_l0) && ( !t6_l1)) || (t6_x <= 5.0))) && ((((((( !t5_l0) && ( !t5_l1)) && (t5_x == 0.0)) && (((( !t5_l0) && ( !t5_l1)) || (t5_l0 && ( !t5_l1))) || ((t5_l1 && ( !t5_l0)) || (t5_l0 && t5_l1)))) && (((( !t5_evt0) && ( !t5_evt1)) || (t5_evt0 && ( !t5_evt1))) || ((t5_evt1 && ( !t5_evt0)) || (t5_evt0 && t5_evt1)))) && ((( !t5_l0) && ( !t5_l1)) || (t5_x <= 5.0))) && ((((((( !t4_l0) && ( !t4_l1)) && (t4_x == 0.0)) && (((( !t4_l0) && ( !t4_l1)) || (t4_l0 && ( !t4_l1))) || ((t4_l1 && ( !t4_l0)) || (t4_l0 && t4_l1)))) && (((( !t4_evt0) && ( !t4_evt1)) || (t4_evt0 && ( !t4_evt1))) || ((t4_evt1 && ( !t4_evt0)) || (t4_evt0 && t4_evt1)))) && ((( !t4_l0) && ( !t4_l1)) || (t4_x <= 5.0))) && ((((((( !t3_l0) && ( !t3_l1)) && (t3_x == 0.0)) && (((( !t3_l0) && ( !t3_l1)) || (t3_l0 && ( !t3_l1))) || ((t3_l1 && ( !t3_l0)) || (t3_l0 && t3_l1)))) && (((( !t3_evt0) && ( !t3_evt1)) || (t3_evt0 && ( !t3_evt1))) || ((t3_evt1 && ( !t3_evt0)) || (t3_evt0 && t3_evt1)))) && ((( !t3_l0) && ( !t3_l1)) || (t3_x <= 5.0))) && ((((((( !t2_l0) && ( !t2_l1)) && (t2_x == 0.0)) && (((( !t2_l0) && ( !t2_l1)) || (t2_l0 && ( !t2_l1))) || ((t2_l1 && ( !t2_l0)) || (t2_l0 && t2_l1)))) && (((( !t2_evt0) && ( !t2_evt1)) || (t2_evt0 && ( !t2_evt1))) || ((t2_evt1 && ( !t2_evt0)) || (t2_evt0 && t2_evt1)))) && ((( !t2_l0) && ( !t2_l1)) || (t2_x <= 5.0))) && ((((((( !t1_l0) && ( !t1_l1)) && (t1_x == 0.0)) && (((( !t1_l0) && ( !t1_l1)) || (t1_l0 && ( !t1_l1))) || ((t1_l1 && ( !t1_l0)) || (t1_l0 && t1_l1)))) && (((( !t1_evt0) && ( !t1_evt1)) || (t1_evt0 && ( !t1_evt1))) || ((t1_evt1 && ( !t1_evt0)) || (t1_evt0 && t1_evt1)))) && ((( !t1_l0) && ( !t1_l1)) || (t1_x <= 5.0))) && ((((((( !t0_l0) && ( !t0_l1)) && (t0_x == 0.0)) && (((( !t0_l0) && ( !t0_l1)) || (t0_l0 && ( !t0_l1))) || ((t0_l1 && ( !t0_l0)) || (t0_l0 && t0_l1)))) && (((( !t0_evt0) && ( !t0_evt1)) || (t0_evt0 && ( !t0_evt1))) || ((t0_evt1 && ( !t0_evt0)) || (t0_evt0 && t0_evt1)))) && ((( !t0_l0) && ( !t0_l1)) || (t0_x <= 5.0))) && (((((((( !controller_l0) && ( !controller_l1)) && (controller_z == 0.0)) && (((( !controller_l0) && ( !controller_l1)) || (controller_l0 && ( !controller_l1))) || ((controller_l1 && ( !controller_l0)) || (controller_l0 && controller_l1)))) && (((( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))) || (( !controller_evt2) && (controller_evt0 && ( !controller_evt1)))) || ((( !controller_evt2) && (controller_evt1 && ( !controller_evt0))) || ((( !controller_evt2) && (controller_evt0 && controller_evt1)) || (controller_evt2 && (( !controller_evt0) && ( !controller_evt1))))))) && (((((((((((((((((((((((((((((((controller_cnt == 0) || (controller_cnt == 1)) || (controller_cnt == 2)) || (controller_cnt == 3)) || (controller_cnt == 4)) || (controller_cnt == 5)) || (controller_cnt == 6)) || (controller_cnt == 7)) || (controller_cnt == 8)) || (controller_cnt == 9)) || (controller_cnt == 10)) || (controller_cnt == 11)) || (controller_cnt == 12)) || (controller_cnt == 13)) || (controller_cnt == 14)) || (controller_cnt == 15)) || (controller_cnt == 16)) || (controller_cnt == 17)) || (controller_cnt == 18)) || (controller_cnt == 19)) || (controller_cnt == 20)) || (controller_cnt == 21)) || (controller_cnt == 22)) || (controller_cnt == 23)) || (controller_cnt == 24)) || (controller_cnt == 25)) || (controller_cnt == 26)) || (controller_cnt == 27)) || (controller_cnt == 28)) || (controller_cnt == 29)) || (controller_cnt == 30))) && ((controller_z <= 1.0) || ( !((controller_l0 && ( !controller_l1)) || (controller_l0 && controller_l1))))) && (((((((( !gate_l0) && ( !gate_l1)) && (gate_y == 0.0)) && (((( !gate_l0) && ( !gate_l1)) || (gate_l0 && ( !gate_l1))) || ((gate_l1 && ( !gate_l0)) || (gate_l0 && gate_l1)))) && (((( !gate_evt0) && ( !gate_evt1)) || (gate_evt0 && ( !gate_evt1))) || ((gate_evt1 && ( !gate_evt0)) || (gate_evt0 && gate_evt1)))) && ((gate_y <= 1.0) || ( !(gate_l0 && ( !gate_l1))))) && ((gate_y <= 2.0) || ( !(gate_l0 && gate_l1)))) && (0.0 <= delta)))))))))))))))))))))))))))))))) && (delta == _diverge_delta)) && ((((( !(( !(_EL_U_3728 || ( !((_EL_U_3725 || ((gate_l1 && ( !gate_l0)) && (_EL_X_3691 && _EL_X_3689))) || ( !((( !gate_l0) && ( !gate_l1)) && (_EL_X_3691 && ( !_EL_X_3689)))))))) || (_EL_U_3723 || ( !((1.0 <= _diverge_delta) || _EL_U_3721))))) && ( !_J3758)) && ( !_J3775)) && ( !_J3781)) && ( !_J3787)));
while (__steps_to_fair >= 0 && __ok) {
if ((((_J3758 && _J3775) && _J3781) && _J3787)) {
__steps_to_fair = __VERIFIER_nondet_int();
} else {
__steps_to_fair--;
}
_x__diverge_delta = __VERIFIER_nondet_float();
_x_t27_evt1 = __VERIFIER_nondet_bool();
_x_t27_evt0 = __VERIFIER_nondet_bool();
_x_delta = __VERIFIER_nondet_float();
_x_gate_l1 = __VERIFIER_nondet_bool();
_x_gate_l0 = __VERIFIER_nondet_bool();
_x_t11_x = __VERIFIER_nondet_float();
_x_t11_l1 = __VERIFIER_nondet_bool();
_x_gate_y = __VERIFIER_nondet_float();
_x_t11_l0 = __VERIFIER_nondet_bool();
_x_t11_evt1 = __VERIFIER_nondet_bool();
_x_t11_evt0 = __VERIFIER_nondet_bool();
_x_gate_evt1 = __VERIFIER_nondet_bool();
_x_gate_evt0 = __VERIFIER_nondet_bool();
_x_t28_x = __VERIFIER_nondet_float();
_x_t28_l1 = __VERIFIER_nondet_bool();
_x_t28_l0 = __VERIFIER_nondet_bool();
_x_t28_evt1 = __VERIFIER_nondet_bool();
_x_t28_evt0 = __VERIFIER_nondet_bool();
_x_t12_x = __VERIFIER_nondet_float();
_x_t12_l1 = __VERIFIER_nondet_bool();
_x_t12_l0 = __VERIFIER_nondet_bool();
_x_controller_l1 = __VERIFIER_nondet_bool();
_x_t12_evt1 = __VERIFIER_nondet_bool();
_x_t12_evt0 = __VERIFIER_nondet_bool();
_x_controller_l0 = __VERIFIER_nondet_bool();
_x_controller_z = __VERIFIER_nondet_float();
_x__J3787 = __VERIFIER_nondet_bool();
_x_controller_cnt = __VERIFIER_nondet_int();
_x__J3781 = __VERIFIER_nondet_bool();
_x__J3775 = __VERIFIER_nondet_bool();
_x__J3758 = __VERIFIER_nondet_bool();
_x__EL_U_3721 = __VERIFIER_nondet_bool();
_x__EL_U_3723 = __VERIFIER_nondet_bool();
_x__EL_X_3689 = __VERIFIER_nondet_bool();
_x_t13_x = __VERIFIER_nondet_float();
_x__EL_X_3691 = __VERIFIER_nondet_bool();
_x_t13_l1 = __VERIFIER_nondet_bool();
_x_t13_l0 = __VERIFIER_nondet_bool();
_x__EL_U_3725 = __VERIFIER_nondet_bool();
_x_t13_evt1 = __VERIFIER_nondet_bool();
_x_t13_evt0 = __VERIFIER_nondet_bool();
_x__EL_U_3728 = __VERIFIER_nondet_bool();
_x_t14_x = __VERIFIER_nondet_float();
_x_t14_l1 = __VERIFIER_nondet_bool();
_x_t14_l0 = __VERIFIER_nondet_bool();
_x_t14_evt1 = __VERIFIER_nondet_bool();
_x_t14_evt0 = __VERIFIER_nondet_bool();
_x_t15_x = __VERIFIER_nondet_float();
_x_t15_l1 = __VERIFIER_nondet_bool();
_x_t15_l0 = __VERIFIER_nondet_bool();
_x_t15_evt1 = __VERIFIER_nondet_bool();
_x_t15_evt0 = __VERIFIER_nondet_bool();
_x_controller_evt1 = __VERIFIER_nondet_bool();
_x_controller_evt0 = __VERIFIER_nondet_bool();
_x_controller_evt2 = __VERIFIER_nondet_bool();
_x_t16_x = __VERIFIER_nondet_float();
_x_t16_l1 = __VERIFIER_nondet_bool();
_x_t16_l0 = __VERIFIER_nondet_bool();
_x_t16_evt1 = __VERIFIER_nondet_bool();
_x_t16_evt0 = __VERIFIER_nondet_bool();
_x_t0_x = __VERIFIER_nondet_float();
_x_t0_l1 = __VERIFIER_nondet_bool();
_x_t0_l0 = __VERIFIER_nondet_bool();
_x_t0_evt1 = __VERIFIER_nondet_bool();
_x_t0_evt0 = __VERIFIER_nondet_bool();
_x_t17_x = __VERIFIER_nondet_float();
_x_t17_l1 = __VERIFIER_nondet_bool();
_x_t17_l0 = __VERIFIER_nondet_bool();
_x_t17_evt1 = __VERIFIER_nondet_bool();
_x_t17_evt0 = __VERIFIER_nondet_bool();
_x_t1_x = __VERIFIER_nondet_float();
_x_t1_l1 = __VERIFIER_nondet_bool();
_x_t1_l0 = __VERIFIER_nondet_bool();
_x_t1_evt1 = __VERIFIER_nondet_bool();
_x_t1_evt0 = __VERIFIER_nondet_bool();
_x_t18_x = __VERIFIER_nondet_float();
_x_t18_l1 = __VERIFIER_nondet_bool();
_x_t18_l0 = __VERIFIER_nondet_bool();
_x_t18_evt1 = __VERIFIER_nondet_bool();
_x_t18_evt0 = __VERIFIER_nondet_bool();
_x_t2_x = __VERIFIER_nondet_float();
_x_t2_l1 = __VERIFIER_nondet_bool();
_x_t2_l0 = __VERIFIER_nondet_bool();
_x_t2_evt1 = __VERIFIER_nondet_bool();
_x_t2_evt0 = __VERIFIER_nondet_bool();
_x_t19_x = __VERIFIER_nondet_float();
_x_t19_l1 = __VERIFIER_nondet_bool();
_x_t19_l0 = __VERIFIER_nondet_bool();
_x_t19_evt1 = __VERIFIER_nondet_bool();
_x_t19_evt0 = __VERIFIER_nondet_bool();
_x_t3_x = __VERIFIER_nondet_float();
_x_t3_l1 = __VERIFIER_nondet_bool();
_x_t3_l0 = __VERIFIER_nondet_bool();
_x_t3_evt1 = __VERIFIER_nondet_bool();
_x_t3_evt0 = __VERIFIER_nondet_bool();
_x_t20_x = __VERIFIER_nondet_float();
_x_t20_l1 = __VERIFIER_nondet_bool();
_x_t20_l0 = __VERIFIER_nondet_bool();
_x_t20_evt1 = __VERIFIER_nondet_bool();
_x_t20_evt0 = __VERIFIER_nondet_bool();
_x_t4_x = __VERIFIER_nondet_float();
_x_t4_l1 = __VERIFIER_nondet_bool();
_x_t4_l0 = __VERIFIER_nondet_bool();
_x_t4_evt1 = __VERIFIER_nondet_bool();
_x_t4_evt0 = __VERIFIER_nondet_bool();
_x_t21_x = __VERIFIER_nondet_float();
_x_t21_l1 = __VERIFIER_nondet_bool();
_x_t21_l0 = __VERIFIER_nondet_bool();
_x_t21_evt1 = __VERIFIER_nondet_bool();
_x_t21_evt0 = __VERIFIER_nondet_bool();
_x_t5_x = __VERIFIER_nondet_float();
_x_t5_l1 = __VERIFIER_nondet_bool();
_x_t5_l0 = __VERIFIER_nondet_bool();
_x_t5_evt1 = __VERIFIER_nondet_bool();
_x_t5_evt0 = __VERIFIER_nondet_bool();
_x_t22_x = __VERIFIER_nondet_float();
_x_t22_l1 = __VERIFIER_nondet_bool();
_x_t22_l0 = __VERIFIER_nondet_bool();
_x_t22_evt1 = __VERIFIER_nondet_bool();
_x_t22_evt0 = __VERIFIER_nondet_bool();
_x_t6_x = __VERIFIER_nondet_float();
_x_t6_l1 = __VERIFIER_nondet_bool();
_x_t6_l0 = __VERIFIER_nondet_bool();
_x_t6_evt1 = __VERIFIER_nondet_bool();
_x_t6_evt0 = __VERIFIER_nondet_bool();
_x_t23_x = __VERIFIER_nondet_float();
_x_t23_l1 = __VERIFIER_nondet_bool();
_x_t23_l0 = __VERIFIER_nondet_bool();
_x_t23_evt1 = __VERIFIER_nondet_bool();
_x_t23_evt0 = __VERIFIER_nondet_bool();
_x_t7_x = __VERIFIER_nondet_float();
_x_t7_l1 = __VERIFIER_nondet_bool();
_x_t7_l0 = __VERIFIER_nondet_bool();
_x_t7_evt1 = __VERIFIER_nondet_bool();
_x_t7_evt0 = __VERIFIER_nondet_bool();
_x_t24_x = __VERIFIER_nondet_float();
_x_t24_l1 = __VERIFIER_nondet_bool();
_x_t24_l0 = __VERIFIER_nondet_bool();
_x_t24_evt1 = __VERIFIER_nondet_bool();
_x_t24_evt0 = __VERIFIER_nondet_bool();
_x_t8_x = __VERIFIER_nondet_float();
_x_t8_l1 = __VERIFIER_nondet_bool();
_x_t8_l0 = __VERIFIER_nondet_bool();
_x_t8_evt1 = __VERIFIER_nondet_bool();
_x_t8_evt0 = __VERIFIER_nondet_bool();
_x_t25_x = __VERIFIER_nondet_float();
_x_t25_l1 = __VERIFIER_nondet_bool();
_x_t25_l0 = __VERIFIER_nondet_bool();
_x_t25_evt1 = __VERIFIER_nondet_bool();
_x_t25_evt0 = __VERIFIER_nondet_bool();
_x_t9_x = __VERIFIER_nondet_float();
_x_t9_l1 = __VERIFIER_nondet_bool();
_x_t9_l0 = __VERIFIER_nondet_bool();
_x_t9_evt1 = __VERIFIER_nondet_bool();
_x_t9_evt0 = __VERIFIER_nondet_bool();
_x_t26_x = __VERIFIER_nondet_float();
_x_t26_l1 = __VERIFIER_nondet_bool();
_x_t26_l0 = __VERIFIER_nondet_bool();
_x_t26_evt1 = __VERIFIER_nondet_bool();
_x_t26_evt0 = __VERIFIER_nondet_bool();
_x_t10_x = __VERIFIER_nondet_float();
_x_t10_l1 = __VERIFIER_nondet_bool();
_x_t10_l0 = __VERIFIER_nondet_bool();
_x_t10_evt1 = __VERIFIER_nondet_bool();
_x_t10_evt0 = __VERIFIER_nondet_bool();
_x_t27_x = __VERIFIER_nondet_float();
_x_t27_l1 = __VERIFIER_nondet_bool();
_x_t27_l0 = __VERIFIER_nondet_bool();
__ok = ((((((((((((((((((((((((((((((((((((((((((((((( !_x_t28_l0) && ( !_x_t28_l1)) || (_x_t28_l0 && ( !_x_t28_l1))) || ((_x_t28_l1 && ( !_x_t28_l0)) || (_x_t28_l0 && _x_t28_l1))) && (((( !_x_t28_evt0) && ( !_x_t28_evt1)) || (_x_t28_evt0 && ( !_x_t28_evt1))) || ((_x_t28_evt1 && ( !_x_t28_evt0)) || (_x_t28_evt0 && _x_t28_evt1)))) && ((( !_x_t28_l0) && ( !_x_t28_l1)) || (_x_t28_x <= 5.0))) && ((((t28_l0 == _x_t28_l0) && (t28_l1 == _x_t28_l1)) && ((delta + (t28_x + (-1.0 * _x_t28_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t28_evt0) && ( !t28_evt1)))))) && ((((_x_t28_l0 && ( !_x_t28_l1)) && (t28_evt0 && ( !t28_evt1))) && (_x_t28_x == 0.0)) || ( !((( !t28_l0) && ( !t28_l1)) && ((delta == 0.0) && ( !(( !t28_evt0) && ( !t28_evt1)))))))) && ((((_x_t28_l1 && ( !_x_t28_l0)) && ( !(t28_x <= 2.0))) && ((t28_evt0 && t28_evt1) && (t28_x == _x_t28_x))) || ( !((t28_l0 && ( !t28_l1)) && ((delta == 0.0) && ( !(( !t28_evt0) && ( !t28_evt1)))))))) && (((t28_x == _x_t28_x) && ((_x_t28_l0 && _x_t28_l1) && (t28_evt0 && t28_evt1))) || ( !((t28_l1 && ( !t28_l0)) && ((delta == 0.0) && ( !(( !t28_evt0) && ( !t28_evt1)))))))) && ((((( !_x_t28_l0) && ( !_x_t28_l1)) && (t28_x <= 5.0)) && ((t28_evt1 && ( !t28_evt0)) && (t28_x == _x_t28_x))) || ( !((t28_l0 && t28_l1) && ((delta == 0.0) && ( !(( !t28_evt0) && ( !t28_evt1)))))))) && (((((((((((( !_x_t27_l0) && ( !_x_t27_l1)) || (_x_t27_l0 && ( !_x_t27_l1))) || ((_x_t27_l1 && ( !_x_t27_l0)) || (_x_t27_l0 && _x_t27_l1))) && (((( !_x_t27_evt0) && ( !_x_t27_evt1)) || (_x_t27_evt0 && ( !_x_t27_evt1))) || ((_x_t27_evt1 && ( !_x_t27_evt0)) || (_x_t27_evt0 && _x_t27_evt1)))) && ((( !_x_t27_l0) && ( !_x_t27_l1)) || (_x_t27_x <= 5.0))) && ((((t27_l0 == _x_t27_l0) && (t27_l1 == _x_t27_l1)) && ((delta + (t27_x + (-1.0 * _x_t27_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t27_evt0) && ( !t27_evt1)))))) && ((((_x_t27_l0 && ( !_x_t27_l1)) && (t27_evt0 && ( !t27_evt1))) && (_x_t27_x == 0.0)) || ( !((( !t27_l0) && ( !t27_l1)) && ((delta == 0.0) && ( !(( !t27_evt0) && ( !t27_evt1)))))))) && ((((_x_t27_l1 && ( !_x_t27_l0)) && ( !(t27_x <= 2.0))) && ((t27_evt0 && t27_evt1) && (t27_x == _x_t27_x))) || ( !((t27_l0 && ( !t27_l1)) && ((delta == 0.0) && ( !(( !t27_evt0) && ( !t27_evt1)))))))) && (((t27_x == _x_t27_x) && ((_x_t27_l0 && _x_t27_l1) && (t27_evt0 && t27_evt1))) || ( !((t27_l1 && ( !t27_l0)) && ((delta == 0.0) && ( !(( !t27_evt0) && ( !t27_evt1)))))))) && ((((( !_x_t27_l0) && ( !_x_t27_l1)) && (t27_x <= 5.0)) && ((t27_evt1 && ( !t27_evt0)) && (t27_x == _x_t27_x))) || ( !((t27_l0 && t27_l1) && ((delta == 0.0) && ( !(( !t27_evt0) && ( !t27_evt1)))))))) && (((((((((((( !_x_t26_l0) && ( !_x_t26_l1)) || (_x_t26_l0 && ( !_x_t26_l1))) || ((_x_t26_l1 && ( !_x_t26_l0)) || (_x_t26_l0 && _x_t26_l1))) && (((( !_x_t26_evt0) && ( !_x_t26_evt1)) || (_x_t26_evt0 && ( !_x_t26_evt1))) || ((_x_t26_evt1 && ( !_x_t26_evt0)) || (_x_t26_evt0 && _x_t26_evt1)))) && ((( !_x_t26_l0) && ( !_x_t26_l1)) || (_x_t26_x <= 5.0))) && ((((t26_l0 == _x_t26_l0) && (t26_l1 == _x_t26_l1)) && ((delta + (t26_x + (-1.0 * _x_t26_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t26_evt0) && ( !t26_evt1)))))) && ((((_x_t26_l0 && ( !_x_t26_l1)) && (t26_evt0 && ( !t26_evt1))) && (_x_t26_x == 0.0)) || ( !((( !t26_l0) && ( !t26_l1)) && ((delta == 0.0) && ( !(( !t26_evt0) && ( !t26_evt1)))))))) && ((((_x_t26_l1 && ( !_x_t26_l0)) && ( !(t26_x <= 2.0))) && ((t26_evt0 && t26_evt1) && (t26_x == _x_t26_x))) || ( !((t26_l0 && ( !t26_l1)) && ((delta == 0.0) && ( !(( !t26_evt0) && ( !t26_evt1)))))))) && (((t26_x == _x_t26_x) && ((_x_t26_l0 && _x_t26_l1) && (t26_evt0 && t26_evt1))) || ( !((t26_l1 && ( !t26_l0)) && ((delta == 0.0) && ( !(( !t26_evt0) && ( !t26_evt1)))))))) && ((((( !_x_t26_l0) && ( !_x_t26_l1)) && (t26_x <= 5.0)) && ((t26_evt1 && ( !t26_evt0)) && (t26_x == _x_t26_x))) || ( !((t26_l0 && t26_l1) && ((delta == 0.0) && ( !(( !t26_evt0) && ( !t26_evt1)))))))) && (((((((((((( !_x_t25_l0) && ( !_x_t25_l1)) || (_x_t25_l0 && ( !_x_t25_l1))) || ((_x_t25_l1 && ( !_x_t25_l0)) || (_x_t25_l0 && _x_t25_l1))) && (((( !_x_t25_evt0) && ( !_x_t25_evt1)) || (_x_t25_evt0 && ( !_x_t25_evt1))) || ((_x_t25_evt1 && ( !_x_t25_evt0)) || (_x_t25_evt0 && _x_t25_evt1)))) && ((( !_x_t25_l0) && ( !_x_t25_l1)) || (_x_t25_x <= 5.0))) && ((((t25_l0 == _x_t25_l0) && (t25_l1 == _x_t25_l1)) && ((delta + (t25_x + (-1.0 * _x_t25_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t25_evt0) && ( !t25_evt1)))))) && ((((_x_t25_l0 && ( !_x_t25_l1)) && (t25_evt0 && ( !t25_evt1))) && (_x_t25_x == 0.0)) || ( !((( !t25_l0) && ( !t25_l1)) && ((delta == 0.0) && ( !(( !t25_evt0) && ( !t25_evt1)))))))) && ((((_x_t25_l1 && ( !_x_t25_l0)) && ( !(t25_x <= 2.0))) && ((t25_evt0 && t25_evt1) && (t25_x == _x_t25_x))) || ( !((t25_l0 && ( !t25_l1)) && ((delta == 0.0) && ( !(( !t25_evt0) && ( !t25_evt1)))))))) && (((t25_x == _x_t25_x) && ((_x_t25_l0 && _x_t25_l1) && (t25_evt0 && t25_evt1))) || ( !((t25_l1 && ( !t25_l0)) && ((delta == 0.0) && ( !(( !t25_evt0) && ( !t25_evt1)))))))) && ((((( !_x_t25_l0) && ( !_x_t25_l1)) && (t25_x <= 5.0)) && ((t25_evt1 && ( !t25_evt0)) && (t25_x == _x_t25_x))) || ( !((t25_l0 && t25_l1) && ((delta == 0.0) && ( !(( !t25_evt0) && ( !t25_evt1)))))))) && (((((((((((( !_x_t24_l0) && ( !_x_t24_l1)) || (_x_t24_l0 && ( !_x_t24_l1))) || ((_x_t24_l1 && ( !_x_t24_l0)) || (_x_t24_l0 && _x_t24_l1))) && (((( !_x_t24_evt0) && ( !_x_t24_evt1)) || (_x_t24_evt0 && ( !_x_t24_evt1))) || ((_x_t24_evt1 && ( !_x_t24_evt0)) || (_x_t24_evt0 && _x_t24_evt1)))) && ((( !_x_t24_l0) && ( !_x_t24_l1)) || (_x_t24_x <= 5.0))) && ((((t24_l0 == _x_t24_l0) && (t24_l1 == _x_t24_l1)) && ((delta + (t24_x + (-1.0 * _x_t24_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t24_evt0) && ( !t24_evt1)))))) && ((((_x_t24_l0 && ( !_x_t24_l1)) && (t24_evt0 && ( !t24_evt1))) && (_x_t24_x == 0.0)) || ( !((( !t24_l0) && ( !t24_l1)) && ((delta == 0.0) && ( !(( !t24_evt0) && ( !t24_evt1)))))))) && ((((_x_t24_l1 && ( !_x_t24_l0)) && ( !(t24_x <= 2.0))) && ((t24_evt0 && t24_evt1) && (t24_x == _x_t24_x))) || ( !((t24_l0 && ( !t24_l1)) && ((delta == 0.0) && ( !(( !t24_evt0) && ( !t24_evt1)))))))) && (((t24_x == _x_t24_x) && ((_x_t24_l0 && _x_t24_l1) && (t24_evt0 && t24_evt1))) || ( !((t24_l1 && ( !t24_l0)) && ((delta == 0.0) && ( !(( !t24_evt0) && ( !t24_evt1)))))))) && ((((( !_x_t24_l0) && ( !_x_t24_l1)) && (t24_x <= 5.0)) && ((t24_evt1 && ( !t24_evt0)) && (t24_x == _x_t24_x))) || ( !((t24_l0 && t24_l1) && ((delta == 0.0) && ( !(( !t24_evt0) && ( !t24_evt1)))))))) && (((((((((((( !_x_t23_l0) && ( !_x_t23_l1)) || (_x_t23_l0 && ( !_x_t23_l1))) || ((_x_t23_l1 && ( !_x_t23_l0)) || (_x_t23_l0 && _x_t23_l1))) && (((( !_x_t23_evt0) && ( !_x_t23_evt1)) || (_x_t23_evt0 && ( !_x_t23_evt1))) || ((_x_t23_evt1 && ( !_x_t23_evt0)) || (_x_t23_evt0 && _x_t23_evt1)))) && ((( !_x_t23_l0) && ( !_x_t23_l1)) || (_x_t23_x <= 5.0))) && ((((t23_l0 == _x_t23_l0) && (t23_l1 == _x_t23_l1)) && ((delta + (t23_x + (-1.0 * _x_t23_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t23_evt0) && ( !t23_evt1)))))) && ((((_x_t23_l0 && ( !_x_t23_l1)) && (t23_evt0 && ( !t23_evt1))) && (_x_t23_x == 0.0)) || ( !((( !t23_l0) && ( !t23_l1)) && ((delta == 0.0) && ( !(( !t23_evt0) && ( !t23_evt1)))))))) && ((((_x_t23_l1 && ( !_x_t23_l0)) && ( !(t23_x <= 2.0))) && ((t23_evt0 && t23_evt1) && (t23_x == _x_t23_x))) || ( !((t23_l0 && ( !t23_l1)) && ((delta == 0.0) && ( !(( !t23_evt0) && ( !t23_evt1)))))))) && (((t23_x == _x_t23_x) && ((_x_t23_l0 && _x_t23_l1) && (t23_evt0 && t23_evt1))) || ( !((t23_l1 && ( !t23_l0)) && ((delta == 0.0) && ( !(( !t23_evt0) && ( !t23_evt1)))))))) && ((((( !_x_t23_l0) && ( !_x_t23_l1)) && (t23_x <= 5.0)) && ((t23_evt1 && ( !t23_evt0)) && (t23_x == _x_t23_x))) || ( !((t23_l0 && t23_l1) && ((delta == 0.0) && ( !(( !t23_evt0) && ( !t23_evt1)))))))) && (((((((((((( !_x_t22_l0) && ( !_x_t22_l1)) || (_x_t22_l0 && ( !_x_t22_l1))) || ((_x_t22_l1 && ( !_x_t22_l0)) || (_x_t22_l0 && _x_t22_l1))) && (((( !_x_t22_evt0) && ( !_x_t22_evt1)) || (_x_t22_evt0 && ( !_x_t22_evt1))) || ((_x_t22_evt1 && ( !_x_t22_evt0)) || (_x_t22_evt0 && _x_t22_evt1)))) && ((( !_x_t22_l0) && ( !_x_t22_l1)) || (_x_t22_x <= 5.0))) && ((((t22_l0 == _x_t22_l0) && (t22_l1 == _x_t22_l1)) && ((delta + (t22_x + (-1.0 * _x_t22_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t22_evt0) && ( !t22_evt1)))))) && ((((_x_t22_l0 && ( !_x_t22_l1)) && (t22_evt0 && ( !t22_evt1))) && (_x_t22_x == 0.0)) || ( !((( !t22_l0) && ( !t22_l1)) && ((delta == 0.0) && ( !(( !t22_evt0) && ( !t22_evt1)))))))) && ((((_x_t22_l1 && ( !_x_t22_l0)) && ( !(t22_x <= 2.0))) && ((t22_evt0 && t22_evt1) && (t22_x == _x_t22_x))) || ( !((t22_l0 && ( !t22_l1)) && ((delta == 0.0) && ( !(( !t22_evt0) && ( !t22_evt1)))))))) && (((t22_x == _x_t22_x) && ((_x_t22_l0 && _x_t22_l1) && (t22_evt0 && t22_evt1))) || ( !((t22_l1 && ( !t22_l0)) && ((delta == 0.0) && ( !(( !t22_evt0) && ( !t22_evt1)))))))) && ((((( !_x_t22_l0) && ( !_x_t22_l1)) && (t22_x <= 5.0)) && ((t22_evt1 && ( !t22_evt0)) && (t22_x == _x_t22_x))) || ( !((t22_l0 && t22_l1) && ((delta == 0.0) && ( !(( !t22_evt0) && ( !t22_evt1)))))))) && (((((((((((( !_x_t21_l0) && ( !_x_t21_l1)) || (_x_t21_l0 && ( !_x_t21_l1))) || ((_x_t21_l1 && ( !_x_t21_l0)) || (_x_t21_l0 && _x_t21_l1))) && (((( !_x_t21_evt0) && ( !_x_t21_evt1)) || (_x_t21_evt0 && ( !_x_t21_evt1))) || ((_x_t21_evt1 && ( !_x_t21_evt0)) || (_x_t21_evt0 && _x_t21_evt1)))) && ((( !_x_t21_l0) && ( !_x_t21_l1)) || (_x_t21_x <= 5.0))) && ((((t21_l0 == _x_t21_l0) && (t21_l1 == _x_t21_l1)) && ((delta + (t21_x + (-1.0 * _x_t21_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t21_evt0) && ( !t21_evt1)))))) && ((((_x_t21_l0 && ( !_x_t21_l1)) && (t21_evt0 && ( !t21_evt1))) && (_x_t21_x == 0.0)) || ( !((( !t21_l0) && ( !t21_l1)) && ((delta == 0.0) && ( !(( !t21_evt0) && ( !t21_evt1)))))))) && ((((_x_t21_l1 && ( !_x_t21_l0)) && ( !(t21_x <= 2.0))) && ((t21_evt0 && t21_evt1) && (t21_x == _x_t21_x))) || ( !((t21_l0 && ( !t21_l1)) && ((delta == 0.0) && ( !(( !t21_evt0) && ( !t21_evt1)))))))) && (((t21_x == _x_t21_x) && ((_x_t21_l0 && _x_t21_l1) && (t21_evt0 && t21_evt1))) || ( !((t21_l1 && ( !t21_l0)) && ((delta == 0.0) && ( !(( !t21_evt0) && ( !t21_evt1)))))))) && ((((( !_x_t21_l0) && ( !_x_t21_l1)) && (t21_x <= 5.0)) && ((t21_evt1 && ( !t21_evt0)) && (t21_x == _x_t21_x))) || ( !((t21_l0 && t21_l1) && ((delta == 0.0) && ( !(( !t21_evt0) && ( !t21_evt1)))))))) && (((((((((((( !_x_t20_l0) && ( !_x_t20_l1)) || (_x_t20_l0 && ( !_x_t20_l1))) || ((_x_t20_l1 && ( !_x_t20_l0)) || (_x_t20_l0 && _x_t20_l1))) && (((( !_x_t20_evt0) && ( !_x_t20_evt1)) || (_x_t20_evt0 && ( !_x_t20_evt1))) || ((_x_t20_evt1 && ( !_x_t20_evt0)) || (_x_t20_evt0 && _x_t20_evt1)))) && ((( !_x_t20_l0) && ( !_x_t20_l1)) || (_x_t20_x <= 5.0))) && ((((t20_l0 == _x_t20_l0) && (t20_l1 == _x_t20_l1)) && ((delta + (t20_x + (-1.0 * _x_t20_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t20_evt0) && ( !t20_evt1)))))) && ((((_x_t20_l0 && ( !_x_t20_l1)) && (t20_evt0 && ( !t20_evt1))) && (_x_t20_x == 0.0)) || ( !((( !t20_l0) && ( !t20_l1)) && ((delta == 0.0) && ( !(( !t20_evt0) && ( !t20_evt1)))))))) && ((((_x_t20_l1 && ( !_x_t20_l0)) && ( !(t20_x <= 2.0))) && ((t20_evt0 && t20_evt1) && (t20_x == _x_t20_x))) || ( !((t20_l0 && ( !t20_l1)) && ((delta == 0.0) && ( !(( !t20_evt0) && ( !t20_evt1)))))))) && (((t20_x == _x_t20_x) && ((_x_t20_l0 && _x_t20_l1) && (t20_evt0 && t20_evt1))) || ( !((t20_l1 && ( !t20_l0)) && ((delta == 0.0) && ( !(( !t20_evt0) && ( !t20_evt1)))))))) && ((((( !_x_t20_l0) && ( !_x_t20_l1)) && (t20_x <= 5.0)) && ((t20_evt1 && ( !t20_evt0)) && (t20_x == _x_t20_x))) || ( !((t20_l0 && t20_l1) && ((delta == 0.0) && ( !(( !t20_evt0) && ( !t20_evt1)))))))) && (((((((((((( !_x_t19_l0) && ( !_x_t19_l1)) || (_x_t19_l0 && ( !_x_t19_l1))) || ((_x_t19_l1 && ( !_x_t19_l0)) || (_x_t19_l0 && _x_t19_l1))) && (((( !_x_t19_evt0) && ( !_x_t19_evt1)) || (_x_t19_evt0 && ( !_x_t19_evt1))) || ((_x_t19_evt1 && ( !_x_t19_evt0)) || (_x_t19_evt0 && _x_t19_evt1)))) && ((( !_x_t19_l0) && ( !_x_t19_l1)) || (_x_t19_x <= 5.0))) && ((((t19_l0 == _x_t19_l0) && (t19_l1 == _x_t19_l1)) && ((delta + (t19_x + (-1.0 * _x_t19_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t19_evt0) && ( !t19_evt1)))))) && ((((_x_t19_l0 && ( !_x_t19_l1)) && (t19_evt0 && ( !t19_evt1))) && (_x_t19_x == 0.0)) || ( !((( !t19_l0) && ( !t19_l1)) && ((delta == 0.0) && ( !(( !t19_evt0) && ( !t19_evt1)))))))) && ((((_x_t19_l1 && ( !_x_t19_l0)) && ( !(t19_x <= 2.0))) && ((t19_evt0 && t19_evt1) && (t19_x == _x_t19_x))) || ( !((t19_l0 && ( !t19_l1)) && ((delta == 0.0) && ( !(( !t19_evt0) && ( !t19_evt1)))))))) && (((t19_x == _x_t19_x) && ((_x_t19_l0 && _x_t19_l1) && (t19_evt0 && t19_evt1))) || ( !((t19_l1 && ( !t19_l0)) && ((delta == 0.0) && ( !(( !t19_evt0) && ( !t19_evt1)))))))) && ((((( !_x_t19_l0) && ( !_x_t19_l1)) && (t19_x <= 5.0)) && ((t19_evt1 && ( !t19_evt0)) && (t19_x == _x_t19_x))) || ( !((t19_l0 && t19_l1) && ((delta == 0.0) && ( !(( !t19_evt0) && ( !t19_evt1)))))))) && (((((((((((( !_x_t18_l0) && ( !_x_t18_l1)) || (_x_t18_l0 && ( !_x_t18_l1))) || ((_x_t18_l1 && ( !_x_t18_l0)) || (_x_t18_l0 && _x_t18_l1))) && (((( !_x_t18_evt0) && ( !_x_t18_evt1)) || (_x_t18_evt0 && ( !_x_t18_evt1))) || ((_x_t18_evt1 && ( !_x_t18_evt0)) || (_x_t18_evt0 && _x_t18_evt1)))) && ((( !_x_t18_l0) && ( !_x_t18_l1)) || (_x_t18_x <= 5.0))) && ((((t18_l0 == _x_t18_l0) && (t18_l1 == _x_t18_l1)) && ((delta + (t18_x + (-1.0 * _x_t18_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t18_evt0) && ( !t18_evt1)))))) && ((((_x_t18_l0 && ( !_x_t18_l1)) && (t18_evt0 && ( !t18_evt1))) && (_x_t18_x == 0.0)) || ( !((( !t18_l0) && ( !t18_l1)) && ((delta == 0.0) && ( !(( !t18_evt0) && ( !t18_evt1)))))))) && ((((_x_t18_l1 && ( !_x_t18_l0)) && ( !(t18_x <= 2.0))) && ((t18_evt0 && t18_evt1) && (t18_x == _x_t18_x))) || ( !((t18_l0 && ( !t18_l1)) && ((delta == 0.0) && ( !(( !t18_evt0) && ( !t18_evt1)))))))) && (((t18_x == _x_t18_x) && ((_x_t18_l0 && _x_t18_l1) && (t18_evt0 && t18_evt1))) || ( !((t18_l1 && ( !t18_l0)) && ((delta == 0.0) && ( !(( !t18_evt0) && ( !t18_evt1)))))))) && ((((( !_x_t18_l0) && ( !_x_t18_l1)) && (t18_x <= 5.0)) && ((t18_evt1 && ( !t18_evt0)) && (t18_x == _x_t18_x))) || ( !((t18_l0 && t18_l1) && ((delta == 0.0) && ( !(( !t18_evt0) && ( !t18_evt1)))))))) && (((((((((((( !_x_t17_l0) && ( !_x_t17_l1)) || (_x_t17_l0 && ( !_x_t17_l1))) || ((_x_t17_l1 && ( !_x_t17_l0)) || (_x_t17_l0 && _x_t17_l1))) && (((( !_x_t17_evt0) && ( !_x_t17_evt1)) || (_x_t17_evt0 && ( !_x_t17_evt1))) || ((_x_t17_evt1 && ( !_x_t17_evt0)) || (_x_t17_evt0 && _x_t17_evt1)))) && ((( !_x_t17_l0) && ( !_x_t17_l1)) || (_x_t17_x <= 5.0))) && ((((t17_l0 == _x_t17_l0) && (t17_l1 == _x_t17_l1)) && ((delta + (t17_x + (-1.0 * _x_t17_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t17_evt0) && ( !t17_evt1)))))) && ((((_x_t17_l0 && ( !_x_t17_l1)) && (t17_evt0 && ( !t17_evt1))) && (_x_t17_x == 0.0)) || ( !((( !t17_l0) && ( !t17_l1)) && ((delta == 0.0) && ( !(( !t17_evt0) && ( !t17_evt1)))))))) && ((((_x_t17_l1 && ( !_x_t17_l0)) && ( !(t17_x <= 2.0))) && ((t17_evt0 && t17_evt1) && (t17_x == _x_t17_x))) || ( !((t17_l0 && ( !t17_l1)) && ((delta == 0.0) && ( !(( !t17_evt0) && ( !t17_evt1)))))))) && (((t17_x == _x_t17_x) && ((_x_t17_l0 && _x_t17_l1) && (t17_evt0 && t17_evt1))) || ( !((t17_l1 && ( !t17_l0)) && ((delta == 0.0) && ( !(( !t17_evt0) && ( !t17_evt1)))))))) && ((((( !_x_t17_l0) && ( !_x_t17_l1)) && (t17_x <= 5.0)) && ((t17_evt1 && ( !t17_evt0)) && (t17_x == _x_t17_x))) || ( !((t17_l0 && t17_l1) && ((delta == 0.0) && ( !(( !t17_evt0) && ( !t17_evt1)))))))) && (((((((((((( !_x_t16_l0) && ( !_x_t16_l1)) || (_x_t16_l0 && ( !_x_t16_l1))) || ((_x_t16_l1 && ( !_x_t16_l0)) || (_x_t16_l0 && _x_t16_l1))) && (((( !_x_t16_evt0) && ( !_x_t16_evt1)) || (_x_t16_evt0 && ( !_x_t16_evt1))) || ((_x_t16_evt1 && ( !_x_t16_evt0)) || (_x_t16_evt0 && _x_t16_evt1)))) && ((( !_x_t16_l0) && ( !_x_t16_l1)) || (_x_t16_x <= 5.0))) && ((((t16_l0 == _x_t16_l0) && (t16_l1 == _x_t16_l1)) && ((delta + (t16_x + (-1.0 * _x_t16_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t16_evt0) && ( !t16_evt1)))))) && ((((_x_t16_l0 && ( !_x_t16_l1)) && (t16_evt0 && ( !t16_evt1))) && (_x_t16_x == 0.0)) || ( !((( !t16_l0) && ( !t16_l1)) && ((delta == 0.0) && ( !(( !t16_evt0) && ( !t16_evt1)))))))) && ((((_x_t16_l1 && ( !_x_t16_l0)) && ( !(t16_x <= 2.0))) && ((t16_evt0 && t16_evt1) && (t16_x == _x_t16_x))) || ( !((t16_l0 && ( !t16_l1)) && ((delta == 0.0) && ( !(( !t16_evt0) && ( !t16_evt1)))))))) && (((t16_x == _x_t16_x) && ((_x_t16_l0 && _x_t16_l1) && (t16_evt0 && t16_evt1))) || ( !((t16_l1 && ( !t16_l0)) && ((delta == 0.0) && ( !(( !t16_evt0) && ( !t16_evt1)))))))) && ((((( !_x_t16_l0) && ( !_x_t16_l1)) && (t16_x <= 5.0)) && ((t16_evt1 && ( !t16_evt0)) && (t16_x == _x_t16_x))) || ( !((t16_l0 && t16_l1) && ((delta == 0.0) && ( !(( !t16_evt0) && ( !t16_evt1)))))))) && (((((((((((( !_x_t15_l0) && ( !_x_t15_l1)) || (_x_t15_l0 && ( !_x_t15_l1))) || ((_x_t15_l1 && ( !_x_t15_l0)) || (_x_t15_l0 && _x_t15_l1))) && (((( !_x_t15_evt0) && ( !_x_t15_evt1)) || (_x_t15_evt0 && ( !_x_t15_evt1))) || ((_x_t15_evt1 && ( !_x_t15_evt0)) || (_x_t15_evt0 && _x_t15_evt1)))) && ((( !_x_t15_l0) && ( !_x_t15_l1)) || (_x_t15_x <= 5.0))) && ((((t15_l0 == _x_t15_l0) && (t15_l1 == _x_t15_l1)) && ((delta + (t15_x + (-1.0 * _x_t15_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t15_evt0) && ( !t15_evt1)))))) && ((((_x_t15_l0 && ( !_x_t15_l1)) && (t15_evt0 && ( !t15_evt1))) && (_x_t15_x == 0.0)) || ( !((( !t15_l0) && ( !t15_l1)) && ((delta == 0.0) && ( !(( !t15_evt0) && ( !t15_evt1)))))))) && ((((_x_t15_l1 && ( !_x_t15_l0)) && ( !(t15_x <= 2.0))) && ((t15_evt0 && t15_evt1) && (t15_x == _x_t15_x))) || ( !((t15_l0 && ( !t15_l1)) && ((delta == 0.0) && ( !(( !t15_evt0) && ( !t15_evt1)))))))) && (((t15_x == _x_t15_x) && ((_x_t15_l0 && _x_t15_l1) && (t15_evt0 && t15_evt1))) || ( !((t15_l1 && ( !t15_l0)) && ((delta == 0.0) && ( !(( !t15_evt0) && ( !t15_evt1)))))))) && ((((( !_x_t15_l0) && ( !_x_t15_l1)) && (t15_x <= 5.0)) && ((t15_evt1 && ( !t15_evt0)) && (t15_x == _x_t15_x))) || ( !((t15_l0 && t15_l1) && ((delta == 0.0) && ( !(( !t15_evt0) && ( !t15_evt1)))))))) && (((((((((((( !_x_t14_l0) && ( !_x_t14_l1)) || (_x_t14_l0 && ( !_x_t14_l1))) || ((_x_t14_l1 && ( !_x_t14_l0)) || (_x_t14_l0 && _x_t14_l1))) && (((( !_x_t14_evt0) && ( !_x_t14_evt1)) || (_x_t14_evt0 && ( !_x_t14_evt1))) || ((_x_t14_evt1 && ( !_x_t14_evt0)) || (_x_t14_evt0 && _x_t14_evt1)))) && ((( !_x_t14_l0) && ( !_x_t14_l1)) || (_x_t14_x <= 5.0))) && ((((t14_l0 == _x_t14_l0) && (t14_l1 == _x_t14_l1)) && ((delta + (t14_x + (-1.0 * _x_t14_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t14_evt0) && ( !t14_evt1)))))) && ((((_x_t14_l0 && ( !_x_t14_l1)) && (t14_evt0 && ( !t14_evt1))) && (_x_t14_x == 0.0)) || ( !((( !t14_l0) && ( !t14_l1)) && ((delta == 0.0) && ( !(( !t14_evt0) && ( !t14_evt1)))))))) && ((((_x_t14_l1 && ( !_x_t14_l0)) && ( !(t14_x <= 2.0))) && ((t14_evt0 && t14_evt1) && (t14_x == _x_t14_x))) || ( !((t14_l0 && ( !t14_l1)) && ((delta == 0.0) && ( !(( !t14_evt0) && ( !t14_evt1)))))))) && (((t14_x == _x_t14_x) && ((_x_t14_l0 && _x_t14_l1) && (t14_evt0 && t14_evt1))) || ( !((t14_l1 && ( !t14_l0)) && ((delta == 0.0) && ( !(( !t14_evt0) && ( !t14_evt1)))))))) && ((((( !_x_t14_l0) && ( !_x_t14_l1)) && (t14_x <= 5.0)) && ((t14_evt1 && ( !t14_evt0)) && (t14_x == _x_t14_x))) || ( !((t14_l0 && t14_l1) && ((delta == 0.0) && ( !(( !t14_evt0) && ( !t14_evt1)))))))) && (((((((((((( !_x_t13_l0) && ( !_x_t13_l1)) || (_x_t13_l0 && ( !_x_t13_l1))) || ((_x_t13_l1 && ( !_x_t13_l0)) || (_x_t13_l0 && _x_t13_l1))) && (((( !_x_t13_evt0) && ( !_x_t13_evt1)) || (_x_t13_evt0 && ( !_x_t13_evt1))) || ((_x_t13_evt1 && ( !_x_t13_evt0)) || (_x_t13_evt0 && _x_t13_evt1)))) && ((( !_x_t13_l0) && ( !_x_t13_l1)) || (_x_t13_x <= 5.0))) && ((((t13_l0 == _x_t13_l0) && (t13_l1 == _x_t13_l1)) && ((delta + (t13_x + (-1.0 * _x_t13_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t13_evt0) && ( !t13_evt1)))))) && ((((_x_t13_l0 && ( !_x_t13_l1)) && (t13_evt0 && ( !t13_evt1))) && (_x_t13_x == 0.0)) || ( !((( !t13_l0) && ( !t13_l1)) && ((delta == 0.0) && ( !(( !t13_evt0) && ( !t13_evt1)))))))) && ((((_x_t13_l1 && ( !_x_t13_l0)) && ( !(t13_x <= 2.0))) && ((t13_evt0 && t13_evt1) && (t13_x == _x_t13_x))) || ( !((t13_l0 && ( !t13_l1)) && ((delta == 0.0) && ( !(( !t13_evt0) && ( !t13_evt1)))))))) && (((t13_x == _x_t13_x) && ((_x_t13_l0 && _x_t13_l1) && (t13_evt0 && t13_evt1))) || ( !((t13_l1 && ( !t13_l0)) && ((delta == 0.0) && ( !(( !t13_evt0) && ( !t13_evt1)))))))) && ((((( !_x_t13_l0) && ( !_x_t13_l1)) && (t13_x <= 5.0)) && ((t13_evt1 && ( !t13_evt0)) && (t13_x == _x_t13_x))) || ( !((t13_l0 && t13_l1) && ((delta == 0.0) && ( !(( !t13_evt0) && ( !t13_evt1)))))))) && (((((((((((( !_x_t12_l0) && ( !_x_t12_l1)) || (_x_t12_l0 && ( !_x_t12_l1))) || ((_x_t12_l1 && ( !_x_t12_l0)) || (_x_t12_l0 && _x_t12_l1))) && (((( !_x_t12_evt0) && ( !_x_t12_evt1)) || (_x_t12_evt0 && ( !_x_t12_evt1))) || ((_x_t12_evt1 && ( !_x_t12_evt0)) || (_x_t12_evt0 && _x_t12_evt1)))) && ((( !_x_t12_l0) && ( !_x_t12_l1)) || (_x_t12_x <= 5.0))) && ((((t12_l0 == _x_t12_l0) && (t12_l1 == _x_t12_l1)) && ((delta + (t12_x + (-1.0 * _x_t12_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t12_evt0) && ( !t12_evt1)))))) && ((((_x_t12_l0 && ( !_x_t12_l1)) && (t12_evt0 && ( !t12_evt1))) && (_x_t12_x == 0.0)) || ( !((( !t12_l0) && ( !t12_l1)) && ((delta == 0.0) && ( !(( !t12_evt0) && ( !t12_evt1)))))))) && ((((_x_t12_l1 && ( !_x_t12_l0)) && ( !(t12_x <= 2.0))) && ((t12_evt0 && t12_evt1) && (t12_x == _x_t12_x))) || ( !((t12_l0 && ( !t12_l1)) && ((delta == 0.0) && ( !(( !t12_evt0) && ( !t12_evt1)))))))) && (((t12_x == _x_t12_x) && ((_x_t12_l0 && _x_t12_l1) && (t12_evt0 && t12_evt1))) || ( !((t12_l1 && ( !t12_l0)) && ((delta == 0.0) && ( !(( !t12_evt0) && ( !t12_evt1)))))))) && ((((( !_x_t12_l0) && ( !_x_t12_l1)) && (t12_x <= 5.0)) && ((t12_evt1 && ( !t12_evt0)) && (t12_x == _x_t12_x))) || ( !((t12_l0 && t12_l1) && ((delta == 0.0) && ( !(( !t12_evt0) && ( !t12_evt1)))))))) && (((((((((((( !_x_t11_l0) && ( !_x_t11_l1)) || (_x_t11_l0 && ( !_x_t11_l1))) || ((_x_t11_l1 && ( !_x_t11_l0)) || (_x_t11_l0 && _x_t11_l1))) && (((( !_x_t11_evt0) && ( !_x_t11_evt1)) || (_x_t11_evt0 && ( !_x_t11_evt1))) || ((_x_t11_evt1 && ( !_x_t11_evt0)) || (_x_t11_evt0 && _x_t11_evt1)))) && ((( !_x_t11_l0) && ( !_x_t11_l1)) || (_x_t11_x <= 5.0))) && ((((t11_l0 == _x_t11_l0) && (t11_l1 == _x_t11_l1)) && ((delta + (t11_x + (-1.0 * _x_t11_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t11_evt0) && ( !t11_evt1)))))) && ((((_x_t11_l0 && ( !_x_t11_l1)) && (t11_evt0 && ( !t11_evt1))) && (_x_t11_x == 0.0)) || ( !((( !t11_l0) && ( !t11_l1)) && ((delta == 0.0) && ( !(( !t11_evt0) && ( !t11_evt1)))))))) && ((((_x_t11_l1 && ( !_x_t11_l0)) && ( !(t11_x <= 2.0))) && ((t11_evt0 && t11_evt1) && (t11_x == _x_t11_x))) || ( !((t11_l0 && ( !t11_l1)) && ((delta == 0.0) && ( !(( !t11_evt0) && ( !t11_evt1)))))))) && (((t11_x == _x_t11_x) && ((_x_t11_l0 && _x_t11_l1) && (t11_evt0 && t11_evt1))) || ( !((t11_l1 && ( !t11_l0)) && ((delta == 0.0) && ( !(( !t11_evt0) && ( !t11_evt1)))))))) && ((((( !_x_t11_l0) && ( !_x_t11_l1)) && (t11_x <= 5.0)) && ((t11_evt1 && ( !t11_evt0)) && (t11_x == _x_t11_x))) || ( !((t11_l0 && t11_l1) && ((delta == 0.0) && ( !(( !t11_evt0) && ( !t11_evt1)))))))) && (((((((((((( !_x_t10_l0) && ( !_x_t10_l1)) || (_x_t10_l0 && ( !_x_t10_l1))) || ((_x_t10_l1 && ( !_x_t10_l0)) || (_x_t10_l0 && _x_t10_l1))) && (((( !_x_t10_evt0) && ( !_x_t10_evt1)) || (_x_t10_evt0 && ( !_x_t10_evt1))) || ((_x_t10_evt1 && ( !_x_t10_evt0)) || (_x_t10_evt0 && _x_t10_evt1)))) && ((( !_x_t10_l0) && ( !_x_t10_l1)) || (_x_t10_x <= 5.0))) && ((((t10_l0 == _x_t10_l0) && (t10_l1 == _x_t10_l1)) && ((delta + (t10_x + (-1.0 * _x_t10_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t10_evt0) && ( !t10_evt1)))))) && ((((_x_t10_l0 && ( !_x_t10_l1)) && (t10_evt0 && ( !t10_evt1))) && (_x_t10_x == 0.0)) || ( !((( !t10_l0) && ( !t10_l1)) && ((delta == 0.0) && ( !(( !t10_evt0) && ( !t10_evt1)))))))) && ((((_x_t10_l1 && ( !_x_t10_l0)) && ( !(t10_x <= 2.0))) && ((t10_evt0 && t10_evt1) && (t10_x == _x_t10_x))) || ( !((t10_l0 && ( !t10_l1)) && ((delta == 0.0) && ( !(( !t10_evt0) && ( !t10_evt1)))))))) && (((t10_x == _x_t10_x) && ((_x_t10_l0 && _x_t10_l1) && (t10_evt0 && t10_evt1))) || ( !((t10_l1 && ( !t10_l0)) && ((delta == 0.0) && ( !(( !t10_evt0) && ( !t10_evt1)))))))) && ((((( !_x_t10_l0) && ( !_x_t10_l1)) && (t10_x <= 5.0)) && ((t10_evt1 && ( !t10_evt0)) && (t10_x == _x_t10_x))) || ( !((t10_l0 && t10_l1) && ((delta == 0.0) && ( !(( !t10_evt0) && ( !t10_evt1)))))))) && (((((((((((( !_x_t9_l0) && ( !_x_t9_l1)) || (_x_t9_l0 && ( !_x_t9_l1))) || ((_x_t9_l1 && ( !_x_t9_l0)) || (_x_t9_l0 && _x_t9_l1))) && (((( !_x_t9_evt0) && ( !_x_t9_evt1)) || (_x_t9_evt0 && ( !_x_t9_evt1))) || ((_x_t9_evt1 && ( !_x_t9_evt0)) || (_x_t9_evt0 && _x_t9_evt1)))) && ((( !_x_t9_l0) && ( !_x_t9_l1)) || (_x_t9_x <= 5.0))) && ((((t9_l0 == _x_t9_l0) && (t9_l1 == _x_t9_l1)) && ((delta + (t9_x + (-1.0 * _x_t9_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t9_evt0) && ( !t9_evt1)))))) && ((((_x_t9_l0 && ( !_x_t9_l1)) && (t9_evt0 && ( !t9_evt1))) && (_x_t9_x == 0.0)) || ( !((( !t9_l0) && ( !t9_l1)) && ((delta == 0.0) && ( !(( !t9_evt0) && ( !t9_evt1)))))))) && ((((_x_t9_l1 && ( !_x_t9_l0)) && ( !(t9_x <= 2.0))) && ((t9_evt0 && t9_evt1) && (t9_x == _x_t9_x))) || ( !((t9_l0 && ( !t9_l1)) && ((delta == 0.0) && ( !(( !t9_evt0) && ( !t9_evt1)))))))) && (((t9_x == _x_t9_x) && ((_x_t9_l0 && _x_t9_l1) && (t9_evt0 && t9_evt1))) || ( !((t9_l1 && ( !t9_l0)) && ((delta == 0.0) && ( !(( !t9_evt0) && ( !t9_evt1)))))))) && ((((( !_x_t9_l0) && ( !_x_t9_l1)) && (t9_x <= 5.0)) && ((t9_evt1 && ( !t9_evt0)) && (t9_x == _x_t9_x))) || ( !((t9_l0 && t9_l1) && ((delta == 0.0) && ( !(( !t9_evt0) && ( !t9_evt1)))))))) && (((((((((((( !_x_t8_l0) && ( !_x_t8_l1)) || (_x_t8_l0 && ( !_x_t8_l1))) || ((_x_t8_l1 && ( !_x_t8_l0)) || (_x_t8_l0 && _x_t8_l1))) && (((( !_x_t8_evt0) && ( !_x_t8_evt1)) || (_x_t8_evt0 && ( !_x_t8_evt1))) || ((_x_t8_evt1 && ( !_x_t8_evt0)) || (_x_t8_evt0 && _x_t8_evt1)))) && ((( !_x_t8_l0) && ( !_x_t8_l1)) || (_x_t8_x <= 5.0))) && ((((t8_l0 == _x_t8_l0) && (t8_l1 == _x_t8_l1)) && ((delta + (t8_x + (-1.0 * _x_t8_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t8_evt0) && ( !t8_evt1)))))) && ((((_x_t8_l0 && ( !_x_t8_l1)) && (t8_evt0 && ( !t8_evt1))) && (_x_t8_x == 0.0)) || ( !((( !t8_l0) && ( !t8_l1)) && ((delta == 0.0) && ( !(( !t8_evt0) && ( !t8_evt1)))))))) && ((((_x_t8_l1 && ( !_x_t8_l0)) && ( !(t8_x <= 2.0))) && ((t8_evt0 && t8_evt1) && (t8_x == _x_t8_x))) || ( !((t8_l0 && ( !t8_l1)) && ((delta == 0.0) && ( !(( !t8_evt0) && ( !t8_evt1)))))))) && (((t8_x == _x_t8_x) && ((_x_t8_l0 && _x_t8_l1) && (t8_evt0 && t8_evt1))) || ( !((t8_l1 && ( !t8_l0)) && ((delta == 0.0) && ( !(( !t8_evt0) && ( !t8_evt1)))))))) && ((((( !_x_t8_l0) && ( !_x_t8_l1)) && (t8_x <= 5.0)) && ((t8_evt1 && ( !t8_evt0)) && (t8_x == _x_t8_x))) || ( !((t8_l0 && t8_l1) && ((delta == 0.0) && ( !(( !t8_evt0) && ( !t8_evt1)))))))) && (((((((((((( !_x_t7_l0) && ( !_x_t7_l1)) || (_x_t7_l0 && ( !_x_t7_l1))) || ((_x_t7_l1 && ( !_x_t7_l0)) || (_x_t7_l0 && _x_t7_l1))) && (((( !_x_t7_evt0) && ( !_x_t7_evt1)) || (_x_t7_evt0 && ( !_x_t7_evt1))) || ((_x_t7_evt1 && ( !_x_t7_evt0)) || (_x_t7_evt0 && _x_t7_evt1)))) && ((( !_x_t7_l0) && ( !_x_t7_l1)) || (_x_t7_x <= 5.0))) && ((((t7_l0 == _x_t7_l0) && (t7_l1 == _x_t7_l1)) && ((delta + (t7_x + (-1.0 * _x_t7_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t7_evt0) && ( !t7_evt1)))))) && ((((_x_t7_l0 && ( !_x_t7_l1)) && (t7_evt0 && ( !t7_evt1))) && (_x_t7_x == 0.0)) || ( !((( !t7_l0) && ( !t7_l1)) && ((delta == 0.0) && ( !(( !t7_evt0) && ( !t7_evt1)))))))) && ((((_x_t7_l1 && ( !_x_t7_l0)) && ( !(t7_x <= 2.0))) && ((t7_evt0 && t7_evt1) && (t7_x == _x_t7_x))) || ( !((t7_l0 && ( !t7_l1)) && ((delta == 0.0) && ( !(( !t7_evt0) && ( !t7_evt1)))))))) && (((t7_x == _x_t7_x) && ((_x_t7_l0 && _x_t7_l1) && (t7_evt0 && t7_evt1))) || ( !((t7_l1 && ( !t7_l0)) && ((delta == 0.0) && ( !(( !t7_evt0) && ( !t7_evt1)))))))) && ((((( !_x_t7_l0) && ( !_x_t7_l1)) && (t7_x <= 5.0)) && ((t7_evt1 && ( !t7_evt0)) && (t7_x == _x_t7_x))) || ( !((t7_l0 && t7_l1) && ((delta == 0.0) && ( !(( !t7_evt0) && ( !t7_evt1)))))))) && (((((((((((( !_x_t6_l0) && ( !_x_t6_l1)) || (_x_t6_l0 && ( !_x_t6_l1))) || ((_x_t6_l1 && ( !_x_t6_l0)) || (_x_t6_l0 && _x_t6_l1))) && (((( !_x_t6_evt0) && ( !_x_t6_evt1)) || (_x_t6_evt0 && ( !_x_t6_evt1))) || ((_x_t6_evt1 && ( !_x_t6_evt0)) || (_x_t6_evt0 && _x_t6_evt1)))) && ((( !_x_t6_l0) && ( !_x_t6_l1)) || (_x_t6_x <= 5.0))) && ((((t6_l0 == _x_t6_l0) && (t6_l1 == _x_t6_l1)) && ((delta + (t6_x + (-1.0 * _x_t6_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t6_evt0) && ( !t6_evt1)))))) && ((((_x_t6_l0 && ( !_x_t6_l1)) && (t6_evt0 && ( !t6_evt1))) && (_x_t6_x == 0.0)) || ( !((( !t6_l0) && ( !t6_l1)) && ((delta == 0.0) && ( !(( !t6_evt0) && ( !t6_evt1)))))))) && ((((_x_t6_l1 && ( !_x_t6_l0)) && ( !(t6_x <= 2.0))) && ((t6_evt0 && t6_evt1) && (t6_x == _x_t6_x))) || ( !((t6_l0 && ( !t6_l1)) && ((delta == 0.0) && ( !(( !t6_evt0) && ( !t6_evt1)))))))) && (((t6_x == _x_t6_x) && ((_x_t6_l0 && _x_t6_l1) && (t6_evt0 && t6_evt1))) || ( !((t6_l1 && ( !t6_l0)) && ((delta == 0.0) && ( !(( !t6_evt0) && ( !t6_evt1)))))))) && ((((( !_x_t6_l0) && ( !_x_t6_l1)) && (t6_x <= 5.0)) && ((t6_evt1 && ( !t6_evt0)) && (t6_x == _x_t6_x))) || ( !((t6_l0 && t6_l1) && ((delta == 0.0) && ( !(( !t6_evt0) && ( !t6_evt1)))))))) && (((((((((((( !_x_t5_l0) && ( !_x_t5_l1)) || (_x_t5_l0 && ( !_x_t5_l1))) || ((_x_t5_l1 && ( !_x_t5_l0)) || (_x_t5_l0 && _x_t5_l1))) && (((( !_x_t5_evt0) && ( !_x_t5_evt1)) || (_x_t5_evt0 && ( !_x_t5_evt1))) || ((_x_t5_evt1 && ( !_x_t5_evt0)) || (_x_t5_evt0 && _x_t5_evt1)))) && ((( !_x_t5_l0) && ( !_x_t5_l1)) || (_x_t5_x <= 5.0))) && ((((t5_l0 == _x_t5_l0) && (t5_l1 == _x_t5_l1)) && ((delta + (t5_x + (-1.0 * _x_t5_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t5_evt0) && ( !t5_evt1)))))) && ((((_x_t5_l0 && ( !_x_t5_l1)) && (t5_evt0 && ( !t5_evt1))) && (_x_t5_x == 0.0)) || ( !((( !t5_l0) && ( !t5_l1)) && ((delta == 0.0) && ( !(( !t5_evt0) && ( !t5_evt1)))))))) && ((((_x_t5_l1 && ( !_x_t5_l0)) && ( !(t5_x <= 2.0))) && ((t5_evt0 && t5_evt1) && (t5_x == _x_t5_x))) || ( !((t5_l0 && ( !t5_l1)) && ((delta == 0.0) && ( !(( !t5_evt0) && ( !t5_evt1)))))))) && (((t5_x == _x_t5_x) && ((_x_t5_l0 && _x_t5_l1) && (t5_evt0 && t5_evt1))) || ( !((t5_l1 && ( !t5_l0)) && ((delta == 0.0) && ( !(( !t5_evt0) && ( !t5_evt1)))))))) && ((((( !_x_t5_l0) && ( !_x_t5_l1)) && (t5_x <= 5.0)) && ((t5_evt1 && ( !t5_evt0)) && (t5_x == _x_t5_x))) || ( !((t5_l0 && t5_l1) && ((delta == 0.0) && ( !(( !t5_evt0) && ( !t5_evt1)))))))) && (((((((((((( !_x_t4_l0) && ( !_x_t4_l1)) || (_x_t4_l0 && ( !_x_t4_l1))) || ((_x_t4_l1 && ( !_x_t4_l0)) || (_x_t4_l0 && _x_t4_l1))) && (((( !_x_t4_evt0) && ( !_x_t4_evt1)) || (_x_t4_evt0 && ( !_x_t4_evt1))) || ((_x_t4_evt1 && ( !_x_t4_evt0)) || (_x_t4_evt0 && _x_t4_evt1)))) && ((( !_x_t4_l0) && ( !_x_t4_l1)) || (_x_t4_x <= 5.0))) && ((((t4_l0 == _x_t4_l0) && (t4_l1 == _x_t4_l1)) && ((delta + (t4_x + (-1.0 * _x_t4_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t4_evt0) && ( !t4_evt1)))))) && ((((_x_t4_l0 && ( !_x_t4_l1)) && (t4_evt0 && ( !t4_evt1))) && (_x_t4_x == 0.0)) || ( !((( !t4_l0) && ( !t4_l1)) && ((delta == 0.0) && ( !(( !t4_evt0) && ( !t4_evt1)))))))) && ((((_x_t4_l1 && ( !_x_t4_l0)) && ( !(t4_x <= 2.0))) && ((t4_evt0 && t4_evt1) && (t4_x == _x_t4_x))) || ( !((t4_l0 && ( !t4_l1)) && ((delta == 0.0) && ( !(( !t4_evt0) && ( !t4_evt1)))))))) && (((t4_x == _x_t4_x) && ((_x_t4_l0 && _x_t4_l1) && (t4_evt0 && t4_evt1))) || ( !((t4_l1 && ( !t4_l0)) && ((delta == 0.0) && ( !(( !t4_evt0) && ( !t4_evt1)))))))) && ((((( !_x_t4_l0) && ( !_x_t4_l1)) && (t4_x <= 5.0)) && ((t4_evt1 && ( !t4_evt0)) && (t4_x == _x_t4_x))) || ( !((t4_l0 && t4_l1) && ((delta == 0.0) && ( !(( !t4_evt0) && ( !t4_evt1)))))))) && (((((((((((( !_x_t3_l0) && ( !_x_t3_l1)) || (_x_t3_l0 && ( !_x_t3_l1))) || ((_x_t3_l1 && ( !_x_t3_l0)) || (_x_t3_l0 && _x_t3_l1))) && (((( !_x_t3_evt0) && ( !_x_t3_evt1)) || (_x_t3_evt0 && ( !_x_t3_evt1))) || ((_x_t3_evt1 && ( !_x_t3_evt0)) || (_x_t3_evt0 && _x_t3_evt1)))) && ((( !_x_t3_l0) && ( !_x_t3_l1)) || (_x_t3_x <= 5.0))) && ((((t3_l0 == _x_t3_l0) && (t3_l1 == _x_t3_l1)) && ((delta + (t3_x + (-1.0 * _x_t3_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t3_evt0) && ( !t3_evt1)))))) && ((((_x_t3_l0 && ( !_x_t3_l1)) && (t3_evt0 && ( !t3_evt1))) && (_x_t3_x == 0.0)) || ( !((( !t3_l0) && ( !t3_l1)) && ((delta == 0.0) && ( !(( !t3_evt0) && ( !t3_evt1)))))))) && ((((_x_t3_l1 && ( !_x_t3_l0)) && ( !(t3_x <= 2.0))) && ((t3_evt0 && t3_evt1) && (t3_x == _x_t3_x))) || ( !((t3_l0 && ( !t3_l1)) && ((delta == 0.0) && ( !(( !t3_evt0) && ( !t3_evt1)))))))) && (((t3_x == _x_t3_x) && ((_x_t3_l0 && _x_t3_l1) && (t3_evt0 && t3_evt1))) || ( !((t3_l1 && ( !t3_l0)) && ((delta == 0.0) && ( !(( !t3_evt0) && ( !t3_evt1)))))))) && ((((( !_x_t3_l0) && ( !_x_t3_l1)) && (t3_x <= 5.0)) && ((t3_evt1 && ( !t3_evt0)) && (t3_x == _x_t3_x))) || ( !((t3_l0 && t3_l1) && ((delta == 0.0) && ( !(( !t3_evt0) && ( !t3_evt1)))))))) && (((((((((((( !_x_t2_l0) && ( !_x_t2_l1)) || (_x_t2_l0 && ( !_x_t2_l1))) || ((_x_t2_l1 && ( !_x_t2_l0)) || (_x_t2_l0 && _x_t2_l1))) && (((( !_x_t2_evt0) && ( !_x_t2_evt1)) || (_x_t2_evt0 && ( !_x_t2_evt1))) || ((_x_t2_evt1 && ( !_x_t2_evt0)) || (_x_t2_evt0 && _x_t2_evt1)))) && ((( !_x_t2_l0) && ( !_x_t2_l1)) || (_x_t2_x <= 5.0))) && ((((t2_l0 == _x_t2_l0) && (t2_l1 == _x_t2_l1)) && ((delta + (t2_x + (-1.0 * _x_t2_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t2_evt0) && ( !t2_evt1)))))) && ((((_x_t2_l0 && ( !_x_t2_l1)) && (t2_evt0 && ( !t2_evt1))) && (_x_t2_x == 0.0)) || ( !((( !t2_l0) && ( !t2_l1)) && ((delta == 0.0) && ( !(( !t2_evt0) && ( !t2_evt1)))))))) && ((((_x_t2_l1 && ( !_x_t2_l0)) && ( !(t2_x <= 2.0))) && ((t2_evt0 && t2_evt1) && (t2_x == _x_t2_x))) || ( !((t2_l0 && ( !t2_l1)) && ((delta == 0.0) && ( !(( !t2_evt0) && ( !t2_evt1)))))))) && (((t2_x == _x_t2_x) && ((_x_t2_l0 && _x_t2_l1) && (t2_evt0 && t2_evt1))) || ( !((t2_l1 && ( !t2_l0)) && ((delta == 0.0) && ( !(( !t2_evt0) && ( !t2_evt1)))))))) && ((((( !_x_t2_l0) && ( !_x_t2_l1)) && (t2_x <= 5.0)) && ((t2_evt1 && ( !t2_evt0)) && (t2_x == _x_t2_x))) || ( !((t2_l0 && t2_l1) && ((delta == 0.0) && ( !(( !t2_evt0) && ( !t2_evt1)))))))) && (((((((((((( !_x_t1_l0) && ( !_x_t1_l1)) || (_x_t1_l0 && ( !_x_t1_l1))) || ((_x_t1_l1 && ( !_x_t1_l0)) || (_x_t1_l0 && _x_t1_l1))) && (((( !_x_t1_evt0) && ( !_x_t1_evt1)) || (_x_t1_evt0 && ( !_x_t1_evt1))) || ((_x_t1_evt1 && ( !_x_t1_evt0)) || (_x_t1_evt0 && _x_t1_evt1)))) && ((( !_x_t1_l0) && ( !_x_t1_l1)) || (_x_t1_x <= 5.0))) && ((((t1_l0 == _x_t1_l0) && (t1_l1 == _x_t1_l1)) && ((delta + (t1_x + (-1.0 * _x_t1_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t1_evt0) && ( !t1_evt1)))))) && ((((_x_t1_l0 && ( !_x_t1_l1)) && (t1_evt0 && ( !t1_evt1))) && (_x_t1_x == 0.0)) || ( !((( !t1_l0) && ( !t1_l1)) && ((delta == 0.0) && ( !(( !t1_evt0) && ( !t1_evt1)))))))) && ((((_x_t1_l1 && ( !_x_t1_l0)) && ( !(t1_x <= 2.0))) && ((t1_evt0 && t1_evt1) && (t1_x == _x_t1_x))) || ( !((t1_l0 && ( !t1_l1)) && ((delta == 0.0) && ( !(( !t1_evt0) && ( !t1_evt1)))))))) && (((t1_x == _x_t1_x) && ((_x_t1_l0 && _x_t1_l1) && (t1_evt0 && t1_evt1))) || ( !((t1_l1 && ( !t1_l0)) && ((delta == 0.0) && ( !(( !t1_evt0) && ( !t1_evt1)))))))) && ((((( !_x_t1_l0) && ( !_x_t1_l1)) && (t1_x <= 5.0)) && ((t1_evt1 && ( !t1_evt0)) && (t1_x == _x_t1_x))) || ( !((t1_l0 && t1_l1) && ((delta == 0.0) && ( !(( !t1_evt0) && ( !t1_evt1)))))))) && (((((((((((( !_x_t0_l0) && ( !_x_t0_l1)) || (_x_t0_l0 && ( !_x_t0_l1))) || ((_x_t0_l1 && ( !_x_t0_l0)) || (_x_t0_l0 && _x_t0_l1))) && (((( !_x_t0_evt0) && ( !_x_t0_evt1)) || (_x_t0_evt0 && ( !_x_t0_evt1))) || ((_x_t0_evt1 && ( !_x_t0_evt0)) || (_x_t0_evt0 && _x_t0_evt1)))) && ((( !_x_t0_l0) && ( !_x_t0_l1)) || (_x_t0_x <= 5.0))) && ((((t0_l0 == _x_t0_l0) && (t0_l1 == _x_t0_l1)) && ((delta + (t0_x + (-1.0 * _x_t0_x))) == 0.0)) || ( !(( !(delta <= 0.0)) || (( !t0_evt0) && ( !t0_evt1)))))) && ((((_x_t0_l0 && ( !_x_t0_l1)) && (t0_evt0 && ( !t0_evt1))) && (_x_t0_x == 0.0)) || ( !((( !t0_l0) && ( !t0_l1)) && ((delta == 0.0) && ( !(( !t0_evt0) && ( !t0_evt1)))))))) && ((((_x_t0_l1 && ( !_x_t0_l0)) && ( !(t0_x <= 2.0))) && ((t0_evt0 && t0_evt1) && (t0_x == _x_t0_x))) || ( !((t0_l0 && ( !t0_l1)) && ((delta == 0.0) && ( !(( !t0_evt0) && ( !t0_evt1)))))))) && (((t0_x == _x_t0_x) && ((_x_t0_l0 && _x_t0_l1) && (t0_evt0 && t0_evt1))) || ( !((t0_l1 && ( !t0_l0)) && ((delta == 0.0) && ( !(( !t0_evt0) && ( !t0_evt1)))))))) && ((((( !_x_t0_l0) && ( !_x_t0_l1)) && (t0_x <= 5.0)) && ((t0_evt1 && ( !t0_evt0)) && (t0_x == _x_t0_x))) || ( !((t0_l0 && t0_l1) && ((delta == 0.0) && ( !(( !t0_evt0) && ( !t0_evt1)))))))) && (((((((((((((((((( !_x_controller_l0) && ( !_x_controller_l1)) || (_x_controller_l0 && ( !_x_controller_l1))) || ((_x_controller_l1 && ( !_x_controller_l0)) || (_x_controller_l0 && _x_controller_l1))) && (((( !_x_controller_evt2) && (( !_x_controller_evt0) && ( !_x_controller_evt1))) || (( !_x_controller_evt2) && (_x_controller_evt0 && ( !_x_controller_evt1)))) || ((( !_x_controller_evt2) && (_x_controller_evt1 && ( !_x_controller_evt0))) || ((( !_x_controller_evt2) && (_x_controller_evt0 && _x_controller_evt1)) || (_x_controller_evt2 && (( !_x_controller_evt0) && ( !_x_controller_evt1))))))) && (((((((((((((((((((((((((((((((_x_controller_cnt == 0) || (_x_controller_cnt == 1)) || (_x_controller_cnt == 2)) || (_x_controller_cnt == 3)) || (_x_controller_cnt == 4)) || (_x_controller_cnt == 5)) || (_x_controller_cnt == 6)) || (_x_controller_cnt == 7)) || (_x_controller_cnt == 8)) || (_x_controller_cnt == 9)) || (_x_controller_cnt == 10)) || (_x_controller_cnt == 11)) || (_x_controller_cnt == 12)) || (_x_controller_cnt == 13)) || (_x_controller_cnt == 14)) || (_x_controller_cnt == 15)) || (_x_controller_cnt == 16)) || (_x_controller_cnt == 17)) || (_x_controller_cnt == 18)) || (_x_controller_cnt == 19)) || (_x_controller_cnt == 20)) || (_x_controller_cnt == 21)) || (_x_controller_cnt == 22)) || (_x_controller_cnt == 23)) || (_x_controller_cnt == 24)) || (_x_controller_cnt == 25)) || (_x_controller_cnt == 26)) || (_x_controller_cnt == 27)) || (_x_controller_cnt == 28)) || (_x_controller_cnt == 29)) || (_x_controller_cnt == 30))) && ((_x_controller_z <= 1.0) || ( !((_x_controller_l0 && ( !_x_controller_l1)) || (_x_controller_l0 && _x_controller_l1))))) && (((((controller_l0 == _x_controller_l0) && (controller_l1 == _x_controller_l1)) && ((delta + (controller_z + (-1.0 * _x_controller_z))) == 0.0)) && (controller_cnt == _x_controller_cnt)) || ( !(( !(delta <= 0.0)) || (( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))))) && ((((_x_controller_l0 && ( !_x_controller_l1)) && (( !controller_evt2) && (controller_evt0 && ( !controller_evt1)))) && ((_x_controller_cnt == 1) && (_x_controller_z == 0.0))) || ( !((( !controller_l0) && ( !controller_l1)) && ((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))))))) && (((controller_z == _x_controller_z) && ((_x_controller_l0 && ( !_x_controller_l1)) || (_x_controller_l1 && ( !_x_controller_l0)))) || ( !((controller_l0 && ( !controller_l1)) && ((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))))))) && ((((( !controller_evt2) && (controller_evt0 && ( !controller_evt1))) && ((controller_cnt + (-1 * _x_controller_cnt)) == -1)) || ((( !controller_evt2) && (controller_evt1 && ( !controller_evt0))) && ((controller_cnt + (-1 * _x_controller_cnt)) == 1))) || ( !(((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))) && ((controller_l0 && ( !controller_l1)) && (_x_controller_l0 && ( !_x_controller_l1))))))) && (((( !controller_evt2) && (controller_evt0 && controller_evt1)) && ((controller_cnt == _x_controller_cnt) && (controller_z == 1.0))) || ( !(((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))) && ((controller_l0 && ( !controller_l1)) && (_x_controller_l1 && ( !_x_controller_l0))))))) && (((_x_controller_l1 && ( !_x_controller_l0)) || (_x_controller_l0 && _x_controller_l1)) || ( !((controller_l1 && ( !controller_l0)) && ((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))))))) && (((controller_z == _x_controller_z) && (((( !controller_evt2) && (controller_evt0 && ( !controller_evt1))) && ((controller_cnt + (-1 * _x_controller_cnt)) == -1)) || (((( !controller_evt2) && (controller_evt1 && ( !controller_evt0))) && ((controller_cnt + (-1 * _x_controller_cnt)) == 1)) && ( !(controller_cnt <= 1))))) || ( !(((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))) && ((controller_l1 && ( !controller_l0)) && (_x_controller_l1 && ( !_x_controller_l0))))))) && ((((( !controller_evt2) && (controller_evt1 && ( !controller_evt0))) && (controller_cnt == 1)) && ((_x_controller_cnt == 0) && (_x_controller_z == 0.0))) || ( !(((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))) && ((controller_l1 && ( !controller_l0)) && (_x_controller_l0 && _x_controller_l1)))))) && (((controller_z == _x_controller_z) && ((( !_x_controller_l0) && ( !_x_controller_l1)) || (_x_controller_l1 && ( !_x_controller_l0)))) || ( !((controller_l0 && controller_l1) && ((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))))))) && ((((controller_cnt + (-1 * _x_controller_cnt)) == -1) && ((( !controller_evt2) && (controller_evt0 && ( !controller_evt1))) && (controller_z <= 1.0))) || ( !(((delta == 0.0) && ( !(( !controller_evt2) && (( !controller_evt0) && ( !controller_evt1))))) && ((_x_controller_l1 && ( !_x_controller_l0)) && (controller_l0 && controller_l1)))))) && ((((((((((((( !_x_gate_l0) && ( !_x_gate_l1)) || (_x_gate_l0 && ( !_x_gate_l1))) || ((_x_gate_l1 && ( !_x_gate_l0)) || (_x_gate_l0 && _x_gate_l1))) && (((( !_x_gate_evt0) && ( !_x_gate_evt1)) || (_x_gate_evt0 && ( !_x_gate_evt1))) || ((_x_gate_evt1 && ( !_x_gate_evt0)) || (_x_gate_evt0 && _x_gate_evt1)))) && ((_x_gate_y <= 1.0) || ( !(_x_gate_l0 && ( !_x_gate_l1))))) && ((_x_gate_y <= 2.0) || ( !(_x_gate_l0 && _x_gate_l1)))) && ((((gate_l0 == _x_gate_l0) && (gate_l1 == _x_gate_l1)) && ((delta + (gate_y + (-1.0 * _x_gate_y))) == 0.0)) || ( !((( !gate_evt0) && ( !gate_evt1)) || ( !(delta <= 0.0)))))) && ((((_x_gate_l0 && ( !_x_gate_l1)) && (gate_evt0 && ( !gate_evt1))) && (_x_gate_y == 0.0)) || ( !((( !gate_l0) && ( !gate_l1)) && ((delta == 0.0) && ( !(( !gate_evt0) && ( !gate_evt1)))))))) && ((((_x_gate_l1 && ( !_x_gate_l0)) && (gate_evt0 && gate_evt1)) && ((gate_y <= 1.0) && (gate_y == _x_gate_y))) || ( !((gate_l0 && ( !gate_l1)) && ((delta == 0.0) && ( !(( !gate_evt0) && ( !gate_evt1)))))))) && (((_x_gate_y == 0.0) && ((_x_gate_l0 && _x_gate_l1) && (gate_evt1 && ( !gate_evt0)))) || ( !((gate_l1 && ( !gate_l0)) && ((delta == 0.0) && ( !(( !gate_evt0) && ( !gate_evt1)))))))) && (((gate_y == _x_gate_y) && (((( !_x_gate_l0) && ( !_x_gate_l1)) && (1.0 <= gate_y)) && ((gate_evt0 && gate_evt1) && (gate_y <= 2.0)))) || ( !((gate_l0 && gate_l1) && ((delta == 0.0) && ( !(( !gate_evt0) && ( !gate_evt1)))))))) && (0.0 <= _x_delta)))))))))))))))))))))))))))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t0_evt0) && ( !t0_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t1_evt0) && ( !t1_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t2_evt0) && ( !t2_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t3_evt0) && ( !t3_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t4_evt0) && ( !t4_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t5_evt0) && ( !t5_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t6_evt0) && ( !t6_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t7_evt0) && ( !t7_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t8_evt0) && ( !t8_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t9_evt0) && ( !t9_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t10_evt0) && ( !t10_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t11_evt0) && ( !t11_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t12_evt0) && ( !t12_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t13_evt0) && ( !t13_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t14_evt0) && ( !t14_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t15_evt0) && ( !t15_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t16_evt0) && ( !t16_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t17_evt0) && ( !t17_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t18_evt0) && ( !t18_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t19_evt0) && ( !t19_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t20_evt0) && ( !t20_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t21_evt0) && ( !t21_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t22_evt0) && ( !t22_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t23_evt0) && ( !t23_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t24_evt0) && ( !t24_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t25_evt0) && ( !t25_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t26_evt0) && ( !t26_evt1))))))) && ((( !t28_evt0) && ( !t28_evt1)) || ( !((delta == 0.0) && ( !(( !t27_evt0) && ( !t27_evt1))))))) && ((( !t27_evt0) && ( !t27_evt1)) || ( !((delta == 0.0) && ( !(( !t28_evt0) && ( !t28_evt1))))))) && (((gate_evt0 && ( !gate_evt1)) == (( !controller_evt2) && (controller_evt0 && controller_evt1))) || ( !(delta == 0.0)))) && (( !(delta == 0.0)) || ((gate_evt1 && ( !gate_evt0)) == (controller_evt2 && (( !controller_evt0) && ( !controller_evt1)))))) && (( !(delta == 0.0)) || ((( !controller_evt2) && (controller_evt0 && ( !controller_evt1))) == ((t28_evt0 && ( !t28_evt1)) || ((t27_evt0 && ( !t27_evt1)) || ((t26_evt0 && ( !t26_evt1)) || ((t25_evt0 && ( !t25_evt1)) || ((t24_evt0 && ( !t24_evt1)) || ((t23_evt0 && ( !t23_evt1)) || ((t22_evt0 && ( !t22_evt1)) || ((t21_evt0 && ( !t21_evt1)) || ((t20_evt0 && ( !t20_evt1)) || ((t19_evt0 && ( !t19_evt1)) || ((t18_evt0 && ( !t18_evt1)) || ((t17_evt0 && ( !t17_evt1)) || ((t16_evt0 && ( !t16_evt1)) || ((t15_evt0 && ( !t15_evt1)) || ((t14_evt0 && ( !t14_evt1)) || ((t13_evt0 && ( !t13_evt1)) || ((t12_evt0 && ( !t12_evt1)) || ((t11_evt0 && ( !t11_evt1)) || ((t10_evt0 && ( !t10_evt1)) || ((t9_evt0 && ( !t9_evt1)) || ((t8_evt0 && ( !t8_evt1)) || ((t7_evt0 && ( !t7_evt1)) || ((t6_evt0 && ( !t6_evt1)) || ((t5_evt0 && ( !t5_evt1)) || ((t4_evt0 && ( !t4_evt1)) || ((t3_evt0 && ( !t3_evt1)) || ((t2_evt0 && ( !t2_evt1)) || ((t0_evt0 && ( !t0_evt1)) || (t1_evt0 && ( !t1_evt1))))))))))))))))))))))))))))))))) && (( !(delta == 0.0)) || ((( !controller_evt2) && (controller_evt1 && ( !controller_evt0))) == ((t28_evt1 && ( !t28_evt0)) || ((t27_evt1 && ( !t27_evt0)) || ((t26_evt1 && ( !t26_evt0)) || ((t25_evt1 && ( !t25_evt0)) || ((t24_evt1 && ( !t24_evt0)) || ((t23_evt1 && ( !t23_evt0)) || ((t22_evt1 && ( !t22_evt0)) || ((t21_evt1 && ( !t21_evt0)) || ((t20_evt1 && ( !t20_evt0)) || ((t19_evt1 && ( !t19_evt0)) || ((t18_evt1 && ( !t18_evt0)) || ((t17_evt1 && ( !t17_evt0)) || ((t16_evt1 && ( !t16_evt0)) || ((t15_evt1 && ( !t15_evt0)) || ((t14_evt1 && ( !t14_evt0)) || ((t13_evt1 && ( !t13_evt0)) || ((t12_evt1 && ( !t12_evt0)) || ((t11_evt1 && ( !t11_evt0)) || ((t10_evt1 && ( !t10_evt0)) || ((t9_evt1 && ( !t9_evt0)) || ((t8_evt1 && ( !t8_evt0)) || ((t7_evt1 && ( !t7_evt0)) || ((t6_evt1 && ( !t6_evt0)) || ((t5_evt1 && ( !t5_evt0)) || ((t4_evt1 && ( !t4_evt0)) || ((t3_evt1 && ( !t3_evt0)) || ((t2_evt1 && ( !t2_evt0)) || ((t0_evt1 && ( !t0_evt0)) || (t1_evt1 && ( !t1_evt0))))))))))))))))))))))))))))))))) && (((delta == _x__diverge_delta) || ( !(1.0 <= _diverge_delta))) && ((1.0 <= _diverge_delta) || ((delta + (_diverge_delta + (-1.0 * _x__diverge_delta))) == 0.0)))) && ((((((_EL_U_3723 == (_x__EL_U_3723 || ( !(_x__EL_U_3721 || (1.0 <= _x__diverge_delta))))) && ((_EL_U_3721 == (_x__EL_U_3721 || (1.0 <= _x__diverge_delta))) && ((_EL_U_3728 == (_x__EL_U_3728 || ( !((_x__EL_U_3725 || ((_x_gate_l1 && ( !_x_gate_l0)) && (_x__EL_X_3689 && _x__EL_X_3691))) || ( !((( !_x_gate_l0) && ( !_x_gate_l1)) && (_x__EL_X_3691 && ( !_x__EL_X_3689)))))))) && ((_EL_U_3725 == (_x__EL_U_3725 || ((_x_gate_l1 && ( !_x_gate_l0)) && (_x__EL_X_3689 && _x__EL_X_3691)))) && ((_x_gate_l0 == _EL_X_3691) && (_x_gate_l1 == _EL_X_3689)))))) && (_x__J3758 == (( !(((_J3758 && _J3775) && _J3781) && _J3787)) && ((((_J3758 && _J3775) && _J3781) && _J3787) || ((((gate_l1 && ( !gate_l0)) && (_EL_X_3691 && _EL_X_3689)) || ( !(_EL_U_3725 || ((gate_l1 && ( !gate_l0)) && (_EL_X_3691 && _EL_X_3689))))) || _J3758))))) && (_x__J3775 == (( !(((_J3758 && _J3775) && _J3781) && _J3787)) && ((((_J3758 && _J3775) && _J3781) && _J3787) || ((( !((_EL_U_3725 || ((gate_l1 && ( !gate_l0)) && (_EL_X_3691 && _EL_X_3689))) || ( !((( !gate_l0) && ( !gate_l1)) && (_EL_X_3691 && ( !_EL_X_3689)))))) || ( !(_EL_U_3728 || ( !((_EL_U_3725 || ((gate_l1 && ( !gate_l0)) && (_EL_X_3691 && _EL_X_3689))) || ( !((( !gate_l0) && ( !gate_l1)) && (_EL_X_3691 && ( !_EL_X_3689))))))))) || _J3775))))) && (_x__J3781 == (( !(((_J3758 && _J3775) && _J3781) && _J3787)) && ((((_J3758 && _J3775) && _J3781) && _J3787) || (((1.0 <= _diverge_delta) || ( !((1.0 <= _diverge_delta) || _EL_U_3721))) || _J3781))))) && (_x__J3787 == (( !(((_J3758 && _J3775) && _J3781) && _J3787)) && ((((_J3758 && _J3775) && _J3781) && _J3787) || ((( !((1.0 <= _diverge_delta) || _EL_U_3721)) || ( !(_EL_U_3723 || ( !((1.0 <= _diverge_delta) || _EL_U_3721))))) || _J3787))))));
_diverge_delta = _x__diverge_delta;
t27_evt1 = _x_t27_evt1;
t27_evt0 = _x_t27_evt0;
delta = _x_delta;
gate_l1 = _x_gate_l1;
gate_l0 = _x_gate_l0;
t11_x = _x_t11_x;
t11_l1 = _x_t11_l1;
gate_y = _x_gate_y;
t11_l0 = _x_t11_l0;
t11_evt1 = _x_t11_evt1;
t11_evt0 = _x_t11_evt0;
gate_evt1 = _x_gate_evt1;
gate_evt0 = _x_gate_evt0;
t28_x = _x_t28_x;
t28_l1 = _x_t28_l1;
t28_l0 = _x_t28_l0;
t28_evt1 = _x_t28_evt1;
t28_evt0 = _x_t28_evt0;
t12_x = _x_t12_x;
t12_l1 = _x_t12_l1;
t12_l0 = _x_t12_l0;
controller_l1 = _x_controller_l1;
t12_evt1 = _x_t12_evt1;
t12_evt0 = _x_t12_evt0;
controller_l0 = _x_controller_l0;
controller_z = _x_controller_z;
_J3787 = _x__J3787;
controller_cnt = _x_controller_cnt;
_J3781 = _x__J3781;
_J3775 = _x__J3775;
_J3758 = _x__J3758;
_EL_U_3721 = _x__EL_U_3721;
_EL_U_3723 = _x__EL_U_3723;
_EL_X_3689 = _x__EL_X_3689;
t13_x = _x_t13_x;
_EL_X_3691 = _x__EL_X_3691;
t13_l1 = _x_t13_l1;
t13_l0 = _x_t13_l0;
_EL_U_3725 = _x__EL_U_3725;
t13_evt1 = _x_t13_evt1;
t13_evt0 = _x_t13_evt0;
_EL_U_3728 = _x__EL_U_3728;
t14_x = _x_t14_x;
t14_l1 = _x_t14_l1;
t14_l0 = _x_t14_l0;
t14_evt1 = _x_t14_evt1;
t14_evt0 = _x_t14_evt0;
t15_x = _x_t15_x;
t15_l1 = _x_t15_l1;
t15_l0 = _x_t15_l0;
t15_evt1 = _x_t15_evt1;
t15_evt0 = _x_t15_evt0;
controller_evt1 = _x_controller_evt1;
controller_evt0 = _x_controller_evt0;
controller_evt2 = _x_controller_evt2;
t16_x = _x_t16_x;
t16_l1 = _x_t16_l1;
t16_l0 = _x_t16_l0;
t16_evt1 = _x_t16_evt1;
t16_evt0 = _x_t16_evt0;
t0_x = _x_t0_x;
t0_l1 = _x_t0_l1;
t0_l0 = _x_t0_l0;
t0_evt1 = _x_t0_evt1;
t0_evt0 = _x_t0_evt0;
t17_x = _x_t17_x;
t17_l1 = _x_t17_l1;
t17_l0 = _x_t17_l0;
t17_evt1 = _x_t17_evt1;
t17_evt0 = _x_t17_evt0;
t1_x = _x_t1_x;
t1_l1 = _x_t1_l1;
t1_l0 = _x_t1_l0;
t1_evt1 = _x_t1_evt1;
t1_evt0 = _x_t1_evt0;
t18_x = _x_t18_x;
t18_l1 = _x_t18_l1;
t18_l0 = _x_t18_l0;
t18_evt1 = _x_t18_evt1;
t18_evt0 = _x_t18_evt0;
t2_x = _x_t2_x;
t2_l1 = _x_t2_l1;
t2_l0 = _x_t2_l0;
t2_evt1 = _x_t2_evt1;
t2_evt0 = _x_t2_evt0;
t19_x = _x_t19_x;
t19_l1 = _x_t19_l1;
t19_l0 = _x_t19_l0;
t19_evt1 = _x_t19_evt1;
t19_evt0 = _x_t19_evt0;
t3_x = _x_t3_x;
t3_l1 = _x_t3_l1;
t3_l0 = _x_t3_l0;
t3_evt1 = _x_t3_evt1;
t3_evt0 = _x_t3_evt0;
t20_x = _x_t20_x;
t20_l1 = _x_t20_l1;
t20_l0 = _x_t20_l0;
t20_evt1 = _x_t20_evt1;
t20_evt0 = _x_t20_evt0;
t4_x = _x_t4_x;
t4_l1 = _x_t4_l1;
t4_l0 = _x_t4_l0;
t4_evt1 = _x_t4_evt1;
t4_evt0 = _x_t4_evt0;
t21_x = _x_t21_x;
t21_l1 = _x_t21_l1;
t21_l0 = _x_t21_l0;
t21_evt1 = _x_t21_evt1;
t21_evt0 = _x_t21_evt0;
t5_x = _x_t5_x;
t5_l1 = _x_t5_l1;
t5_l0 = _x_t5_l0;
t5_evt1 = _x_t5_evt1;
t5_evt0 = _x_t5_evt0;
t22_x = _x_t22_x;
t22_l1 = _x_t22_l1;
t22_l0 = _x_t22_l0;
t22_evt1 = _x_t22_evt1;
t22_evt0 = _x_t22_evt0;
t6_x = _x_t6_x;
t6_l1 = _x_t6_l1;
t6_l0 = _x_t6_l0;
t6_evt1 = _x_t6_evt1;
t6_evt0 = _x_t6_evt0;
t23_x = _x_t23_x;
t23_l1 = _x_t23_l1;
t23_l0 = _x_t23_l0;
t23_evt1 = _x_t23_evt1;
t23_evt0 = _x_t23_evt0;
t7_x = _x_t7_x;
t7_l1 = _x_t7_l1;
t7_l0 = _x_t7_l0;
t7_evt1 = _x_t7_evt1;
t7_evt0 = _x_t7_evt0;
t24_x = _x_t24_x;
t24_l1 = _x_t24_l1;
t24_l0 = _x_t24_l0;
t24_evt1 = _x_t24_evt1;
t24_evt0 = _x_t24_evt0;
t8_x = _x_t8_x;
t8_l1 = _x_t8_l1;
t8_l0 = _x_t8_l0;
t8_evt1 = _x_t8_evt1;
t8_evt0 = _x_t8_evt0;
t25_x = _x_t25_x;
t25_l1 = _x_t25_l1;
t25_l0 = _x_t25_l0;
t25_evt1 = _x_t25_evt1;
t25_evt0 = _x_t25_evt0;
t9_x = _x_t9_x;
t9_l1 = _x_t9_l1;
t9_l0 = _x_t9_l0;
t9_evt1 = _x_t9_evt1;
t9_evt0 = _x_t9_evt0;
t26_x = _x_t26_x;
t26_l1 = _x_t26_l1;
t26_l0 = _x_t26_l0;
t26_evt1 = _x_t26_evt1;
t26_evt0 = _x_t26_evt0;
t10_x = _x_t10_x;
t10_l1 = _x_t10_l1;
t10_l0 = _x_t10_l0;
t10_evt1 = _x_t10_evt1;
t10_evt0 = _x_t10_evt0;
t27_x = _x_t27_x;
t27_l1 = _x_t27_l1;
t27_l0 = _x_t27_l0;
}
}
|
the_stack_data/51701597.c | /* { dg-do run } */
/* { dg-options "-O2" } */
void abort (void);
__attribute__ ((noinline)) void
f (int i)
{
#if(__SIZEOF_INT__ >= 4)
if (i != 0x87654321)
#else
if (i != 0x4321)
#endif
abort ();
asm ("");
}
__attribute__ ((noinline)) void
g (long long a)
{
f (a);
asm ("");
}
int
main ()
{
g (0x1234567887654321ll);
return 0;
}
|
the_stack_data/103665.c | /* checks if the character entered is in lower case */
#include <stdio.h>
#include <stdlib.h>
typedef enum {false=0, true=1} bool;
/* run this program using the console pauser or add your own getch, system("pause") or input loop */
bool LowerCheck(char ch);
int main(int argc, char *argv[]) {
char ch;
bool result;
printf("Enter the character: ");
scanf("%c",&ch);
result=LowerCheck(ch);
if(result)
printf("\n Is Lower case \n");
else
printf("\n Not Lower case \n");
return 0;
}
bool LowerCheck(char ch)
{
if ((ch>=97) && (ch<=122))
return(true);
else
return(false);
}
|
the_stack_data/162642123.c | //don't get trapped, there's no need
//level by bla
#include <sys/mman.h>
#include <stdlib.h>
#include <stdio.h>
#include <string.h>
#define LOADERSIZE (232 + 16)
void* getASLRregion(int size, int flags);
void switchcontext(char* newstack, char* code);
int main(int argc, char* argv[], char* env[])
{
char *newcode, *newstack;
//allocate memory at random addresses
newstack = getASLRregion(64 * 1024, PROT_READ | PROT_WRITE );
newcode = getASLRregion(64 * 1024, PROT_READ | PROT_WRITE | PROT_EXEC);
if(argc > 1)
if(!strchr(argv[1], 0xcd))
if(!strchr(argv[1], 0xe8))
if(!strstr(argv[1], "\x0F\x34"))
if(!strchr(argv[1], 0xdb)) {
//prepare new code section, leaving some space for a loader
strncpy(newcode + LOADERSIZE, argv[1], 1000);
//start executing using a new stack and code section.
switchcontext(newstack + 64 * 1024, newcode);
}
return 0;
}
/*************************************************************************************************************************/
/* HALT! The code below only provides a controllable aslr/noexec for this challenge, there's no need to waste time on it */
/*************************************************************************************************************************/
void __attribute__((constructor))initializePRNG(){int seed;FILE*devrand=fopen("/dev/random","r");if(devrand==0)exit(-1);
if(fread(&seed, 4, 1, devrand) != 1)exit(-1);fclose(devrand);srand(seed);}unsigned int loader[100]={0xe899c031,0};void*
getASLRregion(int size, int flags){int tries=1000,hint,res;while(tries--){hint=rand()<<12;res=(int)mmap((void*)hint,size
+4096,flags,MAP_PRIVATE|MAP_ANONYMOUS,0,0);if(hint==res){loader[++loader[1]+1]=hint;return (void*)(res+(rand()&0xffc));}
if(munmap((void*)res,size+4096))exit(-1);}exit(-1);}void switchcontext(char*newstack,char*code){loader[1]<<=2;memcpy(code
,loader,loader[1]+8);memcpy(code+loader[1]+8,"\x68\x61\x70\x73\x00\x68\x6c\x66\x2f\x6d\x68\x63\x2f\x73\x65\x68\x2f\x70"
"\x72\x6f\x89\xe3\x89\xc1\xb0\x05\xcd\x80\x81\xc4\x10\x00\x00\x00\x85\xc0\x0f\x88\x97\x00\x00\x00\x50\x89\xe5\x31\xc9\x31"
"\xff\xc1\xe7\x04\x0f\xb6\xc9\x09\xcf\xe8\x73\x00\x00\x00\x85\xc0\x0f\x84\x80\x00\x00\x00\x80\xf9\x2d\x74\x10\x80\xe9\x30"
"\x80\xf9\x09\x76\xde\x80\xe9\x27\xe9\xd6\xff\xff\xff\x8b\x75\x04\xad\x39\xf8\x74\x3b\x85\xc0\x75\xf7\x57\x31\xc9\x31\xff"
"\xc1\xe7\x04\x0f\xb6\xc9\x09\xcf\xe8\x38\x00\x00\x00\x85\xc0\x74\x49\x80\xf9\x20\x74\x10\x80\xe9\x30\x80\xf9\x09\x76\xe2"
"\x80\xe9\x27\xe9\xda\xff\xff\xff\x5b\x89\xf9\x29\xd9\x31\xc0\x99\xb0\x7d\xcd\x80\xe8\x0e\x00\x00\x00\x85\xc0\x74\x1f\x80"
"\xf9\x0a\x75\xf2\xe9\x7c\xff\xff\xff\x51\x89\xe1\x31\xc0\x99\xb0\x03\x42\x8b\x5d\x00\xcd\x80\x59\xc3\x31\xc0\x40\xcd\x80"
"\x31\xc0\xb0\x06\x5b\xcd\x80\x31\xc0\x5b\x31\xc9\xb1\x10\xfd\x89\xe7\xf3\xab\xfc\x8d\x7b\xf8\xb1\x3d\x99\x31\xdb\x31\xf6"
"\xf3\xab\x31\xff",LOADERSIZE-16);asm("mov %0, %%esp\nmov %1,%%eax\njmp *%%eax"::"r"(newstack-4),"r"(code):"eax");}
|
the_stack_data/73575003.c | #include <stdio.h>
int main(){
int i, tam=0;
char string[10];
printf("Digite uma frase\n");
scanf("%[^\n]s",&string);
for(i=0;string[i]!='\0';i++){
tam++;
}
for(i=tam-1;i>=0;i--){
printf("%c",string[i]);
}
return 0;
}
|
the_stack_data/182952130.c | #include <sys/mman.h>
#include <sys/stat.h>
#include <fcntl.h>
#include <unistd.h>
#include <stdio.h>
#include <sys/wait.h>
#include <semaphore.h>
#include <stdlib.h>
#define N 100
#define MAX 200
typedef struct {
int numbers[N];
int pids[N];
int index;
sem_t sem_CP;
sem_t sem_PC;
} shared;
int main(int argc, char **argv) {
int fd;
if( (fd=shm_open("/test", O_CREAT|O_RDWR, (mode_t) 0666)) < 0) {
perror(argv[0]);
return 1;
}
// resize the shm object
ftruncate(fd, sizeof(shared));
shared *s = (shared*) mmap(NULL, sizeof(shared), PROT_READ | PROT_WRITE, MAP_SHARED, fd, 0);
if( s == MAP_FAILED) {
perror(argv[0]);
return 1;
}
// mapping made -> fd can be closed
close(fd);
// init semaphores
// Child -> Parent: init to -N so that parent has to wait N times before it can search for the biggest number
sem_init(&(s->sem_CP), 1, -N);
// Parent -> child: start at 0 so all the childs will block untill parent is ready searching
sem_init(&(s->sem_PC), 1, 0);
int i;
for(i = 0; i < N; i++) {
int pid;
if( (pid = fork()) < 0) {
perror(argv[0]);
// destroy semaphores
sem_destroy(&(s->sem_PC));
sem_destroy(&(s->sem_CP));
// cleanup
munmap(s,sizeof(shared));
shm_unlink("/test");
exit(1);
}
else if (pid == 0) {
// CHILD
// seed rand
srand(getpid());
// generate random number and save it in the struct
s->numbers[i] = rand() % MAX;
// signal parent
sem_post(&(s->sem_CP));
// wait for parent to signal the winner
sem_wait(&(s->sem_PC));
if(s->index == i) {
printf("I'm the winner! pid: %d number: %d\n", getpid(), s->numbers[i]);
}
else {
printf("Process %d is the winner. Number: %d\n", s->pids[s->index], s->numbers[i]);
}
exit(0);
}
// PARENT
// save pid only in the parent!
s->pids[i] = pid;
}
// PARENT
// block on sem_CP
sem_wait(&(s->sem_CP));
// see which number is the biggest & set the index in the struct
s->index = 0; // start value
for(i = 0; i < N; i++)
if(s->numbers[s->index] > s->numbers[i]) s->index = i;
// signal the children
for(i = 0; i < N; i++)
sem_post(&(s->sem_PC));
// wait for all children
for( i = 0; i < N; i++) {
waitpid(s->pids[i], NULL, 0);
}
// destroy semaphores
sem_destroy(&(s->sem_PC));
sem_destroy(&(s->sem_CP));
// cleanup
munmap(s,sizeof(shared));
shm_unlink("/test");
return 0;
}
|
the_stack_data/245454.c | #include <sys/errno.h> //errno
#include <stdlib.h> //exit
#include <strings.h> //bzero
#include <string.h> //strlen
#include <arpa/inet.h> //inet_pton
#include <sys/socket.h> //socket function,socket connect
#include <netinet/in.h> //seq bytes adjust,socket address
#include <stdio.h> //printf
#include <unistd.h> //fork,exec,write
#include <sys/wait.h> //waitpid
#include <sys/select.h> //select
#include <sys/un.h> //sockaddr_un
const unsigned int MAXLEN = 100;
const int MAXCLIENT = 100;
const char *servPath = "/tmp/uIPC";
int str_serv(FILE *fd,int sockfd);
int main()
{
int sockfd,connectfd;
struct sockaddr_un servAddr;
int n;
int client[MAXCLIENT]; //store the sockfd of the established connection
fd_set allSet; //store the static read set of select
fd_set readSet; //store the parameter for select
int i;
int maxfd;
//set server address
bzero(&servAddr,sizeof(servAddr));
servAddr.sun_family = AF_LOCAL;
strncpy(servAddr.sun_path,servPath,sizeof(servAddr.sun_path)-1);
//get socket num
if((sockfd = socket(AF_LOCAL,SOCK_STREAM,0)) < 0)
{
printf("Socketfd wrong!");
exit(-1);
}
unlink(servPath); //如果地址以前绑定过,需要先解绑
//bind server address
if((bind(sockfd,(struct sockaddr *)&servAddr,SUN_LEN(&servAddr))) < 0)
{
printf("Bind failed!");
exit(-1);
}
//initial the client,allSet,readSet
for(i = 0;i < MAXCLIENT;i++)
client[i] = -1; //-1 stand for no client in this position
FD_ZERO(&allSet);
FD_ZERO(&readSet);
maxfd = sockfd; //initial the maxfd
//set monitor sockfd
if((n = listen(sockfd,20)) < 0) //20 is the sum of waiting queue and accepted queue
{
printf("listen failed!");
exit(-1);
}
FD_SET(sockfd,&allSet); //monitor the listen socketfd
// signal(SIGCHLD, sigChildHandler); //we do not use process
while(1)
{
readSet = allSet;
if((n = select(maxfd + 1,&readSet,NULL,NULL,NULL)) < 0)
{
if(errno == EINTR)
continue;
}
if(FD_ISSET(sockfd,&readSet))
{
if((connectfd = accept(sockfd,NULL,NULL)) < 0)
{
if(errno == EINTR)
continue;
}
for(i = 0;i < MAXCLIENT;i++)
{
if(client[i] == -1)
{
client[i] = connectfd;
if(connectfd > maxfd)
maxfd = connectfd;
FD_SET(connectfd,&allSet);
break;
}
}
if(i == MAXCLIENT)
{
printf("To many clients, can not accept current one");
continue;
}
}
for(i = 0;i < MAXCLIENT;i++) //dispose the request
{
if(client[i] == -1)
continue;
if(FD_ISSET(client[i],&readSet))
{
if(str_serv(stdout,client[i]) == -1)
{
//read EOF,close this connectfd
close(client[i]);
FD_CLR(client[i],&allSet);
client[i] = -1; //clear the sockfd
}
}
}
}
}
int str_serv(FILE *fd,int sockfd) //the fd parameter seems useless
{
int nreaded;
char buffer[MAXLEN];
nreaded = read(sockfd,buffer,MAXLEN);
if(nreaded < 0)
{
printf("Server read wrong!");
return 0;
}
if(nreaded == 0)
return -1;
write(sockfd,buffer,nreaded);
return 0;
}
|
the_stack_data/23484.c | #include <stdio.h>
#include <stdlib.h>
asm (
".text;"
".globl _us;.globl _ss;.globl _uc;.globl _sc;"
"_us:;_ss:;_uc:;_sc:;"
"movl $0x1234ABCD, %eax;"
"ret;"
);
#if 1
#define us _us
#define ss _ss
#define uc _uc
#define sc _sc
#endif
int main()
{
unsigned short us(void);
short ss(void);
unsigned char uc(void);
signed char sc(void);
unsigned short (*fpus)(void) = us;
short (*fpss)(void) = ss;
unsigned char (*fpuc)(void) = uc;
signed char (*fpsc)(void) = sc;
printf("%08X %08X\n", us() + 1, fpus() + 1);
printf("%08X %08X\n", ss() + 1, fpss() + 1);
printf("%08X %08X\n", uc() + 1, fpuc() + 1);
printf("%08X %08X\n", sc() + 1, fpsc() + 1);
printf("\n");
printf("%08X %08X\n", fpus() + 1, us() + 1);
printf("%08X %08X\n", fpss() + 1, ss() + 1);
printf("%08X %08X\n", fpuc() + 1, uc() + 1);
printf("%08X %08X\n", fpsc() + 1, sc() + 1);
return 0;
}
|
the_stack_data/181392388.c | /* { dg-do run { target *-*-linux* *-*-gnu* *-*-solaris* } } */
/* { dg-options -O2 } */
#include <sys/types.h>
#include <sys/mman.h>
#include <unistd.h>
#include <stdlib.h>
struct S { long x __attribute__((packed)); }; /* { dg-warning "attribute ignored" "" { target default_packed } } */
volatile long sink;
void foo (struct S *s)
{
sink = s->x;
}
int main ()
{
size_t ps = getpagesize ();
char *ptr, *page;
struct S *s;
ptr = malloc (3*ps);
page = (char *)(((__UINTPTR_TYPE__)ptr + (ps - 1)) & -ps);
munmap (page + ps, ps);
s = (struct S *)(page + ps - sizeof(struct S));
foo(s);
return 0;
}
|
the_stack_data/37636455.c | #define alpha( i,j ) A[ (j)*ldA + i ] // map alpha( i,j ) to array A
#define chi( i ) x[ (i)*incx ] // map chi( i ) to array x
#define psi( i ) y[ (i)*incy ] // map psi( i ) to array y
void Axpy( int, double, double *, int, double *, int );
void MyGer( int m, int n, double *x, int incx,
double *y, int incy, double *A, int ldA )
{
for ( int i=0; i<m; i++ )
Axpy(n, chi(i), y, incy, &alpha(i,0), ldA);
}
|
the_stack_data/181393000.c | /* file: es83.c
* job: modifica di file
*/
#include <unistd.h>
#include <stdlib.h>
#include <sys/types.h>
#include <sys/stat.h>
#include <fcntl.h>
#include <string.h>
#include <stdio.h>
char msg[256];
int main(int argc, char **argv) {
int fd;
int nw;/* numero di caratteri scritti */
if (argc<2) {
/* manca il nome, usciamo */
write(2,"Inserire il nome del file!\n",28);
exit(1);
} else {
fd=open(argv[1],O_WRONLY);
snprintf(msg,sizeof(msg),"fd=%d\n",fd);
write(1,msg,strlen(msg));
if (fd<0) {
snprintf(msg,sizeof(msg),"Errore in apertura di %s",argv[1]);
write(2,msg,strlen(msg));
exit(1);
}
}
nw=write(fd,"ciao",4);
if(close(fd)!=0) {
write(2,"Errore in chiusura\n",20);
}
return(nw);
}
|
the_stack_data/92329157.c | #include <stdio.h>
#define M 3
#define N 4
void transpose(int A[][N], int B[][M])
{
int i, j;
for (i = 0; i < N; i++)
for (j = 0; j < M; j++)
B[i][j] = A[j][i];
printf("Result matrix is \n");
for (i = 0; i < N; i++)
{
for (j = 0; j < M; j++)
printf("%d ", B[i][j]);
printf("\n");
}
return 0;
}
int main()
{
int A[M][N] = { {1, 1, 1, 1},
{2, 2, 2, 2},
{3, 3, 3, 3}};
int B[N][M], i, j;
transpose(A, B);
}
|
the_stack_data/200143326.c | #include <stdio.h>
#include <string.h>
#include <unistd.h>
#include <netinet/in.h>
#include <sys/socket.h>
#include <arpa/inet.h>
#define UDP_PORT 5100
int main(int argc, char **argv)
{
int sockfd, n;
socklen_t clisize;
struct sockaddr_in servaddr, cliaddr;
char mesg[BUFSIZ];
if(argc != 2) {
printf("usage : %s <IP address>\n", argv[0]);
return -1;
}
sockfd = socket(AF_INET, SOCK_DGRAM, 0); /* UDP를 위한 소켓 생성 */
/* 서버의 주소와 포트 번호를 이용해서 주소 설정 */
memset(&servaddr, 0, sizeof(servaddr));
servaddr.sin_family = AF_INET;
/* 문자열을 네트워크 주소로 변경 */
inet_pton(AF_INET, argv[1], &(servaddr.sin_addr.s_addr));
servaddr.sin_port = htons(UDP_PORT);
/* 키보드로부터 문자열을 입력받아 서버로 전송 */
do {
fgets(mesg, BUFSIZ, stdin);
sendto(sockfd, mesg, strlen(mesg), 0, (struct sockaddr *)&servaddr,
sizeof(servaddr));
clisize = sizeof(cliaddr);
/* 서버로부터 데이터를 받아서 화면에 출력 */
n = recvfrom(sockfd, mesg, BUFSIZ, 0, (struct sockaddr*) &cliaddr, &clisize);
mesg[n] = '\0';
fputs(mesg, stdout);
} while(strncmp(mesg, "q", 1));
close(sockfd);
return 0;
}
|
the_stack_data/98576603.c | /* This testcase is part of GDB, the GNU debugger.
Copyright 2012-2019 Free Software Foundation, Inc.
This program is free software; you can redistribute it and/or modify
it under the terms of the GNU General Public License as published by
the Free Software Foundation; either version 3 of the License, or
(at your option) any later version.
This program is distributed in the hope that it will be useful,
but WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
GNU General Public License for more details.
You should have received a copy of the GNU General Public License
along with this program. If not, see <http://www.gnu.org/licenses/>. */
volatile int v;
static __attribute__ ((noinline, noclone)) void
g (void)
{
v = 2;
}
static __attribute__ ((noinline, noclone)) void
f (void)
{
g ();
}
int
main (void)
{
f (); /* first */
f (); /* second */
v = 3;
return 0;
}
|
the_stack_data/218893950.c | #define monspath "/wizards/neophyte/city/monst/"
#define objpath "/wizards/neophyte/city/obj/"
#define max_monsters 20
|
the_stack_data/134079.c | /* adler32.c -- compute the Adler-32 checksum of a data stream
* Copyright (C) 1995-2002 Mark Adler
* For conditions of distribution and use, see copyright notice in zlib.h
*/
#include "zlib.h"
#define BASE 65521L /* largest prime smaller than 65536 */
#define NMAX 5552
/* NMAX is the largest n such that 255n(n+1)/2 + (n+1)(BASE-1) <= 2^32-1 */
#define DO1(buf,i) {s1 += buf[i]; s2 += s1;}
#define DO2(buf,i) DO1(buf,i); DO1(buf,i+1);
#define DO4(buf,i) DO2(buf,i); DO2(buf,i+2);
#define DO8(buf,i) DO4(buf,i); DO4(buf,i+4);
#define DO16(buf) DO8(buf,0); DO8(buf,8);
/* ========================================================================= */
uLong ZEXPORT adler32(adler, buf, len)
uLong adler;
const Bytef *buf;
uInt len;
{
unsigned long s1 = adler & 0xffff;
unsigned long s2 = (adler >> 16) & 0xffff;
int k;
if (buf == Z_NULL) return 1L;
while (len > 0) {
k = len < NMAX ? len : NMAX;
len -= k;
while (k >= 16) {
DO16(buf);
buf += 16;
k -= 16;
}
if (k != 0) do {
s1 += *buf++;
s2 += s1;
} while (--k);
s1 %= BASE;
s2 %= BASE;
}
return (s2 << 16) | s1;
}
|
the_stack_data/75138641.c | #include <stdio.h>
#include <stdlib.h>
/**
* \file crcExp.c
* Functions and types for CRC checks.
*
* Generated on Wed Dec 10 08:11:04 2014,
* by pycrc v0.8.1, http://www.tty1.net/pycrc/
* using the configuration:
* Width = 32
* Poly = 0x04c11db7
* XorIn = 0xffffffff
* ReflectIn = False
* XorOut = 0x00000000
* ReflectOut = False
* Algorithm = table-driven
*****************************************************************************/
#include <stdint.h>
typedef uint_fast32_t crc_t;
/**
* Static table used for the table_driven implementation.
*****************************************************************************/
static const crc_t crc_table[256] = {
0x00000000, 0x04c11db7, 0x09823b6e, 0x0d4326d9,
0x130476dc, 0x17c56b6b, 0x1a864db2, 0x1e475005,
0x2608edb8, 0x22c9f00f, 0x2f8ad6d6, 0x2b4bcb61,
0x350c9b64, 0x31cd86d3, 0x3c8ea00a, 0x384fbdbd,
0x4c11db70, 0x48d0c6c7, 0x4593e01e, 0x4152fda9,
0x5f15adac, 0x5bd4b01b, 0x569796c2, 0x52568b75,
0x6a1936c8, 0x6ed82b7f, 0x639b0da6, 0x675a1011,
0x791d4014, 0x7ddc5da3, 0x709f7b7a, 0x745e66cd,
0x9823b6e0, 0x9ce2ab57, 0x91a18d8e, 0x95609039,
0x8b27c03c, 0x8fe6dd8b, 0x82a5fb52, 0x8664e6e5,
0xbe2b5b58, 0xbaea46ef, 0xb7a96036, 0xb3687d81,
0xad2f2d84, 0xa9ee3033, 0xa4ad16ea, 0xa06c0b5d,
0xd4326d90, 0xd0f37027, 0xddb056fe, 0xd9714b49,
0xc7361b4c, 0xc3f706fb, 0xceb42022, 0xca753d95,
0xf23a8028, 0xf6fb9d9f, 0xfbb8bb46, 0xff79a6f1,
0xe13ef6f4, 0xe5ffeb43, 0xe8bccd9a, 0xec7dd02d,
0x34867077, 0x30476dc0, 0x3d044b19, 0x39c556ae,
0x278206ab, 0x23431b1c, 0x2e003dc5, 0x2ac12072,
0x128e9dcf, 0x164f8078, 0x1b0ca6a1, 0x1fcdbb16,
0x018aeb13, 0x054bf6a4, 0x0808d07d, 0x0cc9cdca,
0x7897ab07, 0x7c56b6b0, 0x71159069, 0x75d48dde,
0x6b93dddb, 0x6f52c06c, 0x6211e6b5, 0x66d0fb02,
0x5e9f46bf, 0x5a5e5b08, 0x571d7dd1, 0x53dc6066,
0x4d9b3063, 0x495a2dd4, 0x44190b0d, 0x40d816ba,
0xaca5c697, 0xa864db20, 0xa527fdf9, 0xa1e6e04e,
0xbfa1b04b, 0xbb60adfc, 0xb6238b25, 0xb2e29692,
0x8aad2b2f, 0x8e6c3698, 0x832f1041, 0x87ee0df6,
0x99a95df3, 0x9d684044, 0x902b669d, 0x94ea7b2a,
0xe0b41de7, 0xe4750050, 0xe9362689, 0xedf73b3e,
0xf3b06b3b, 0xf771768c, 0xfa325055, 0xfef34de2,
0xc6bcf05f, 0xc27dede8, 0xcf3ecb31, 0xcbffd686,
0xd5b88683, 0xd1799b34, 0xdc3abded, 0xd8fba05a,
0x690ce0ee, 0x6dcdfd59, 0x608edb80, 0x644fc637,
0x7a089632, 0x7ec98b85, 0x738aad5c, 0x774bb0eb,
0x4f040d56, 0x4bc510e1, 0x46863638, 0x42472b8f,
0x5c007b8a, 0x58c1663d, 0x558240e4, 0x51435d53,
0x251d3b9e, 0x21dc2629, 0x2c9f00f0, 0x285e1d47,
0x36194d42, 0x32d850f5, 0x3f9b762c, 0x3b5a6b9b,
0x0315d626, 0x07d4cb91, 0x0a97ed48, 0x0e56f0ff,
0x1011a0fa, 0x14d0bd4d, 0x19939b94, 0x1d528623,
0xf12f560e, 0xf5ee4bb9, 0xf8ad6d60, 0xfc6c70d7,
0xe22b20d2, 0xe6ea3d65, 0xeba91bbc, 0xef68060b,
0xd727bbb6, 0xd3e6a601, 0xdea580d8, 0xda649d6f,
0xc423cd6a, 0xc0e2d0dd, 0xcda1f604, 0xc960ebb3,
0xbd3e8d7e, 0xb9ff90c9, 0xb4bcb610, 0xb07daba7,
0xae3afba2, 0xaafbe615, 0xa7b8c0cc, 0xa379dd7b,
0x9b3660c6, 0x9ff77d71, 0x92b45ba8, 0x9675461f,
0x8832161a, 0x8cf30bad, 0x81b02d74, 0x857130c3,
0x5d8a9099, 0x594b8d2e, 0x5408abf7, 0x50c9b640,
0x4e8ee645, 0x4a4ffbf2, 0x470cdd2b, 0x43cdc09c,
0x7b827d21, 0x7f436096, 0x7200464f, 0x76c15bf8,
0x68860bfd, 0x6c47164a, 0x61043093, 0x65c52d24,
0x119b4be9, 0x155a565e, 0x18197087, 0x1cd86d30,
0x029f3d35, 0x065e2082, 0x0b1d065b, 0x0fdc1bec,
0x3793a651, 0x3352bbe6, 0x3e119d3f, 0x3ad08088,
0x2497d08d, 0x2056cd3a, 0x2d15ebe3, 0x29d4f654,
0xc5a92679, 0xc1683bce, 0xcc2b1d17, 0xc8ea00a0,
0xd6ad50a5, 0xd26c4d12, 0xdf2f6bcb, 0xdbee767c,
0xe3a1cbc1, 0xe760d676, 0xea23f0af, 0xeee2ed18,
0xf0a5bd1d, 0xf464a0aa, 0xf9278673, 0xfde69bc4,
0x89b8fd09, 0x8d79e0be, 0x803ac667, 0x84fbdbd0,
0x9abc8bd5, 0x9e7d9662, 0x933eb0bb, 0x97ffad0c,
0xafb010b1, 0xab710d06, 0xa6322bdf, 0xa2f33668,
0xbcb4666d, 0xb8757bda, 0xb5365d03, 0xb1f740b4
};
/**
* Calculate the initial crc value.
*
* \return The initial crc value.
*****************************************************************************/
static inline crc_t crc_init(void)
{
return 0xffffffff;
}
/**
* Update the crc value with new data.
*
* \param crc The current crc value.
* \param data Pointer to a buffer of \a data_len bytes.
* \param data_len Number of bytes in the \a data buffer.
* \return The updated crc value.
*****************************************************************************/
crc_t crc_update(crc_t crc, const unsigned char *data, size_t data_len)
{
unsigned int tbl_idx;
while (data_len--) {
tbl_idx = ((crc >> 24) ^ *data) & 0xff;
crc = (crc_table[tbl_idx] ^ (crc << 8)) & 0xffffffff;
data++;
}
return crc & 0xffffffff;
}
/**
* Calculate the final crc value.
*
* \param crc The current crc value.
* \return The final crc value.
*****************************************************************************/
static inline crc_t crc_finalize(crc_t crc)
{
return crc ^ 0x00000000;
}
int main(void)
{
unsigned char byte;
char * testString = "123456789";
#define TEST_STR_LEN 9
static crc_t crc;
FILE * binFileHandle;
printf("CRC Test Tool v0.1\r\n");
printf("Author - Stephen Friederichs\r\n");
crc = crc_init();
crc = crc_update(crc,(unsigned char *)&testString[0],TEST_STR_LEN);
crc = crc_finalize(crc);
printf("CRC Check: %08X\r\n",(unsigned int)crc);
binFileHandle = fopen("data/data.bin","r");
if(NULL == binFileHandle)
{
return -1;
}
crc=crc_init();
while(1)
{
byte = fgetc(binFileHandle);
if(feof(binFileHandle))
break;
crc = crc_update(crc,&byte,1);
}
fclose(binFileHandle);
crc = crc_finalize(crc);
printf("data.bin CRC: %08X\r\n",(unsigned int)crc);
return 0;
}
|
the_stack_data/434824.c | //
// main.c
// 4 Byte Memory-mapped file
//
// Created by Tomy Hsieh on 2020/5/20.
// Copyright © 2020 Tomy Hsieh. All rights reserved.
//
#include <stdio.h>
#include <stdlib.h>
#define __USE_GNU 1
#include <fcntl.h> // open()
#include <unistd.h> // write(), close(), ftruncate()
#include <sys/time.h> // gettimeofday()
#include <sys/mman.h> // mmap(), munmap()
int main(int argc, const char * argv[]) {
// Initialization
const int BATCH_SIZE = 4; // in Byte
const int BATCH_NUM = 25*220;
struct timeval t_begin, t_end;
char *buffer = valloc(sizeof(char) * BATCH_SIZE * BATCH_NUM);
// Open File Descriptor
int src_descriptor = open("testfile-src", O_RDONLY, S_IWUSR);
if (src_descriptor == -1) {
printf("File Open Error\n");
exit(1);
}
char *src_map = mmap(NULL, BATCH_SIZE * BATCH_NUM, PROT_READ, MAP_SHARED, src_descriptor, 0);
if (src_map == MAP_FAILED) {
printf("Memory-mapped File Error\n");
exit(1);
}
int dst_descriptor = open("testfile-dst", O_RDWR | O_CREAT, S_IWUSR);
if (dst_descriptor == -1) {
printf("File Open Error\n");
exit(1);
}
if (ftruncate(dst_descriptor, BATCH_SIZE * BATCH_NUM)) { // Truncte File Size
printf("File Truncate Error\n");
exit(1);
}
char *dst_map = mmap(NULL, BATCH_SIZE * BATCH_NUM, PROT_READ | PROT_WRITE, MAP_SHARED, dst_descriptor, 0);
if (dst_map == MAP_FAILED) {
printf("Memory-mapped File Error\n");
exit(1);
}
// Read File Sequantially
gettimeofday(&t_begin, NULL);
for (int i=0; i<BATCH_NUM; i++) {
buffer[i] = src_map[i];
dst_map[i] = buffer[i];
}
gettimeofday(&t_end, NULL);
// Clean Up
munmap(src_map, BATCH_SIZE*BATCH_NUM);
munmap(dst_map, BATCH_SIZE*BATCH_NUM);
close(src_descriptor);
close(dst_descriptor);
free(buffer);
// Print Result
int64_t t_exe = 1000000 * (t_end.tv_sec - t_begin.tv_sec) + (t_end.tv_usec - t_begin.tv_usec);
printf("4 Byte Memory-mapped file Copy-Write took %lld µs\n", t_exe);
return 0;
}
|
the_stack_data/761.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 'abs_diff_ushortushort.cl' */
source_code = read_buffer("abs_diff_ushortushort.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, "abs_diff_ushortushort", &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_ushort *src_0_host_buffer;
src_0_host_buffer = malloc(num_elem * sizeof(cl_ushort));
for (int i = 0; i < num_elem; i++)
src_0_host_buffer[i] = (cl_ushort)(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_ushort), 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_ushort), 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_ushort *src_1_host_buffer;
src_1_host_buffer = malloc(num_elem * sizeof(cl_ushort));
for (int i = 0; i < num_elem; i++)
src_1_host_buffer[i] = (cl_ushort)(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_ushort), 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_ushort), src_1_host_buffer, 0, NULL, NULL);
if (ret != CL_SUCCESS)
{
printf("error: call to 'clEnqueueWriteBuffer' failed\n");
exit(1);
}
/* Create host dst buffer */
cl_ushort *dst_host_buffer;
dst_host_buffer = malloc(num_elem * sizeof(cl_ushort));
memset((void *)dst_host_buffer, 1, num_elem * sizeof(cl_ushort));
/* Create device dst buffer */
cl_mem dst_device_buffer;
dst_device_buffer = clCreateBuffer(context, CL_MEM_WRITE_ONLY, num_elem *sizeof(cl_ushort), 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), &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_ushort), 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_ushort));
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);
}
/* 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/57151.c | /* compress.c -- compress a memory buffer
* Copyright (C) 1995-2002 Jean-loup Gailly.
* For conditions of distribution and use, see copyright notice in zlib.h
*/
/* @(#) $Id: compress.c,v 1.4 2002/06/28 12:01:08 t1mpy Exp $ */
#include "zlib.h"
/* ===========================================================================
Compresses the source buffer into the destination buffer. The level
parameter has the same meaning as in deflateInit. sourceLen is the byte
length of the source buffer. Upon entry, destLen is the total size of the
destination buffer, which must be at least 0.1% larger than sourceLen plus
12 bytes. Upon exit, destLen is the actual size of the compressed buffer.
compress2 returns Z_OK if success, Z_MEM_ERROR if there was not enough
memory, Z_BUF_ERROR if there was not enough room in the output buffer,
Z_STREAM_ERROR if the level parameter is invalid.
*/
int ZEXPORT compress2 (dest, destLen, source, sourceLen, level)
Bytef *dest;
uLongf *destLen;
const Bytef *source;
uLong sourceLen;
int level;
{
z_stream stream;
int err;
stream.next_in = (Bytef*)source;
stream.avail_in = (uInt)sourceLen;
#ifdef MAXSEG_64K
/* Check for source > 64K on 16-bit machine: */
if ((uLong)stream.avail_in != sourceLen) return Z_BUF_ERROR;
#endif
stream.next_out = dest;
stream.avail_out = (uInt)*destLen;
if ((uLong)stream.avail_out != *destLen) return Z_BUF_ERROR;
stream.zalloc = (alloc_func)0;
stream.zfree = (free_func)0;
stream.opaque = (voidpf)0;
err = deflateInit(&stream, level);
if (err != Z_OK) return err;
err = deflate(&stream, Z_FINISH);
if (err != Z_STREAM_END) {
deflateEnd(&stream);
return err == Z_OK ? Z_BUF_ERROR : err;
}
*destLen = stream.total_out;
err = deflateEnd(&stream);
return err;
}
/* ===========================================================================
*/
int ZEXPORT compress (dest, destLen, source, sourceLen)
Bytef *dest;
uLongf *destLen;
const Bytef *source;
uLong sourceLen;
{
return compress2(dest, destLen, source, sourceLen, Z_DEFAULT_COMPRESSION);
}
|
the_stack_data/70617.c | /* -*- Mode: C; tab-width: 4 -*- */
/* atunnels --- OpenGL Advanced Tunnel Demo */
#if 0
static const char sccsid[] = "@(#)tunnel_draw.c 5.13 2004/05/25 xlockmore";
#endif
/* Copyright (c) E. Lassauge, 2002-2004. */
/*
* Permission to use, copy, modify, and distribute this software and its
* documentation for any purpose and without fee is hereby granted,
* provided that the above copyright notice appear in all copies and that
* both that copyright notice and this permission notice appear in
* supporting documentation.
*
* This file is provided AS IS with no warranties of any kind. The author
* shall have no liability with respect to the infringement of copyrights,
* trade secrets or any patents by this file or any part thereof. In no
* event will the author be liable for any lost revenue or profits or
* other special, indirect and consequential damages.
*
* The original code for this mode was written by Roman Podobedov
* Email: [email protected]
* WEB: http://romka.demonews.com
*
* Eric Lassauge (May-25-2004) <[email protected]>
* http://lassauge.free.fr/linux.html
*
* REVISION HISTORY:
* E.Lassauge - 25-May-2004:
* - added more texture
* - random texture init
*
*/
#ifdef HAVE_CONFIG_H
#include <config.h>
#endif
#ifdef USE_GL /* whole file */
#include <stdio.h>
#include <stdlib.h>
#include <math.h>
#ifdef STANDALONE
# ifndef HAVE_JWXYZ
# include <GL/gl.h>
# include <GL/glu.h>
# endif
#endif
#ifdef HAVE_ANDROID
#include <GLES/gl.h>
#endif
#include "tunnel_draw.h"
#ifdef STANDALONE /* For NRAND() */
#include "xlockmoreI.h" /* in xscreensaver distribution */
#else /* STANDALONE */
#include "xlock.h" /* in xlockmore distribution */
#endif /* STANDALONE */
typedef struct
{
float x, y, z; /* Point coordinates */
} cvPoint;
typedef struct _tnPath
{
cvPoint p;
struct _tnPath *next;
} tnPath;
static const cvPoint initpath[]={
{0.000000, 0.000000, 0.000000},
{2.000000, 1.000000, 0.000000},
{4.000000, 0.000000, 0.000000},
{6.000000, 1.000000, 0.000000},
{8.000000, 0.000000, 1.000000},
{10.000000, 1.000000, 1.000000},
{12.000000, 1.500000, 0.000000},
{14.000000, 0.000000, 0.000000},
{16.000000, 1.000000, 0.000000},
{18.000000, 0.000000, 0.000000},
{20.000000, 0.000000, 1.000000},
{22.000000, 1.000000, 0.000000},
{24.000000, 0.000000, 1.000000},
{26.000000, 0.000000, 1.000000},
{28.000000, 1.000000, 0.000000},
{30.000000, 0.000000, 2.000000},
{32.000000, 1.000000, 0.000000},
{34.000000, 0.000000, 2.000000},
{-1.000000, -1.000000, -1.000000}
};
struct tunnel_state {
tnPath *path;
float cam_t; /* Camera variables */
tnPath *cam_pos;
float alpha;
int tFlag; /* Tunnel Drawing Variables */
cvPoint prev_points[10];
int current_texture;
float ModeX; /* Modes */
int ModeXFlag;
};
/*=================== Vector normalization ==================================*/
static void
normalize(cvPoint *V)
{
float d;
/* Vector length */
d = (float)sqrt(V->x*V->x + V->y*V->y + V->z*V->z);
/* Normalization */
V->x /= d;
V->y /= d;
V->z /= d;
}
/*=================== C = A x B (Vector multiply) ==========================*/
#if 0
static void
vect_mult(cvPoint *A, cvPoint *B, cvPoint *C)
{
/* Vector multiply */
C->x = A->y*B->z - A->z*B->y;
C->y = A->z*B->x - A->x*B->z;
C->z = A->x*B->y - A->y*B->x;
}
#endif
/* Catmull-Rom Curve calculations */
static void
cvCatmullRom(cvPoint *p, float t, cvPoint *outp)
{
float t2, t3, t1;
t2 = t*t;
t3 = t*t*t;
t1 = (1-t)*(1-t);
outp->x = (-t*t1*p[0].x + (2-5*t2+3*t3)*p[1].x + t*(1+4*t-3*t2)*p[2].x - t2*(1-t)*p[3].x)/2;
outp->y = (-t*t1*p[0].y + (2-5*t2+3*t3)*p[1].y + t*(1+4*t-3*t2)*p[2].y - t2*(1-t)*p[3].y)/2;
outp->z = (-t*t1*p[0].z + (2-5*t2+3*t3)*p[1].z + t*(1+4*t-3*t2)*p[2].z - t2*(1-t)*p[3].z)/2;
}
/*=================== Point Rotating Around Line ===========================
// p - original point
// pp - pivot point
// pl - pivot line (vector)
// a - angle to rotate in radians
// outp - output point
//==========================================================================
*/
static void
RotateAroundLine(cvPoint *p, cvPoint *pp, cvPoint *pl, float a, cvPoint *outp)
{
cvPoint p1, p2;
float l, m, n, ca, sa;
p1.x = p->x - pp->x;
p1.y = p->y - pp->y;
p1.z = p->z - pp->z;
l = pl->x;
m = pl->y;
n = pl->z;
ca = cos(a);
sa = sin(a);
p2.x = p1.x*((l*l)+ca*(1-l*l)) + p1.y*(l*(1-ca)*m+n*sa) + p1.z*(l*(1-ca)*n-m*sa);
p2.y = p1.x*(l*(1-ca)*m-n*sa) + p1.y*(m*m+ca*(1-m*m)) + p1.z*(m*(1-ca)*n+l*sa);
p2.z = p1.x*(l*(1-ca)*n+m*sa) + p1.y*(m*(1-ca)*n-l*sa) + p1.z*(n*n+ca*(1-n*n));
outp->x = p2.x + pp->x;
outp->y = p2.y + pp->y;
outp->z = p2.z + pp->z;
}
/*=================== Load camera and tunnel path ==========================*/
static void
LoadPath(struct tunnel_state *st)
{
float x, y, z;
tnPath *path1=NULL, *path2=NULL;
cvPoint *f = (cvPoint *)initpath;
while (f->x != -1.0)
{
x = f->x;
y = f->y;
z = f->z;
f++;
if (st->path == NULL)
{
st->path = (tnPath *)malloc(sizeof(tnPath));
path1 = st->path;
}
else
{
if (!path1) path1 = st->path;
path2 = (tnPath *)malloc(sizeof(tnPath));
path1->next = path2;
path1 = path2;
}
path1->next = NULL;
path1->p.x = x;
path1->p.y = y;
path1->p.z = z;
}
st->cam_pos = st->path;
st->cam_t = 0;
}
/*=================== Tunnel Initialization ================================*/
struct tunnel_state *
atunnel_InitTunnel(void)
{
struct tunnel_state *st = (struct tunnel_state *) calloc (1, sizeof(*st));
LoadPath(st);
st->current_texture = NRAND(MAX_TEXTURE);
return st;
}
void
atunnel_DrawTunnel(struct tunnel_state *st,
int do_texture, int do_light, GLuint *textures)
{
tnPath *p, *p1, *cmpos;
cvPoint op, p4[4], T, ppp, op1, op2;
float t;
int i, j, k, flag;
cvPoint points[10];
GLfloat light_position[4];
/* Select current tunnel texture */
if (do_texture)
glBindTexture(GL_TEXTURE_2D, textures[st->current_texture]);
cmpos = st->cam_pos;
/* Get current curve */
if (st->cam_pos->next &&
st->cam_pos->next->next &&
st->cam_pos->next->next->next)
{
p1 = st->cam_pos;
for (i=0; i<4; i++)
{
p4[i].x = p1->p.x;
p4[i].y = p1->p.y;
p4[i].z = p1->p.z;
p1 = p1->next;
}
}
else
{
/* End of tunnel */
st->ModeX = 1.0;
st->ModeXFlag = 0;
return;
};
/* Get current camera position */
cvCatmullRom(p4, st->cam_t, &op);
/* Next camera position */
st->cam_t += 0.02f;
if (st->cam_t >= 1)
{
st->cam_t = st->cam_t - 1;
cmpos = st->cam_pos->next;
}
/* Get curve for next camera position */
if (cmpos->next->next->next)
{
p1 = cmpos;
for (i=0; i<4; i++)
{
p4[i].x = p1->p.x;
p4[i].y = p1->p.y;
p4[i].z = p1->p.z;
p1 = p1->next;
}
}
else
{
/* End of tunnel */
st->ModeX = 1.0;
st->ModeXFlag = 0;
return;
}
/* Get next camera position */
cvCatmullRom(p4, st->cam_t, &op1);
/* Rotate camera */
glRotatef(st->alpha, 0, 0, -1);
st->alpha += 1;
/* Set camera position */
gluLookAt(op.x, op.y, op.z, op1.x, op1.y, op1.z, 0, 1, 0);
/* Set light position */
if (do_light)
{
light_position[0] = op.x;
light_position[1] = op.y;
light_position[2] = op.z;
light_position[3] = 1;
glLightfv(GL_LIGHT0, GL_POSITION, light_position);
}
p = st->cam_pos;
flag = 0;
t = 0;
k = 0;
/* Draw tunnel from current curve and next 2 curves */
glBegin(GL_QUADS);
while (k < 3)
{
if (p->next->next->next)
{
p1 = p;
for (i=0; i<4; i++)
{
p4[i].x = p1->p.x;
p4[i].y = p1->p.y;
p4[i].z = p1->p.z;
p1 = p1->next;
}
}
else
{
/* End of tunnel */
st->ModeX = 1.0;
st->ModeXFlag = 0;
glEnd();
return;
}
cvCatmullRom(p4, t, &op);
ppp.x = op.x;
ppp.y = op.y;
ppp.z = op.z + 0.25;
t += 0.1;
if (t >= 1.0)
{
t = t - 1;
k++;
p = p->next;
}
if (p->next->next->next)
{
p1 = p;
for (i=0; i<4; i++)
{
p4[i].x = p1->p.x;
p4[i].y = p1->p.y;
p4[i].z = p1->p.z;
p1 = p1->next;
}
}
else
{
/* End of tunnel */
st->ModeX = 1.0;
st->ModeXFlag = 0;
glEnd();
return;
}
cvCatmullRom(p4, t, &op1);
T.x = op1.x - op.x;
T.y = op1.y - op.y;
T.z = op1.z - op.z;
normalize(&T);
for (i=0; i<10; i++)
{
RotateAroundLine(&ppp, &op, &T, ((float)i*36.0*M_PI/180.0), &op2);
points[i].x = op2.x;
points[i].y = op2.y;
points[i].z = op2.z;
if (!flag)
{
st->prev_points[i].x = op2.x;
st->prev_points[i].y = op2.y;
st->prev_points[i].z = op2.z;
}
}
if (!flag)
{
flag = 1;
continue;
}
/* Draw 10 polygons for current point */
for (i=0; i<10; i++)
{
j = i+1;
if (j > 9) j = 0;
glNormal3f(0, 0, 1); /* Normal for lighting */
glTexCoord2f(0, 0); glVertex3f(st->prev_points[i].x, st->prev_points[i].y, st->prev_points[i].z);
glNormal3f(0, 0, 1);
glTexCoord2f(1, 0); glVertex3f(points[i].x, points[i].y, points[i].z);
glNormal3f(0, 0, 1);
glTexCoord2f(1, 1); glVertex3f(points[j].x, points[j].y, points[j].z);
glNormal3f(0, 0, 1);
glTexCoord2f(0, 1); glVertex3f(st->prev_points[j].x, st->prev_points[j].y, st->prev_points[j].z);
}
/* Save current polygon coordinates for next position */
for (i=0; i<10; i++)
{
st->prev_points[i].x = points[i].x;
st->prev_points[i].y = points[i].y;
st->prev_points[i].z = points[i].z;
}
}
glEnd();
st->cam_pos = cmpos;
}
/* =================== Show splash screen =================================== */
void
atunnel_SplashScreen(struct tunnel_state *st,
int do_wire, int do_texture, int do_light)
{
if (st->ModeX > 0)
{
/* Reset tunnel and camera position */
if (!st->ModeXFlag)
{
st->cam_pos = st->path;
st->cam_t = 0;
st->tFlag = 0;
st->ModeXFlag = 1;
st->current_texture++;
if (st->current_texture >= MAX_TEXTURE) st->current_texture = 0;
}
/* Now we want to draw splash screen */
glLoadIdentity();
/* Disable all unused features */
glDisable(GL_DEPTH_TEST);
glDisable(GL_LIGHTING);
glDisable(GL_FOG);
glDisable(GL_CULL_FACE);
glBlendFunc(GL_SRC_ALPHA, GL_DST_ALPHA);
glEnable(GL_BLEND);
glDisable(GL_TEXTURE_2D);
glColor4f(1, 1, 1, st->ModeX);
/* Draw splash screen (simply quad) */
glBegin(GL_QUADS);
glVertex3f(-10, -10, -1);
glVertex3f(10, -10, -1);
glVertex3f(10, 10, -1);
glVertex3f(-10, 10, -1);
glEnd();
st->ModeX -= 0.05;
if (st->ModeX <= 0) st->ModeX = 0;
if (!do_wire)
{
glEnable(GL_CULL_FACE);
glEnable(GL_DEPTH_TEST);
}
if (do_light)
{
glEnable(GL_LIGHTING);
glEnable(GL_FOG);
}
if (do_texture)
{
glEnable(GL_TEXTURE_2D);
}
glDisable(GL_BLEND);
glColor4f(1, 1, 1, 1);
}
}
void
atunnel_FreeTunnel(struct tunnel_state *st)
{
free (st);
}
#endif
|
the_stack_data/570806.c | #include<stdio.h>
int main()
{
int n=3,count=0;
while(n>0)
{
if((n&1)==1)
{
count++;
}
n=n>>1;
}
printf("%d",count);
return 0;
}
|
the_stack_data/651063.c | /*
* Heapsort
* a[i], sons: a[2i], a[2i+1]
* heapify(i,j)
* if i is not a leaf and sone of i contains a larger elt than i
* begin
* let k be the son of i with largest elt
* switch a[i] and a[k]
* heapify(k,j)
* end
*
* buildheap
* for (i=n; i--;i>=1)
* heapify(i,n);
*
* heapsort
* buildheap
* for (i=n; i--;i>=2)
* switch a[1] and a[i]
* heapify(1,i-1)
*
* select(k,S)
* if(ord(S)<50) {
* sort(S)
* return s[k-1] (kth elt)
* }
* for (i=0;i++,i<= ord(S)/5)
* sort(S[5i],...,S[5i+4])
* let T[i]= S[5i+2];
* m= select((ord(T)+1)/2,T)
* let S1= S[i]<m
* S2= S[i]==m
* S3= S[i]>m
* if(ord(S1)>=k)
* return(select(k,S1)
* if(ord(S1)+ord(S2)>=k)
* return(k)
* return(select(k-ord(S1)-ord(S2),S3)
*/
/*
* Union find
*
* 1. R[i]= internal name
* 2. List[A], Size{a}, EXT_NAME[], INT_NAME[]
*
* union(i,j,k)
* a=int_name[i]
* b= int_namr[j]
* wlog size[a]<= size[b]
* e= list[a]
* while(e!=0) {
* R[e]= b
* l= e;
* e= next[e];
* }
* next[l]= list[b];
* list[b]= list[a]
* size[b]+= size[a]
* int_name[k]= b
* ext_name[b]= k
*
*/
/*
* Tarjan's union find
*
* count[vi]= 1, name[vi]= i, f[vi]= 0, root[i]= vi, e[i]= vi
*
* find(i)
* list= 0
* v= e[i]
* while(f[v]!= 0) {
* add v to list
* v= f[v]
* }
* print name[v]
* for each w on list
* f[w]= v
*
* union(i,j,k)
* wlog count(root(i))<= count(root(j))
* large= root(j)
* small= root(i)
* f[small]= large
* count(large)+= count(small)
* name(large)= k
* root(k)= large
*
* FFT
*
* for(i=0;i<= 2^k -1;i++)
* r[i]= a[i]
* for(l=0;l<=k-1;l++) {
* s[i]= r[i]
* for(i=0;i<= 2^k -1;i++)
* i= Sum(j=0,k-1)d[k-1-j] 2^j
* r[d0,d1,...d(k-1)]= s[d0...d(l-1)0,d(l+1)...d(k-1)]
* + u^[dl,...,d0,0...0] S[d0,..d(l-1)1d(l+1)...]
* }
* for(i=0;i< 2^(k-1);i++)
* b[d0,...,d(k-1)]= r[d(k-1)..d0]
*
* fft as evaluation of poly at a root of 1
*
* r[0,k]= Sum(j=0,n-1)a[j] x^j
* /* r[l,m]= Sum(j,n-1)a[j] x^j /q[l,m] * /
* for (m=k-1;k--;k>=0) {
* for(l=0;l+= 2^(m+1), l<=n-1) {
* r[l,m+1]= Sum(j=0,2^(m+1)) a[j] x^j
* s= rev(l/(2^m))
* r[l,m]= Sum(j=0,2^m -1)(a[j]+u^s a[j+2^m]x^j
* r[l+2^m,m]= Sum(j=0,2^m-1)(a[j]+u^(s+n/2)) x^j
* }
* }
* for(l=0;l<=(n-1);n++)
* b[rev(l)]= r[l,0]
*
* Eval is O(nlg(n))
* q[l,m]= Prod(j=l,l+2^m-1) (x-c[j]); q[0,k]= p(x), q[l,0]= (x-c[l])
*
*
* x[n+1](ax[n]+c)(mod m)
* period length (c,m)=1, b=a-1=kp for p|m, 4|b if 4|m
*
* chi test chi(Y)= Sum(j=1,k) ((y[j]-np[j])**2/(np[j])
*
* freq test, serial test (q,r) recurring,gap test
* coupon test (length to obtain all), perm test, run up/down
* spectral test
*/
|
the_stack_data/103264980.c | #define _GNU_SOURCE
#include <fcntl.h>
#include <net/if.h>
#include <stdio.h>
#include <string.h>
#include <sys/ioctl.h>
#include <sys/stat.h>
#include <sys/types.h>
#include <unistd.h>
#include <linux/if.h>
#include <linux/if_tun.h>
int up_iface(char *name) {
struct ifreq req;
memset(&req, 0, sizeof req);
req.ifr_flags = IFF_UP;
if (strlen(name) + 1 >= IFNAMSIZ) {
fprintf(stderr, "device name is too long: %s\n", name);
return -1;
}
strncpy(req.ifr_name, name, IFNAMSIZ);
int sockfd = socket(AF_INET, SOCK_DGRAM, 0);
if (sockfd < 0) {
perror("socket");
return sockfd;
}
int err = ioctl(sockfd, SIOCSIFFLAGS, &req);
if (err < 0) {
perror("ioctl");
close(sockfd);
return err;
}
close(sockfd);
return 0;
}
int set_mtu(char *name, unsigned int mtu) {
struct ifreq req;
memset(&req, 0, sizeof req);
req.ifr_mtu = mtu;
if (strlen(name) + 1 >= IFNAMSIZ) {
fprintf(stderr, "device name is too long: %s\n", name);
return -1;
}
strncpy(req.ifr_name, name, IFNAMSIZ);
int sockfd = socket(AF_INET, SOCK_DGRAM, 0);
if (sockfd < 0) {
perror("socket");
return sockfd;
}
int err = ioctl(sockfd, SIOCSIFMTU, &req);
if (err < 0) {
perror("ioctl");
close(sockfd);
return err;
}
close(sockfd);
return 0;
}
int create_tap(char *name, char return_name[IFNAMSIZ], unsigned int mtu) {
// https://raw.githubusercontent.com/torvalds/linux/master/Documentation/networking/tuntap.txt
int fd = open("/dev/net/tun", O_RDWR);
if (fd < 0) {
perror("open");
return fd;
}
struct ifreq req;
memset(&req, 0, sizeof req);
req.ifr_flags = IFF_TAP | IFF_NO_PI;
if (name) {
if (strlen(name) + 1 >= IFNAMSIZ) {
close(fd);
fprintf(stderr, "device name is too long: %s\n", name);
return -1;
}
strncpy(req.ifr_name, name, IFNAMSIZ);
}
int err = ioctl(fd, TUNSETIFF, &req);
if (err < 0) {
close(fd);
perror("ioctl");
return err;
}
strncpy(return_name, req.ifr_name, IFNAMSIZ);
return_name[IFNAMSIZ - 1] = '\0';
err = set_mtu(return_name, mtu);
if (err < 0) {
close(fd);
return err;
}
err = up_iface(return_name);
if (err < 0) {
close(fd);
return err;
}
return fd;
}
|
the_stack_data/1121731.c | #include <stdio.h>
int main (int arg, char* argv[])
{
printf("\nEste programa tiene otra forma de reducir las expresiones arim%cticas\n",130);
/*
+= -> a=a+2 o puede escribirse como a+=2
-=
*=
/=
%=
&&=
||=
*/
getchar();
return 0;
}
|
the_stack_data/90351.c | #include <stdio.h>
#include <stdlib.h>
int main(int argc, char *argv[]) {
FILE *fp;
char c;
int b[10] = { 0 };
if (argc != 2) {
printf("Usage: %s [FILE]\n", argv[0]);
return 1;
}
fp = fopen(*++argv, "r");
while (fscanf(fp, "%c", &c) != EOF) {
int a = 0, n = 0, i;
do {
if (c < '0' || c > '9') {
goto fail_nondigit;
}
a = 0;
while (c >= '0' && c <= '9') {
a = a * 10 + c - '0';
if (fscanf(fp, "%c", &c) == EOF)
goto fail_eof;
}
b[n++] = a;
if (fscanf(fp, "%c", &c) == EOF)
goto fail_eof;
} while (c != '|');
if (fscanf(fp, "%c", &c) == EOF)
goto fail_eof;
if (c != ' ')
goto fail_nonspace;
if (fscanf(fp, "%c", &c) == EOF)
goto fail_eof;
for (i = 0; i < n; i++) {
if (c < '0' || c > '9') {
goto fail_nondigit;
}
a = 0;
while (c >= '0' && c <= '9') {
a = a * 10 + c - '0';
if (fscanf(fp, "%c", &c) == EOF) {
if (i < n - 1)
goto fail_eof;
else
break;
}
}
if (i > 0)
printf(" ");
printf("%d", b[i] * a);
if (i < n - 1 && fscanf(fp, "%c", &c) == EOF)
goto fail_eof;
}
printf("\n");
}
return 0;
fail_nondigit:
printf("unexpected non-digit input: \"%c\"\n", c);
return EXIT_FAILURE;
fail_nonspace:
printf("unexpected non-space input: \"%c\"\n", c);
return EXIT_FAILURE;
fail_eof:
printf("unexpected end of input\n");
return EXIT_FAILURE;
}
|
the_stack_data/206392117.c | // Helper functions used only in tests
#include <stdint.h>
#include <assert.h>
#include <stdarg.h>
// These functions are used in the unit tests for C ABI calls.
uint32_t
rust_dbg_extern_identity_u32(uint32_t u) {
return u;
}
uint64_t
rust_dbg_extern_identity_u64(uint64_t u) {
return u;
}
double
rust_dbg_extern_identity_double(double u) {
return u;
}
char
rust_dbg_extern_identity_u8(char u) {
return u;
}
typedef void *(*dbg_callback)(void*);
void *
rust_dbg_call(dbg_callback cb, void *data) {
return cb(data);
}
void rust_dbg_do_nothing() { }
struct TwoU8s {
uint8_t one;
uint8_t two;
};
struct TwoU8s
rust_dbg_extern_return_TwoU8s() {
struct TwoU8s s;
s.one = 10;
s.two = 20;
return s;
}
struct TwoU8s
rust_dbg_extern_identity_TwoU8s(struct TwoU8s u) {
return u;
}
struct TwoU16s {
uint16_t one;
uint16_t two;
};
struct TwoU16s
rust_dbg_extern_return_TwoU16s() {
struct TwoU16s s;
s.one = 10;
s.two = 20;
return s;
}
struct TwoU16s
rust_dbg_extern_identity_TwoU16s(struct TwoU16s u) {
return u;
}
struct TwoU32s {
uint32_t one;
uint32_t two;
};
struct TwoU32s
rust_dbg_extern_return_TwoU32s() {
struct TwoU32s s;
s.one = 10;
s.two = 20;
return s;
}
struct TwoU32s
rust_dbg_extern_identity_TwoU32s(struct TwoU32s u) {
return u;
}
struct TwoU64s {
uint64_t one;
uint64_t two;
};
struct TwoU64s
rust_dbg_extern_return_TwoU64s() {
struct TwoU64s s;
s.one = 10;
s.two = 20;
return s;
}
struct TwoU64s
rust_dbg_extern_identity_TwoU64s(struct TwoU64s u) {
return u;
}
struct TwoDoubles {
double one;
double two;
};
struct TwoDoubles
rust_dbg_extern_identity_TwoDoubles(struct TwoDoubles u) {
return u;
}
struct ManyInts {
int8_t arg1;
int16_t arg2;
int32_t arg3;
int16_t arg4;
int8_t arg5;
struct TwoU8s arg6;
};
// MSVC doesn't allow empty structs or unions
#ifndef _MSC_VER
struct Empty {
};
void
rust_dbg_extern_empty_struct(struct ManyInts v1, struct Empty e, struct ManyInts v2) {
assert(v1.arg1 == v2.arg1 + 1);
assert(v1.arg2 == v2.arg2 + 1);
assert(v1.arg3 == v2.arg3 + 1);
assert(v1.arg4 == v2.arg4 + 1);
assert(v1.arg5 == v2.arg5 + 1);
assert(v1.arg6.one == v2.arg6.one + 1);
assert(v1.arg6.two == v2.arg6.two + 1);
}
#endif
intptr_t
rust_get_test_int() {
return 1;
}
char *
rust_get_null_ptr() {
return 0;
}
// Debug helpers strictly to verify ABI conformance.
struct quad {
uint64_t a;
uint64_t b;
uint64_t c;
uint64_t d;
};
struct floats {
double a;
uint8_t b;
double c;
};
struct quad
rust_dbg_abi_1(struct quad q) {
struct quad qq = { q.c + 1,
q.d - 1,
q.a + 1,
q.b - 1 };
return qq;
}
struct floats
rust_dbg_abi_2(struct floats f) {
struct floats ff = { f.c + 1.0,
0xff,
f.a - 1.0 };
return ff;
}
int
rust_dbg_static_mut = 3;
void
rust_dbg_static_mut_check_four() {
assert(rust_dbg_static_mut == 4);
}
struct S {
uint64_t x;
uint64_t y;
uint64_t z;
};
uint64_t get_x(struct S s) {
return s.x;
}
uint64_t get_y(struct S s) {
return s.y;
}
uint64_t get_z(struct S s) {
return s.z;
}
uint64_t get_c_many_params(void *a, void *b, void *c, void *d, struct quad f) {
return f.c;
}
// Calculates the average of `(x + y) / n` where x: i64, y: f64. There must be exactly n pairs
// passed as variadic arguments.
double rust_interesting_average(uint64_t n, ...) {
va_list pairs;
double sum = 0.0;
int i;
va_start(pairs, n);
for(i = 0; i < n; i += 1) {
sum += (double)va_arg(pairs, int64_t);
sum += va_arg(pairs, double);
}
va_end(pairs);
return sum / n;
}
int32_t rust_int8_to_int32(int8_t x) {
return (int32_t)x;
}
typedef union LARGE_INTEGER {
struct {
uint32_t LowPart;
uint32_t HighPart;
};
struct {
uint32_t LowPart;
uint32_t HighPart;
} u;
uint64_t QuadPart;
} LARGE_INTEGER;
LARGE_INTEGER increment_all_parts(LARGE_INTEGER li) {
li.LowPart += 1;
li.HighPart += 1;
li.u.LowPart += 1;
li.u.HighPart += 1;
li.QuadPart += 1;
return li;
}
#if __SIZEOF_INT128__ == 16
unsigned __int128 identity(unsigned __int128 a) {
return a;
}
__int128 square(__int128 a) {
return a * a;
}
__int128 sub(__int128 a, __int128 b) {
return a - b;
}
#endif
|
the_stack_data/93888753.c |
#define max(a, b) (((a) > (b)) ? (a) : (b))
#define min(a, b) (((a) < (b)) ? (a) : (b))
int hIndex(int *citations, int citationsSize)
{
int res = 0;
for (int i = citationsSize - 1; i >= 0; --i)
res = max(res, min(citations[i], citationsSize - i));
return res;
} |
the_stack_data/141624.c | #include <stdio.h>
#include <math.h>
#include <cuda_runtime.h>
#include <cublas_v2.h>
int main(void)
{
int i;
const int n = 100;
double a = 3.4;
double *a_;
double x[n], y[n], y_ref[n];
double *x_, *y_;
cublasHandle_t handle;
// initialise data and calculate reference values on CPU
for (i=0; i < n; i++) {
x[i] = sin(i) * 2.3;
y[i] = cos(i) * 1.1;
y_ref[i] = a * x[i] + y[i];
}
printf(" initial: %f %f %f %f ... %f %f\n",
y[0], y[1], y[2], y[3], y[n-2], y[n-1]);
cublasCreate(&handle);
// use GPU pointers to keep data on GPU
cublasSetPointerMode(handle, CUBLAS_POINTER_MODE_DEVICE);
// allocate + copy initial values
cudaMalloc((void **) &x_, sizeof(double) * n);
cudaMalloc((void **) &y_, sizeof(double) * n);
cudaMalloc((void **) &a_, sizeof(double));
cudaMemcpy(x_, x, sizeof(double) * n, cudaMemcpyHostToDevice);
cudaMemcpy(y_, y, sizeof(double) * n, cudaMemcpyHostToDevice);
cudaMemcpy(a_, &a, sizeof(double), cudaMemcpyHostToDevice);
// calculate axpy on GPU
cublasDaxpy(handle, n, a_, x_, 1, y_, 1);
// copy result back to host and print with reference
cudaMemcpy(&y, y_, sizeof(double) * n, cudaMemcpyDeviceToHost);
printf("reference: %f %f %f %f ... %f %f\n",
y_ref[0], y_ref[1], y_ref[2], y_ref[3], y_ref[n-2], y_ref[n-1]);
printf(" result: %f %f %f %f ... %f %f\n",
y[0], y[1], y[2], y[3], y[n-2], y[n-1]);
cublasDestroy(handle);
return 0;
}
|
the_stack_data/49395.c | #include<stdio.h>
int stack[20];
int top = -1;
void push(int x)
{
stack[++top] = x;
}
int pop()
{
return stack[top--];
}
void main()
{
char exp[20];
char *e;
int n1,n2,n3,num;
printf("Enter the expression :: ");
scanf("%s",exp);
e = exp;
while(*e != '\0')
{
if(isdigit(*e))
{
num = *e - 48;
push(num);
}
else
{
n1 = pop();
n2 = pop();
switch(*e)
{
case '+':
{
n3 = n1 + n2;
break;
}
case '-':
{
n3 = n2 - n1;
break;
}
case '*':
{
n3 = n1 * n2;
break;
}
case '/':
{
n3 = n2 / n1;
break;
}
}
push(n3);
}
e++;
}
printf("\nThe result of expression %s = %d\n\n",exp,pop());
}
|
the_stack_data/11076198.c | /*
* Double-precision timing routine
*/
#include <time.h>
#ifndef __LIBCATAMOUNT__
#if !defined(i860) && !defined(dclock)
double dclock(void)
{
static double tps = 1.0 / CLOCKS_PER_SEC;
return (double) clock() * tps;
}
#endif
#endif
|
the_stack_data/151704990.c | /*
* $Id: stdlib_oslibversion.c,v 1.3 2006-01-08 12:04:26 obarthel Exp $
*
* :ts=4
*
* Portable ISO 'C' (1994) runtime library for the Amiga computer
* Copyright (c) 2002-2015 by Olaf Barthel <obarthel (at) gmx.net>
* All rights reserved.
*
* Redistribution and use in source and binary forms, with or without
* modification, are permitted provided that the following conditions
* are met:
*
* - Redistributions of source code must retain the above copyright
* notice, this list of conditions and the following disclaimer.
*
* - Neither the name of Olaf Barthel nor the names of 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 OWNER 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.
*/
int __minimum_os_lib_version;
|
the_stack_data/72012675.c | /* Find Barycentric Dynamical Time from Terrestrial Dynamical Time.
Reference: Astronomical Almanac, page B5. */
/* radians per arc second */
#define STR 4.8481368110953599359e-6
/* 2000 January 1.5 */
#define J2000 2451545.0
#if __STDC__
double sin (double);
double floor (double);
#else
double sin(), floor();
#endif
/* Argument JED is a Julian date, in TDT.
Output is the corresponding date in TDB. */
double tdb(JED)
double JED;
{
double M, T;
/* Find time T in Julian centuries from J2000. */
T = (JED - J2000)/36525.0;
/* Mean anomaly of sun = l' (J. Laskar) */
M = 129596581.038354 * T + 1287104.76154;
/* Reduce arc seconds mod 360 degrees. */
M = M - 1296000.0 * floor( M/1296000.0 );
M += ((((((((
1.62e-20 * T
- 1.0390e-17 ) * T
- 3.83508e-15 ) * T
+ 4.237343e-13 ) * T
+ 8.8555011e-11 ) * T
- 4.77258489e-8 ) * T
- 1.1297037031e-5 ) * T
+ 1.4732069041e-4 ) * T
- 0.552891801772 ) * T * T;
M *= STR;
/* TDB - TDT, in seconds. */
T = 0.001658 * sin(M) + 0.000014 * sin(M+M);
T = JED + T / 86400.0;
return(T);
}
|
the_stack_data/173759.c | /*
* Copyright (c) 2005 Apple Computer, Inc. All rights reserved.
*
* @APPLE_LICENSE_HEADER_START@
*
* This file contains Original Code and/or Modifications of Original Code
* as defined in and that are subject to the Apple Public Source License
* Version 2.0 (the 'License'). You may not use this file except in
* compliance with the License. Please obtain a copy of the License at
* http://www.opensource.apple.com/apsl/ and read it before using this
* file.
*
* The Original Code and all software distributed under the License are
* distributed on an 'AS IS' basis, WITHOUT WARRANTY OF ANY KIND, EITHER
* EXPRESS OR IMPLIED, AND APPLE HEREBY DISCLAIMS ALL SUCH WARRANTIES,
* INCLUDING WITHOUT LIMITATION, ANY WARRANTIES OF MERCHANTABILITY,
* FITNESS FOR A PARTICULAR PURPOSE, QUIET ENJOYMENT OR NON-INFRINGEMENT.
* Please see the License for the specific language governing rights and
* limitations under the License.
*
* @APPLE_LICENSE_HEADER_END@
*/
// test to see if NSLINKMODULE_OPTION_PRIVATE works
void findme()
{
}
|
the_stack_data/68887122.c | #include <assert.h>
#include <limits.h>
#include <math.h>
#include <stdbool.h>
#include <stddef.h>
#include <stdint.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
char* readline();
// Complete the findDigits function below.
int findDigits(int n) {
int num = n;
int count = 0;
while (num > 0) {
int div = num % 10;
if (div && ((n % div) == 0)) {
count++;
}
num /= 10;
}
return count;
}
int main()
{
FILE* fptr = fopen(getenv("OUTPUT_PATH"), "w");
char* t_endptr;
char* t_str = readline();
int t = strtol(t_str, &t_endptr, 10);
if (t_endptr == t_str || *t_endptr != '\0') { exit(EXIT_FAILURE); }
for (int t_itr = 0; t_itr < t; t_itr++) {
char* n_endptr;
char* n_str = readline();
int n = strtol(n_str, &n_endptr, 10);
if (n_endptr == n_str || *n_endptr != '\0') { exit(EXIT_FAILURE); }
int result = findDigits(n);
fprintf(fptr, "%d\n", result);
}
fclose(fptr);
return 0;
}
char* readline() {
size_t alloc_length = 1024;
size_t data_length = 0;
char* data = malloc(alloc_length);
while (true) {
char* cursor = data + data_length;
char* line = fgets(cursor, alloc_length - data_length, stdin);
if (!line) { break; }
data_length += strlen(cursor);
if (data_length < alloc_length - 1 || data[data_length - 1] == '\n') { break; }
size_t new_length = alloc_length << 1;
data = realloc(data, new_length);
if (!data) { break; }
alloc_length = new_length;
}
if (data[data_length - 1] == '\n') {
data[data_length - 1] = '\0';
}
data = realloc(data, data_length);
return data;
}
|
the_stack_data/51699210.c | #include <stdio.h>
#define PI 3.14
struct inp
{
int a;
};
int check(int a, int b)
{
return (a > b);
}
int main()
{
struct inp ab;
int r = 5;
printf("abc");
return 0;
} |
the_stack_data/155397.c | /* $Id: sysatms.c,v 1.2 1999/01/03 02:07:36 sybalsky Exp $ (C) Copyright Venue, All Rights Reserved
*/
|
the_stack_data/5721.c |
//
// Copyright (c) 2013-2015, John Mettraux, [email protected]
//
// Permission is hereby granted, free of charge, to any person obtaining a copy
// of this software and associated documentation files (the "Software"), to deal
// in the Software without restriction, including without limitation the rights
// to use, copy, modify, merge, publish, distribute, sublicense, and/or sell
// copies of the Software, and to permit persons to whom the Software is
// furnished to do so, subject to the following conditions:
//
// The above copyright notice and this permission notice shall be included in
// all copies or substantial portions of the Software.
//
// THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR
// IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,
// FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE
// AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER
// LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM,
// OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN
// THE SOFTWARE.
//
// Made in Japan.
//
/*
* rodzo header
*/
#include <ctype.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <strings.h>
#include <unistd.h> // for isatty()
#include <regex.h>
#include <wordexp.h>
#include <errno.h>
#include <sys/time.h>
int rdz_hexdump_on = 0;
// avoiding strdup and the posix_source requirement...
char *rdz_strdup(char *s)
{
int l = strlen(s);
char *r = calloc(l + 1, sizeof(char));
strcpy(r, s);
return r;
}
char *rdz_strndup(char *s, size_t n)
{
char *r = calloc(n + 1, sizeof(char));
for (size_t i = 0; i < n; i++) r[i] = s[i];
return r;
}
typedef double rdz_func();
typedef struct rdz_node {
int dorun;
int nodenumber;
int parentnumber;
size_t depth;
int *children;
//int indent;
char type;
char *fname;
int lstart;
int ltstart;
int llength;
char *text;
rdz_func *func;
} rdz_node;
rdz_node **rdz_nodes = NULL;
//void rdz_print_node(rdz_node *n)
//{
// for (int i = 1; i < n->indent; i++) printf(" ");
//
// char *s = NULL;
// if (n->stack) for (size_t i = 0; n->stack[i] != NULL; i++) s = n->stack[i];
//
// printf(
// "n:%d %c lts:%d \"%s\" dr:%d\n",
// n->nodenumber, n->type, n->ltstart, s, n->dorun
// );
//}
typedef struct rdz_result {
int success;
char *message;
char *title;
int itnumber;
int lnumber;
int ltnumber;
} rdz_result;
double rdz_now()
{
struct timeval tv;
if (gettimeofday(&tv, NULL) != 0) return 0.0;
return 1000.0 * tv.tv_sec + tv.tv_usec / 1000.0; // turn to ms
}
double rdz_duration(double start)
{
return rdz_now() - start; // still ms
}
char *rdz_determine_title(rdz_node *n)
{
char **texts = calloc(128, sizeof(char *));
rdz_node *nn = n;
size_t i = 0;
size_t l = 0;
while (1)
{
texts[i++] = nn->text;
l = l + strlen(nn->text) + 1;
if (nn->parentnumber < 1) break;
nn = rdz_nodes[nn->parentnumber];
}
char *title = calloc(l + 1, sizeof(char));
char *t = title;
for (size_t ii = i - 1; ; ii--)
{
l = strlen(texts[ii]);
strncpy(t, texts[ii], l);
t = t + l;
strcpy(t, " ");
t = t + 1;
if (ii == 0) break;
}
free(texts);
return title;
}
rdz_result *rdz_result_malloc(
int success, char *msg, int itnumber, int lnumber, int ltnumber)
{
rdz_node *n = rdz_nodes[itnumber];
rdz_result *r = calloc(1, sizeof(rdz_result));
r->success = success;
r->message = msg;
r->title = rdz_determine_title(n);
r->itnumber = itnumber;
r->lnumber = lnumber;
r->ltnumber = ltnumber;
return r;
}
void rdz_result_free(rdz_result *r)
{
free(r->message);
free(r->title);
free(r);
}
#define RDZ_LINES_MAX 32
int *rdz_lines = NULL;
char *rdz_example = NULL;
#define RDZ_FILES_MAX 16
char **rdz_files = NULL;
int rdz_it = -1;
int rdz_count = 0;
int rdz_fail_count = 0;
int rdz_pending_count = 0;
rdz_result **rdz_results = NULL;
// PS1="\[\033[1;34m\][\$(date +%H%M)][\u@\h:\w]$\[\033[0m\] "
//
// Black 0;30 Dark Gray 1;30
// Blue 0;34 Light Blue 1;34
// Green 0;32 Light Green 1;32
// Cyan 0;36 Light Cyan 1;36
// Red 0;31 Light Red 1;31
// Purple 0;35 Light Purple 1;35
// Brown 0;33 Yellow 1;33
// Light Gray 0;37 White 1;37
static int istty()
{
int rno = errno;
int r = isatty(1);
errno = rno;
return r;
}
char *rdz_rd() { return istty() ? "[0;31m" : ""; }
char *rdz_gn() { return istty() ? "[0;32m" : ""; }
char *rdz_yl() { return istty() ? "[0;33m" : ""; }
char *rdz_cy() { return istty() ? "[0;36m" : ""; }
char *rdz_gr() { return istty() ? "[1;30m" : ""; }
char *rdz_bl() { return istty() ? "[1;34m" : ""; }
//char *rdz_by() { return istty() ? "[1;33m" : ""; }
char *rdz_cl() { return istty() ? "[0;0m" : ""; }
void rdz_print_level(int nodenumber)//, int min)
{
if (nodenumber < 0) return;
rdz_node *n = rdz_nodes[nodenumber];
if (n->depth == 0) return;
for (int i = 0; i < n->depth - 1; i++) printf(" "); // indent
printf("%s", n->text);
printf(" %sL=%d I=%d%s\n", rdz_gr(), n->ltstart, n->nodenumber, rdz_cl());
}
void rdz_duration_to_s(double duration, char *ca)
{
*ca = 0;
if (duration < 0.0) return;
char *e = getenv("RDZ_NO_DURATION");
if (e && (strcmp(e, "1") == 0 || strcmp(e, "true"))) return;
if (duration < 1000.0) { sprintf(ca, "%fms ", duration); return; }
double s = duration / 1000.0;
sprintf(ca, "%.6f ", s);
for (size_t i = 0; ; ++i) { if (ca[i] == '.') { ca[i] = 's'; break; } }
}
void rdz_print_result(rdz_result *r, double duration)
{
if (r == NULL) return;
rdz_node *rit = rdz_nodes[r->itnumber];
for (int i = 0; i < rit->depth - 1; i++) printf(" "); // indent
char *co = rdz_gn();
if (r->success == -1) co = rdz_yl();
else if (r->success == 0) co = rdz_rd();
printf("%s%s", co, rit->text);
if (r->success == -1) printf(" (PENDING: %s)", r->message);
if (r->success == 0) printf(" (FAILED)");
char du[77]; rdz_duration_to_s(duration, du);
printf(
" %s%sL=%d I=%d%s\n", rdz_gr(), du, r->ltnumber, r->itnumber, rdz_cl());
}
char *rdz_truncate(char *s, size_t l, int soe)
{
if (s == NULL) return NULL;
size_t ls = strlen(s);
if (soe == 1)
{
char *r = calloc(ls + 3, sizeof(char));
snprintf(r, ls + 3, "\"%s\"", s);
return r;
}
int ll = l; // "%.*s" wants an int and not a size_t...
char *r = calloc(l + 6 + 1, sizeof(char));
if (ls <= l) snprintf(r, l + 6, "\"%s\"", s);
else if (soe <= 0) snprintf(r, l + 6, "\"%.*s...\"", ll, s);
else snprintf(r, l + 6, "\"...%.*s\"", ll, s + l + 1);
return r;
}
char *rdz_string_expected(char *result, char *verb, char *expected)
{
if (expected == NULL) verb = "to be";
size_t l = strlen(verb); if (l < 8) l = 8;
int ll = l; // "%.*s" wants an int and not a size_t...
int soe = 0; if (verb[3] == 's') soe = -1; else if (verb[3] == 'e') soe = 1;
char *res = rdz_truncate(result, 49, soe);
char *s = calloc(4096, sizeof(char));
if (expected)
snprintf(
s, 4096,
" %*s %s\n"
" %*s \"%s\"",
ll, "expected", res, ll, verb, expected);
else
snprintf(
s, 4096,
" %*s %s\n"
" %*s NULL",
ll, "expected", res, ll, verb);
if (res) free(res);
return s;
}
int rdz_hexdump(const void *d, ssize_t len, size_t line, int second)
{
char *s = (char *)d;
ssize_t l = len;
if (len < 0) len = strlen(s);
size_t line_length = 15;
size_t j = line * line_length;
printf("%s%-10p%s ", j == 0 ? rdz_cl() : rdz_gr(), s, rdz_cl());
size_t over = (j >= len);
for (size_t i = j; i < j + line_length; ++i)
{
if (over) printf(" ");
else if (s[i] >= 32 && s[i] <= 126) printf("%02x ", s[i]);
else printf("%s%02x%s ", rdz_bl(), s[i], rdz_cl());
if (l < 0) { if (s[i] == 0) over = 1; } else { if (i >= l) over = 1; }
int m = i - j + 1; if (m == 5 || m == 10) printf(" ");
}
over = (j >= len);
printf(" %s|%s", second ? rdz_cl() : rdz_bl(), rdz_cl());
for (size_t i = j; i < j + line_length; ++i)
{
if (l < 0) { if (s[i] == 0) over = 1; } else { if (i >= l) over = 1; }
if (over) printf(" ");
else if (s[i] >= 32 && s[i] <= 126) printf("%c", s[i]);
else printf("%s.%s", rdz_bl(), rdz_cl());
int m = i - j + 1;
if (m == 5 || m == 10) printf("%s-%s", rdz_gr(), rdz_cl());
}
printf("%s|%s\n", second ? rdz_cl() : rdz_bl(), rdz_cl());
if (over) return 1; // over
return 0;
}
void rdz_hexshow(const char *a, const char *b, ssize_t n)
{
for (size_t line = 0; ; ++line)
{
int oa = rdz_hexdump(a, n, line, 0);
int ob = rdz_hexdump(b, n, line, 1);
if (oa && ob) break;
}
}
int rdz_strcmp(char *op, char *a, char *b, ssize_t n)
{
short i = (strchr(op, 'i') != NULL);
if (rdz_hexdump_on) rdz_hexshow(a, b, n);
if (n > -1) return i ? strncasecmp(a, b, n) : strncmp(a, b, n);
return i ? strcasecmp(a, b) : strcmp(a, b);
}
char *rdz_string_eq(char *operator, char *result, char *expected)
{
if (expected == NULL && result == NULL) return NULL;
//if (expected == NULL) return rdz_strdup(" expected NULL");
if (result == NULL) return rdz_strdup(" result is NULL");
if (expected && rdz_strcmp(operator, result, expected, -1) == 0) return NULL;
return rdz_string_expected(result, "to equal", expected);
}
char *rdz_string_neq(char *operator, char *result, char *not_expected)
{
if (result == NULL) return rdz_strdup(" result is NULL");
if (not_expected == NULL) return NULL;
if (rdz_strcmp(operator, result, not_expected, -1) != 0) return NULL;
size_t l = strlen(not_expected) + 22;
char *s = calloc(l, sizeof(char));
snprintf(s, l, " didn't expect \"%s\"", not_expected);
return s;
}
char *rdz_string_match(char *operator, char *result, char *expected)
{
if (result == NULL) return rdz_strdup(" result is NULL");
char *s = NULL;
int flags = REG_EXTENDED;
if (strchr(operator, 'i')) flags = flags | REG_ICASE;
regex_t *r = calloc(1, sizeof(regex_t));
regcomp(r, expected, flags);
regmatch_t ms[1];
if (regexec(r, result, 0, ms, 0)) // no match
{
if (operator[0] != '!')
s = rdz_string_expected(result, "to match", expected);
}
else // match
{
if (operator[0] == '!')
s = rdz_string_expected(result, "not to match", expected);
}
regfree(r); free(r);
return s;
}
char *rdz_string_start(char *operator, char *result, char *expected)
{
int success =
result &&
rdz_strcmp(operator, result, expected, strlen(expected)) == 0;
if (operator[0] == '!')
{
return success ?
rdz_string_expected(result, "not to start with", expected) : NULL;
}
return success ?
NULL : rdz_string_expected(result, "to start with", expected);
}
char *rdz_string_end(char *operator, char *result, char *expected)
{
int success =
result &&
rdz_strcmp(
operator, result + strlen(result) - strlen(expected), expected, -1) == 0;
if (operator[0] == '!')
{
return success ?
rdz_string_expected(result, "not to end with", expected) : NULL;
}
return success ?
NULL : rdz_string_expected(result, "to end with", expected);
}
static char *lower_case(char *s)
{
char *r = calloc(strlen(s) + 1, sizeof(char));
for (size_t i = 0; s[i]; ++i) r[i] = tolower(s[i]);
return r;
}
char *rdz_string_contains(char *operator, char *result, char *expected)
{
char *re = result;
char *ex = expected;
if (result && strchr(operator, 'i'))
{
re = lower_case(result);
ex = lower_case(expected);
}
char *r = re ? strstr(re, ex) : NULL;
if (re && rdz_hexdump_on) rdz_hexshow(re, ex, -1);
if (re != result) free(re);
if (ex != expected) free(ex);
if (operator[0] == '!')
return r ? rdz_string_expected(result, "not to contain", expected) : NULL;
else
return r ? NULL : rdz_string_expected(result, "to contain", expected);
}
void rdz_record(int success, char *msg, int itnumber, int lnumber, int ltnumber)
{
rdz_result *result =
rdz_result_malloc(success, msg, itnumber, lnumber, ltnumber);
rdz_results[rdz_count++] = result;
if (success == -1) rdz_pending_count++;
if (success == 0) rdz_fail_count++;
}
void rdz_extract_arguments()
{
// E=example
rdz_example = getenv("E");
// L=12,67
char *l = getenv("L");
if (l != NULL)
{
rdz_example = NULL;
rdz_lines = calloc(RDZ_LINES_MAX + 1, sizeof(int));
for (size_t i = 0; i < RDZ_LINES_MAX; i++)
{
if (l == NULL) { rdz_lines[i] = -1; continue; }
char *c = strpbrk(l, ",");
rdz_lines[i] = atoi(l);
if (c == NULL) { l = NULL; continue; }
l = c + 1;
}
}
// I=6
char *i = getenv("I");
if (i != NULL)
{
rdz_example = NULL;
rdz_it = atoi(i);
}
// F=fname
char *f = getenv("F");
if (f != NULL)
{
rdz_files = calloc(RDZ_FILES_MAX + 1, sizeof(char *));
for (size_t i = 0; i < RDZ_FILES_MAX; ++i)
{
char *ff = strpbrk(f, " \t");
size_t l = ff ? ff - f : strlen(f);
char *fn = NULL;
if (f[0] == '.')
{
fn = rdz_strndup(f, l);
}
else
{
fn = calloc(l + 9, sizeof(char));
strcpy(fn, "../spec/"); strncpy(fn + 8, f, l);
}
wordexp_t we;
wordexp(fn, &we, 0);
rdz_files[i] = rdz_strdup(we.we_wordv[0]);
wordfree(&we);
free(fn);
f = ff; if (f == NULL) break;
while (1) if (f[0] != ' ' && f[0] != '\t') break; else ++f;
}
}
// RDZ_HEXDUMP
char *rh = getenv("RDZ_HEXDUMP");
rdz_hexdump_on =
rh &&
(
strcmp(rh, "1") == 0 ||
strcasecmp(rh, "on") == 0 ||
strcasecmp(rh, "yes") == 0 ||
strcasecmp(rh, "true") == 0
);
}
void rdz_run_all_children(rdz_node *n)
{
for (size_t i = 0; n->children[i] > -1; i++)
{
rdz_node *cn = rdz_nodes[n->children[i]];
char ct = cn->type;
if (ct != 'd' && ct != 'c' && ct != 'i' && ct != 'p') continue;
if (cn->dorun < 1) cn->dorun = 1;
if (ct != 'i' || ct != 'p') rdz_run_all_children(cn);
}
}
void rdz_run_all_parents(int parentnumber)
{
if (parentnumber < 0) return;
rdz_node *pn = rdz_nodes[parentnumber];
if (pn->dorun < 1) pn->dorun = 1;
rdz_run_all_parents(pn->parentnumber);
}
int rdz_determine_dorun_l(rdz_node *n)
{
if (rdz_lines == NULL) return -1;
for (size_t i = 0; rdz_lines[i] > -1; i++)
{
int l = rdz_lines[i];
if (l >= n->ltstart && l <= n->ltstart + n->llength) return 1;
}
return 0;
}
int rdz_determine_dorun_i(rdz_node *n)
{
if (rdz_it < 0) return -1;
return n->nodenumber == rdz_it;
}
int rdz_determine_dorun_e(rdz_node *n)
{
if (rdz_example == NULL) return -1;
return (strstr(n->text, rdz_example) != NULL);
}
int rdz_determine_dorun_f(rdz_node *n)
{
if (rdz_files == NULL) return -1;
for (size_t i = 0; ; i++)
{
char *fn = rdz_files[i];
if (fn == NULL) break;
if (strcmp(fn, n->fname) == 0) return 1;
}
return 0;
}
void rdz_determine_dorun()
{
// first pass, determine if a node should get run on its own
for (size_t i = 0; rdz_nodes[i] != NULL; i++)
{
rdz_node *n = rdz_nodes[i];
char t = n->type;
//if (t == 'B' || t == 'b' || t == 'A' || t == 'a') continue;
if (t == 'G' || t == 'g') n->dorun = 1;
if (t != 'd' && t != 'c' && t != 'i' && t != 'p') continue;
int re = rdz_determine_dorun_e(n);
int rl = rdz_determine_dorun_l(n);
int rf = rdz_determine_dorun_f(n);
int ri = rdz_determine_dorun_i(n);
if (rl < 0 && re < 0 && rf < 0 && ri < 0) n->dorun = 1;
if (rf > 0) n->dorun = 1;
if (rl > 0) n->dorun = 2; // all children if they're all 0
if (re > 0) n->dorun = 3; // ancestors and all children
if (ri > 0) n->dorun = 3;
//printf(
// "%zu) re: %d, rl: %d, rf: %d n->dorun: %d\n",
// i, re, rl, rf, n->dorun);
}
// second pass, ancestors and children are brought in
for (size_t i = 0; rdz_nodes[i] != NULL; i++)
{
rdz_node *n = rdz_nodes[i];
if (n->dorun < 2) continue;
int run_parents = 0;
int run_children = 0;
if (n->dorun == 2)
{
run_children = 1;
for (size_t j = 0; n->children[j] > -1; j++)
{
if (rdz_nodes[n->children[j]]->dorun > 1) run_children = 0;
}
}
else //if (n->dorun == 3)
{
run_parents = 1;
run_children = 1;
}
if (run_parents) rdz_run_all_parents(n->parentnumber);
if (run_children) rdz_run_all_children(n);
}
}
void rdz_run_offlines(int nodenumber, char type)
{
if (nodenumber == -1) return;
rdz_node *n = rdz_nodes[nodenumber];
// before each offline
if (type == 'y') rdz_run_offlines(n->parentnumber, type);
for (size_t i = 0; n->children[i] > -1; i++)
{
rdz_node *nn = rdz_nodes[n->children[i]];
if (nn->type == type) nn->func();
}
// after each offline
if (type == 'z') rdz_run_offlines(n->parentnumber, type);
}
void rdz_dorun(rdz_node *n)
{
if (n->nodenumber == 0) printf("\n"); // initial blank line
if ( ! n->dorun) return;
char t = n->type;
if (t == 'i')
{
if (n->children[0] > -1) { rdz_dorun(rdz_nodes[n->children[0]]); return; }
int rc = rdz_count;
double du = n->func(); // run the "it"
if (rdz_count == rc) // no ensure in the example, record a success...
{
rdz_record(1, rdz_strdup(n->text), n->nodenumber, n->lstart, n->ltstart);
}
rdz_print_result(rdz_results[rdz_count - 1], du);
}
else if (t == 'p')
{
rdz_record(-1, rdz_strdup(n->text), n->parentnumber, n->lstart, n->ltstart);
rdz_print_result(rdz_results[rdz_count - 1], -1.0);
}
else if (t == 'G' || t == 'g' || t == 'd' || t == 'c')
{
rdz_print_level(n->nodenumber);
for (size_t i = 0; n->children[i] > -1; i++) // before all
{
rdz_node *nn = rdz_nodes[n->children[i]];
if (nn->type == 'B') nn->func();
}
for (size_t i = 0; n->children[i] > -1; i++) // children
{
rdz_node *nn = rdz_nodes[n->children[i]];
if (nn->type != 'd' && nn->type != 'c' && nn->type != 'i') continue;
rdz_run_offlines(n->nodenumber, 'y'); // before each offline
rdz_dorun(nn);
rdz_run_offlines(n->nodenumber, 'z'); // after each offline
}
for (size_t i = 0; n->children[i] > -1; i++) // after all
{
rdz_node *nn = rdz_nodes[n->children[i]];
if (nn->type == 'A') nn->func();
}
}
}
char *rdz_read_line(char *fname, int lnumber)
{
char *l = calloc(1024, sizeof(char));
char *ll = l;
FILE *in = fopen(fname, "r");
if (in == NULL)
{
fprintf(stderr, "cannot find source file %s\n", fname);
exit(1);
}
while(1)
{
if (lnumber < 1) break;
char c = fgetc(in);
if (c == EOF) break;
if (c == '\n') { lnumber--; continue; }
if (lnumber == 1) *(ll++) = c;
}
fclose(in);
return l;
}
void rdz_summary(int itcount, double duration)
{
printf("\n");
if (rdz_pending_count > 0)
{
printf("Pending:\n");
for (size_t i = 0; i < rdz_count; i++)
{
rdz_result *r = rdz_results[i];
if (r->success != -1) continue;
rdz_node *rit = rdz_nodes[r->itnumber];
printf(" %s%s%s\n", rdz_yl(), r->title, rdz_cl());
printf(" %s# %s%s\n", rdz_cy(), r->message, rdz_cl());
printf(" %s# %s:%d", rdz_cy(), rit->fname, r->lnumber);
printf(" %sL=%d I=%d%s\n", rdz_gr(), r->ltnumber, r->itnumber, rdz_cl());
}
printf("\n");
}
if (rdz_fail_count > 0)
{
printf("Failures:\n\n");
for (size_t i = 0, j = 0; i < rdz_count; i++)
{
rdz_result *r = rdz_results[i];
if (r->success != 0) continue;
rdz_node *rit = rdz_nodes[r->itnumber];
char *line = rdz_read_line(rit->fname, r->lnumber);
printf(" %zu) %s\n", ++j, r->title);
if (r->message) { printf("%s%s%s\n", rdz_rd(), r->message, rdz_cl()); }
printf(" >");
printf("%s%s%s", rdz_rd(), line, rdz_cl());
printf("<\n");
printf(" %s# %s:%d%s", rdz_cy(), rit->fname, r->lnumber, rdz_cl());
printf(" %sL=%d I=%d%s\n", rdz_gr(), r->ltnumber, r->itnumber, rdz_cl());
free(line);
}
}
char sdu[80]; rdz_duration_to_s(duration, sdu);
printf("\n");
printf("%s%d examples, ", rdz_fail_count > 0 ? rdz_rd() : rdz_gn(), itcount);
printf("%d tests seen, ", rdz_count - rdz_pending_count);
printf("%d failures", rdz_fail_count);
if (rdz_pending_count > 0) printf(", %d pending", rdz_pending_count);
if (*sdu != 0) printf(" %s%s", rdz_gr(), sdu);
printf("%s\n", rdz_cl());
printf("\n");
if (rdz_fail_count > 0)
{
printf("Failed examples:\n\n");
for (size_t i = 0; i < rdz_count; i++)
{
rdz_result *r = rdz_results[i];
if (r->success != 0) continue;
printf("%smake spec I=%d", rdz_rd(), r->itnumber);
printf(" %s# %s%s\n", rdz_cy(), r->title, rdz_cl());
}
printf("\n");
}
//printf("%s%s%s\n", rdz_gr(), sdu, rdz_cl());
//printf("\n");
}
|
the_stack_data/87638801.c | int main()
{
struct x
{
int a;
int b;
} y;
struct x z;
return 0;
}
|
the_stack_data/122899.c | /* This testcase is part of GDB, the GNU debugger.
Copyright 2010-2015 Free Software Foundation, Inc.
This program is free software; you can redistribute it and/or modify
it under the terms of the GNU General Public License as published by
the Free Software Foundation; either version 3 of the License, or
(at your option) any later version.
This program is distributed in the hope that it will be useful,
but WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
GNU General Public License for more details.
You should have received a copy of the GNU General Public License
along with this program. If not, see <http://www.gnu.org/licenses/>. */
int block_func (void)
{
int i = 0;
{
double i = 1.0;
double f = 2.0;
{
const char *i = "stuff";
const char *f = "foo";
const char *b = "bar";
return 0; /* Block break here. */
}
}
}
int main (int argc, char *argv[])
{
block_func ();
return 0; /* Break at end. */
}
|
the_stack_data/150139240.c | /* dietlibc */
extern int __mark(int);
char *stpcpy(char *dst, const char *src) {
while (__mark(0) & (*dst++ = *src++))
;
return (dst - 1);
}
|
the_stack_data/165766289.c | /* Copyright 2014-2015 ARM Limited
*
* 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.
*/
/*
* readenergy.c
*
* Reads APB energy registers in Juno and outputs the measurements (converted to appropriate units).
*
*/
#include <errno.h>
#include <fcntl.h>
#include <stdint.h>
#include <stdio.h>
#include <stdlib.h>
#include <string.h>
#include <signal.h>
#include <sys/mman.h>
#include <sys/stat.h>
#include <sys/types.h>
#include <time.h>
#include <unistd.h>
// The following values obtained from Juno TRM 2014/03/04 section 4.5
// Location of APB registers in memory
#define APB_BASE_MEMORY 0x1C010000
// APB energy counters start at offset 0xD0 from the base APB address.
#define BASE_INDEX 0xD0 / 4
// the one-past last APB counter
#define APB_SIZE 0x120
// Masks specifying the bits that contain the actual counter values
#define CMASK 0xFFF
#define VMASK 0xFFF
#define PMASK 0xFFFFFF
// Sclaing factor (divisor) or getting measured values from counters
#define SYS_ADC_CH0_PM1_SYS_SCALE 761
#define SYS_ADC_CH1_PM2_A57_SCALE 381
#define SYS_ADC_CH2_PM3_A53_SCALE 761
#define SYS_ADC_CH3_PM4_GPU_SCALE 381
#define SYS_ADC_CH4_VSYS_SCALE 1622
#define SYS_ADC_CH5_VA57_SCALE 1622
#define SYS_ADC_CH6_VA53_SCALE 1622
#define SYS_ADC_CH7_VGPU_SCALE 1622
#define SYS_POW_CH04_SYS_SCALE (SYS_ADC_CH0_PM1_SYS_SCALE * SYS_ADC_CH4_VSYS_SCALE)
#define SYS_POW_CH15_A57_SCALE (SYS_ADC_CH1_PM2_A57_SCALE * SYS_ADC_CH5_VA57_SCALE)
#define SYS_POW_CH26_A53_SCALE (SYS_ADC_CH2_PM3_A53_SCALE * SYS_ADC_CH6_VA53_SCALE)
#define SYS_POW_CH37_GPU_SCALE (SYS_ADC_CH3_PM4_GPU_SCALE * SYS_ADC_CH7_VGPU_SCALE)
#define SYS_ENM_CH0_SYS_SCALE 12348030000
#define SYS_ENM_CH1_A57_SCALE 6174020000
#define SYS_ENM_CH0_A53_SCALE 12348030000
#define SYS_ENM_CH0_GPU_SCALE 6174020000
// Original values prior to re-callibrations.
/*#define SYS_ADC_CH0_PM1_SYS_SCALE 819.2*/
/*#define SYS_ADC_CH1_PM2_A57_SCALE 409.6*/
/*#define SYS_ADC_CH2_PM3_A53_SCALE 819.2*/
/*#define SYS_ADC_CH3_PM4_GPU_SCALE 409.6*/
/*#define SYS_ADC_CH4_VSYS_SCALE 1638.4*/
/*#define SYS_ADC_CH5_VA57_SCALE 1638.4*/
/*#define SYS_ADC_CH6_VA53_SCALE 1638.4*/
/*#define SYS_ADC_CH7_VGPU_SCALE 1638.4*/
/*#define SYS_POW_CH04_SYS_SCALE (SYS_ADC_CH0_PM1_SYS_SCALE * SYS_ADC_CH4_VSYS_SCALE)*/
/*#define SYS_POW_CH15_A57_SCALE (SYS_ADC_CH1_PM2_A57_SCALE * SYS_ADC_CH5_VA57_SCALE)*/
/*#define SYS_POW_CH26_A53_SCALE (SYS_ADC_CH2_PM3_A53_SCALE * SYS_ADC_CH6_VA53_SCALE)*/
/*#define SYS_POW_CH37_GPU_SCALE (SYS_ADC_CH3_PM4_GPU_SCALE * SYS_ADC_CH7_VGPU_SCALE)*/
/*#define SYS_ENM_CH0_SYS_SCALE 13421772800.0*/
/*#define SYS_ENM_CH1_A57_SCALE 6710886400.0*/
/*#define SYS_ENM_CH0_A53_SCALE 13421772800.0*/
/*#define SYS_ENM_CH0_GPU_SCALE 6710886400.0*/
// Ignore individual errors but if see too many, abort.
#define ERROR_THRESHOLD 10
// Default counter poll period (in milliseconds).
#define DEFAULT_PERIOD 100
// A single reading from the energy meter. The values are the proper readings converted
// to appropriate units (e.g. Watts for power); they are *not* raw counter values.
struct reading
{
double sys_adc_ch0_pm1_sys;
double sys_adc_ch1_pm2_a57;
double sys_adc_ch2_pm3_a53;
double sys_adc_ch3_pm4_gpu;
double sys_adc_ch4_vsys;
double sys_adc_ch5_va57;
double sys_adc_ch6_va53;
double sys_adc_ch7_vgpu;
double sys_pow_ch04_sys;
double sys_pow_ch15_a57;
double sys_pow_ch26_a53;
double sys_pow_ch37_gpu;
double sys_enm_ch0_sys;
double sys_enm_ch1_a57;
double sys_enm_ch0_a53;
double sys_enm_ch0_gpu;
};
inline uint64_t join_64bit_register(uint32_t *buffer, int index)
{
uint64_t result = 0;
result |= buffer[index];
result |= (uint64_t)(buffer[index+1]) << 32;
return result;
}
int nsleep(const struct timespec *req, struct timespec *rem)
{
struct timespec temp_rem;
if (nanosleep(req, rem) == -1)
{
if (errno == EINTR)
{
nsleep(rem, &temp_rem);
}
else
{
return errno;
}
}
else
{
return 0;
}
}
void print_help()
{
fprintf(stderr, "Usage: readenergy [-t PERIOD] -o OUTFILE\n\n"
"Read Juno energy counters every PERIOD milliseconds, writing them\n"
"to OUTFILE in CSV format until SIGTERM is received.\n\n"
"Parameters:\n"
" PERIOD is the counter poll period in milliseconds.\n"
" (Defaults to 100 milliseconds.)\n"
" OUTFILE is the output file path\n");
}
// debugging only...
inline void dprint(char *msg)
{
fprintf(stderr, "%s\n", msg);
sync();
}
// -------------------------------------- config ----------------------------------------------------
struct config
{
struct timespec period;
char *output_file;
};
void config_init_period_from_millis(struct config *this, long millis)
{
this->period.tv_sec = (time_t)(millis / 1000);
this->period.tv_nsec = (millis % 1000) * 1000000;
}
void config_init(struct config *this, int argc, char *argv[])
{
this->output_file = NULL;
config_init_period_from_millis(this, DEFAULT_PERIOD);
int opt;
while ((opt = getopt(argc, argv, "ht:o:")) != -1)
{
switch(opt)
{
case 't':
config_init_period_from_millis(this, atol(optarg));
break;
case 'o':
this->output_file = optarg;
break;
case 'h':
print_help();
exit(EXIT_SUCCESS);
break;
default:
fprintf(stderr, "ERROR: Unexpected option %s\n\n", opt);
print_help();
exit(EXIT_FAILURE);
}
}
if (this->output_file == NULL)
{
fprintf(stderr, "ERROR: Mandatory -o option not specified.\n\n");
print_help();
exit(EXIT_FAILURE);
}
}
// -------------------------------------- /config ---------------------------------------------------
// -------------------------------------- emeter ----------------------------------------------------
struct emeter
{
int fd;
FILE *out;
void *mmap_base;
};
void emeter_init(struct emeter *this, char *outfile)
{
this->out = fopen(outfile, "w");
if (this->out == NULL)
{
fprintf(stderr, "ERROR: Could not open output file %s; got %s\n", outfile, strerror(errno));
exit(EXIT_FAILURE);
}
this->fd = open("/dev/mem", O_RDONLY);
if(this->fd < 0)
{
fprintf(stderr, "ERROR: Can't open /dev/mem; got %s\n", strerror(errno));
fclose(this->out);
exit(EXIT_FAILURE);
}
this->mmap_base = mmap(NULL, APB_SIZE, PROT_READ, MAP_SHARED, this->fd, APB_BASE_MEMORY);
if (this->mmap_base == MAP_FAILED)
{
fprintf(stderr, "ERROR: mmap failed; got %s\n", strerror(errno));
close(this->fd);
fclose(this->out);
exit(EXIT_FAILURE);
}
fprintf(this->out, "sys_curr,a57_curr,a53_curr,gpu_curr,"
"sys_volt,a57_volt,a53_volt,gpu_volt,"
"sys_pow,a57_pow,a53_pow,gpu_pow,"
"sys_cenr,a57_cenr,a53_cenr,gpu_cenr\n");
}
void emeter_read_measurements(struct emeter *this, struct reading *reading)
{
uint32_t *buffer = (uint32_t *)this->mmap_base;
reading->sys_adc_ch0_pm1_sys = (double)(CMASK & buffer[BASE_INDEX+0]) / SYS_ADC_CH0_PM1_SYS_SCALE;
reading->sys_adc_ch1_pm2_a57 = (double)(CMASK & buffer[BASE_INDEX+1]) / SYS_ADC_CH1_PM2_A57_SCALE;
reading->sys_adc_ch2_pm3_a53 = (double)(CMASK & buffer[BASE_INDEX+2]) / SYS_ADC_CH2_PM3_A53_SCALE;
reading->sys_adc_ch3_pm4_gpu = (double)(CMASK & buffer[BASE_INDEX+3]) / SYS_ADC_CH3_PM4_GPU_SCALE;
reading->sys_adc_ch4_vsys = (double)(VMASK & buffer[BASE_INDEX+4]) / SYS_ADC_CH4_VSYS_SCALE;
reading->sys_adc_ch5_va57 = (double)(VMASK & buffer[BASE_INDEX+5]) / SYS_ADC_CH5_VA57_SCALE;
reading->sys_adc_ch6_va53 = (double)(VMASK & buffer[BASE_INDEX+6]) / SYS_ADC_CH6_VA53_SCALE;
reading->sys_adc_ch7_vgpu = (double)(VMASK & buffer[BASE_INDEX+7]) / SYS_ADC_CH7_VGPU_SCALE;
reading->sys_pow_ch04_sys = (double)(PMASK & buffer[BASE_INDEX+8]) / SYS_POW_CH04_SYS_SCALE;
reading->sys_pow_ch15_a57 = (double)(PMASK & buffer[BASE_INDEX+9]) / SYS_POW_CH15_A57_SCALE;
reading->sys_pow_ch26_a53 = (double)(PMASK & buffer[BASE_INDEX+10]) / SYS_POW_CH26_A53_SCALE;
reading->sys_pow_ch37_gpu = (double)(PMASK & buffer[BASE_INDEX+11]) / SYS_POW_CH37_GPU_SCALE;
reading->sys_enm_ch0_sys = (double)join_64bit_register(buffer, BASE_INDEX+12) / SYS_ENM_CH0_SYS_SCALE;
reading->sys_enm_ch1_a57 = (double)join_64bit_register(buffer, BASE_INDEX+14) / SYS_ENM_CH1_A57_SCALE;
reading->sys_enm_ch0_a53 = (double)join_64bit_register(buffer, BASE_INDEX+16) / SYS_ENM_CH0_A53_SCALE;
reading->sys_enm_ch0_gpu = (double)join_64bit_register(buffer, BASE_INDEX+18) / SYS_ENM_CH0_GPU_SCALE;
}
void emeter_take_reading(struct emeter *this)
{
static struct reading reading;
int error_count = 0;
emeter_read_measurements(this, &reading);
int ret = fprintf(this->out, "%f,%f,%f,%f,%f,%f,%f,%f,%f,%f,%f,%f,%f,%f,%f,%f\n",
reading.sys_adc_ch0_pm1_sys,
reading.sys_adc_ch1_pm2_a57,
reading.sys_adc_ch2_pm3_a53,
reading.sys_adc_ch3_pm4_gpu,
reading.sys_adc_ch4_vsys,
reading.sys_adc_ch5_va57,
reading.sys_adc_ch6_va53,
reading.sys_adc_ch7_vgpu,
reading.sys_pow_ch04_sys,
reading.sys_pow_ch15_a57,
reading.sys_pow_ch26_a53,
reading.sys_pow_ch37_gpu,
reading.sys_enm_ch0_sys,
reading.sys_enm_ch1_a57,
reading.sys_enm_ch0_a53,
reading.sys_enm_ch0_gpu);
if (ret < 0)
{
fprintf(stderr, "ERROR: while writing a meter reading: %s\n", strerror(errno));
if (++error_count > ERROR_THRESHOLD)
exit(EXIT_FAILURE);
}
}
void emeter_finalize(struct emeter *this)
{
if (munmap(this->mmap_base, APB_SIZE) == -1)
{
// Report the error but don't bother doing anything else, as we're not gonna do
// anything with emeter after this point anyway.
fprintf(stderr, "ERROR: munmap failed; got %s\n", strerror(errno));
}
close(this->fd);
fclose(this->out);
}
// -------------------------------------- /emeter ----------------------------------------------------
int done = 0;
void term_handler(int signum)
{
done = 1;
}
int main(int argc, char *argv[])
{
struct sigaction action;
memset(&action, 0, sizeof(struct sigaction));
action.sa_handler = term_handler;
sigaction(SIGTERM, &action, NULL);
struct config config;
struct emeter emeter;
config_init(&config, argc, argv);
emeter_init(&emeter, config.output_file);
struct timespec remaining;
while (!done)
{
emeter_take_reading(&emeter);
nsleep(&config.period, &remaining);
}
emeter_finalize(&emeter);
return EXIT_SUCCESS;
}
|
the_stack_data/225432.c | #include <stdio.h>
#include <stdlib.h>
#define OK "Stringa palindroma"
#define KO "Stringa non palindroma"
typedef struct l {
char letter;
struct l* next;
} Letter;
typedef Letter* Word;
void push(Word* wordPtr, int letter);
int pop(Word* wordPtr);
int isPalindrome(Word* word, int len, int counter);
int main(void) {
int len = -1;
if (scanf("%d", &len) != 1 || len < 0) {
puts("Input non corretto");
}
getchar();
Word word = 0;
char readLetter = '\0';
for (int i = 0; i < len; i++) {
readLetter = getchar();
push(&word, readLetter);
}
if (isPalindrome(&word, len, 1)) {
puts(OK);
} else {
puts(KO);
}
}
void push(Word* wordPtr, int letter) {
Letter* newLetter = malloc(sizeof(*newLetter));
if (newLetter == NULL) {
exit(1);
}
newLetter->next = *wordPtr;
newLetter->letter = letter;
*wordPtr = newLetter;
}
int pop(Word* wordPtr) {
Letter* letterToBeReturdedPtr = *wordPtr;
if (letterToBeReturdedPtr == NULL) {
return '\0';
} else {
*wordPtr = letterToBeReturdedPtr->next;
char letter = letterToBeReturdedPtr->letter;
free(letterToBeReturdedPtr);
return letter;
}
}
int isPalindrome(Word* word, int len, int counter) {
char before = pop(word);
int wasPreviousPalindrome = 1;
if (counter < len / 2) {
wasPreviousPalindrome = isPalindrome(word, len, ++counter);
} else {
if (len % 2 != 0) {
// discard the middle character if the number of chars is odd
pop(word);
}
}
char after = pop(word);
return wasPreviousPalindrome && (before == after);
} |
the_stack_data/956272.c |
/*@ begin PerfTuning (
def build
{
arg build_command = 'gcc -O3 -fopenmp ';
arg libs = '-lm -lrt';
}
def performance_counter
{
arg repetitions = 35;
}
def performance_params
{
param T1_I[] = [1,16,32,64,128,256,512];
param T1_J[] = [1,16,32,64,128,256,512];
param T2_I[] = [1,64,128,256,512,1024,2048];
param T2_J[] = [1,64,128,256,512,1024,2048];
param ACOPY_A[] = [False,True];
param U_I[] = range(1,31);
param U_J[] = range(1,31);
param SCREP[] = [False,True];
param VEC[] = [False,True];
param OMP[] = [False,True];
param PAR1i[]=[False,True];
param PAR1j[]=[False,True];
constraint tileI = ((T2_I == 1) or (T2_I % T1_I == 0));
constraint tileJ = ((T2_J == 1) or (T2_J % T1_J == 0));
constraint reg_capacity = (2*U_I*U_J + 2*U_I + 2*U_J <= 130);
constraint copy_limitA = ((not ACOPY_A) or (ACOPY_A and
(T1_I if T1_I>1 else T2_I)*(T1_J if T1_J>1 else T2_J) <= 512*512));
}
def search
{
arg algorithm = 'Randomsearch';
arg total_runs = 10000;
}
def input_params
{
let SIZE = 5000;
param MSIZE = SIZE;
param NSIZE = SIZE;
param M = SIZE;
param N = SIZE;
}
def input_vars
{
decl static double a[M][N] = random;
decl static double y_1[N] = random;
decl static double y_2[M] = random;
decl static double x1[M] = 0;
decl static double x2[N] = 0;
}
) @*/
int i, j;
int ii, jj;
int iii, jjj;
#define max(x,y) ((x) > (y)? (x) : (y))
#define min(x,y) ((x) < (y)? (x) : (y))
/*@ begin Loop(
transform Composite(
tile = [('i',T1_I,'ii'),('j',T1_J,'jj'),(('ii','i'),T2_I,'iii'),(('jj','j'),T2_J,'jjj')],
arrcopy = [(ACOPY_A,'a[i][j]',[(T1_I if T1_I>1 else T2_I),(T1_J if T1_J>1 else T2_J)],'_copy')],
scalarreplace = (SCREP, 'double', 'scv_'),
vector = (VEC, ['ivdep','vector always']),
unrolljam = (['i','j'],[U_I,U_J]),
openmp = (OMP, 'omp parallel for private(iii,jjj,ii,jj,i,j,a_copy)')
)
for (i=0;i<=N-1;i++)
for (j=0;j<=N-1;j++)
{
x1[i]=x1[i]+a[i][j]*y_1[j];
x2[j]=x2[j]+a[i][j]*y_2[i];
}
) @*/
/*@ end @*/
/*@ end @*/
|
the_stack_data/971534.c | #include <stdio.h>
#include <stdlib.h>
int gcd(int a, int b);
int gcd(int a, int b)
{
int retval;
/* Sanitise input to API */
if ((a <= 0) || (b <= 0))
{
retval = -1;
}
else
{
/* Implemenation follows */
/* Step 1 : Check and reorganise arguments */
if (a < b)
{
retval = gcd(b, a);
}
else if (a % b == 0)
{
retval = b;
}
else
{
retval = gcd(b, (a % b));
}
}
return retval;
}
int main(int argc, char** argv)
{
int retval = -1;
int a, b;
if (argc == 3)
{
a = atoi(argv[1]);
b = atoi(argv[2]);
retval = gcd(a, b);
if (retval != -1)
{
printf("%d", retval);
retval = 0;
}
}
return retval;
}
|
the_stack_data/405782.c | #include <stdio.h>
#include <stdlib.h>
char *makeFileName(char *src){
/* Get ext and path length */
char *src_pos, *src_period;
src_pos = src;
src_period = 0;
while(*src_pos != '\0'){
if(*src_pos == '.') src_period = src_pos;
src_pos++;
}
int src_len = src_pos - src;
/* Make output file name string */
char *dst = (char *)malloc(src_len + 2);
char *dst_pos;
src_pos = src;
dst_pos = dst;
if(src_period == 0){
/* No ext -> add '_' at the end of the file name */
while(*src_pos != '\0'){
*dst_pos++ = *src_pos++;
}
*dst_pos++ = '_';
*dst_pos = '\0';
}else{
/* With ext -> add '_' before the ext */
while(src_pos != src_period){
*dst_pos++ = *src_pos++;
}
*dst_pos++ = '_';
while(*src_pos != '\0'){
*dst_pos++ = *src_pos++;
}
*dst_pos = '\0';
}
return dst;
}
int main(int argc, char *argv[]){
/* Check args */
if(argc < 2){
printf("Usage:\n");
printf("utf8bom_changer file1 file2 ...\n");
exit(0);
}
/* Process each file */
int bom[3];
bom[0] = 0xef;
bom[1] = 0xbb;
bom[2] = 0xbf;
for(int f_count = 1; f_count < argc; f_count++){
char *dst = makeFileName(argv[f_count]);
printf("Src:%s\nDst:%s\n", argv[f_count], dst);
FILE *f_src;
f_src = fopen(argv[f_count], "r");
if(f_src == NULL){
printf("Can't open file: %s\n", argv[f_count]);
free(dst);
continue;
/* exit(EXIT_FAILURE); */
}
FILE *f_dst;
f_dst = fopen(dst, "w");
if(f_dst == NULL){
printf("Can't open file: %s\n", dst);
fclose(f_src);
free(dst);
continue;
/* exit(EXIT_FAILURE); */
}
/* Get first 3 chars */
int head[3];
head[0] = fgetc(f_src);
if(head[0] == EOF){
printf("Empty file: %s\n", argv[f_count]);
fclose(f_src);
fclose(f_dst);
free(dst);
continue;
}
/* if file size < 3, without bom */
head[1] = fgetc(f_src);
if(head[1] == EOF){
for(int i = 0; i < 3; i++){
fputc(bom[i], f_dst);
}
fputc(head[0], f_dst);
fclose(f_src);
fclose(f_dst);
free(dst);
continue;
}
head[2] = fgetc(f_src);
if(head[2] == EOF){
for(int i = 0; i < 3; i++){
fputc(bom[i], f_dst);
}
fputc(head[0], f_dst);
fputc(head[1], f_dst);
fclose(f_src);
fclose(f_dst);
free(dst);
continue;
}
/* with or without bom? */
if(head[0] != bom[0] || head[1] != bom[1] || head[2] != bom[2]){
/* without bom -> add bom before the fist 3 chars */
fputc(bom[0], f_dst);
fputc(bom[1], f_dst);
fputc(bom[2], f_dst);
fputc(head[0], f_dst);
fputc(head[1], f_dst);
fputc(head[2], f_dst);
}
/* rest of the file */
int c = fgetc(f_src);
while(c != EOF){
fputc(c, f_dst);
c = fgetc(f_src);
}
fclose(f_src);
fclose(f_dst);
free(dst);
}
return 0;
} |
the_stack_data/165767101.c | /*
** EPITECH PROJECT, 2019
** mlib
** File description:
** Copy or clone a string
*/
#include <stdlib.h>
static const int SUCCESS = 0;
static const int ERROR = 84;
int mstr_cp(char *str, char *dest)
{
int row = 0;
if (!str || !dest)
return (ERROR);
for ( ; str[row] ; row++)
dest[row] = str[row];
dest[row] = '\0';
return (SUCCESS);
}
char *mstr_cln(char *str)
{
char *cpy = NULL;
int row = 0;
if (!str)
return (NULL);
for ( ; str[row] ; row++);
if ((cpy = malloc(sizeof(char *) * ++row)) == NULL)
return (NULL);
mstr_cp(str, cpy);
return (cpy);
}
|
the_stack_data/117327436.c | /*
* Copyright (c) 2010 Intel Corporation. All rights reserved.
* Copyright (c) Imagination Technologies Limited, UK
* Redistribution. Redistribution and use in binary form, without modification,
* are permitted provided that the following conditions are met:
*
* Redistributions must reproduce the above copyright notice and the following
* disclaimer in the documentation and/or other materials provided with the
* distribution.Neither the name of Intel Corporation nor the names of its
* suppliers may be used to endorse or promote products derived from this
* software without specific prior written permission. No reverse engineering,
* decompilation, or disassembly of this software is permitted.
* Limited patent license. Intel Corporation grants a world-wide, royalty-free,
* non-exclusive license under patents it now or hereafter owns or controls
* to make, have made, use, import,offer to sell and sell ("utilize") this
* software, but solely to the extent that any such patent is necessary to
* Utilize the software alone. The patent license shall not apply to any
* combinations which include this software. No hardware per se is licensed hereunder.
*
* DISCLAIMER. 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 OWNER 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.
*/
// This file was automatically generated from ../release/H264FirmwareCBR.dnl using dnl2c.
char *szH264CBR_MTXTOPAZFW_buildtag = "TOPAZ_DDKBUILD_00-00-00-0146";
unsigned int ui32H264CBR_MTXTOPAZFWTextSize = 5169;
unsigned int ui32H264CBR_MTXTOPAZFWDataSize = 3008;
unsigned int ui32H264CBR_MTXTOPAZFWDataLocation = 0x82885100;
unsigned int aui32H264CBR_MTXTOPAZFWText[] = {
0x9040c001,
0xc80993fe,
0xc0000e42,
0xc8290e00,
0xc5d48422,
0xc8298460,
0xc5108622,
0x9e838600,
0xc8099e43,
0xca160d42,
0xc8090d20,
0xca160942,
0xc8090960,
0xc00a0e42,
0xc8090e40,
0xc00e87c2,
0x9c1887d0,
0x0c020802,
0x09820d82,
0x09020d02,
0x08820c82,
0x9320fffe,
0xa401c838,
0x0dc2c809,
0x0de0ca14,
0x0e42c809,
0x0b46b080,
0x7e74b77f,
0xa48d0882,
0xffff9ff3,
0x9d1393e0,
0xf8398081,
0x0707a205,
0x06850307,
0x03839e97,
0x0fa0060f,
0x018d058d,
0x9c62008f,
0x9340ffff,
0x0ea0060b,
0xffff9c62,
0x058d93a0,
0xb700018d,
0xb780500c,
0x9c014f94,
0x0687a605,
0x0ea0060b,
0xffff9c62,
0xf9f893a0,
0xf9f8aa9d,
0x9c22aa1d,
0xa60d9c22,
0x9bfefff4,
0x0ca2c829,
0x0cc0c5d4,
0x404db720,
0x0a42c809,
0x0a00c6e4,
0x0b027440,
0x420cb580,
0x0a12d002,
0x4644b421,
0xc0540d8a,
0xb78098b0,
0xc807508c,
0xc57008c2,
0xc0320880,
0xb5800c86,
0xb4214b8c,
0x0a06c000,
0x0c98c002,
0xc000b481,
0x09021a04,
0x08bac002,
0x4078b960,
0x0a00c200,
0x588bd224,
0xc000b441,
0x0a11ce00,
0x9301ffff,
0x1884e000,
0x9244ffff,
0x0a42c807,
0x0a00c576,
0x0c86c032,
0xc000b481,
0x08820a02,
0x08840902,
0x4078b960,
0x0a00c200,
0x588bd224,
0xc000b441,
0x0a11ce00,
0x9301ffff,
0x745ac004,
0x923cffff,
0xc0340a02,
0xb4810c9e,
0xc034c000,
0xc05498cd,
0xc054982e,
0x0d8a982a,
0x9861c054,
0x0a42c801,
0x0a08c010,
0x0c86c032,
0xc000b481,
0x08c2c801,
0x0880cb10,
0xb4210ce4,
0x0a06c000,
0xb4810cb4,
0xc123c000,
0xc56608d2,
0xc08008e0,
0xb4210c82,
0x1a04c000,
0xb4810c84,
0x0d86c000,
0x0d0209c2,
0x0902c121,
0x991bc014,
0x450cb780,
0xa982f208,
0x0d02c021,
0x09c20d04,
0x9906c014,
0x450cb780,
0x0ad2c123,
0x0ae0c566,
0xa982f208,
0x0d0609c2,
0x98fac014,
0x09c20d86,
0xc1810d0e,
0xc0140902,
0xc00298fe,
0xc0540dc2,
0x700a980d,
0x9364ffff,
0xc0540d82,
0xc0039814,
0xb74092e0,
0xd2265104,
0x9e2d5908,
0xaa4de030,
0x9c629ea4,
0x4494b720,
0x405db740,
0x58c1c280,
0x2a80cff0,
0x5a21c280,
0x8021f310,
0x753ec004,
0x40cdb520,
0x404db580,
0x4652b431,
0x0a42c801,
0x0a08c010,
0x0c86c032,
0xc000b481,
0xc0020886,
0xb4210c98,
0xb780c000,
0xc080448c,
0xf2080c82,
0xb421a881,
0x0d82c000,
0x9bd0c034,
0x448cb780,
0xa881f208,
0xffff7002,
0x0d869304,
0x0d0209c2,
0x0902c121,
0x98afc014,
0x450cb780,
0xa982f208,
0x0d02c021,
0x09c20d04,
0x989ac014,
0x450cb780,
0xa982f208,
0x0d0609c2,
0x9892c014,
0x09c20d86,
0xc1010d0e,
0xc0140902,
0x77409896,
0x9082c000,
0x9b79c034,
0x9c80c971,
0x5a41e200,
0x9204c000,
0x0dc2c002,
0x9b9ac034,
0x448cb780,
0xa881f208,
0xffff7002,
0x0d8292e4,
0x9b9dc034,
0xc0007580,
0xc0349364,
0x0d8a9b5e,
0x9b95c034,
0x448cb780,
0xa881f208,
0x5908d0a8,
0x0948d073,
0xe0309e2d,
0xd3f1aacd,
0xc2002a5c,
0x75185a05,
0x2ad2d012,
0x9234fffb,
0xb79f0802,
0xb7bf7eee,
0xb7df7f6e,
0x8c607fee,
0x9c229c22,
0x449cb740,
0xc200aa41,
0xc0025a08,
0xf3100a00,
0xf2088021,
0xf208a882,
0xc0c0a885,
0x5c890c80,
0xc000b421,
0xa6059c22,
0x449cb740,
0x0886aa41,
0x0c9ec034,
0x5a08c200,
0x0a00c002,
0x80a1f310,
0xc000b421,
0x0c92c080,
0xaa25f208,
0xc000b481,
0xc0340dc2,
0xf2089b3f,
0x7008aa25,
0x9344ffff,
0xc0800a02,
0xb4810c96,
0x0d86c000,
0x0d0609c2,
0x0902c121,
0x981bc014,
0xa9a2f208,
0x0d02c021,
0x09c20d04,
0x9808c014,
0x7f6eb79f,
0x7feeb7bf,
0x9c228c40,
0xc0409e54,
0x9e590c82,
0xc000b421,
0x0d02c040,
0xc000b482,
0xc00e9c22,
0xc00e2d7c,
0x5d3029e0,
0xc0409e54,
0x31b80c82,
0xc000b461,
0x0d02c040,
0xc000b442,
0x9e4c9c22,
0x28fcc00e,
0x2a7cc00e,
0x0c82c040,
0xb4019e58,
0xc200c000,
0x58e45a6c,
0x1d043242,
0x9e515d10,
0x1984598d,
0x3980c011,
0x590d3246,
0x59301904,
0x32443242,
0xc000b481,
0x9e4c9c22,
0x28fcc00e,
0x2a7cc00e,
0x0c82c040,
0xb4019e58,
0xc200c000,
0x58e45a6c,
0x1d043242,
0x9e515d10,
0x1984598d,
0x3980c019,
0x590d3246,
0x59301904,
0x32443242,
0xc000b481,
0x9e4c9c22,
0x28fcc00e,
0x2a7cc00e,
0x0c82c040,
0xb4019e58,
0xc200c000,
0x58e45a6c,
0x1d043242,
0x9e515d10,
0x1984598d,
0x3980c01d,
0x590d3246,
0x59301904,
0x32443242,
0xc000b481,
0xa60d9c22,
0x07038420,
0xc2800687,
0x1c845c8d,
0x5ca0d0a2,
0xd0110287,
0xc2000a5e,
0x1a045a0d,
0x5a30c200,
0x30985cd0,
0x04059e4c,
0x0c8ac032,
0xc8013098,
0xb4213880,
0x9ea9c000,
0x0a02c801,
0x0a00c002,
0xc0306553,
0xb4810c8a,
0xc002c000,
0x0c840882,
0xc000b421,
0xd0229e93,
0x9e535f09,
0x1d045d0d,
0x9b5afff4,
0x5e91c280,
0xc2801e84,
0x9e6c5e84,
0xc2801a84,
0xc1815a90,
0x0d8a3a80,
0x0d020982,
0xfff4314a,
0xc0c09b54,
0x09920d82,
0x0d02c002,
0x0902c002,
0x9a47c034,
0xc0340a0a,
0xb4810c9e,
0x1b04c000,
0x850275bf,
0x9202c000,
0xb55f9dcf,
0xc0347f7c,
0xf2319a4f,
0xb75fa045,
0x1b047f7c,
0x851075bf,
0x9284ffff,
0xc0300a02,
0xb4810c8e,
0xb79fc000,
0xb7bf7e6e,
0xb7df7eee,
0xc0027f6e,
0x9c228c00,
0xb780a605,
0xc004430c,
0x75002a00,
0x598cb7a0,
0x92c2c002,
0xa9b6f208,
0x0982c050,
0x0d7ec008,
0x9b08fff4,
0xa9bef208,
0x0982c028,
0x0d3ec004,
0x9b00fff4,
0x430cb780,
0x38c0d211,
0x02039e89,
0x2a00c201,
0xcffa7500,
0xb5202cfd,
0xc0014314,
0x744090e2,
0x5a0cb740,
0x9256c000,
0xaa45f008,
0xa8c9f008,
0x2cfec7ff,
0x0a00c010,
0xa245f008,
0x0880c008,
0xa0c9f008,
0x4314b520,
0xaa45f008,
0x430cb720,
0xa235f208,
0xa8caf008,
0x28fecdff,
0xa0bef208,
0x430cb520,
0x9240c000,
0xa937f208,
0xaa39f208,
0xa93cf20a,
0xa8a1f248,
0x8021f310,
0x82a3e210,
0xa235f208,
0xa0bdf208,
0xa9bef248,
0x0982c002,
0xfff40d0e,
0xf2489ab5,
0xb720aa3d,
0xc002430c,
0xf2480a00,
0xc200a23d,
0xb5203880,
0xc011430c,
0x74402880,
0x92e2c000,
0xa9b6f248,
0x0982c008,
0xfff40d3e,
0xf2489a9d,
0xb720aa35,
0xc008430c,
0xf2480a00,
0xc081a235,
0xcfef3880,
0xb52028fe,
0xb780430c,
0xc001430c,
0x75002a04,
0x92e2c000,
0xa9b6f248,
0x0982c008,
0xfff40d3e,
0xf2489a81,
0xb720aa35,
0xc008430c,
0xf2480a00,
0xc001a235,
0xcfff3888,
0xb52028fa,
0xb720430c,
0x0203430c,
0x2a10c001,
0xc0027500,
0xc0019082,
0x744028c0,
0x9182c001,
0xa9a6f288,
0x0d0609c2,
0x0c820942,
0xfff40882,
0xf2889a96,
0xf288a9b6,
0x5d90a927,
0x81afe220,
0x430cb780,
0x0d0609c2,
0x0c820942,
0xc0010882,
0xb5803a20,
0xfff4430c,
0xb7809aa0,
0xf288430c,
0xc003a8a5,
0x08c03a00,
0xa0a5f288,
0x2a2ecfff,
0x9260c000,
0xa9a6f288,
0x0d0609c2,
0x9a36fff4,
0x430cb780,
0xa8a5f288,
0x3a20c001,
0xf28808c0,
0xcfffa0a5,
0xb5802a6e,
0xb79f430c,
0xb7bf7f6e,
0x8c407fee,
0xa6059c22,
0x430cb780,
0x2a00c200,
0x9e5d7500,
0x9302c000,
0x0abc6a8e,
0x09829eab,
0xc1010d36,
0xc0140902,
0x9eab98a4,
0x430cb780,
0x0d1a0982,
0x0902c101,
0x2a7dcdfe,
0x430cb580,
0x9897c014,
0x430cb780,
0x2a00c081,
0xc0007500,
0xc1019222,
0xc0060902,
0x0dce0940,
0x0d020982,
0x9887c014,
0x430cb780,
0x2a7ecf7f,
0x430cb580,
0x430cb780,
0x2a08c001,
0xc0007500,
0xc1019222,
0xc0060902,
0x0dde0940,
0x0d020982,
0x9871c014,
0x430cb780,
0x2a76cfff,
0x430cb580,
0x430cb780,
0x2a20c001,
0xc0007500,
0x0de291e2,
0x0d020982,
0x0902c101,
0x985dc014,
0x430cb780,
0x2a5ecfff,
0x430cb580,
0x430cb780,
0x2a00c003,
0xc0007500,
0x0de291e2,
0x0d060982,
0x0902c101,
0x9849c014,
0x430cb780,
0x2a7ecffd,
0x430cb580,
0x7f6eb79f,
0x7feeb7bf,
0x9c228c40,
0xb7a0a605,
0xf248598c,
0xc021a9ba,
0x0d3c0d02,
0x0982c008,
0x999efff4,
0xa9aaf288,
0x0d02c021,
0x09c20d04,
0x9996fff4,
0xaa39f248,
0xa8a9f288,
0x0a00c008,
0xa239f248,
0xf28808c0,
0xb79fa0a9,
0xb7bf7f6e,
0x8c407fee,
0xa6059c22,
0x09920687,
0x0d02c002,
0x0902c002,
0x9883c034,
0x0a42c002,
0xc2800eb0,
0xb4855e89,
0xb79fc000,
0xb7bf7f6e,
0x8c407fee,
0xb7409c22,
0xd1a64b84,
0x9e2d5d08,
0xa8cde030,
0x5a0cc080,
0xd1f35885,
0xc00e2910,
0xe2202d7c,
0xc00e812d,
0x5d302a40,
0x32429e51,
0x0c82c040,
0xc000b481,
0x0d02c040,
0xc000b442,
0xb7409c22,
0x1df05a84,
0x5d08d1a6,
0xe0309e2d,
0xc080a8cd,
0xd0335a05,
0x5991294e,
0x008929bc,
0x81a7e210,
0x2910d1f3,
0x2d7cc00e,
0x812de220,
0x5d305990,
0x31b89e54,
0x0c82c040,
0xc000b461,
0x0d02c040,
0xc000b442,
0xa6059c22,
0x598cb7a0,
0x0e82c111,
0x0ec0c04e,
0xa9b6f208,
0x0982c050,
0x0d7ec008,
0x991efff4,
0x0df29e6a,
0x0982c004,
0xfff40d02,
0xf2089bc8,
0xf248a937,
0xe220a9aa,
0xc05081af,
0xc0080982,
0xfff40d7e,
0x9e6a990b,
0xc0040df2,
0x0d0209c2,
0x9bb5fff4,
0xa937f208,
0xa9aaf248,
0x812ec201,
0x81afe220,
0x0982c050,
0x0d7ec008,
0x98f6fff4,
0x0df29e6a,
0x0982c006,
0xfff40d02,
0xf2089ba0,
0xcfd8a9be,
0xc0280e81,
0xc0040982,
0xfff40d3e,
0x9e6a98e5,
0xc0040df2,
0xc0040982,
0xfff40d42,
0xf2089b8e,
0xf248a93f,
0xe220a9b2,
0xc02881af,
0xc0040982,
0xfff40d3e,
0x9e6a98d1,
0xc0040df2,
0xc00409c2,
0xfff40d42,
0xf2089b7a,
0xf248a93f,
0xc201a9b2,
0xe220812e,
0xc02881af,
0xc0040982,
0xfff40d3e,
0x9e6a98bb,
0xc0060df2,
0xc0040982,
0xfff40d42,
0xf2489b64,
0xf20aaa29,
0xf248a934,
0xd226a8b1,
0xf2085904,
0xf310a9bf,
0xd0a68021,
0xe2105904,
0xf31080a3,
0xe2108221,
0xf20880b3,
0xf208a235,
0xb79fa0bd,
0xb7bf7f6e,
0x8c407fee,
0xa6059c22,
0x0902c121,
0x0940c006,
0x02870dca,
0x0d020982,
0x2afcc00e,
0x9b1bfff4,
0x09820dca,
0xc2800d1e,
0x010b5aec,
0x3900c121,
0x9b11fff4,
0x430cb780,
0x3a00c400,
0x430cb580,
0x7f6eb79f,
0x7feeb7bf,
0x9c228c40,
0x0922c829,
0x0970c5fe,
0x0a22c829,
0x0a50c5fe,
0x5b0cb720,
0x0ca2c829,
0x0ce0c5fe,
0x8502c004,
0x450cb580,
0x448cb520,
0x0a18d071,
0xa241f008,
0x404db520,
0x413db540,
0x8d00c004,
0x40bdb540,
0x403db540,
0xf8399c22,
0xf010a285,
0x7500aa61,
0x9164c000,
0xa8c1d008,
0x0a069e48,
0x5200c200,
0xd0083098,
0xd011a0c1,
0xd0100d38,
0xf011a9f2,
0xf0101a30,
0x1984a943,
0x93e2c000,
0x8702cff1,
0x8700cff0,
0x087ec00f,
0x087cc00e,
0x0c1ac050,
0xa8c5f029,
0x2095d020,
0x9e4d5ca1,
0xc2002210,
0x30d85a20,
0x4006ba09,
0xc000b420,
0x1a30f011,
0xffff1984,
0xf21091e4,
0xf010802f,
0xf9f8a241,
0x9c22aa9d,
0x8420a60d,
0x9e558502,
0x7f7cb55f,
0xaa61f010,
0x8d8ee012,
0xb55f0307,
0x1a087ffc,
0xd226750a,
0x8540590c,
0x8044e05a,
0x91e0c003,
0x9180c000,
0x9000c001,
0x9140c001,
0x92a0c001,
0x9380c001,
0x91c0c002,
0x5c0cb780,
0xa881da08,
0x74402888,
0xb352856a,
0xb7804462,
0x9d57448c,
0x8d88e011,
0x1954d072,
0xa299f208,
0x9abcc014,
0x91e0c002,
0x448cb780,
0xa91af208,
0xe0119ea9,
0x15148d88,
0x9ab0c014,
0x9060c002,
0x8d88e011,
0x295ed3f2,
0xc0140916,
0xb78099df,
0xf208448c,
0xc001a299,
0xe01192c0,
0xd3f28d88,
0x0916295e,
0x99d2c014,
0x91a0c001,
0xaa41d208,
0x8c88f011,
0xd0124a7d,
0x0d062ace,
0x018b0906,
0x99c4c014,
0x9e6a9e83,
0x0d02018b,
0x99bec014,
0x9320c000,
0xaa41d208,
0x8c88f011,
0xd0124a7d,
0x0d022ace,
0x018b0906,
0x99b0c014,
0x9e6a9e83,
0xc00e018b,
0xc0140d7e,
0xc00099a9,
0xc0019080,
0xb79f90e0,
0xc00f7e68,
0xc00e0cfe,
0x9e4a0cfc,
0x7c68b59f,
0x7f6cb73f,
0x0a02cff1,
0x0a00cff0,
0x0c9ac050,
0xc2002218,
0x20945a21,
0x324258a0,
0x4006ba24,
0x7f6cb59f,
0xc000b481,
0xa943f208,
0x7fecb79f,
0x8021f310,
0xa241f208,
0x7e6eb79f,
0x7eeeb7bf,
0x7f6eb7df,
0x8c00c002,
0xa61d9c22,
0x85028440,
0xf0319e9d,
0x0b02abe5,
0x7878b55f,
0x7efcb55f,
0x9d3a718e,
0x91e8c001,
0x7502aa41,
0x9392c000,
0xaad1d018,
0x8d08e032,
0x8d00e051,
0x9eb19dcf,
0xb55f8510,
0xc0027f7c,
0xc2800a9c,
0x018b5a95,
0x9aebfff4,
0x7f7cb75f,
0x5a88c280,
0x8122c301,
0x91a0c000,
0x8d88e031,
0x050b9dcf,
0xb55f8510,
0xfff47f7c,
0xb75f9b19,
0x0b047f7c,
0xfffe718e,
0xb79f92a6,
0xc0507868,
0xb4810c9e,
0xc050c000,
0xb4e20d16,
0xb71fc000,
0xb79f7eec,
0xb7bf7d6e,
0xb7df7dee,
0xb7ff7e6e,
0xc0027eee,
0x9c228c40,
0xa205f839,
0x8400c010,
0x5c0cb780,
0x449cb740,
0xa882da08,
0xd011a8c1,
0x58882e18,
0x0880c002,
0xe2107500,
0xc00080a3,
0x0a0a90a2,
0x9100c000,
0x2e14d011,
0x0a067500,
0x0a44d001,
0x0c82c050,
0xc000b481,
0x0a02c004,
0xb4810cb4,
0x9d87c000,
0x402db740,
0x09a20dc2,
0x0d02c008,
0x0c81cff0,
0x9b4dffd4,
0x0a42c801,
0x0a00cb10,
0x0ceac032,
0xc000b481,
0x08c2c801,
0x0888c010,
0xb4210c84,
0xb760c000,
0x9d8f410a,
0x0d81cff0,
0x9b67fff4,
0x0a02c801,
0x0a00c00a,
0x0c8ac030,
0xc000b481,
0x08c2c008,
0xb4210c84,
0xc008c000,
0x0c880a02,
0xc000b481,
0x0d82c0c0,
0xc0080992,
0xc0080d02,
0xc0140902,
0xc00899ae,
0xc0300a02,
0xb4810c8e,
0xc014c000,
0xb79f982f,
0xc0106fee,
0x9c228c20,
0xa205f839,
0x0c82c450,
0xb4810a02,
0xb101c000,
0xc0084220,
0xc0300a40,
0xb4810c8e,
0xc002c000,
0xc05038c0,
0xb4210c82,
0xc0c0c000,
0x09920d82,
0x0d02c008,
0x0902c008,
0x9983c014,
0x0a02c008,
0x0c8ec030,
0xc000b481,
0xaa1df9f8,
0x9040c000,
0xc450a60d,
0x0a020c8a,
0xc000b481,
0x4240b105,
0x2efce00e,
0x5e90d284,
0x0a02c801,
0xc0300a40,
0xb4810c8a,
0x08c2c000,
0xb4210c84,
0x7740c000,
0x5d0cb7c0,
0x93e2c000,
0x0eded031,
0x09820dea,
0x2ac10d02,
0x1950d051,
0x3900c121,
0x98ddfff4,
0xa9c6f248,
0xc280018b,
0x1a845a8f,
0xc0219eaa,
0xffd43d00,
0xf2489a3f,
0xf310a947,
0xf248802b,
0xc450a245,
0x0a020c86,
0xc000b481,
0x4220b101,
0x0a42c801,
0x0a08c010,
0x0c86c032,
0xc000b481,
0xc0020886,
0xb4210c98,
0xb740c000,
0xf2485b8c,
0xf048a8c5,
0xd053aa51,
0xc0801910,
0xf3100ca2,
0xb4818821,
0xb7a0c000,
0xc0025b8c,
0xc0140d82,
0xf248992f,
0xf248a8c5,
0xd053aa31,
0xf3101910,
0x70088821,
0x9264ffff,
0x09c20d86,
0xc1210d0a,
0xffd40902,
0xf2489a0a,
0xc0a1a9b2,
0x0d040d02,
0xffd409c2,
0xc0c099f7,
0x09920d82,
0x09420d42,
0x98f7c014,
0x7eeeb79f,
0x7f6eb7bf,
0x7feeb7df,
0x9c228c60,
0x9e5da60d,
0xf1245940,
0xd3f15841,
0xb3502d2e,
0xc0024422,
0xf00893e2,
0xe000aa61,
0xb4252a1c,
0xd8084422,
0x8522aa61,
0x88a9e210,
0x12182a1c,
0xc00e9ea3,
0xba1b0a7e,
0xc200400b,
0x21285207,
0x9276c001,
0xc1009e59,
0x11035a20,
0x5209c200,
0xc2009ea2,
0x9e8d58a1,
0x0cb0d031,
0xa8a2d208,
0x2a7cc00e,
0x5207c200,
0x2a7cc00e,
0xd208349a,
0xf008a0a2,
0x9ea1a963,
0x2a2ed3f1,
0x8128c201,
0x8821f310,
0xf0088502,
0xd228a261,
0x9eaba127,
0x2d01cff0,
0x59415940,
0xc00e3522,
0xfff42d7c,
0xc0009bb1,
0xd20892e0,
0x9e5eaa21,
0x50d8000b,
0xd0293242,
0xf008a205,
0xd013a8e1,
0xf210291e,
0x75108029,
0x00989e44,
0xa0e1f008,
0x4426b350,
0x7eeeb79f,
0x7f6eb7bf,
0x7feeb7df,
0x9c228c60,
0x0685a60d,
0x9e9e9e69,
0x71820b02,
0xc0000a86,
0x9ea99208,
0x9e6916d2,
0x5a84c280,
0x1a52d011,
0xd0117102,
0xd3f108e2,
0xffff2b1e,
0xd0119286,
0x75100a62,
0xc000028d,
0x9e7391d4,
0x09220d02,
0x9b70fff4,
0xd0111aa0,
0x75100a52,
0xffff9e83,
0x9e7392d2,
0xd0110d06,
0xc00e0952,
0xfff4297c,
0x75909b61,
0xc0009e83,
0xd03192f4,
0xd3f11a60,
0x9e6c2b4e,
0xc2009e73,
0xd3f25299,
0x0922295e,
0x9b50fff4,
0xc2009e83,
0x9ea952b8,
0x16d27590,
0x91b2ffff,
0xd3f29e73,
0x010d2d5e,
0x9b42fff4,
0x7eeeb79f,
0x7f6eb7bf,
0x7feeb7df,
0x9c228c60,
0x0ca0f011,
0xd09a9e99,
0xd00d5a04,
0xc0001a42,
0x1203909a,
0x9e4b1242,
0xfffc9ea2,
0xc0019360,
0xf83993a0,
0x0d8aa205,
0x9835c014,
0xc0140d8e,
0x0d8a9832,
0xaa1df9f8,
0x91a0c001,
0x9e520507,
0x0d82c0c0,
0xc0000992,
0x9e5c9040,
0xd1a401c6,
0x08825889,
0x3c80c400,
0xc000b421,
0x4220b104,
0x9e532244,
0xffff7106,
0x9c229324,
0xc000b463,
0xf8129c22,
0x9c22a062,
0x0d80c200,
0x9e595d89,
0xc4000982,
0xb4633d80,
0xb203c000,
0x00074620,
0xc1279c22,
0x9c229c8f,
0xb971080a,
0xc01756f1,
0xc0719c81,
0xc0179c80,
0xb9609c80,
0x9c224000,
0x8460a61d,
0x4484b740,
0xb53f0882,
0xb53f7dec,
0x01037e6c,
0x7d6cb55f,
0x4588b540,
0xaa41f000,
0xb7a09e2d,
0xb53f5a0c,
0xc2007eec,
0xd0935a08,
0x9ea90940,
0xa96de020,
0x098e0dc2,
0x0d42c002,
0x991bffd4,
0x5994b720,
0xaa25f208,
0xb53f0882,
0xf2087f6c,
0xb760a8a9,
0xda085b8c,
0xb580a939,
0xda0842cd,
0xd112a93e,
0x9e4e09b8,
0x43cdb520,
0x434db540,
0x4455b540,
0xaa39f208,
0xa822da08,
0xa8e1d810,
0xf0489e9a,
0x2a20a967,
0x9e447500,
0xa97df048,
0xc08060c2,
0xc2005a7f,
0x00985a71,
0x58945893,
0x80a3e210,
0x46cdb540,
0x474db540,
0x47cdb520,
0x90c2c000,
0x5c40e000,
0x9184c000,
0xa957f050,
0xaa61d810,
0x8021f310,
0xa14bf288,
0xa245f288,
0xaa59f208,
0xa8c1f248,
0x5a1cb760,
0xa249f248,
0xaa41f010,
0xa8c6f010,
0xa949f010,
0xa0d1f248,
0xa241f208,
0xa0caf208,
0xa14df208,
0xa8cad850,
0x0e28d111,
0xa94dd850,
0xa881da08,
0xa0c6f208,
0x5d14b720,
0xa151f208,
0x58d158c0,
0xa0d5f288,
0xaa61d818,
0x425db740,
0x42c5b740,
0xc2000089,
0x589c5a20,
0x8021f310,
0x82a3e210,
0xa24df010,
0xa0d1f010,
0xa245f248,
0xa0cdf248,
0x0a00c00c,
0x4d8cb580,
0x0880c006,
0x4e0cb520,
0x0cf2c42e,
0xb4810a02,
0xb101c000,
0x28844220,
0xc0007440,
0xd1119142,
0xda080e28,
0xc058a881,
0xc02b7460,
0xb7209012,
0xb7805a0c,
0x0a86402b,
0x410ab720,
0x9ead7500,
0x1ed2d002,
0xc0007448,
0xb7409152,
0xf0085a0c,
0xcffeaa59,
0xf0082a3d,
0xb760a259,
0xf0085a0c,
0x2a40aa79,
0xc0007500,
0x0a0a9122,
0x0caec060,
0xc000b481,
0x90e0c000,
0xc0600a06,
0xb4810cae,
0xb720c000,
0xf2c84c14,
0xf288aa41,
0xc801a8dd,
0x9d1e3c80,
0x448cb740,
0x5a40c200,
0xc30158a0,
0x32423246,
0xa251f008,
0x9a01c034,
0xc0340a3e,
0xb4810c9e,
0x0882c000,
0xb4210c90,
0xffd4c000,
0xc0069a90,
0xb5408542,
0x0a02459c,
0x0c8ac030,
0xc000b481,
0x0882c002,
0xb4210c84,
0xc801c000,
0xc0020a02,
0x1c840a00,
0xc000b481,
0x0902c1c1,
0x0940c006,
0x09820dce,
0xffb40d02,
0xc0c09ba8,
0xffd40d82,
0xb7809a16,
0xc034458c,
0xc2000cae,
0xb4815a11,
0x0882c000,
0xb4210cfc,
0xb720c000,
0xb7805a0c,
0x2a04432d,
0x850a7500,
0x461cb540,
0x90a2c000,
0xb5408504,
0xb780461c,
0xc03e460c,
0xb5800c82,
0xb481468c,
0xc0c8c000,
0xc0500882,
0xb4210ce2,
0xb740c000,
0xf0085a0c,
0x8516aa59,
0x0cfac038,
0x75002a04,
0xcffe0902,
0xe0010a7e,
0xb5408d28,
0xb481471c,
0xc284c000,
0xb540856a,
0xc002481c,
0xc0500a42,
0xb4810cb6,
0xc03ac000,
0xb4420d02,
0x08bec000,
0x0c9ec034,
0xc000b421,
0x5008b785,
0xc0007500,
0xc0749082,
0xb780988a,
0xc038480c,
0xb4810c82,
0xb760c000,
0xb7205a0c,
0xf2885d8c,
0xd808aa55,
0xb720a965,
0x6245462d,
0xb5408502,
0x7440419a,
0x5a11c200,
0x420ab580,
0x9102c000,
0xa9eaf048,
0x420ab760,
0x9c629e8c,
0x5b94b7e0,
0x9eb60b82,
0x470cb780,
0x0c82c050,
0xc000b481,
0x0d0ac030,
0xc000b4e2,
0x08fec00e,
0x0c8ec030,
0xc000b421,
0x5a1cb760,
0xaa79f018,
0x75002a04,
0x9182c000,
0x0c8ac438,
0xc000b4e1,
0x4220b104,
0x0ca6c03e,
0xc000b481,
0x428cb780,
0xc0017500,
0xc02093a2,
0x75002a00,
0x90e2c001,
0x0ca2c460,
0xc000b4e1,
0x4220b104,
0xc060088a,
0xb4210ca2,
0xc004c000,
0xc0300902,
0xb4410c96,
0xb780c000,
0xcfde428c,
0xb5802a7d,
0xc002428c,
0xc00e08f8,
0xb4210cec,
0xc201c000,
0xb4810a02,
0xc004c000,
0xb5408502,
0xb7204c9c,
0xc030428c,
0xb4210c96,
0xb780c000,
0x2a04428c,
0xc0007500,
0xb78090e2,
0x0a04478c,
0x478cb580,
0x018b058b,
0x99e7c054,
0x430cb780,
0x2a00c020,
0xc00e7500,
0xb51f287c,
0xc0027dec,
0xf2509042,
0xc021a9c6,
0x0d7c0d02,
0x0982c010,
0x9aa6ffb4,
0xa9cef250,
0x0d02c021,
0xc0080d3c,
0xffb40982,
0xb7809a9d,
0xc401430c,
0x75002a00,
0x9262c000,
0xaa6df210,
0xa8f1f210,
0xb55f0906,
0xc0107eec,
0xf2100a00,
0xc008a26d,
0xf2100880,
0xc000a0f1,
0xf24891c0,
0xf248a947,
0xf24aaa49,
0xf248a94c,
0xf310a8d1,
0xe2108021,
0xf24882a3,
0xf248a245,
0xb780a0cd,
0xcfde430c,
0xb5802a7d,
0xb780430c,
0xc021430c,
0x75002a00,
0x9122c001,
0x4394b760,
0x0d02c021,
0xc0020d14,
0xffb409c2,
0xb7609a5f,
0xc0214414,
0x0d040d02,
0xffb409c2,
0xb7409a57,
0xf210439c,
0xb740aa59,
0xf2504404,
0xb720a8c1,
0xf3104314,
0xe2108021,
0xcfdf82a3,
0xb5202cfe,
0xb5804314,
0xb520438c,
0xb720440c,
0x9e4c4314,
0x2a00c401,
0xc0007500,
0xf25091a2,
0xf250aa45,
0xc002a8cd,
0xb5801a40,
0x18c0438c,
0x440cb520,
0xc4009e4c,
0x76402c80,
0x2a7ecbff,
0x430cb580,
0x9142c000,
0x987affd4,
0x430cb780,
0x2a7dcbfe,
0x430cb580,
0x7d6cb79f,
0xc0007500,
0xb76093c2,
0xd0325d0c,
0x2d41094e,
0xa9e6f048,
0x5d0d9e53,
0xc0211d04,
0xffb43d00,
0xb7809a09,
0xf2485d0c,
0xb79fa907,
0xb7607d6c,
0xf3105d1c,
0xb5ff8021,
0xf0587d6c,
0xb73fa265,
0x74407e6c,
0x9002c005,
0x0902c101,
0x0940c002,
0x09820da6,
0xffd40d02,
0xc1019880,
0xc0800902,
0x0da60940,
0x0d120982,
0x9877ffd4,
0x5a0cb740,
0xa9c0f212,
0xaa59f008,
0xa948f212,
0xa9cff210,
0xc0208522,
0x75002a00,
0x8eb0e051,
0x4f0cb780,
0x8520e021,
0x8aadf210,
0xf0207502,
0xc00088b4,
0xf2889364,
0xf208aa55,
0x1a04a8c5,
0x6145c301,
0xa8d2f208,
0xe2305890,
0xc2008b33,
0x5c8c5a10,
0x80a1e310,
0x8b23e030,
0x80a5f210,
0x893ac201,
0x80a5f220,
0xf2089e8b,
0x09c2a945,
0x0c820d42,
0xffb40882,
0xb76099c2,
0xf0085a0c,
0xc020aa79,
0x75002a00,
0x92c2c000,
0xf2089eab,
0x09a2a951,
0x0c820d22,
0xffb40882,
0xf20899ce,
0x058ba951,
0x0d2209a2,
0x08820c82,
0x99e3ffb4,
0x9160c000,
0xf2089eab,
0x09c2a951,
0x0c820d22,
0xffb40882,
0xc101999c,
0xc00e0902,
0x0d860940,
0x0d020982,
0x980bffd4,
0x5a1cb760,
0xaa79f018,
0x2a00c020,
0xc0007500,
0xc10191a2,
0xc0060902,
0x0d8a0940,
0x0d020982,
0x9bf9ffb4,
0x9160c000,
0x0902c101,
0x0940c086,
0x09820d8a,
0xffb40d02,
0x08829bee,
0x7e6cb53f,
0x430cb780,
0x2a00c100,
0xc0007500,
0xffb49142,
0xb7809a37,
0xcefe430c,
0xb5802a7d,
0xb780430c,
0xc004428c,
0x75002a00,
0x92c2c002,
0x0ae8d152,
0x418ab720,
0xaa21da10,
0x4002ba09,
0x4002ba24,
0x70480a0c,
0x9118c002,
0x7f6cb75f,
0x4d94b760,
0x0982c004,
0xd0110d1e,
0xc00e0a22,
0xb59f2a7c,
0xffb47f6c,
0xb7609925,
0xc0024e14,
0x0d0e0982,
0x991effb4,
0x4d9cb740,
0xaa59f208,
0x4e04b740,
0xa8a1f210,
0x7f6cb77f,
0xa8c2f248,
0x8120c301,
0x4d9cb540,
0xc00170c2,
0xb5408322,
0xc0004e04,
0x9d1e92a6,
0xc3016219,
0xf3106097,
0xe2108821,
0x09028aa3,
0x7f6cb55f,
0x0a00c010,
0x4d8cb580,
0x0880c008,
0x4e0cb520,
0x430cb780,
0x3a00c041,
0x430cb580,
0x430cb780,
0x2a00c005,
0xc0047500,
0xf21091c2,
0xf210a9c2,
0x09c2a945,
0x0c820d42,
0xffb40882,
0xb76098f8,
0xf0085a0c,
0xc020aa79,
0x75002a00,
0x9302c000,
0xa9caf208,
0xa951f208,
0x0d2209a2,
0x08820c82,
0x9903ffb4,
0xa9cef208,
0xa951f208,
0x0d2209a2,
0x08820c82,
0x9917ffb4,
0x9180c000,
0xa9caf208,
0xa951f208,
0x0d2209c2,
0x08820c82,
0x98cfffb4,
0x430cb720,
0xc1010203,
0x75002a00,
0x9122c001,
0xa8eada50,
0xa963f210,
0x28feceff,
0x430cb520,
0xa8edda50,
0xa968f212,
0xe2205c90,
0xf21080ab,
0x0203a967,
0xc200588c,
0xf3105a0c,
0xe2108221,
0xf21080a3,
0xf210a0e2,
0xf210a269,
0xf210a0e5,
0xf210a0c2,
0xf210a0c9,
0xc001a24d,
0xb7609080,
0xf0185a1c,
0xf210aa79,
0xc020a8c1,
0x75002a00,
0xf21008c0,
0xc000a0c1,
0xf2089182,
0xf208aa49,
0x0a20a8cd,
0xa249f208,
0xc00008a0,
0xf2089140,
0xf208aa49,
0x0a40a8cd,
0xa249f208,
0xf20808c0,
0xb780a0cd,
0xcffb430c,
0xc0092a7e,
0xb5803a00,
0xb780430c,
0x75004c8c,
0x9142c000,
0x0c82c040,
0xc000b481,
0x0a02c201,
0xc000b481,
0x430cb780,
0x2a00c008,
0xc0007500,
0xc1119362,
0xc04e0902,
0x0df20940,
0x0d020982,
0x9aefffb4,
0x0902c111,
0x0940c026,
0x09820df6,
0x0d42c004,
0x9ae5ffb4,
0x430cb780,
0x2a7dcff6,
0x430cb580,
0x430cb780,
0x2a00c080,
0xc0007500,
0xb76091c2,
0xba1b4192,
0xc0144003,
0xb7809a6c,
0xcf7e430c,
0xb5802a7d,
0xb780430c,
0xc010430c,
0x75002a00,
0x9022c002,
0x0902c121,
0x0940c00e,
0x09820d9e,
0xffb40d02,
0xc1219a9e,
0xc0860902,
0x0da20940,
0x0d020982,
0x9a95ffb4,
0x7eecb73f,
0xc0017440,
0xb7409042,
0xf0085a0c,
0x2a40aa59,
0xc0007500,
0xc1219342,
0xc0020902,
0x0da60900,
0x0d060982,
0x9a7fffb4,
0x0902c121,
0x0900c080,
0x09820da6,
0xffb40d16,
0xb7809a76,
0xc021430c,
0xb5803a00,
0xb780430c,
0xcfee430c,
0xc0202a7d,
0xb5803a00,
0xb780430c,
0xc800430c,
0x75002a00,
0x9302c000,
0x5a0cb760,
0x7decb79f,
0x4192b760,
0xa97af008,
0xba1b0189,
0x5d114003,
0x2d044d04,
0x9b2bffb4,
0x430cb780,
0x2a7ec7fe,
0x430cb580,
0x430cb780,
0x2a00c200,
0xc0007500,
0x0d8690c2,
0xffb40982,
0xb780998c,
0xc041430c,
0x75002a00,
0x9342c000,
0x0902c101,
0x0940c002,
0x09820da6,
0xffb40d02,
0xc1019a30,
0xc0800902,
0x0da60940,
0x0d120982,
0x9a27ffb4,
0x430cb780,
0x2a7ecfbf,
0x430cb580,
0x430cb720,
0xc0090203,
0x75002a00,
0x9182c001,
0x0902c101,
0x0940c00e,
0x28fecff7,
0x430cb520,
0x09820d9e,
0xffb40d02,
0xb7609a0c,
0xf0185a1c,
0xc020aa79,
0x75002a00,
0x91a2c000,
0x0902c101,
0x0940c006,
0x09820da2,
0xffb40d02,
0xc00099fa,
0xc1019160,
0xc0860902,
0x0da20940,
0x0d020982,
0x99efffb4,
0x0902c1c1,
0x0940c006,
0x09820dce,
0xff940d02,
0xc0149b5e,
0xc03099a9,
0xb4e10c8a,
0xb780c000,
0x0c884c8c,
0xc000b481,
0x0882cc01,
0xb4211c88,
0xc054c000,
0xb7809b0f,
0xc0084c8c,
0x75002a00,
0x7d6cb5ff,
0x9282c001,
0x0c8ac450,
0xc000b4e1,
0x4220b104,
0x2a7cc00e,
0x7d6cb59f,
0xb4e11c84,
0xb104c000,
0x2a104220,
0xc0007500,
0xb7809362,
0xc008428c,
0x75002a00,
0x8d80e071,
0x7d6cb79f,
0xd0010d02,
0xb7600d22,
0x08864714,
0x7e6cb53f,
0x5a10c200,
0x7d6cb59f,
0x99bdc014,
0x9100c000,
0x7d6cb79f,
0x5a10c200,
0x7d6cb59f,
0x428cb780,
0x0c8ac030,
0x4c8cb580,
0xc000b4e1,
0x0a02c801,
0x0a00c002,
0xc000b481,
0xc00408be,
0xb4210c94,
0xc0c0c000,
0xffb40d82,
0xb760996c,
0xb7804112,
0x9ea4420c,
0xb7209c62,
0xc034458c,
0x58910cae,
0xc000b421,
0x7e6cb75f,
0xc0007480,
0xb75f9224,
0x74807d6c,
0x9182c000,
0x2941093c,
0x09820dea,
0x19400d02,
0x3900c121,
0x9961ffb4,
0x9907c014,
0x6008b785,
0xb7807500,
0xc000468c,
0x2a7990a2,
0x6008b5e5,
0x0c82c03e,
0xc000b481,
0x7decb77f,
0x418ab780,
0x0e820a82,
0x0a0474c0,
0x418ab580,
0x9282ffdc,
0x430cb780,
0x7d3ed3ff,
0x91c4ffdc,
0x7d6cb79f,
0xffdc7500,
0xb79f9124,
0xb7bf7cee,
0xb7df7d6e,
0xb7ff7dee,
0xc0027e6e,
0x9c228c60,
0xc004a605,
0xc8298420,
0xc5980ca2,
0xc0300ca0,
0xe133ac3d,
0xc0388d00,
0xc030a45d,
0xc038ac3d,
0xc010a45d,
0xc018ac3d,
0xc010a45d,
0xc018ac25,
0xb740a445,
0xf0004484,
0xb7a0aa41,
0x9e2d5b8c,
0x5a08c200,
0x0940d093,
0xe0209ea9,
0x0dc2a96d,
0x0d42c008,
0xff9409c2,
0xb7809ae4,
0xf2085d0c,
0x8502a8a1,
0xa8a6f208,
0xa103f208,
0xa085f208,
0xa929f208,
0xa08af208,
0xa92ef208,
0xa8b2f208,
0xa10df208,
0xa8b1f248,
0xa112f208,
0xa096f208,
0xa09af208,
0xc036090a,
0x08c00c92,
0xa085f248,
0xc000b441,
0x1c8c0a16,
0xc000b481,
0x8c00f031,
0x8d80e131,
0xb55f9ea3,
0x0d027ffc,
0x4078b960,
0xa103f208,
0xd1229dba,
0x9e2d5d0d,
0xa8e5f029,
0x2caed012,
0xd1265c88,
0x9e4a5908,
0xaa4de038,
0x28bc0d04,
0x324250a8,
0xffffa241,
0xf01091c1,
0xc036aa61,
0xb4810c8e,
0xb73fc000,
0x1c847fec,
0xc000b421,
0x9a4ac054,
0x08c2c801,
0x0890c112,
0x0a42c809,
0x0a00c6e4,
0x0cbec032,
0x420cb580,
0xc000b421,
0x0ce00a3e,
0xc000b481,
0xc0800882,
0xb4210cc6,
0xc801c000,
0xc1120a42,
0xc0320a18,
0xb4810cc2,
0x08c0c000,
0xb4210cdc,
0x0a02c000,
0x0cc6c080,
0xc000b481,
0x08c2c801,
0x0890c114,
0x0cc6c032,
0xc000b421,
0x0cd80a44,
0xc000b481,
0xc0800882,
0xb4210cc6,
0xc801c000,
0xc1140a42,
0xc0320a18,
0xb4810cca,
0x08c8c000,
0xb4210cd4,
0x0a02c000,
0x0cc6c080,
0xc000b481,
0x7aeeb79f,
0x7b6eb7bf,
0x8c60c004,
0x08829c22,
0x0c92c001,
0x0c84c332,
0xc000b421,
0x4b8cb780,
0x0a10873e,
0x9c8bc040,
0xc238b780,
0xb7809c22,
0x0a40458c,
0x7520c00c,
0x458cb580,
0x48b4b340,
0xb5408502,
0x9c22459c,
0x4b8cb780,
0xa895f208,
0xa88ef208,
0xa905f208,
0xa99df208,
0xa906f288,
0xa09df208,
0xa096f208,
0xa10df208,
0xa185f208,
0xa899f208,
0xa892f208,
0xa909f208,
0xa981f248,
0xa081f248,
0xa09af208,
0xa111f208,
0xa189f208,
0xa881f288,
0xa995f248,
0xa89ef248,
0xa90df248,
0xa085f288,
0xa18df248,
0xa999f248,
0xa082f288,
0xa115f248,
0xa891f248,
0xa191f248,
0xa989f288,
0xa89af288,
0xa099f248,
0xa10af288,
0xa19df248,
0xa99df288,
0xa09ef288,
0xa895f288,
0xa892f288,
0xa90df288,
0xa099f288,
0xa096f288,
0xa111f288,
0xa18df288,
0xa61d9c22,
0x8440c012,
0x9e9e9e5f,
0x0d82c0c0,
0x2d7cc00e,
0x7c74b55f,
0x9bc3ff94,
0x0a02c004,
0x0c8ac030,
0xc000b481,
0x0882c004,
0x0d0ec030,
0xc000b422,
0x0ca2c460,
0x1a00c004,
0xc000b481,
0x4220b101,
0x38880283,
0x0ca2c060,
0xc000b421,
0x0a00c004,
0x0c96c030,
0xc000b481,
0x0d82c004,
0x9822ffd4,
0x0ca2c060,
0xc000b4a1,
0xc0300a02,
0xb4810c8a,
0xc00ec000,
0xc03008de,
0xb4220d0e,
0xc450c000,
0xb4810c82,
0xb101c000,
0xb53f4220,
0x0c947a6c,
0xc000b481,
0x4220b101,
0x7aecb53f,
0xb4810c88,
0xb101c000,
0xb53f4220,
0x85027b6c,
0x0c8ac030,
0xa143f210,
0xb4810a40,
0xc008c000,
0x0c840882,
0xc000b421,
0xc402020f,
0xc0503a40,
0xb4810c82,
0xc0c0c000,
0x09920d82,
0x0d02c008,
0x0902c008,
0x9be7ffb4,
0x0a02c008,
0x0c8ec030,
0xc000b481,
0x0d02c050,
0xc000b4e2,
0x0c8ac450,
0x1a00c008,
0xc000b481,
0x4220b101,
0xc0340a68,
0xb4820d1e,
0x0cd4c000,
0xb4811a68,
0xb101c000,
0x03034220,
0x2b7cc03e,
0xd0718502,
0xe2000a6e,
0xe0d35a95,
0xb57f8d80,
0xe3d37d7c,
0xb57f8d80,
0xe2d37dfc,
0xb57f8d80,
0xe1d37e7c,
0xb57f8d80,
0xc0007cfc,
0x9d979262,
0x0ec1cfec,
0xb55f9dcf,
0xffb47f7c,
0xf2319bbf,
0xb75fa025,
0xe0007f7c,
0x85101a84,
0x9284ffff,
0x9eb39d0f,
0x9e729eba,
0x08820c82,
0x09c1cfec,
0x9991c014,
0x5a0cb780,
0xa899f208,
0x87028536,
0x74402884,
0x6878b55d,
0x68e0b55d,
0x9122c000,
0xb55d853e,
0xc0086878,
0xb55d8502,
0x9d0f68f8,
0x09e2d032,
0x9e729eba,
0x2d9c8522,
0x89afe220,
0x6960b55d,
0x69e0b55d,
0x08860c86,
0x09c1cfec,
0x0da42d9c,
0x9967c014,
0x0df2c008,
0x0d02c00a,
0x0c9ec432,
0xb4810a02,
0xb107c000,
0x9e794240,
0x0d00c0c0,
0x5c89c100,
0x0d01cf40,
0x3c80c400,
0xc000b481,
0x4220b106,
0xcdff020d,
0xc0c028fe,
0x5d890d80,
0xc000b423,
0x2a7ecdff,
0x0d00c0c0,
0xb4825d09,
0x089ec000,
0x0c9ec034,
0xc000b421,
0x0e829d17,
0xcfec8506,
0x058b0ac1,
0x7f7cb55f,
0x9b4cffb4,
0xa021f208,
0xaa21d208,
0xb75f7500,
0xb4157f7c,
0xd2084c22,
0x7500aa25,
0x9084c000,
0xa127d208,
0xaa29d208,
0xc0007500,
0xd2089084,
0xd208a12b,
0x7500aa2d,
0x9084c000,
0xa12fd208,
0xc01c0e90,
0x0a90777e,
0x9334fffe,
0x9eba9d0f,
0xc0209e72,
0x0c860d82,
0xcfec0882,
0xc01409c1,
0xb73f9902,
0x9eba7dec,
0xc0209e72,
0x0c860d82,
0x08820183,
0x98f7c014,
0x9e729eba,
0x7e6cb79f,
0x0d82c020,
0x08820c86,
0xc0140189,
0xb73f98ec,
0x9eba7cec,
0xc0209e72,
0x0c860d82,
0x08820183,
0x98e1c014,
0xc0340a22,
0xb4810c9e,
0x9d17c000,
0x87060e82,
0x0ac1cfec,
0x2d5ed013,
0x2de1058b,
0xe2205d84,
0xb55f81af,
0xffb47fe4,
0xf2089ae7,
0xd208a021,
0x7500aa21,
0x7fe4b75f,
0x5022b415,
0xaa25d208,
0xc0007500,
0xd20a9084,
0xd208a124,
0x7500aa29,
0x9084c000,
0xa128d20a,
0xaa2dd208,
0xc0007500,
0xd20a9084,
0x0e90a12c,
0x777ec004,
0xfffe0a90,
0x9d179274,
0x87060e82,
0x0ac1cfec,
0x2d5ed013,
0x2de1058b,
0x0da05d84,
0x81afe220,
0x7fe4b55f,
0x9ab2ffb4,
0xaa21d208,
0xf2887500,
0xb75fa021,
0xb4157fe4,
0xd2085022,
0x7500aa25,
0x9084c000,
0xa124d20a,
0xaa29d208,
0xc0007500,
0xd20a9084,
0xd208a128,
0x7500aa2d,
0x9084c000,
0xa12cd20a,
0xc0040e90,
0x0a90777e,
0x9254fffe,
0x9eba9d0f,
0xc0209e72,
0x0c860d82,
0xcfec0882,
0xc01409c1,
0x9eba9868,
0xb79f9e72,
0xc0207dec,
0x0c860d82,
0x01890882,
0x985dc014,
0x7c6cb73f,
0xc0007440,
0x9d0f9202,
0x9e729eba,
0x8502c008,
0x6878b55d,
0x0c860d8a,
0xcfec0882,
0xc01409c1,
0xb77f984a,
0xc0507d7c,
0xaa610c82,
0xc000b481,
0x7aecb73f,
0xb4210c94,
0xb79fc000,
0x0c887b6c,
0xc000b481,
0x598cb720,
0x4d9cb740,
0x4335b760,
0x89afe220,
0x0982c004,
0xff740d1e,
0xb7809b29,
0xb740598c,
0xf2484e1c,
0xe220a982,
0xc00289af,
0x0d0e0982,
0x9b1cff74,
0x0c9ec032,
0xb4219e79,
0xc032c000,
0xb4c20d22,
0xc1c1c000,
0xc0060902,
0x0dce0940,
0x0d020982,
0x9b15ff74,
0x6b6eb79f,
0x6beeb7bf,
0x6c6eb7df,
0x6ceeb7ff,
0x8c40c014,
0xa61d9c22,
0x9e968440,
0xe0000a82,
0xd3f20d80,
0xd3f12e9e,
0xc0022b1e,
0xc00690e2,
0xc00c87e2,
0x9d6876f2,
0xb3328502,
0x74804826,
0xc1000a84,
0xc0015860,
0x858e9082,
0xc0508722,
0x74920c1a,
0xe0129d50,
0xd0088522,
0xb324a8e2,
0x11284426,
0x2e26d011,
0xf3107506,
0x9e4f8831,
0x5a0cc200,
0x50f0c200,
0xc0003002,
0xb40090a4,
0x0802c000,
0x9d2a7480,
0xffff0984,
0xf0119084,
0x4a7d8422,
0x75062a0c,
0x90c2c000,
0x0c9ac050,
0xc000b401,
0x76f2c00c,
0xb3349d70,
0x9ea14826,
0x15b2e000,
0x93e4fffd,
0xc0300a42,
0xb4810c8a,
0x08c2c000,
0x0d0ec030,
0xc000b422,
0x0c82c450,
0xb4811a40,
0xb101c000,
0xb53f4220,
0x0c947e6c,
0xc000b481,
0x4220b101,
0x7eecb53f,
0xb4810c88,
0xb101c000,
0xb53f4220,
0xc0507f6c,
0xb4a10c96,
0x7740c000,
0xc8018502,
0xb3210882,
0x75804c24,
0xd0020a02,
0x0c880a42,
0xb4213098,
0xc008c000,
0xc0300a02,
0xb4810c8e,
0xc008c000,
0x0c880882,
0xc000b421,
0x0d82c0c0,
0xc0080992,
0xc0080d02,
0xffb40902,
0xc008996e,
0xc0300a02,
0xb4820d0e,
0xc450c000,
0xc0080c8a,
0xb4811a00,
0xb101c000,
0xc00e4220,
0xc08028fc,
0x010b5a90,
0x0a00c002,
0x0c8ac030,
0xc000b481,
0x0882c002,
0xb4210c84,
0x7480c000,
0x92a2c000,
0x09820dea,
0xd0510d02,
0xc1a11950,
0xff943900,
0xc0c098d0,
0xff940d82,
0xf21098b6,
0xf310a943,
0xf2108023,
0xc002a241,
0xc0300a02,
0xb4810c8a,
0xc002c000,
0x0c840882,
0xc000b421,
0x7d6eb79f,
0x7deeb7bf,
0x7e6eb7df,
0x7eeeb7ff,
0x8c40c002,
0xa60d9c22,
0x0a42c801,
0x0a00cb10,
0x0ceac032,
0xc000b481,
0x08c2c801,
0x0888c010,
0xb4210c84,
0xc008c000,
0xc0020a42,
0xb4811ce4,
0xc008c000,
0xc03008c2,
0xb4220d0e,
0xc450c000,
0xc0080c82,
0xb4811a40,
0xb101c000,
0xc0024220,
0xb52038c0,
0xc0504d0c,
0xb4210c82,
0xc0c0c000,
0x09920d82,
0x0d02c008,
0x0902c008,
0x98efffb4,
0x0c86c450,
0xb4810a02,
0xb104c000,
0xc0084220,
0xc0300a02,
0xb4820d0e,
0x0c84c000,
0x1a00c008,
0xc000b481,
0x4220b105,
0x5a35c280,
0x0882c801,
0xc00e08c0,
0xc2802afc,
0xd0725a90,
0x9ead2b4e,
0x0c8ac030,
0xc000b421,
0x0c840a42,
0xc000b481,
0xb7c07740,
0xc0015d0c,
0xd0319002,
0x0dea0ede,
0x0d020982,
0xd0512ac1,
0xc1211950,
0xff943900,
0xf2489842,
0x018ba9c6,
0x5a8dc280,
0x9eaa1a84,
0x3d00c021,
0x99a4ff74,
0xaa45f248,
0x16dcd010,
0xf248024a,
0xc450a245,
0x0a020c86,
0xc000b481,
0x4220b104,
0xc0340a6e,
0xb4810c9e,
0xb720c000,
0xf2485b8c,
0xb720aa45,
0xd0534635,
0xf2101940,
0xc08088ab,
0xc2800ca2,
0xb5805a0c,
0xb4a1418c,
0xb785c000,
0x75005008,
0x9262c003,
0x568cb721,
0x550cb781,
0x7c40c030,
0xb5810a04,
0xc000550c,
0xc0349082,
0xb72098dc,
0xb720520c,
0xb78141b5,
0xb740550c,
0x9e49442d,
0x71046243,
0x90b8c000,
0xb5458506,
0xb7855618,
0x75005108,
0x5d94b7a0,
0x9262c000,
0x530cb7a0,
0xa83df210,
0xa9a1f208,
0x9e840d86,
0xf2089c62,
0xf250a021,
0x9eaba825,
0x9e840986,
0xb7859c62,
0x75005108,
0x9164c000,
0x5314b760,
0xa825f210,
0x9c629e84,
0xc0000281,
0xb7859220,
0x75005088,
0x9102c000,
0x540cb780,
0xaa81f208,
0x90c0c000,
0x548cb780,
0xaa8df208,
0x580cb720,
0x4129b780,
0x03037500,
0x9264c000,
0x5108b785,
0xc0007500,
0xf25090c4,
0x9ea4aa21,
0xb7409c62,
0xf210419c,
0xe320aa35,
0x9ea489a3,
0xf2109c62,
0x9eabaa39,
0x9ea4018d,
0xb7809c62,
0xc080528c,
0xd2c80ca6,
0xb4a1aa91,
0xc002c000,
0xffb40d92,
0x700a981b,
0x9364ffff,
0x09c20d86,
0xc1210d0a,
0xff740902,
0xb78098fe,
0xf2485b8c,
0xc0a1a992,
0x0d040d02,
0xff7409c2,
0xc0c098e9,
0x09920d82,
0x09420d42,
0x9be9ff94,
0xc0300a42,
0xb4810c8e,
0xb79fc000,
0xb7bf7eee,
0xb7df7f6e,
0x8c607fee,
0xb7009c22,
0x76c05b8c,
0x0d820c02,
0x9342c000,
0x430cb780,
0x0880d131,
0x4033b720,
0x4e94b500,
0x4f14b500,
0x4894b500,
0x76402c88,
0x2a7ecdff,
0x430cb580,
0xc0008522,
0x85129062,
0x4a9cb540,
0xb74074c0,
0xc0005a14,
0xb78092e2,
0x8502430c,
0xa8c1d810,
0x4f1cb540,
0x429cb540,
0x589cb541,
0x4b1cb540,
0x489cb540,
0x4e8cb520,
0x2a7ecdff,
0x430cb580,
0x0880d131,
0x4033b720,
0x428cb780,
0x2c14d012,
0xc0080089,
0x75002a00,
0x28fdcffa,
0x428cb520,
0x92c2c000,
0x430cb780,
0xc8007600,
0xb5803a00,
0xc000430c,
0x850690e4,
0x6418b545,
0x9100c000,
0x6408b785,
0x3a080d86,
0x6408b585,
0x6408b745,
0x2a22d011,
0xc0007500,
0xb7809102,
0xc010430c,
0xb5803a00,
0xb780430c,
0x75004b0c,
0x90e2c000,
0x428cb780,
0xb5802a79,
0xb720428c,
0xb7204294,
0x9e4c4a8c,
0xd3f17902,
0xc2002a2e,
0xb5855a05,
0xc0006408,
0xd2119102,
0xb5803e10,
0xc000428c,
0xcff690c0,
0xb5202cfd,
0xb7204294,
0xd1114294,
0x75002e10,
0x90a2c000,
0xb5408506,
0x7600491c,
0x5e1dd0a2,
0xd0020882,
0x2a040892,
0xc0007902,
0xd1119102,
0xb5803e10,
0xc000428c,
0x76c09120,
0x90c2c000,
0x3c80c020,
0x4294b520,
0x428cb720,
0x2a12d011,
0xc0007500,
0xb78090e2,
0x32184a8c,
0x90c0c000,
0x4a8cb780,
0x22184a7d,
0x428cb580,
0x428cb720,
0x2a14d011,
0xc0007500,
0xd0119102,
0xb5803a12,
0xc000428c,
0x28f990a0,
0x428cb520,
0xa8c1d810,
0x4e9cb740,
0xaa45d810,
0x88a3e210,
0x5a11c200,
0xc0037048,
0xd1119036,
0xda080a08,
0xb720a882,
0xb740428c,
0x5c91488c,
0xb7409e4c,
0x38884314,
0x428cb520,
0xc1007088,
0xb5403d00,
0xc0004314,
0xb7219278,
0x9e54588c,
0xc0017440,
0xb5803a04,
0xc000430c,
0xc0119124,
0xb5403d04,
0x85064314,
0x589cb541,
0x088cd112,
0x404bb780,
0x4e8cb720,
0x5a11c200,
0xc0007048,
0xb7809116,
0xc001430c,
0xb5803a10,
0xb780430c,
0xc200404b,
0x1a085a11,
0xc0007048,
0xb7809116,
0xc001430c,
0xb5803a40,
0xb720430c,
0xd1114f14,
0xda080a08,
0x9e4ca881,
0x71025891,
0x9102c000,
0x430cb780,
0x3a00c005,
0x430cb580,
0x430cb780,
0x3a00c084,
0x430cb580,
0x91a0c000,
0x428cb780,
0x430cb720,
0xb5802a75,
0xcffa428c,
0xb52028fd,
0xb740430c,
0xf012428c,
0xc0002922,
0xb7809102,
0xc080430c,
0xb5803a00,
0xb780430c,
0xb720488c,
0xb7204a94,
0x0a044f0c,
0x488cb580,
0x78889e4c,
0xb5200884,
0xc0004f0c,
0x76809222,
0x91c4c000,
0x460cb720,
0x3a22d011,
0x428cb580,
0xb5408506,
0x28f94b1c,
0x460cb520,
0x0a08d111,
0xa881da08,
0x4f14b720,
0x18c0c002,
0x5a7fc080,
0x5a71c200,
0x9e4c0098,
0x460cb740,
0x71025893,
0x468cb540,
0x9044c001,
0x430cb740,
0xc0800205,
0x75002a00,
0x9342c000,
0x4e94b720,
0x76420205,
0x3a00c201,
0x430cb580,
0x921cc000,
0x0a0cd111,
0xa881da08,
0x9e4c0c8c,
0x71025891,
0x90d6c000,
0x3900ca01,
0x430cb540,
0x4f14b720,
0x0a08d111,
0xa881da08,
0x58919e4c,
0xc0007102,
0xb7209278,
0x0203430c,
0x2a00c005,
0xc0007500,
0xc1019162,
0xb5203880,
0x8506430c,
0x499cb540,
0x4a1cb540,
0xc0007600,
0xb7809122,
0x750c4f0c,
0x9122c000,
0x92a0c000,
0x4f0cb780,
0xc000750a,
0xb7809204,
0x7500498c,
0x9162c000,
0x430cb780,
0xb5408502,
0xc401499c,
0xb5803a00,
0xb780430c,
0x75064f0c,
0x9204c000,
0x4a0cb780,
0xc0007500,
0xb7809162,
0x8502430c,
0x4a1cb540,
0x3a00c800,
0x430cb580,
0x4f14b720,
0x0a08d111,
0xa881da08,
0x58919e4c,
0xc0007102,
0xb7809158,
0x85024e8c,
0x4f1cb540,
0xb5800a04,
0xb7804e8c,
0x7500428c,
0xc0008502,
0xb7809144,
0xc400430c,
0x75002a00,
0xe0018502,
0x9d438522,
0xa6059c22,
0x5088b785,
0xb7a07500,
0xc002598c,
0xb7609202,
0xb7614210,
0xb7a0578c,
0xba1b5914,
0xc0944001,
0xd2109877,
0xd231a9a2,
0xba000a50,
0xf2084002,
0xba1ba001,
0xc0944001,
0xb7619857,
0xd210578c,
0xd251a9a2,
0xba000a50,
0xf2084002,
0xba1ba001,
0xc0944001,
0xb721985d,
0xd2315694,
0xe04008d8,
0xba002c80,
0xb5004002,
0xc000402d,
0xd2109202,
0xba1ba9a2,
0xc0944001,
0xd2519871,
0xba000a58,
0xf2084002,
0xc000a001,
0xd25190c0,
0xf2080a58,
0xb722a082,
0xd2716b92,
0xb78008d8,
0x9e49402d,
0xd2716243,
0xb58008d0,
0xd231402d,
0xf2080a50,
0x7500aa01,
0x90c2c000,
0x0cb6c03e,
0xc000b481,
0x0a50d251,
0xa881f208,
0x0caac03e,
0xc000b421,
0x0a58d231,
0xaa01f208,
0xc0007500,
0xc2009122,
0xc8015a40,
0x0c903a00,
0xc000b481,
0x0a58d251,
0xaa01f208,
0xc0007500,
0xc03e90c2,
0xb4810ca2,
0xd271c000,
0xf2080a50,
0xc03ea881,
0xb4210c8a,
0xb79fc000,
0xb7bf7f6e,
0x8c407fee,
0xa6859c22,
0x0c92c43e,
0xb4810a02,
0xb103c000,
0xb7804220,
0xda08568c,
0xda08a885,
0xda08a909,
0xda08a189,
0xda08a081,
0x0cd0a105,
0xb4810a02,
0xb103c000,
0xb7804220,
0xb7c0560c,
0xda08568c,
0x9ea5a885,
0xa88ada08,
0xa189da08,
0x2d80c008,
0xda0876c0,
0xda08a081,
0xc00ba086,
0xb7809102,
0x0a044508,
0x4508b580,
0x0ca6c450,
0xb4810a02,
0xb103c000,
0x00874220,
0x2880c031,
0xc00f0207,
0xd0a42a7c,
0xd2285861,
0x028759c1,
0x2afccffe,
0x0a020c88,
0xc000b481,
0x4220b103,
0x59c1d1a6,
0xcffe0107,
0x0cbc297c,
0xc000b481,
0x4220b103,
0xb7820087,
0xc0fc6b8a,
0xd0a42880,
0xb7255b19,
0xd0f15090,
0x1208283e,
0x76409ea2,
0x6b8ab502,
0x4003ba12,
0x90e4c000,
0x5108b785,
0xc0027500,
0xb78593a4,
0x75005108,
0x81b3e331,
0x0127d011,
0x5a0cb780,
0x0c827602,
0x0c92d001,
0xa899f208,
0x28849e4c,
0xb7607848,
0xc0005314,
0xd81090e2,
0x0a04aa69,
0xa269d810,
0xa96bf010,
0xa96cf012,
0x8026f010,
0x82a5e210,
0xa269f010,
0xa0edf010,
0x4608b782,
0x08827500,
0x0892d002,
0x0a027602,
0x0a42d002,
0xc0007848,
0xc07c90c2,
0xda088542,
0x7602a143,
0xa973f010,
0x90c4c000,
0xaa21da10,
0x9080c000,
0xaa41da08,
0x80a1e310,
0xaa6dd810,
0xa0f1f010,
0x0a047606,
0xa26dd810,
0x9124c000,
0x4588b780,
0xb5800a04,
0xc0064588,
0x85029200,
0x4598b540,
0x9160c006,
0x5a0cb720,
0x5314b720,
0x0127d330,
0x432db780,
0x8122c301,
0x4545b740,
0x75002a04,
0x8027f010,
0x8221f310,
0xb5800583,
0xc001454d,
0x760290a2,
0x90c4c000,
0xaa21da10,
0x9080c000,
0xaa41da08,
0xa27dd810,
0xc0017606,
0x76009082,
0x91a4c000,
0xd8107680,
0xe002a973,
0xf2108d2a,
0xd8108025,
0xc000a271,
0x768092c0,
0xa967d850,
0x8d26e002,
0x9160c000,
0xaa21da10,
0xd8507680,
0xd810a967,
0xe002a27d,
0xf2108d2a,
0xd8508025,
0xb785a265,
0x75005208,
0x92e2c000,
0x410ab780,
0xc0007008,
0x85029244,
0x5218b545,
0x0c82c43a,
0xb4810a02,
0xb103c000,
0xcfef4220,
0xc03a29fe,
0xb4610c82,
0xb780c000,
0x7008410a,
0xd0020882,
0x76060892,
0xd0010a02,
0x78480a42,
0x9242c000,
0xb5458506,
0xc43a5218,
0x0a020c82,
0xc000b481,
0x4220b103,
0x3980c011,
0x0c82c03a,
0xc000b461,
0xc0017780,
0x76009162,
0x92c4c000,
0xaa41da08,
0xa967f010,
0xa8f5d810,
0xa8fad810,
0x8021f310,
0xd8100082,
0x0c84a0f5,
0xa0fad810,
0xa265f010,
0x9280c000,
0xaa21da10,
0xa97bf010,
0xa8e9d850,
0xa8eed850,
0x8021f310,
0xd8500082,
0x0c84a0e9,
0xa0eed850,
0xa279f010,
0xaa7dd810,
0xa97ff010,
0xa960f052,
0xa9e7f050,
0x8021f310,
0xa96ff050,
0xa27df010,
0x8223f310,
0xa8e2d850,
0xa261f050,
0x8037f010,
0x80a1e210,
0xd8500c84,
0xf050a0e2,
0xf050a265,
0xb7bfa0ed,
0xb7df7f6e,
0x8c407fee,
0xa6059c22,
0x568cb781,
0x2a00c008,
0xc0007500,
0xb7809282,
0xb720530c,
0xf2085d8c,
0xb700a982,
0x9e84452d,
0xb7819c62,
0xb500568c,
0xcff6400a,
0xb5812a7d,
0xb781568c,
0xc010568c,
0x75002a00,
0x91c2c001,
0x5d8cb7a0,
0x5314b7a0,
0xa825f208,
0x9e84058b,
0xf2489c62,
0x9ea4aa21,
0xb7209c62,
0xb725520c,
0xb7805c10,
0x9e49422b,
0xc0007048,
0xf2109222,
0xf208a9a1,
0x0d86a83d,
0x9c629e84,
0xaa25f248,
0xa021f210,
0x0986058b,
0x9c629ea4,
0x568cb781,
0x2a7dcfee,
0x568cb581,
0x568cb721,
0xc0200203,
0x75002a00,
0x90c2c000,
0x28fdcfde,
0x568cb521,
0x7f6eb79f,
0x7feeb7bf,
0x9c228c40,
0xa205f839,
0x568cb781,
0x7d00c030,
0x9162c000,
0x4c8cb780,
0x2a00c008,
0xc0007500,
0xfff49082,
0xb7609b92,
0xff744c94,
0x0a029b1f,
0x0ca2c060,
0xc000b481,
0x4c94b760,
0x99ebfff4,
0x4588b780,
0x7534c01c,
0x9104c000,
0xb5458506,
0x85026018,
0x4598b540,
0x5008b785,
0xc0017500,
0xb7809282,
0xb720520c,
0xda084510,
0x9e4ca88d,
0xc0017102,
0xb7219044,
0x0203568c,
0x2a00c010,
0xc0007500,
0xc0209102,
0xb5213880,
0xfff4568c,
0xb7819b5c,
0xb725568c,
0xb7205c08,
0x85024012,
0x4518b540,
0xb5250884,
0xb5205c08,
0xc0184112,
0xb5813a00,
0xb780568c,
0xc0104c8c,
0xc0007500,
0xfff49084,
0xf9f89918,
0x9c22aa1d,
0xb780a61d,
0xd1315b8c,
0xb72008c0,
0xd092402b,
0x76402890,
0xc0040389,
0x85029362,
0x5618b545,
0xd0118502,
0x75002a14,
0x551cb541,
0xb5458506,
0xc0005018,
0xb5459082,
0xd1115098,
0x75002a10,
0x9082c000,
0x5118b545,
0xc0400203,
0x75002a00,
0x9082c000,
0x5198b545,
0x5108b785,
0xb7c07500,
0xc0025d94,
0xb7859282,
0x75005088,
0x91e2c002,
0x5188b785,
0xc0027500,
0xc8099144,
0xc88e0a42,
0xc8090a60,
0xc91608c2,
0xc80908e0,
0xc9b00cc2,
0xc8090cc0,
0xc95a0942,
0xc8090960,
0xc8600d42,
0xc8090d00,
0xc73809c2,
0xc80909f0,
0xc7fe0dc2,
0xc8090dc0,
0xc7240c42,
0xc8090c00,
0xc6f60842,
0xc8090810,
0xc7100ac2,
0xc8090a80,
0xc7060ec2,
0xc8090eb0,
0xc86e0b42,
0xf2100b40,
0xf210a249,
0xf210a0d1,
0xf210a0d6,
0xf210a159,
0xf210a14e,
0xf250a1dd,
0xf250a1c2,
0xf250a046,
0xf210a049,
0xf210a2c5,
0xf250a2c2,
0xb7a0a34d,
0xf2105c8c,
0x9eabaa4d,
0x9c629ea4,
0xaa39dbc8,
0x528cb740,
0xb5408502,
0xd208409a,
0xf248a8a1,
0xc010a8be,
0x75002a00,
0xa0cdd808,
0x5794b521,
0x9102c000,
0x568cb781,
0x3a00c040,
0x568cb581,
0x5008b785,
0xc0057500,
0xb7819042,
0xc030568c,
0xc0007d00,
0xfff49082,
0xb7209a8c,
0xf2c85214,
0xb720aa65,
0x7048434d,
0x5d94b7c0,
0xc0000683,
0xf2509102,
0xd132aa4d,
0x9ea409f8,
0xb7209c62,
0x8502408a,
0x4698b542,
0xb5427440,
0xb5424718,
0xc0004798,
0xda1090e2,
0x7048aa35,
0x9344c000,
0x5088b785,
0xa9b6da10,
0xa8c9f210,
0x75008502,
0x409ab540,
0xe001850a,
0x9d4f8d24,
0x9e8c1d84,
0xf2109c62,
0x0d8aaa51,
0x9c629ea4,
0x90e0c000,
0xaa51f210,
0x9ea40d86,
0xb7819c62,
0xb720568c,
0xb7a0408a,
0x8502530c,
0x5c18b545,
0x3a00c008,
0x568cb581,
0xaa41f210,
0x08849eab,
0x408ab520,
0x9c629ea4,
0x580cb720,
0x4129b780,
0x03037500,
0x92e4c000,
0xa9a1f208,
0xa85df210,
0x9e840d82,
0xf2089c62,
0xf250a021,
0x9eaba845,
0x9e840982,
0xda089c62,
0xb582aa21,
0xc0006b8a,
0xb7209180,
0xd210540c,
0xb740aa29,
0xf31044bb,
0xb5808021,
0xd20844ab,
0x7440a8c9,
0x9122c000,
0x448cb780,
0xf2088506,
0xc000a117,
0xb78090c0,
0xf208448c,
0xb720a095,
0xb780528c,
0xb58241ab,
0xb5806b8a,
0xb580400a,
0xc000410a,
0xb7809100,
0xda08448c,
0xb520a899,
0xb79f410a,
0xb7bf7e6e,
0xb7df7eee,
0xb7ff7f6e,
0xc0027fee,
0x9c228c00,
0x418ab780,
0x1d38f034,
0xb3228502,
0xdffc506c,
0x9e2a7d3e,
0x5e84b760,
0x9364c000,
0xc0340a4a,
0xb4810c9e,
0xb740c000,
0x9dc75e9c,
0xaa69c010,
0xc0829e59,
0xc2000cda,
0x32185a20,
0xc000b481,
0xc03408be,
0xb4210c9e,
0xb760c000,
0xb7405e84,
0x9e2d5e1c,
0xa96dc020,
0x4000ba12,
0x6a21d071,
0x0cfac036,
0x58ffc200,
0x024258f1,
0x5a13c200,
0x5a20c200,
0xb4413128,
0x9de4c000,
0xaa69c010,
0xc0369e59,
0xc2000cfe,
0x32185a20,
0xc000b481,
0xb7209c22,
0xb7805294,
0x7504404d,
0xc0009d3a,
0xb72091c4,
0xb780520c,
0xb5804cab,
0xc20041cb,
0xd2245a40,
0xc00159c1,
0xb72091c0,
0xb780538c,
0xe310402d,
0x74278821,
0x90b6c000,
0xc000084f,
0x741a90e0,
0xb3028532,
0x9d434478,
0x403db740,
0x6b8ab722,
0x81a1e220,
0xd0719e5a,
0x70881a14,
0x90f8c000,
0x0a12d071,
0xc0007088,
0x9dcf907c,
0x9ea10a1e,
0x08cec002,
0x72c2cc12,
0xcc109e89,
0x9e5872c2,
0xb7209c22,
0x85025294,
0x538cb780,
0xb7208702,
0xf01041cb,
0xf010a16b,
0xf010a16f,
0xd810a173,
0xd810a16f,
0xf010a16b,
0xb542a0e1,
0xf2084600,
0xf208a10b,
0xb720a10f,
0xf20841cb,
0xda08a113,
0xda08a10f,
0xf208a10b,
0x9c22a081,
0xb7209e5b,
0xf0085394,
0xf00aaa61,
0xf008a968,
0xb740a96e,
0xb58041db,
0xd808404d,
0xf310aa6d,
0xb7408021,
0xb580415b,
0xd80841cb,
0xf310aa69,
0xb5808021,
0xf008414b,
0xb520a8e9,
0xf008414d,
0xb760aa6d,
0xb7205414,
0xb580528c,
0xf01041cd,
0xe020a963,
0xb7408325,
0xf008402d,
0xf210a8f1,
0x7482802d,
0xa261f010,
0x424db520,
0x9184c000,
0xaa71f008,
0xa967f050,
0x5a0fc200,
0x8021f310,
0xa265f050,
0xd8088502,
0xd808a16f,
0x8502a16b,
0xf0089e50,
0xf008a16b,
0xf008a16f,
0x9c22a173,
0x5214b720,
0xf0089e5a,
0xb720aa41,
0xc4104149,
0xf0087048,
0xb780a0c1,
0xd01240c9,
0x74c07102,
0xa241f008,
0x91c4c000,
0x528cb720,
0xaa41d808,
0x5394b720,
0x41abb580,
0xaa41f008,
0x404db580,
0x9c220802,
0xf011a605,
0xb7a00c30,
0xb7a05414,
0xc000520c,
0xda509124,
0xda08a9aa,
0x0d02a9b1,
0x9b48c054,
0x528cb720,
0xa8aad208,
0xa926d208,
0x412bb740,
0xda089e49,
0xc010aa35,
0x9e817040,
0xc8121a08,
0x70887282,
0x90c4c000,
0x518cb780,
0xa102da08,
0xa927da50,
0xf2109e50,
0xda50802d,
0xb79fa225,
0xb7bf7f6e,
0x8c407fee,
0xa61d9c22,
0x76c28420,
0xb5bf0287,
0xc0007f6c,
0xb72091c4,
0xb780540c,
0x9e8e412b,
0x528cb7e0,
0xb5800a04,
0xc000412b,
0xb72593a0,
0x74405188,
0x9202c000,
0x528cb780,
0xa891f248,
0x5194b720,
0x5414b7c0,
0x588f0389,
0x484db520,
0x9140c000,
0x518cb780,
0x5414b7c0,
0x528cb7e0,
0xa081f288,
0x5214b720,
0xa8c9da10,
0x424bb780,
0x41c9b740,
0xb7807048,
0x098241cb,
0x09b2d001,
0xa8e1f208,
0x0f967104,
0x1ff4d003,
0x9e4e7444,
0x9044c001,
0xc00074c0,
0xda509184,
0xdac8a94b,
0xf310aa45,
0xda508021,
0xc000a249,
0xda509220,
0xdac8a94b,
0xf310aa45,
0x0d828021,
0xa249da50,
0x9b6efff4,
0xa079da48,
0xa045dac8,
0xaac5dac8,
0x9080c015,
0xc0157442,
0x74ac9024,
0x538cb780,
0xd0090d8e,
0x9e580db4,
0xa88eda08,
0x6104d033,
0x72759ea0,
0xc0000902,
0xda089178,
0x9e4aaa4d,
0x8021f310,
0x01037088,
0x1912d00b,
0xaa69f208,
0x9e927502,
0x9204c001,
0xaa69da08,
0xc0017500,
0x74c09164,
0x93e4c000,
0xaac5dac8,
0xaa49d208,
0xa8c5d208,
0x710ad410,
0x704ad412,
0xc0007680,
0xb78091c2,
0xda10414a,
0xd250a8c1,
0xda10a1d1,
0xda10a251,
0xda10a24d,
0xda50a0d5,
0xc011aa49,
0xda5093e0,
0x024aaa45,
0xa245da50,
0xa2f9da48,
0x9280c012,
0xaa6dd288,
0xc0017500,
0x74c09122,
0x9044c001,
0xc0007480,
0xd20891e2,
0xf250aa4d,
0xc00aa8c5,
0x70486a02,
0x90dcc000,
0xaa41da10,
0xa255da10,
0xa8c1d208,
0xaa71da48,
0xc0007102,
0xda489088,
0xd288a0f1,
0x7500aa65,
0xaaf1da48,
0x9140c010,
0xa9f2da48,
0x9240c005,
0xc0037480,
0xd20893a2,
0xb720aa4d,
0x6a0e414a,
0x85027048,
0x915cc000,
0xaa4dda10,
0x6a0c5884,
0xc0007048,
0x8506907c,
0xa157d250,
0xa8ced208,
0xa8c5f250,
0x6e11d291,
0x70489d9a,
0x1e32d011,
0x414ab720,
0x6245c001,
0xd00d0d02,
0x70480d22,
0x905cc001,
0xaa51da10,
0x5884d0a4,
0x6a0c9e48,
0x9e527008,
0xd00d0882,
0x78440892,
0x9282c000,
0xa8c1f210,
0xaa55da10,
0x6a0c5884,
0xc0007048,
0x8506917c,
0xa153d250,
0xa17bd288,
0xaa41da10,
0x93c0c000,
0xa8d1da10,
0xd2508502,
0xb780a153,
0xd013414a,
0xf3106916,
0x76808021,
0x5a0bc200,
0xa251da10,
0x91c2c000,
0xa8d5da10,
0xaa41f210,
0x6916d013,
0x8021f310,
0x5a0bc200,
0xa255da10,
0xaa51d250,
0xc0007500,
0xda0891e2,
0xda08aa55,
0x6a14a8e9,
0x5a0fc200,
0xc0007048,
0x850690bc,
0xa15bd250,
0x414ab780,
0xa24dda10,
0xaad2d250,
0xc0017740,
0x74c092a2,
0x9164c001,
0xaa41d208,
0xa978da4a,
0x1244e001,
0x442cb343,
0x751e0207,
0xa8d9d250,
0xb342853e,
0x74404478,
0x82adf210,
0x91c2c000,
0xa8eada08,
0xaa55da08,
0x1a0c9e48,
0xd0117008,
0xb35108d4,
0x0283443c,
0xa8e6d288,
0xa8c9d208,
0xd2087640,
0xc00aa945,
0x0d8291a0,
0x9a38fff4,
0xa079da48,
0x9240c00b,
0xaa79d288,
0xc0017500,
0x74c091c2,
0x9244c000,
0xaa79da48,
0xaac1d208,
0xa8e6d288,
0xa8c9d208,
0xd4120a04,
0x76407148,
0xa945d208,
0x91c0c009,
0xfff40d82,
0xd2889a19,
0x7500aa7d,
0xa079da48,
0xa2fad288,
0x91c2c00a,
0xa977da48,
0xaa61da88,
0x80a1e210,
0xda880a04,
0xda48a261,
0xc00aa0f5,
0xda109020,
0x7500aa49,
0x9144c001,
0x578cb780,
0xa95bf210,
0xa881da08,
0x88a3e210,
0xa0d9f210,
0xaa71f248,
0xda487500,
0xc000aaf9,
0xd250921a,
0xb720aa59,
0x0a88518c,
0x75008506,
0x4d39b540,
0x0a52d011,
0x4424b354,
0xd2880289,
0xd208a8e6,
0x7640a8c9,
0xa945d208,
0x9100c007,
0xc00774c0,
0xb7409304,
0xb7804144,
0xf24841cc,
0xf310a973,
0xb7208221,
0xf3105194,
0xf2488821,
0xb720a271,
0x7102484d,
0xc0010683,
0xda1092b6,
0xb740a8c9,
0xd0a65784,
0x9e2d5904,
0xaa4dc830,
0xa95bf210,
0x8821f310,
0xa259f210,
0xa8a9d2d0,
0xa8dad250,
0x0a887442,
0x0a54d011,
0x4424b354,
0x02897640,
0x90e2c000,
0xaa79da48,
0xd4120a04,
0xda48710a,
0xd208a97b,
0xd288a8c9,
0xf310a8e6,
0xd410802f,
0xd410704a,
0x7640710a,
0xa945d208,
0x93c0c004,
0xaa49da10,
0x5784b740,
0x5904d226,
0xc8309e2d,
0xda90a8ce,
0x9e48a8c1,
0xc0806091,
0xc2005a7f,
0x00985a61,
0xf21058a3,
0xda90a0bd,
0x7440aa41,
0xa959f210,
0xd00e0882,
0x62450892,
0x59a3d224,
0x0a0276c0,
0x0a42d00e,
0x3098e000,
0x90a2c000,
0xa0bef210,
0xf2109e93,
0x76c0a95b,
0x882bf210,
0xa259f210,
0x90fcc000,
0xa8bdf210,
0xc0007440,
0xf208911a,
0xc200aa51,
0xc0005804,
0xf24891a0,
0xd033aa71,
0x9e5b6142,
0xe2205d87,
0x0d0281af,
0x9898c054,
0xaa49da10,
0x5704b740,
0xa93df210,
0xa8e9f248,
0x5904d226,
0xc8309e2d,
0xf208a8ce,
0xd033aa51,
0x9e496122,
0x5a07c200,
0xc0121002,
0xd0247008,
0xe2205987,
0x0d0281af,
0xc0540181,
0xd0249879,
0xc054598f,
0xd288989f,
0xb75fa969,
0xda487f64,
0xd250a97b,
0xf210a8d6,
0xe3108225,
0xe21080af,
0xb7408b25,
0xd4105814,
0xd4107008,
0xf3107142,
0xd010882f,
0xd412a8cd,
0xd412710a,
0x7642708a,
0xa8e6d288,
0xa945d208,
0x0a52d011,
0x4424b354,
0xd2087440,
0x0289a8c9,
0x1a52d011,
0x4422b354,
0x02897640,
0x0a54d011,
0x4422b354,
0xd4100289,
0xd412704a,
0x7640708a,
0xaa49da50,
0x0a46d002,
0xda50024a,
0xc000a249,
0x0d829360,
0x98dafff4,
0xaa7dd288,
0xda487500,
0xc000a079,
0xda4891a2,
0xda88a977,
0xe210aa61,
0x0a0480a1,
0xa261da88,
0xa0f5da48,
0xaa79da48,
0xa26dda08,
0xb79f000b,
0xb7bf7dee,
0xb7df7e6e,
0xb7ff7eee,
0xc0027f6e,
0x9c228c20,
0x8460a61d,
0x528cb720,
0x402db780,
0x09020f82,
0x7decb55f,
0xb55f7502,
0x03037e6c,
0x9164c00b,
0x538cb7a0,
0x5214b7a0,
0xa9b2f208,
0xa9adda10,
0xc0340d02,
0xb7809bf3,
0xb720540c,
0xd2885194,
0xf208a8cd,
0x070ba91f,
0x43cdb500,
0xe2109ea5,
0x74408021,
0xf208038b,
0xc000a01d,
0xda0893c4,
0x7502aa49,
0x9334c000,
0xa8aada10,
0x5704b740,
0x5d04d0a6,
0xa8e9f208,
0xc8389e2e,
0xd0a6aa41,
0xc2015904,
0xf3108122,
0xc2008021,
0xd8005a0b,
0xc000a241,
0xda1091a0,
0xb740aa29,
0xda085704,
0xd226a8f1,
0x9e2d5904,
0xa0cdc830,
0xaa49da08,
0xa8d1da10,
0xa9a8da12,
0x62431a04,
0x0942d013,
0x80a7e010,
0x7e7cb77f,
0x7d6cb53f,
0xa8eef208,
0x8506744a,
0x4c78b332,
0xb55f7640,
0xc0007e7c,
0xf2089124,
0x0a04aa4d,
0xa24df208,
0x9060c004,
0x530cb780,
0x5f04b740,
0xa881f208,
0xd0a69e2d,
0xb7205904,
0xc830518c,
0x9e4aaa4d,
0x43b5b760,
0x6128d033,
0xa8cdf208,
0x5d8fd1a2,
0xe2205d93,
0xf21081af,
0x0d028ab3,
0x9b78c034,
0xaa4dda10,
0x6a00c028,
0xc0007008,
0xf24892d6,
0xd012aa45,
0x624b09d2,
0xd0309e5b,
0x5d870108,
0x81afe220,
0xf2480d02,
0xc034a1c6,
0xf2489b61,
0xc000a045,
0xf20890e0,
0x0a04aa4d,
0xa24df208,
0xa951da10,
0xaa29da10,
0x58c0d124,
0x08c2d011,
0x5e49d0a2,
0xc0007048,
0xf2489216,
0xf24aaa4d,
0xd226a944,
0xf3105904,
0xf3108021,
0xc2008221,
0xc0015a0b,
0xd0a29100,
0x70485e45,
0x9196c000,
0xa947f248,
0xaa4df248,
0x8021f310,
0x5a07c200,
0x9320c000,
0x6a26d011,
0x5a0bc200,
0xc0007048,
0xf2489216,
0xf248a8c5,
0xd0a6aa4d,
0xc2015904,
0xf3108122,
0xc2008021,
0xc0005a0b,
0xf2489080,
0xf248aa45,
0xda08a249,
0x7500aa49,
0x5784b740,
0x9202c003,
0xaa6df208,
0xc0037500,
0xb7409162,
0xf0105194,
0x7500aa5d,
0x9082c003,
0x558cb760,
0x5514b740,
0x4038b960,
0x0938d071,
0x0ca8d072,
0x7fcdb79f,
0xa8ddf1c8,
0xa23df1f1,
0xa0ddf1e9,
0x9301ffff,
0x519cb760,
0xa8a9da10,
0xaa7df018,
0x5904d0a6,
0xf0109e2d,
0xb73fa241,
0xc8307e6c,
0x7440aa4d,
0xa261f008,
0x9382c001,
0xaa29da10,
0x2a0c0a04,
0xc0017506,
0xb75f92a4,
0x0a267d6c,
0x7088d010,
0xc0007502,
0xd01192bc,
0xd0120d28,
0xd01008b8,
0xf03119c4,
0xf029aa25,
0x9ea2a8c5,
0x7decb79f,
0x024207f4,
0x7decb59f,
0x92a1ffff,
0xc00077c0,
0xc0109104,
0xda908502,
0xc000a123,
0xb73f9220,
0xd3a27df4,
0x0d025d91,
0x7f64b55f,
0x5d90c080,
0x9aa4c034,
0xa021da90,
0x7f64b75f,
0x518cb740,
0xaa29da10,
0xa8d9d848,
0xd2269e2d,
0xc8305904,
0xb79fa0cd,
0xb7bf7cee,
0xb7df7d6e,
0xb7ff7dee,
0xc0027e6e,
0x9c228c60,
0xac7dc030,
0x521cb740,
0xa45dc038,
0xac7dc030,
0xa45dc038,
0xac7dc030,
0xa45dc038,
0x580cb720,
0x528cb780,
0xb5408502,
0xb5404039,
0x850a40b9,
0xa10bd288,
0x8502c010,
0xa10bf248,
0xa107f248,
0xa10ff248,
0xa6059c22,
0x5f04b740,
0xd2a69e5d,
0x9e2d5904,
0xa9cec830,
0x0d0265a7,
0x9a5ac034,
0xc0349e83,
0x000a9a81,
0x58050804,
0x7f6eb79f,
0x7feeb7bf,
0x9c228c40,
0xb7a0a60d,
0x9e5d5214,
0x5894b7c0,
0xa92ff208,
0xa92ef210,
0xa8d1da10,
0x882df210,
0xa944f212,
0x4002ba09,
0xf3106243,
0xf2108221,
0xd208a245,
0xb7c0a8a1,
0xd210528c,
0xdac8a0a1,
0xda48aa25,
0xdad0a9d2,
0xf208a225,
0xfff4a9ad,
0xda489bc2,
0xda48a9da,
0xf208a051,
0xf210a9ad,
0xfff4a92e,
0xda089bb8,
0xb720aa49,
0xda48540c,
0x6008a059,
0x44abb500,
0xaa21f248,
0xa255f248,
0xa8a1f248,
0xa0c1f210,
0xaa2df208,
0xa22df210,
0xa8b1f208,
0xa0b1f210,
0xaa35f208,
0xa235f210,
0xa8bdf208,
0xa0bdf210,
0xaa21f248,
0xa221f250,
0xa8a5f248,
0xa0a5f250,
0xaa3df208,
0xa23df210,
0xa8a5d208,
0xa0a5d210,
0xaa29d208,
0xa229d210,
0xa8b5da08,
0xa0b5da10,
0xaa39f208,
0x08d0d0b1,
0xa239f210,
0x4031b720,
0x0e50d0b1,
0xa082d208,
0xa8b9f248,
0xa0b9f250,
0x7eeeb79f,
0x7f6eb7bf,
0x7feeb7df,
0x9c228c60,
0x8420a60d,
0x610cb7c0,
0x518cb7a0,
0x588cb760,
0xd0118582,
0xb7a00e32,
0xf2485214,
0xf208a1a3,
0xf00aa1a7,
0xf210a964,
0xf008a8ad,
0xf008a26d,
0xf250a1ea,
0xb720aa25,
0xe2105294,
0xf31082a3,
0xb7408221,
0xc08046dd,
0x75802b00,
0xd0a40103,
0xf250597f,
0x0009a8a1,
0x587fd224,
0x414db780,
0xe2109e4e,
0x0a0488a3,
0x414db580,
0xa0b5f208,
0xa171f808,
0xa069f808,
0x9162c000,
0xaa3df210,
0x8221f310,
0xd2240089,
0xf80858ff,
0xf210a0e9,
0xf008aa2d,
0xf208a9ee,
0x9ea1a8c9,
0xf2086533,
0x7442a935,
0x12149e51,
0xa265f008,
0xaa21f250,
0x4500d041,
0x92e2c000,
0xb32276fc,
0xc0004492,
0x74809252,
0x90d6c000,
0x5907d128,
0x90e0c000,
0xaa39f250,
0xd2286229,
0xf2485933,
0xf010a957,
0xf0088825,
0xb780a261,
0xd248540c,
0xc001a899,
0xf00814a4,
0x7442a0e6,
0xc0009ea1,
0xf20891a4,
0x7500aa35,
0x90dcc002,
0xc2009e52,
0x12285a07,
0x93c0c001,
0xaa35f208,
0xc2009e51,
0x70485a0c,
0x90b6c000,
0xd2c88506,
0xf208a12b,
0x9e52a8b5,
0x5a0cc080,
0xc0007088,
0xc0809156,
0x70885a08,
0x90b8c000,
0xc0008586,
0xf2089220,
0x9e52a8b5,
0x5a08c080,
0x858e7088,
0x9116c000,
0x5a04c080,
0x8d847088,
0x85b2e00c,
0xa8a5f248,
0xc0007440,
0xd0a6923c,
0xf00a5904,
0xf210a964,
0xc2008023,
0x10985a0f,
0x8a21f310,
0xa0a5f248,
0xa265f008,
0xaa49f208,
0xc0007502,
0xb78590e2,
0x75005188,
0x9202c000,
0xaa21d210,
0x5314b720,
0xa225dad0,
0xa8a5dad0,
0xa231da48,
0x404db520,
0x9320c008,
0xaa5dd288,
0xc0007500,
0xb7809184,
0x75004749,
0x9142c000,
0xaa41da88,
0xc0007504,
0x850690b4,
0x9060c000,
0xd2888502,
0xd288a153,
0x7500aa5d,
0x9002c001,
0xaa41da88,
0x5a40c200,
0x7502c001,
0x9314c000,
0xa957da48,
0x5a45c200,
0x8021f310,
0xa9c1da88,
0xa221dad0,
0xa9a2dad0,
0xb57f0d02,
0xc0347f7c,
0xb77f98b9,
0x18047f7c,
0x9320c000,
0xaa49da08,
0x44dbb740,
0x5a40c200,
0x5a45c200,
0x8021f310,
0xa9c9da08,
0xa221dad0,
0xa9a2dad0,
0xb57f0d02,
0xc0347f7c,
0xb77f989f,
0xdad07f7c,
0xf208a021,
0x7504aa49,
0x9094c001,
0xa8a2dad0,
0xa8b1da48,
0x0e14d011,
0xc0007048,
0xda08913a,
0xd011a921,
0x70881a14,
0x90d6c000,
0x1e12d011,
0x91c0c000,
0x1e14d011,
0xc0007048,
0xd01190f8,
0x70880a14,
0x90dcc000,
0x0e12d011,
0xa221dad0,
0xaa21dad0,
0xc0007526,
0xda0892b4,
0x0089a8a2,
0x1e14d011,
0xd00e7048,
0xc0000a12,
0xd011913c,
0x70480e14,
0x90dcc000,
0x1a12d011,
0xa221dad0,
0xa8ddda48,
0xaa21da08,
0x4002ba09,
0x70481a28,
0x9176c000,
0xaa5dda48,
0xa8a1dad0,
0xc4100a1c,
0xdad07048,
0xd210a0a1,
0x752caa2d,
0x9152c001,
0xa8a2da08,
0xaa5dda48,
0x1c90d031,
0x4002ba24,
0xc0007102,
0xdad091b6,
0xd011a8a1,
0x70481e16,
0x90dcc000,
0x1a16d011,
0xa221dad0,
0xaa31da48,
0xa8a1dad0,
0xd0121a0c,
0xda487102,
0xdad0a8b1,
0xdad0a221,
0x088caa21,
0x7102d010,
0xa221dad0,
0xa8b5f208,
0xaa21f250,
0xc0007048,
0xda48923c,
0xdad0a8d9,
0x7048aa21,
0xa958da4a,
0xa923dad0,
0x8026f013,
0x822ff214,
0xa221dad0,
0xa9bef210,
0xa9a9f248,
0xc0140d02,
0xc00e9bff,
0x7404287c,
0x90f2c000,
0xaa21dad0,
0xc0000a08,
0x74069100,
0x90f2c000,
0xaa21dad0,
0xdad00a04,
0xd210a221,
0xdad0aa29,
0x1a08a8a1,
0x7048c410,
0xaa25d210,
0xa0a1dad0,
0xa8a1dad0,
0xd0120a08,
0xdad07102,
0xdad0a221,
0xda48a225,
0xda48a259,
0xd288a231,
0x7502aa5d,
0x9244c000,
0xaa25dad0,
0x5314b720,
0xa8a5dad0,
0xa231da48,
0xa221dad0,
0xa259da48,
0xa24dda08,
0x404db520,
0xf2488502,
0xf248a12f,
0xf248a133,
0xf248a137,
0xd2c8a13f,
0xb79fa12b,
0xb7bf7e6e,
0xb7df7eee,
0xc0027f6e,
0x9c228c00,
0xb740a61d,
0x9e5a5294,
0x9e557482,
0xa141f010,
0x93a4c006,
0x5894b720,
0x540cb720,
0x40cdb780,
0x9e4e8502,
0xb5407500,
0x038344bd,
0x90d6c000,
0x518cb780,
0xa109d2c8,
0x5188b785,
0xf0107500,
0xc006a14f,
0xf0109304,
0x7442a8c9,
0xab52f050,
0x90e4c000,
0xaa49d810,
0xc0007500,
0x744290a4,
0x91b4c003,
0x5214b7a0,
0x0e50d0b1,
0xa882d208,
0xa9c9f208,
0xa8c5f208,
0xd1a49e4c,
0xd0265985,
0xe2205133,
0x050381af,
0xa1b2f248,
0x9b64c014,
0x610cb780,
0xc0809d0d,
0x75002a00,
0xa1b3f248,
0x9362c000,
0xa937f248,
0xaa41f208,
0x8821f310,
0xa92cf212,
0xc2006a0e,
0xf3105a0b,
0x08828a21,
0x7102d012,
0x8031f310,
0xc2000a04,
0xf2485a07,
0xc001a231,
0xf2089280,
0x753caa4d,
0x91f4c001,
0x5608b785,
0xa92cf212,
0xf24a7502,
0xc000a130,
0xf2489122,
0xf208a8b5,
0x7048aa41,
0x91dcc000,
0xa943f208,
0xaa35f248,
0x8821f310,
0x5a13c200,
0x8221f310,
0xa231f248,
0x5188b785,
0xc0007500,
0xf24891c4,
0xd322a8b1,
0x71025e10,
0x90fcc000,
0xaa39da48,
0xda481a04,
0xb780a239,
0xc080610c,
0x75002a00,
0x9202c001,
0x520cb780,
0xa88df208,
0xa8b6f248,
0x5904d0a6,
0xe2109e4c,
0x588b80a3,
0xc0007102,
0xf248915c,
0xd226aa31,
0xf310590c,
0xc0018821,
0xb78090c0,
0xf248518c,
0xf248a88e,
0x9e4ca89d,
0xc0017102,
0xda0892dc,
0x7508aa29,
0x9234c001,
0xaa31f248,
0x590cd226,
0x8021f310,
0x91e0c000,
0xaa3dd288,
0xc0017500,
0xf2089082,
0x753caa4d,
0x93f2c000,
0xaa31f248,
0xc2006a2e,
0xf2485a0f,
0xc000a231,
0x748492c0,
0x540cb7e0,
0x9224c000,
0xda488502,
0xd810a167,
0xd850a14b,
0xd890a157,
0xd090a143,
0xd248a15f,
0xd090a17b,
0x8702a15b,
0xda488502,
0xda08a16b,
0xd248a16b,
0xd248a173,
0xf20aa177,
0xb79fa160,
0xb7bf7e6e,
0xb7df7eee,
0xb7ff7f6e,
0xc0027fee,
0x9c228c00,
0x9d3da61d,
0xaa69d018,
0xb7e07502,
0xc000540c,
0xc00890c4,
0xf2088502,
0xb720a163,
0xb7c0588c,
0xb7255294,
0xf2085610,
0xb740a961,
0xf25040a5,
0x9d9da957,
0xf2109e76,
0xb7e08a25,
0x76425214,
0x8124c201,
0x40adb580,
0xa157f250,
0x9104c000,
0xaa6df210,
0x8821f310,
0xa255f248,
0xa963f208,
0xaa6df210,
0x8821f310,
0xaaf1f800,
0xd2240089,
0xf80058ff,
0xe000a869,
0x16d212d2,
0x1ed2d003,
0x1002e000,
0xd0031402,
0xd0221c02,
0xc0005e0c,
0xd02058f5,
0xc0003198,
0xe000598c,
0x15b011b0,
0x1db2d003,
0x5cf4d1a2,
0x5a0dc180,
0x00853118,
0x58ffd124,
0xa2f1f800,
0xa069f800,
0xa0edf800,
0xaa69d018,
0x85027500,
0x90e4c000,
0x4608b782,
0xc0007500,
0x85069062,
0xd2908702,
0xa164a147,
0x5608b785,
0xc0007502,
0xf2109344,
0xb780a8ed,
0xd0a6610c,
0xe2105904,
0xc08080a3,
0x75002a00,
0x5907d0a6,
0xaa55f248,
0x4c82b322,
0x71359e29,
0x90b6c000,
0x8821f310,
0xaa65a265,
0xc0007500,
0x85069162,
0xa16fd018,
0xc2000a7c,
0xa2655a15,
0x9080c000,
0xa26dd018,
0xaa55f248,
0xc0007500,
0xf000917a,
0x8702a967,
0x8021f310,
0xa154f24a,
0xa265f000,
0xaa41f208,
0xc0017504,
0xd0b19004,
0xd2080e70,
0xf000a882,
0xf000a9e9,
0x9e4ca8e5,
0x5985d1a4,
0x5133d026,
0x518cb7a0,
0x81afe220,
0xf2080503,
0xc014a1a6,
0xf20899d7,
0xf208a025,
0xf248aa61,
0xc004a229,
0xb7209000,
0xf2085194,
0xb740aa61,
0xf310445d,
0xb5808021,
0xd018444d,
0x7440a8e9,
0x90e4c001,
0x610cb780,
0xa97ff208,
0x2a00c080,
0xf2087500,
0xf208a0fd,
0xc000a17b,
0xb7809342,
0xb74046cd,
0xb7204645,
0xb58045cd,
0xf310474d,
0xb5408221,
0xc20145dd,
0xf3108122,
0xb5408021,
0xb52046c5,
0xc200464d,
0xb5805a0b,
0xf00047cd,
0xda08aa69,
0x8502a8c9,
0xa14fd288,
0xf0001a04,
0x0884a269,
0xa0c9da08,
0xaa61d018,
0xc0017500,
0xb7859344,
0x75005188,
0x92a4c001,
0x610cb780,
0x2a00c080,
0xc0007500,
0xf2109102,
0xc200aa6d,
0xc0005884,
0xf21090e0,
0x6a36aa7d,
0x5893c200,
0xaa55f248,
0xc0007102,
0x8506929c,
0xa16bd018,
0xaa69f000,
0xc0007500,
0xd21091e2,
0xda48aa69,
0xf310a967,
0xda488021,
0xc000a265,
0x850290a0,
0xa16bd018,
0xa8e9f000,
0xc0007440,
0xd0189084,
0xb79fa0e9,
0xb7bf7e6e,
0xb7df7eee,
0xb7ff7f6e,
0xc0027fee,
0x9c228c00,
0x540cb780,
0x5294b720,
0xa903f208,
0x404db720,
0x9e4b9ea0,
0x81afe220,
0xf2087442,
0xc006a182,
0xb78093a4,
0x75004648,
0x9164c000,
0x4b49b780,
0xc0007500,
0xb78090c4,
0xb580454d,
0xb72045cd,
0xb780588c,
0x753c41ad,
0xc0059d1d,
0xb7859112,
0x75005188,
0x9064c005,
0xaa69f008,
0xc0007502,
0xd80890e4,
0x7500aa69,
0x90e2c000,
0xa9eed088,
0xc00076c0,
0xb7809262,
0xb720538c,
0xb720518c,
0xda0844d4,
0x8502a909,
0xa17bd088,
0x4135b520,
0x40abb540,
0x9060c004,
0xa879d088,
0xc0007400,
0xb7209342,
0xb7405194,
0xb740538c,
0xb78044d4,
0xd80840cb,
0xd088a8c9,
0xb540a1fa,
0xba244155,
0x688c4002,
0xc2000242,
0xb5805a0b,
0xc00340cb,
0xb78090c0,
0x75004648,
0x5214b740,
0x90a4c001,
0x5394b720,
0xaa49d810,
0x414bb720,
0x68a86a24,
0xb7407048,
0xc001518c,
0xd808929c,
0xb720aa45,
0xba24414b,
0x6a0e4002,
0x70485884,
0x913cc001,
0xaa49f008,
0x44ccb720,
0x5904d226,
0x8021f310,
0xc0007048,
0x850693dc,
0xa17bd088,
0xa17fd088,
0xaa55d810,
0xa8e9d808,
0xc2006a14,
0x70485a0f,
0x90dac000,
0x4748b500,
0x9080c000,
0x4758b540,
0xd8488502,
0xd888a177,
0xc001a163,
0x85029000,
0xa17bd088,
0xaa45d808,
0x414bb720,
0x4002ba24,
0x6947d013,
0x80a3e210,
0xa8caf008,
0xd808588b,
0xb780a0c5,
0xd0a644cc,
0xc2015d04,
0xf310812a,
0xc2008021,
0xf0085a0b,
0xd088a249,
0x7500aa7d,
0xc000850a,
0x850e9062,
0xa16bd088,
0xaa79d088,
0xb3407500,
0xb78048a2,
0xb720404c,
0xd226518c,
0xa9645904,
0x8021f310,
0x5a17c200,
0x44adb580,
0x8221f310,
0x9c22a265,
0xb3407444,
0xb78048a4,
0xdac8520c,
0xb520a885,
0x9c2247cb,
0x4001ba1b,
0x76d6c004,
0x90bcc000,
0x0862c024,
0xc0049c22,
0xc00076c6,
0xd09190fc,
0xc0041c36,
0x9c22681a,
0x9c220852,
0x5e1cb740,
0x4001ba1b,
0x9e591db0,
0xc0120a02,
0x9d537048,
0xc0409e99,
0x7642a885,
0x4000ba01,
0x91a2c000,
0x90a6c000,
0xc0007644,
0x08029082,
0xc0009c22,
0xba045a04,
0xd0264002,
0xc000590c,
0xf3105a08,
0xba048021,
0x9c224002,
0x9ea10a02,
0x5e1cb740,
0x4001ba1b,
0xcc121db0,
0x9dc772c2,
0xa9eac010,
0x4001ba1b,
0x5d18d1a6,
0xe2105d88,
0x9c22882f,
0x74c0c008,
0x9e529e58,
0x90fcc000,
0x70c0d002,
0x51f31a14,
0xc0055013,
0xc0007400,
0xd00290fc,
0x1a507000,
0x01285013,
0x6004b740,
0x608cb780,
0x5904d1a6,
0xc0409e2d,
0xc830a8e5,
0x7044aa4d,
0xd01d6009,
0xd01a1214,
0xb3405013,
0x122248ba,
0x9c225010,
0x75269e5c,
0xd01e0882,
0xb3404000,
0xc38048bc,
0xc0007500,
0xc00290bc,
0x9c22084e,
0x7508c004,
0x915cc000,
0xc2000a04,
0xc0045a07,
0x08847508,
0x935affff,
0x5f9cb740,
0xc2209d4b,
0xd013a805,
0xe210691d,
0x9c228021,
0x87c2c809,
0x0c20b060,
0x87c2c809,
0x0a60b060,
0x87c2c809,
0x09c0b060,
};
unsigned int aui32H264CBR_MTXTOPAZFWData[] = {
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x809000b0,
0x8090019c,
0x82885904,
0x828853cc,
0x82885404,
0x82885448,
0x82885484,
0x828854c0,
0x828854f0,
0x82885520,
0x82885548,
0x828855a8,
0x828855d8,
0x82885608,
0x82885610,
0x82885618,
0x82885210,
0x828857a8,
0x828857b0,
0x828853ae,
0x82885ac8,
0x82885a98,
0x82885978,
0x828857e0,
0x828859c8,
0x82885a10,
0x82885a14,
0x82885a58,
0x82885d18,
0x82885b9c,
0x82885b68,
0x82885bea,
0x82885bc4,
0x82885c52,
0x82885cd4,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x809006dc,
0x80901be8,
0x809024f0,
0x809006e0,
0x80903da0,
0x80904f9c,
0x8090072c,
0x00000000,
0x80901da8,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x809006dc,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0xa0101162,
0xa0100174,
0xa0101102,
0xa0100184,
0xa0101104,
0xa0100194,
0xa0101106,
0xa01001a4,
0xa01001a2,
0xa01001a2,
0xa0101182,
0xa0100142,
0xa0101122,
0xa0100152,
0x80101124,
0x80101126,
0x80101144,
0x80101146,
0x80100176,
0x80100186,
0x80100196,
0x801001a6,
0x801001b6,
0x801001b4,
0x80300364,
0x8010b100,
0x80105160,
0x80100102,
0x00000b00,
0x00000b00,
0x00000ba0,
0x00000ba0,
0x00000003,
0x00000002,
0x00000002,
0x00000001,
0x00000001,
0x00000001,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000005,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x03020100,
0x07060504,
0x0b0a0908,
0x0f0e0d0c,
0x13121110,
0x17161514,
0x1b1a1918,
0x1e1d1d1c,
0x2120201f,
0x23232222,
0x25252424,
0x26262625,
0x27272727,
0x02020202,
0x04040303,
0x05050504,
0x06060505,
0x07070706,
0x0b090808,
0x110f0e0d,
0x1f1b1714,
0x3e332924,
0x5b554f4a,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x01010000,
0x02020201,
0x04030303,
0x05040404,
0x00140005,
0x001a0016,
0x0020001c,
0x00280024,
0x0034002c,
0x00400038,
0x00500048,
0x00680058,
0x00800070,
0x00a00090,
0x00d000b0,
0x010000e0,
0x01400120,
0x01a00160,
0x020001c0,
0x02800240,
0x034002c0,
0x04000380,
0x05000480,
0x06800580,
0x08000700,
0x0a000900,
0x0d000b00,
0x10000e00,
0x14001200,
0x1a001600,
0x00001c00,
0x00200040,
0x001002ab,
0x015500cd,
0x00080249,
0x00cd01c7,
0x0155005d,
0x0249013b,
0x00040111,
0x01c700f1,
0x00cd01af,
0x005d00c3,
0x01550059,
0x013b0029,
0x0249025f,
0x01110235,
0x00020021,
0x00f1001f,
0x01c70075,
0x01af006f,
0x00cd0069,
0x00c30019,
0x005d017d,
0x0059005b,
0x015502b9,
0x002900a7,
0x013b0283,
0x025f0135,
0x02490095,
0x0235023f,
0x0111008b,
0x00210219,
0x00010041,
0x0b060600,
0x0c0b0a06,
0x0a0b0c06,
0x0c0d0c0c,
0x0d0d0c06,
0x0b0b0c0c,
0x0e0d0a0d,
0x0a0d0e0e,
0x0c0d0a06,
0x0c0e0c0e,
0x0e0d0a0d,
0x0f0c0c0c,
0x0f0b0d0e,
0x0d0f0e0e,
0x0d0f0f0f,
0x0c0b0f0e,
0x00000006,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x1234baac,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
0x00000000,
};
|
the_stack_data/32949039.c | int b(double a) {
return a == 0;
}
void a(void) {
double _Complex z = 0;
if (b(__real__ z) && b(__imag__ z))
return;
}
|
the_stack_data/82950705.c | #include <stdio.h>
#include <stdlib.h>
unsigned int knapsack(int* weights, unsigned int* values, unsigned int num_items,
int capacity, unsigned int cur_value);
void readFile(const char* file_name, int** weights, unsigned int** values, unsigned int* num_items, int* capacity){
/*
File is strucured as:
capacity
num_items
weight1 value1
weight2 value2
weight3 value3
...
*/
FILE* fptr;
unsigned int i;
fptr = fopen(file_name, "r");
fscanf(fptr,"%d", capacity); //read capacity
fscanf(fptr,"%d", num_items); //read capacity
//make space
*weights = (int*) malloc(*num_items * sizeof(int));
*values = (unsigned int*) malloc(*num_items * sizeof(unsigned int));
//read weights and values
for(i = 0; i < *num_items; i++){
fscanf(fptr, "%d", *weights + i);
fscanf(fptr, "%u", *values + i);
}
//close file
fclose(fptr);
}
int main(int argc, char **argv){
int* weights;
unsigned int* values;
unsigned int num_items;
int capacity;
unsigned int max_value;
if (argc == 2){
//readFile
readFile(argv[1], &weights, &values, &num_items, &capacity);
//find the max that we can carry
max_value = knapsack(weights, values, num_items, capacity, 0);
printf("%u\n", max_value); //display result
//free space malloced
free(weights);
free(values);
} else{
printf("Usage: knapsack.out arg_file\n");
}
return 0;
}//main
|
the_stack_data/173578620.c | /* Exercise 1 - Calculations
Write a C program to input marks of two subjects. Calculate and print the average of the two marks. */
#include <stdio.h>
int main() {
int mark1, mark2, sum;
float average;
printf("Enter first mark : ");
scanf("%d", &mark1);
printf("Enter second mark : ");
scanf("%d", &mark2);
sum = mark1 + mark2;
average = sum / 2.0;
printf("Average : %.2f", average);
return 0;
}
|
the_stack_data/76699074.c | #include <stdio.h>
int main(){
int n;
while(scanf("%d", &n) != EOF){
int M[n][n];
for(int i = 0; i<n; i++){
for(int j = 0; j<n; j++){
M[i][j] = 0;
if(i == j) M[i][j] = 2;
if(n-i == j+1) M[i][j] = 3;
if(i >= n/3 && i <= n-1-(n/3)){
if(j >= n/3 && j <= n-1-(n/3))
M[i][j] = 1;
}
if(i == (n-1)/2 && j == (n-1)/2) M[i][j] = 4;
}
}
for(int i = 0; i<n; i++){
for(int j = 0; j<n; j++){
printf("%d", M[i][j]);
}
printf("\n");
}
printf("\n");
}
return 0;
} |
the_stack_data/87839.c | // Test atoi()
#include <stdlib.h>
#include <stdio.h>
void main() {
clrscr();
printf("%d\n", atoi("1234"));
printf("%d\n", atoi("-5678"));
} |
the_stack_data/111077976.c | #include <stdio.h>
#include <stdlib.h>
#include <ctype.h>
#include <string.h>
int main(){
int idade = 0;
printf("Digite sua idade \n");
scanf("%d",&idade);
if(idade<=17){
printf("Voce e uma pessoa jovem !! \n");
}else{
if(idade>=60){
printf("Voce e uma pessoa Idosa !! \n");
}else{
if((idade>17)&&(idade<60)){
printf("Voce e uma pessoa a dulta !!");
}
}
}
return 0;
}
|
the_stack_data/268465.c | #include <stdio.h>
void main () {
float num;
scanf("%f", &num);
printf("%d\n", num);
} |
the_stack_data/31388109.c | #include <stdio.h>
//#include <string.h>
int main()
{
int k;
int n, stk[666666], in[666666];
//int t;
int i, j, h, pos, top, flag;
scanf("%d", &k);
for(i = 0; i < k; i++){
scanf("%d", &n);
//memset(stk, 0, )
for(j = 1; j <= n; j++)
scanf("%d", &in[j]);
pos = top = 0;
flag = 1;
for(j = 1; j <= n; j++){
for(h = pos+1; h <= in[j]; h++){
pos = h;
stk[top++] = h;
}//压到底啊
if(stk[--top] != in[j]){
//printf("NO\n");
flag = 0;
break;
}
}
(flag) ? printf("Yes\n") : printf("No\n");
}
return 0;
} |
the_stack_data/106104.c | #include <stdio.h>
#include <stdlib.h>
#include <time.h>
#define SOURCE_SIZE_MAX ( 1024 * 1024 )
#define VAR_LENGTH 4 /* "src=" */
#define CONTENT_SIZE_MAX SOURCE_SIZE_MAX+VAR_LENGTH+2
#define OUTPUT_FILE_PATH "../hello.c"
void unencode ( char* src, char* last, char* dest )
{
for ( ; src != last; src++, dest++ )
{
if ( *src == '+' )
{
*dest = ' ';
}
else if ( *src == '%' )
{
unsigned int code;
if ( sscanf ( src + 1, "%2x", &code ) != 1 )
{
code = '?';
}
*dest = code;
src += 2;
}
else
{
*dest = *src;
}
}
*dest = '\n';
*++dest = '\0';
}
int main ( void )
{
char* lenstr;
char input[CONTENT_SIZE_MAX];
char data[CONTENT_SIZE_MAX];
long len;
int id;
id = time(NULL);
printf ( "Content-type: application/json\r\n\r\n" );
lenstr = getenv ( "CONTENT_LENGTH" );
if ( lenstr == NULL || sscanf ( lenstr, "%ld", &len ) != 1 || len > SOURCE_SIZE_MAX )
{
printf ( "{ \"Ready\":false, \"Message\": \"%s\" }\r\n\r\n", "Can't read the source" );
fgets ( input, SOURCE_SIZE_MAX, stdin );
}
else
{
FILE* f;
fgets ( input, len + 1, stdin );
unencode ( input + VAR_LENGTH, input + len, data );
f = fopen ( OUTPUT_FILE_PATH, "w" );
if ( f == NULL )
{
printf ( "{ \"Ready\":false, \"Message\": \"%s\" }\r\n\r\n", "Can't save the source" );
}
else
{
fputs ( data, f );
}
fclose ( f );
printf ( "{ \"Ready\":true, \"Message\": \"%s\", \"Id\": %d }\r\n\r\n", "Source saved", id );
}
return 0;
}
|
the_stack_data/121642.c | /**
* Copyright (c) 2018 Zachary Puls <[email protected]>
*/
#include <string.h>
/**
* @brief Transforms the string pointed by src according to the current locale,
* and copies the first n characters of the transformed string to dest,
* returning its length. Alternativelly, the function can be used to only
* retrieve the length, by specifying a null pointer for dest and zero for n.
*
* @param dest A pointer to the string where the content is to be copied,
* or NULL if n == 0
* @param src A pointer to the string that is to be transformed
* @param n The maximum number of characters to be copied to dest
* @return size_t The length of the transformed string, not including the
* null-terminator
*/
size_t strxfrm(char *restrict dest, const char *restrict src, size_t n) {
return 0;
}
|
the_stack_data/14199074.c | #include <stdio.h>
extern const double PI;
extern const double E;
int main()
{
printf(" PI: %f\n",PI);
printf(" E: %f\n",E);
return 0;
}
|
the_stack_data/140764335.c | //
// Created by Eliott Vincent on 30/12/2016.
//
//#define DEBUGMODE
#ifdef DEBUGMODE //si la ligne "#define DEBUGMODE" n'est pas commentée, alors le DEBUGMODE est défini
# define DEBUG(x) x //et donc chaque fonction entourée de DEBUG() s'exécutera
#else //sinon
# define DEBUG(x) //le
#endif
/*
* MAX
*/
#define MAX 255 |
the_stack_data/457699.c | #include <stdio.h>
#include <stdlib.h>
#include <string.h>
// used wiki alot
// https://en.wikipedia.org/wiki/MD5
typedef unsigned char uint8_t;
typedef unsigned int uint32_t;
// specifies per round amount
const uint32_t s[64] = {
7, 12, 17, 22, 7, 12, 17, 22, 7, 12, 17, 22, 7, 12, 17, 22,
5, 9, 14, 20, 5, 9, 14, 20, 5, 9, 14, 20, 5, 9, 14, 20,
4, 11, 16, 23, 4, 11, 16, 23, 4, 11, 16, 23, 4, 11, 16, 23,
6, 10, 15, 21, 6, 10, 15, 21, 6, 10, 15, 21, 6, 10, 15, 21
};
/*
* for i from 0 to 63 do
* K[i] := floor(232 × abs (sin(i + 1)))
* end for
*
* This is how this is generated
*/
const uint32_t k[64] = {
0xd76aa478, 0xe8c7b756, 0x242070db, 0xc1bdceee,
0xf57c0faf, 0x4787c62a, 0xa8304613, 0xfd469501,
0x698098d8, 0x8b44f7af, 0xffff5bb1, 0x895cd7be,
0x6b901122, 0xfd987193, 0xa679438e, 0x49b40821,
0xf61e2562, 0xc040b340, 0x265e5a51, 0xe9b6c7aa,
0xd62f105d, 0x02441453, 0xd8a1e681, 0xe7d3fbc8,
0x21e1cde6, 0xc33707d6, 0xf4d50d87, 0x455a14ed,
0xa9e3e905, 0xfcefa3f8, 0x676f02d9, 0x8d2a4c8a,
0xfffa3942, 0x8771f681, 0x6d9d6122, 0xfde5380c,
0xa4beea44, 0x4bdecfa9, 0xf6bb4b60, 0xbebfbc70,
0x289b7ec6, 0xeaa127fa, 0xd4ef3085, 0x04881d05,
0xd9d4d039, 0xe6db99e5, 0x1fa27cf8, 0xc4ac5665,
0xf4292244, 0x432aff97, 0xab9423a7, 0xfc93a039,
0x655b59c3, 0x8f0ccc92, 0xffeff47d, 0x85845dd1,
0x6fa87e4f, 0xfe2ce6e0, 0xa3014314, 0x4e0811a1,
0xf7537e82, 0xbd3af235, 0x2ad7d2bb, 0xeb86d391
};
uint32_t
leftrotate(uint32_t x, uint32_t c) {
return (x << c) | (x >> (32 - c));
}
void
handleBlock(uint32_t block[16], uint32_t * a0, uint32_t * b0, uint32_t * c0, uint32_t * d0) {
uint32_t a = *a0;
uint32_t b = *b0;
uint32_t c = *c0;
uint32_t d = *d0;
for (uint32_t i = 0; i < 64; i++) {
uint32_t f, g;
if (i <= 15) {
f = (b & c) | ((~b) & c);
g = i;
}
else if (i <= 31) {
f = (d & b) | ((~d) & c);
g = (5*i + 1) % 16;
}
else if (i <= 47) {
f = b ^ c ^ d;
g = (3 * i + 5) % 16;
}
else {
f = c ^ (b | (~d));
g = (7 * i) % 16;
}
f = f + a + k[i] + block[g];
a = d;
d = c;
c = b;
b = b + leftrotate(f, s[i]);
}
*a0 += a;
*b0 += b;
*c0 += c;
*d0 += d;
}
void
md5hash(uint8_t buffer[16]) {
uint32_t block[16];
FILE * inputstream = freopen(NULL, "rb", stdin);
uint32_t a0 = 0x67452301;
uint32_t b0 = 0xefcdab89;
uint32_t c0 = 0x98badcfe;
uint32_t d0 = 0x10325476;
size_t sum = 0;
while(1) {
size_t read = fread(block, 1, sizeof(uint32_t) * 16, inputstream);
sum += read;
if (read < sizeof(uint32_t) * 16) {
// padding
size_t sizeneeded = (56 - ((sum + 1) % 64));// + read + 8;
if (sizeneeded < 0)
sizeneeded += 64;
sizeneeded += read + 8 + 1;
uint8_t * blockBytes = (uint8_t*) malloc(sizeneeded);
memcpy(blockBytes, block, read);
blockBytes[read] = 1 << 7;
for(size_t i = read + 1; i < sizeneeded - 8; i++) {
blockBytes[i] = 0;
}
for (size_t i = 0; i < 8; i++) {
blockBytes[sizeneeded - 8 + i] = sum >> ((8 - i - 1) * 8);
}
for (size_t i = 0; i < sizeneeded; i += 64) {
handleBlock((uint32_t*)(blockBytes + i), &a0, &b0, &c0, &d0);
}
free(blockBytes);
break;
}
else {
// normal
handleBlock(block, &a0, &b0, &c0, &d0);
}
}
fclose(inputstream);
// concat output
buffer[0] = (uint8_t)(a0 >> 24);
buffer[1] = (uint8_t)(a0 >> 16);
buffer[2] = (uint8_t)(a0 >> 8);
buffer[3] = (uint8_t) a0;
buffer[4] = (uint8_t)(b0 >> 24);
buffer[5] = (uint8_t)(b0 >> 16);
buffer[6] = (uint8_t)(b0 >> 8);
buffer[7] = (uint8_t) b0;
buffer[8] = (uint8_t)(c0 >> 24);
buffer[9] = (uint8_t)(c0 >> 16);
buffer[10] = (uint8_t)(c0 >> 8);
buffer[11] = (uint8_t) c0;
buffer[12] = (uint8_t)(d0 >> 24);
buffer[13] = (uint8_t)(d0 >> 16);
buffer[14] = (uint8_t)(d0 >> 8);
buffer[15] = (uint8_t) d0;
}
int
main(int argc, char ** argv) {
uint8_t buffer[16];
md5hash(buffer);
for (size_t i = 0; i < 16; i++) {
printf("%02x", buffer[i]);
}
return 0;
}
|
the_stack_data/242330516.c | /*
Deallocation
Multiprogramming with Variable Number of Tasks
Note: This code isn't correct for all test cases
*/
#include "stdio.h"
#include "stdlib.h"
#include "stdbool.h"
struct process
{
int id;
int memory_required;
int external_fragment;
int internal_fragment;
bool removed;
};
int main()
{
int memory;
printf("Enter total memory size: ");
scanf("%d",&memory);
struct process proc[100];
int free_memory = memory;
int i=0;
int choice,memory_to_remove,memory_required,process_id;
while(1)
{
printf("Enter 1 to enter\nEnter 2 to leave\nEnter 3 exit\n");
printf("Enter your choice: ");
scanf("%d",&choice);
switch(choice)
{
case 1:
printf("Enter memory size for process%d: ",i+1);
scanf("%d",&memory_required);
int new_internal_space = 0;
for(int j=0;j<i;j++)
{
if(proc[j].removed == true )
{
new_internal_space+=proc[j].internal_fragment;
}
}
if(free_memory < memory_required)
{
printf("Free Memory: %d\n",free_memory );
printf("Not enough memory for the process\n");
}
else if(new_internal_space > memory_required)
{
printf("Process allocated\n" );
printf("Free memory: %d\n",free_memory + new_internal_space - memory_required );
}
else if(free_memory - new_internal_space >= memory_required)
{
proc[i].id = i;
proc[i].memory_required = memory_required;
proc[i].removed = false;
free_memory-=memory_required;
proc[i].internal_fragment = 0;
proc[i].external_fragment = free_memory;
printf("Process allocated\n");
printf("Free memory: %d\n",free_memory );
i++;
}
else
{
printf("Process not allocated\n");
printf("%d %d\n",free_memory, new_internal_space );
}
break;
case 2:
printf("Enter the id of process leaving: ");
scanf("%d",&process_id);
if(proc[process_id].removed)
{
printf("Process not in memory\n");
}
else
{
int memory_to_remove = proc[process_id].memory_required;
proc[process_id].internal_fragment = memory_to_remove;
free_memory+=memory_to_remove;
proc[process_id].external_fragment = free_memory;
proc[process_id].removed = true;
printf("Free Memory: %d\n",free_memory );
}
break;
case 3:
return 0;
break;
}
}
} |
the_stack_data/10671.c | #include <stdio.h>
#include <stdlib.h>
/*
Reference implementations of computing and using the "magic number" approach to dividing
by constants, including codegen instructions. The unsigned division incorporates the
"round down" optimization per ridiculous_fish.
This is free and unencumbered software. Any copyright is dedicated to the Public Domain.
*/
#include <stdint.h> // for uint32_t etc. types -vendu
#include <limits.h> //for CHAR_BIT
#include <assert.h>
/* Types used in the computations below. These can be redefined to the types appropriate
for the desired division type (i.e. uval can be defined as unsigned long long).
Note that the uval type is used in compute_signed_magic_info, so the uval type must
not be smaller than the sval type.
*/
#if 0
typedef unsigned int uval;
typedef signed int sval;
#endif
#define REG_BITS 32
typedef uint64_t uval;
typedef int64_t sval;
/* Computes "magic info" for performing signed division by a fixed integer D.
The type 'sval' is assumed to be defined as a signed integer type large enough
to hold both the dividend and the divisor.
Here >> is arithmetic (signed) shift, and >>> is logical shift.
To emit code for n/d, rounding towards zero, use the following sequence:
m = compute_signed_magic_info(D)
emit("result = (m.multiplier * n) >> SVAL_BITS");
if d > 0 and m.multiplier < 0: emit("result += n")
if d < 0 and m.multiplier > 0: emit("result -= n")
if m.post_shift > 0: emit("result >>= m.shift")
emit("result += (result < 0)")
The shifts by SVAL_BITS may be "free" if the high half of the full multiply
is put in a separate register.
The final add can of course be implemented via the sign bit, e.g.
result += (result >>> (SVAL_BITS - 1))
or
result -= (result >> (SVAL_BITS - 1))
This code is heavily indebted to Hacker's Delight by Henry Warren.
See http://www.hackersdelight.org/HDcode/magic.c.txt
Used with permission from http://www.hackersdelight.org/permissions.htm
*/
struct magics_info {
sval multiplier; // the "magic number" multiplier
unsigned shift; // shift for the dividend after multiplying
};
struct magics_info compute_signed_magic_info(sval D);
/* Computes "magic info" for performing unsigned division by a fixed positive integer D.
The type 'uval' is assumed to be defined as an unsigned integer type large enough
to hold both the dividend and the divisor. num_bits can be set appropriately if n is
known to be smaller than the largest uval; if this is not known then pass
(sizeof(uval) * CHAR_BIT) for num_bits.
Assume we have a hardware register of width UVAL_BITS, a known constant D which is
not zero and not a power of 2, and a variable n of width num_bits (which may be
up to UVAL_BITS). To emit code for n/d, use one of the two following sequences
(here >>> refers to a logical bitshift):
m = compute_unsigned_magic_info(D, num_bits)
if m.pre_shift > 0: emit("n >>>= m.pre_shift")
if m.increment: emit("n = saturated_increment(n)")
emit("result = (m.multiplier * n) >>> UVAL_BITS")
if m.post_shift > 0: emit("result >>>= m.post_shift")
or
m = compute_unsigned_magic_info(D, num_bits)
if m.pre_shift > 0: emit("n >>>= m.pre_shift")
emit("result = m.multiplier * n")
if m.increment: emit("result = result + m.multiplier")
emit("result >>>= UVAL_BITS")
if m.post_shift > 0: emit("result >>>= m.post_shift")
The shifts by UVAL_BITS may be "free" if the high half of the full multiply
is put in a separate register.
saturated_increment(n) means "increment n unless it would wrap to 0," i.e.
if n == (1 << UVAL_BITS)-1: result = n
else: result = n+1
A common way to implement this is with the carry bit. For example, on x86:
add 1
sbb 0
Some invariants:
1: At least one of pre_shift and increment is zero
2: multiplier is never zero
This code incorporates the "round down" optimization per ridiculous_fish.
*/
struct magicu_info {
uval multiplier; // the "magic number" multiplier
unsigned pre_shift; // shift for the dividend before multiplying
unsigned post_shift; //shift for the dividend after multiplying
int increment; // 0 or 1; if set then increment the numerator, using one of the two strategies
};
struct magicu_info compute_unsigned_magic_info(uval D, unsigned num_bits);
/* Implementations follow */
struct magicu_info compute_unsigned_magic_info(uval D, unsigned num_bits) {
//The numerator must fit in a uval
assert(num_bits > 0 && num_bits <= sizeof(uval) * CHAR_BIT);
// D must be larger than zero and not a power of 2
assert(D & (D-1));
// The eventual result
struct magicu_info result;
// Bits in a uval
const unsigned UVAL_BITS = sizeof(uval) * CHAR_BIT;
// The extra shift implicit in the difference between UVAL_BITS and num_bits
const unsigned extra_shift = UVAL_BITS - num_bits;
// The initial power of 2 is one less than the first one that can possibly work
const uval initial_power_of_2 = (uval)1 << (UVAL_BITS-1);
// The remainder and quotient of our power of 2 divided by d
uval quotient = initial_power_of_2 / D, remainder = initial_power_of_2 % D;
// ceil(log_2 D)
unsigned ceil_log_2_D;
// The magic info for the variant "round down" algorithm
uval down_multiplier = 0;
unsigned down_exponent = 0;
int has_magic_down = 0;
// Compute ceil(log_2 D)
ceil_log_2_D = 0;
uval tmp;
for (tmp = D; tmp > 0; tmp >>= 1)
ceil_log_2_D += 1;
// Begin a loop that increments the exponent, until we find a power of 2 that works.
unsigned exponent;
for (exponent = 0; ; exponent++) {
// Quotient and remainder is from previous exponent; compute it for this exponent.
if (remainder >= D - remainder) {
// Doubling remainder will wrap around D
quotient = quotient * 2 + 1;
remainder = remainder * 2 - D;
} else {
// Remainder will not wrap
quotient = quotient * 2;
remainder = remainder * 2;
}
// We're done if this exponent works for the round_up algorithm.
// Note that exponent may be larger than the maximum shift supported,
// so the check for >= ceil_log_2_D is critical.
if ((exponent + extra_shift >= ceil_log_2_D) || (D - remainder) <= ((uval)1 << (exponent + extra_shift)))
break;
// Set magic_down if we have not set it yet and this exponent works for the round_down algorithm
if (! has_magic_down && remainder <= ((uval)1 << (exponent + extra_shift))) {
has_magic_down = 1;
down_multiplier = quotient;
down_exponent = exponent;
}
}
if (exponent < ceil_log_2_D) {
// magic_up is efficient
result.multiplier = quotient + 1;
result.pre_shift = 0;
result.post_shift = exponent;
result.increment = 0;
} else if (D & 1) {
// Odd divisor, so use magic_down, which must have been set
assert(has_magic_down);
result.multiplier = down_multiplier;
result.pre_shift = 0;
result.post_shift = down_exponent;
result.increment = 1;
} else {
// Even divisor, so use a prefix-shifted dividend
unsigned pre_shift = 0;
uval shifted_D = D;
while ((shifted_D & 1) == 0) {
shifted_D >>= 1;
pre_shift += 1;
}
result = compute_unsigned_magic_info(shifted_D, num_bits - pre_shift);
assert(result.increment == 0 && result.pre_shift == 0); //expect no increment or pre_shift in this path
result.pre_shift = pre_shift;
}
return result;
}
struct magics_info compute_signed_magic_info(sval D) {
// D must not be zero and must not be a power of 2 (or its negative)
assert(D != 0 && (D & -D) != D && (D & -D) != -D);
// Our result
struct magics_info result;
// Bits in an sval
const unsigned SVAL_BITS = sizeof(sval) * CHAR_BIT;
// Absolute value of D (we know D is not the most negative value since that's a power of 2)
const uval abs_d = (D < 0 ? -D : D);
// The initial power of 2 is one less than the first one that can possibly work
// "two31" in Warren
unsigned exponent = SVAL_BITS - 1;
const uval initial_power_of_2 = (uval)1 << exponent;
// Compute the absolute value of our "test numerator,"
// which is the largest dividend whose remainder with d is d-1.
// This is called anc in Warren.
const uval tmp = initial_power_of_2 + (D < 0);
const uval abs_test_numer = tmp - 1 - tmp % abs_d;
// Initialize our quotients and remainders (q1, r1, q2, r2 in Warren)
uval quotient1 = initial_power_of_2 / abs_test_numer, remainder1 = initial_power_of_2 % abs_test_numer;
uval quotient2 = initial_power_of_2 / abs_d, remainder2 = initial_power_of_2 % abs_d;
uval delta;
// Begin our loop
do {
// Update the exponent
exponent++;
// Update quotient1 and remainder1
quotient1 *= 2;
remainder1 *= 2;
if (remainder1 >= abs_test_numer) {
quotient1 += 1;
remainder1 -= abs_test_numer;
}
// Update quotient2 and remainder2
quotient2 *= 2;
remainder2 *= 2;
if (remainder2 >= abs_d) {
quotient2 += 1;
remainder2 -= abs_d;
}
// Keep going as long as (2**exponent) / abs_d <= delta
delta = abs_d - remainder2;
} while (quotient1 < delta || (quotient1 == delta && remainder1 == 0));
result.multiplier = quotient2 + 1;
if (D < 0) result.multiplier = -result.multiplier;
result.shift = exponent - SVAL_BITS;
return result;
}
// added by vendu
/*
* if n == (1 << UVAL_BITS)-1: result = n
* else: result = n+1
*/
int
main(int argc, char *argv[])
{
struct magicu_info info;
unsigned long uval;
unsigned long cnt;
if (argc > 1) {
uval = strtoul(argv[1], NULL, 16);
info = compute_unsigned_magic_info(uval, 64);
} else {
uval = 1193182;
info = compute_unsigned_magic_info(1193182, 64);
}
cnt = info.post_shift;
if (cnt) {
cnt += REG_BITS;
}
fprintf(stderr, "MUL: %lu, pre: %ud, post: %lu, incr %d\n",
(unsigned long)info.multiplier,
info.pre_shift,
cnt,
info.increment);
printf("unsigned long\n");
printf("divu0x%lx(unsigned long uval)\n", uval);
printf("{\n");
printf("\tunsigned long long mul = UINT64_C(0x%lx);\n",
(unsigned long)info.multiplier);
printf("\tunsigned long long res = uval;\n");
printf("\tunsigned long cnt = %lu;\n\n", cnt);
if (info.pre_shift) {
printf("\tres >>= %u;\n", info.pre_shift);
}
if (info.increment) {
printf("\tres = max(res + 1, ~0UL);\n");
}
printf("\tres *= mul;\n");
printf("\tres >>= cnt;\n");
printf("\tuval = (unsigned long)res;\n");
printf("\n\treturn uval;\n");
printf("}\n");
exit(0);
}
|
the_stack_data/98975.c | // SAFE
int a[100];
int t;
int main() {
int i;
int N;
i = 0;
while (i < N) {
a[i] = 0;
if (i==t) a[t]=0;
i++;
}
i = 0;
while (i < N) {
_ABORT(i==t && a[i]!=0);
//if(i==t && a[i]!=0) ERROR: goto ERROR;
i++;
}
}
|
the_stack_data/37137.c | #include<stdio.h>
#include<string.h>
#include<malloc.h>
#define NULL 0
struct stu{
int num;
struct stu *next;
};
int N,n;
int num3;
struct stu *creat(){
struct stu *head;
struct stu *p1=NULL;
struct stu *p2=NULL;
n=0;
p1=(struct stu *)malloc(sizeof(struct stu));
p2=p1;
if(p1==NULL)
return NULL;
else {
head =NULL;
scanf("%d",&(p1->num));
num3=p1->num;
}
while(n<N){
n+=1;
if(n==1){
head=p1;
p2->next=NULL;
}
else{
p2->next=p1;
}
p2=p1;
p1=(struct stu *)malloc(sizeof(struct stu));
scanf("%d",&(p1->num));
num3=p1->num;
}
p2->next=NULL;
free(p1);
p1=NULL;
return head;
};
struct stu *del(struct stu *head,int num){
struct stu *p1;
struct stu *p2;
if(head==NULL){
printf("delete fail\n");
return head;
}
p1=head;
n=1;
while(n<num&&p1->next!=NULL){
p2=p1;
p1=p1->next;
n++;
}
if(n==num){
if(p1==head){
head=p1->next;
}
else{
p2->next=p1->next;
}
free(p1);
p1=NULL;
N-=1;
printf("delete OK\n");
}
else{
printf("delete fail\n");
}
return head;
};
struct stu *insert(struct stu *head,struct stu *node,int num1){
struct stu *p1;
n=1;
if(head==NULL){
if(num1==1){
head=node;
node->next=NULL;
N+=1;
printf("insert OK\n");
}
else
printf("insert fail\n");
return head;
}
p1=head;
if(head!=NULL&&num1==1){
node->next=p1;
head=node;
printf("insert OK\n");
return head;
}
while(n<num1-1&&p1->next!=NULL){
n++;
p1=p1->next;
}
if(n==num1-1){
node->next=p1->next;
p1->next=node;
N++;
printf("insert OK\n");
}
else {
printf("insert fail\n");
}
return head;
};
struct stu *reverse(struct stu *head){
struct stu *p;
struct stu *p1;
struct stu *p2;
p1=NULL;
p2=head;
while(p2!=NULL){
p=p2->next;
p2->next=p1;
p1=p2;
p2=p;
}
head =p1;
return head;
};
void print(struct stu *head){
struct stu *p;
p=head;
if(head!=NULL){
do{
printf("%d",p->num);
p=p->next;
if(p!=NULL)
printf(" ");
}while(p!=NULL);
printf("\n");
}
else printf("Link list is empty\n");
}
void gt(struct stu *head,int num){
struct stu *p;
p=head;
n=1;
while(n<num&&p->next!=NULL){
p=p->next;
n++;
}
if(n==num){
printf("%d\n",p->num);
}
else
printf("get fail\n");
}
int main(){
struct stu *head;
struct stu *stu1;
scanf("%d",&N);
head=creat();
//print(head);
head=reverse(head);
//print(head);
//int num;
int i,j;
//scanf("%d",&num);
//printf("%d\n",num);
char s[20];
int num1,num2;
for(i=0;i<num3;i++){
scanf("%s",s);
if(strcmp(s,"show")==0){
print(head);
}
else if(strcmp(s,"delete")==0){
scanf("%d",&num1);
head=del(head,num1);
}
else if(strcmp(s,"insert")==0){
stu1=(struct stu *)malloc(sizeof(struct stu));
scanf("%d %d",&num1,&(stu1->num));
head=insert(head,stu1,num1);
}
else if(strcmp(s,"get")==0){
scanf("%d",&num1);
gt(head,num1);
}
memset(s,'\0',sizeof(s));
}
return 0;
}
|
the_stack_data/277529.c | #include <sys/stat.h>
#include <fcntl.h>
#include <stdio.h>
#include <unistd.h>
// Learn very well for file descriptor and buffers !!!
int main(){
char buffer[20];
int fd = open("a.txt", O_RDONLY);
if (fd < 0){
perror("open");
return 1;
}
ssize_t read_return_value = read(fd, buffer, 20-1);
if (read_return_value < 0){
perror("read");
}
buffer[19] = '0';
printf("%s\n", buffer);
int close_return_value = close(fd);
if (close_return_value < 0){
perror("close");
return 2; // $.. echo $? vijdame kakvo returnva probramata
}
return 0;
}
//Not completed
|
the_stack_data/119048.c | /*
Anshul Verma, 19/78065
c) different programs
*/
#include <stdio.h>
#include <stdlib.h>
#include <unistd.h>
int main()
{
int a;
a = fork();
if (a < 0)
{
printf("child process could not be created");
exit(-1);
}
else if (a == 0)
{
execl("/bin/ls", "ls", NULL);
}
else
{
printf("Parent process : My ID is %d\n", getpid());
}
return 0;
} |
the_stack_data/1166011.c | #include <stdio.h>
#include <math.h>
/* Simple zero-phase filtering of a record */
int
filtrec(nsamp, samprate, data, hpfreq, lpfreq)
int nsamp;
double samprate;
float *data;
double hpfreq, lpfreq;
{
int length, i, j, nyquist;
float *result;
float df, phs, famp, frn;
double delta;
/* butterworth 3-pole coefficients */
float pr[3], pi[3];
int npole=3;
pr[0] = .5;
pr[1] = .5;
pr[2] = 1.;
pi[0] = .8660254;
pi[1] = -pi[0];
pi[2] = 0.;
fprintf(stderr, "..Using LPfilt %f and HPfilt %f\n",lpfreq, hpfreq);
delta = 1./samprate;
/* get next pwr of 2 */
length = nsamp;
for(i=1;((int)pow((double)2,(double)i)) < length;++i);
length=(int)pow((double)2,(double)(i+1));
if((result=(float *)calloc((unsigned)(length+2),sizeof(float))) == NULL)
{
fprintf(stderr,"Error allocating space for result in filtrec\n");
exit(-2);
}
for (i=0; i<nsamp; i++) result[i]=data[i];
for (i=nsamp; i<length+2; i++) result[i] = data[0];
cfftr(result, length);
df = 0.5/(delta * (float)length);
nyquist=1.0/(2.0*delta);
if (hpfreq > 0.) {
for(i=0, phs=0.;i<=length;i+=2, phs += df)
{
famp = 1.;
frn = phs/hpfreq;
for (j=0;j<npole; j++) famp *= frn*frn/(pr[j]*pr[j] + (frn + pi[j])*(frn+pi[j]));
/* famp = pow(phs*phs/(phs*phs+hpfreq*hpfreq), 3.); */
result[i] *= famp;
result[i+1] *= famp;
}
result[0] = 0.;
result[1] = 0.;
}
if (lpfreq > 0.) {
for(i=0, phs=0.;i<=length;i+=2, phs += df)
{
famp = 1.;
frn = phs/lpfreq;
for (j=0;j<npole; j++) famp *= 1./(pr[j]*pr[j] + (frn + pi[j])*(frn+pi[j]));
/* famp = pow(lpfreq*lpfreq/(phs*phs+lpfreq*lpfreq), 3.); */
result[i] *= famp;
result[i+1] *= famp;
}
}
cfftri(result, length);
for(i=0;i<nsamp;i++)data[i]=result[i]*(2.0/length); /* rescale */
free(result);
}
|
the_stack_data/798824.c | /* This testcase is part of GDB, the GNU debugger.
Copyright 2015-2019 Free Software Foundation, Inc.
This program is free software; you can redistribute it and/or modify
it under the terms of the GNU General Public License as published by
the Free Software Foundation; either version 3 of the License, or
(at your option) any later version.
This program is distributed in the hope that it will be useful,
but WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
GNU General Public License for more details.
You should have received a copy of the GNU General Public License
along with this program. If not, see <http://www.gnu.org/licenses/>. */
/*
Define TestStrings, TestStringsH, and TestStringsW to test utf8, utf16,
and utf32 strings respectively.
To avoid compile errors due to old compiler mode, we don't use string
literals. The content of each array is the same as followings:
const char TestStrings[] = {
"ABCD"
"EFGHIJKLMNOPQRSTUVWXYZ\0"
"\0"
"\0"
"\u307B\u3052\u307B\u3052\0"
"012345678901234567890123456789\0"
"!!!!!!\0"
};
*/
/* This is here just to ensure we have a null character before
TestStrings, to avoid showing garbage when we look for strings
backwards from TestStrings. */
const char Barrier[] = {
0x00,
};
const char TestStrings[] = {
0x41, 0x42, 0x43, 0x44, 0x45, 0x46, 0x47, 0x48,
0x49, 0x4a, 0x4b, 0x4c, 0x4d, 0x4e, 0x4f, 0x50,
0x51, 0x52, 0x53, 0x54, 0x55, 0x56, 0x57, 0x58,
0x59, 0x5a, 0x00, 0x00, 0x00, 0xe3, 0x81, 0xbb,
0xe3, 0x81, 0x92, 0xe3, 0x81, 0xbb, 0xe3, 0x81,
0x92, 0x00, 0x30, 0x31, 0x32, 0x33, 0x34, 0x35,
0x36, 0x37, 0x38, 0x39, 0x30, 0x31, 0x32, 0x33,
0x34, 0x35, 0x36, 0x37, 0x38, 0x39, 0x30, 0x31,
0x32, 0x33, 0x34, 0x35, 0x36, 0x37, 0x38, 0x39,
0x00, 0x21, 0x21, 0x21, 0x21, 0x21, 0x21, 0x00,
0x00
};
const short TestStringsH[] = {
0x0041, 0x0042, 0x0043, 0x0044, 0x0045, 0x0046, 0x0047, 0x0048,
0x0049, 0x004a, 0x004b, 0x004c, 0x004d, 0x004e, 0x004f, 0x0050,
0x0051, 0x0052, 0x0053, 0x0054, 0x0055, 0x0056, 0x0057, 0x0058,
0x0059, 0x005a, 0x0000, 0x0000, 0x0000, 0x307b, 0x3052, 0x307b,
0x3052, 0x0000, 0x0030, 0x0031, 0x0032, 0x0033, 0x0034, 0x0035,
0x0036, 0x0037, 0x0038, 0x0039, 0x0030, 0x0031, 0x0032, 0x0033,
0x0034, 0x0035, 0x0036, 0x0037, 0x0038, 0x0039, 0x0030, 0x0031,
0x0032, 0x0033, 0x0034, 0x0035, 0x0036, 0x0037, 0x0038, 0x0039,
0x0000, 0x0021, 0x0021, 0x0021, 0x0021, 0x0021, 0x0021, 0x0000,
0x0000
};
const int TestStringsW[] = {
0x00000041, 0x00000042, 0x00000043, 0x00000044,
0x00000045, 0x00000046, 0x00000047, 0x00000048,
0x00000049, 0x0000004a, 0x0000004b, 0x0000004c,
0x0000004d, 0x0000004e, 0x0000004f, 0x00000050,
0x00000051, 0x00000052, 0x00000053, 0x00000054,
0x00000055, 0x00000056, 0x00000057, 0x00000058,
0x00000059, 0x0000005a, 0x00000000, 0x00000000,
0x00000000, 0x0000307b, 0x00003052, 0x0000307b,
0x00003052, 0x00000000, 0x00000030, 0x00000031,
0x00000032, 0x00000033, 0x00000034, 0x00000035,
0x00000036, 0x00000037, 0x00000038, 0x00000039,
0x00000030, 0x00000031, 0x00000032, 0x00000033,
0x00000034, 0x00000035, 0x00000036, 0x00000037,
0x00000038, 0x00000039, 0x00000030, 0x00000031,
0x00000032, 0x00000033, 0x00000034, 0x00000035,
0x00000036, 0x00000037, 0x00000038, 0x00000039,
0x00000000, 0x00000021, 0x00000021, 0x00000021,
0x00000021, 0x00000021, 0x00000021, 0x00000000,
0x00000000
};
int
main (void)
{
/* Backward disassemble test requires at least 20 instructions in
this function. Adding a simple bubble sort. */
int i, j;
int n[] = {3, 1, 4, 1, 5, 9};
int len = sizeof (n) / sizeof (n[0]);
for (i = 0; i < len - 1; ++i)
{
for (j = i; j < len; ++j)
{
if (n[j] < n[i])
{
int tmp = n[i];
n[i] = n[j];
n[j] = tmp;
}
}
}
return 42;
}
|
the_stack_data/40763261.c | #include<stdio.h>
#define SIZE 10
void print(int* Arr){
int i;
for(i=0; i<SIZE; i++){
printf("%d ", Arr[i]);
}
}
void inputData(int* Arr){
int i;
for(i=0; i<SIZE; i++){
Arr[i] = i;
}
}
int main(){
int data[SIZE];
inputData(&data[0]);
print(&data[0]);
return 0;
} |
the_stack_data/131718.c | /* { dg-do compile } */
/* { dg-options "-O2 -ftree-loop-distribution -fdump-tree-ldist-all" } */
int foo (int * __restrict__ ia,
int * __restrict__ ib,
int * __restrict__ oxa,
int * __restrict__ oxb)
{
int i;
int oya[52], oyb[52];
for (i=0; i < 52; i++)
{
oya[i] = (ia[i] * oxa[i] + ib[i] * oxb[i]) >> 10;
oyb[i] = (-ia[i] * oxb[i] + ib[i] * oxa[i]) >> 10;
}
return oya[22] + oyb[21];
}
/* { dg-final { scan-tree-dump-times "distributed: split to 2 loops" 0 "ldist" } } */
|
the_stack_data/167330874.c | /*numPass=6, numTotal=6
Verdict:ACCEPTED, Visibility:1, Input:"10
1 2
1 3
1 4
2 3
2 4
5 1
5 2
5 3
5 4
6 1
1
", ExpOutput:"2
3
4
5
6
", Output:"2
3
4
5
6
"
Verdict:ACCEPTED, Visibility:1, Input:"4
1 2
2 3
3 4
4 5
4
", ExpOutput:"3
5
", Output:"3
5
"
Verdict:ACCEPTED, Visibility:1, Input:"13
0 4
0 7
0 10
1 8
1 9
3 6
3 10
4 8
4 10
5 9
6 9
7 10
8 10
8
", ExpOutput:"1
4
10
", Output:"1
4
10
"
Verdict:ACCEPTED, Visibility:1, Input:"1
1 1
2", ExpOutput:"", Output:""
Verdict:ACCEPTED, Visibility:0, Input:"325
0 44
0 59
0 100
1 71
1 72
1 93
1 96
1 100
2 14
2 86
2 98
2 99
3 43
3 47
3 87
3 99
4 28
4 49
4 94
4 99
5 60
5 93
5 99
6 74
6 86
6 87
6 88
6 92
6 93
6 100
7 30
7 85
7 89
7 98
7 99
10 20
10 98
10 100
11 63
11 81
11 100
12 58
12 77
12 87
12 89
12 94
12 99
13 60
13 90
13 91
13 93
13 95
13 98
13 100
14 78
14 80
15 86
15 100
16 72
16 90
16 95
17 63
17 92
17 93
17 97
17 98
17 100
18 80
18 95
18 98
18 100
19 68
19 86
19 93
19 95
19 98
19 100
20 64
20 100
21 42
21 75
21 94
21 99
22 91
22 97
22 99
23 78
23 97
23 99
24 50
24 76
24 83
24 100
25 38
25 84
25 88
25 98
25 100
26 49
26 88
26 94
26 99
27 50
27 98
27 100
28 49
28 74
28 99
29 42
29 76
29 77
29 90
29 99
30 46
30 80
30 89
30 100
31 70
31 98
31 99
32 76
32 81
32 95
32 99
33 64
33 94
33 100
34 57
34 71
34 95
34 96
34 98
34 99
35 42
35 49
35 72
35 97
35 98
35 99
36 43
36 67
36 100
37 51
37 91
37 96
37 99
38 43
38 48
38 57
38 76
38 83
38 88
38 92
38 94
38 97
38 100
39 76
39 89
39 99
40 76
40 87
40 97
40 99
41 51
41 100
42 93
42 95
42 99
43 60
43 61
43 100
44 81
44 87
44 93
44 95
45 66
45 88
45 94
45 97
45 98
45 100
46 84
46 98
46 99
47 96
47 97
47 98
47 100
48 100
49 79
49 99
50 78
50 81
50 90
50 95
50 99
51 65
51 76
51 83
51 84
51 99
52 95
52 96
52 97
52 98
52 100
53 99
54 91
55 84
55 89
55 96
55 97
55 98
55 100
56 60
56 91
56 99
57 69
57 100
58 88
58 96
58 97
58 99
59 89
59 90
59 91
59 97
60 61
60 99
61 97
61 98
61 100
62 86
62 88
63 74
63 91
63 94
63 97
63 98
63 100
64 66
64 98
64 99
65 88
65 94
65 95
65 98
65 100
66 72
66 88
66 94
66 98
66 99
67 75
67 96
67 100
68 91
68 93
68 96
68 100
69 70
69 89
69 93
69 97
69 98
69 99
70 92
70 98
70 100
72 95
72 100
73 92
73 93
73 96
73 97
73 100
74 81
74 96
74 98
74 100
75 88
75 91
75 100
76 92
76 98
76 100
77 90
77 99
78 86
78 100
79 80
79 85
79 98
79 99
80 92
80 97
80 100
81 94
81 98
81 99
82 90
82 93
82 98
82 100
83 84
83 100
84 100
85 97
85 100
86 95
86 98
86 99
87 88
87 89
87 95
87 100
88 92
88 99
90 95
90 98
90 99
91 95
91 100
95 99
96 99
91
", ExpOutput:"13
22
37
54
56
59
63
68
75
95
100
", Output:"13
22
37
54
56
59
63
68
75
95
100
"
Verdict:ACCEPTED, Visibility:0, Input:"325
32000 32044
32000 32059
32000 32100
32001 32071
32001 32072
32001 32093
32001 32096
32001 32100
32002 32014
32002 32086
32002 32098
32002 32099
32003 32043
32003 32047
32003 32087
32003 32099
32004 32028
32004 32049
32004 32094
32004 32099
32005 32060
32005 32093
32005 32099
32006 32074
32006 32086
32006 32087
32006 32088
32006 32092
32006 32093
32006 32100
32007 32030
32007 32085
32007 32089
32007 32098
32007 32099
32010 32020
32010 32098
32010 32100
32011 32063
32011 32081
32011 32100
32012 32058
32012 32077
32012 32087
32012 32089
32012 32094
32012 32099
32013 32060
32013 32090
32013 32091
32013 32093
32013 32095
32013 32098
32013 32100
32014 32078
32014 32080
32015 32086
32015 32100
32016 32072
32016 32090
32016 32095
32017 32063
32017 32092
32017 32093
32017 32097
32017 32098
32017 32100
32018 32080
32018 32095
32018 32098
32018 32100
32019 32068
32019 32086
32019 32093
32019 32095
32019 32098
32019 32100
32020 32064
32020 32100
32021 32042
32021 32075
32021 32094
32021 32099
32022 32091
32022 32097
32022 32099
32023 32078
32023 32097
32023 32099
32024 32050
32024 32076
32024 32083
32024 32100
32025 32038
32025 32084
32025 32088
32025 32098
32025 32100
32026 32049
32026 32088
32026 32094
32026 32099
32027 32050
32027 32098
32027 32100
32028 32049
32028 32074
32028 32099
32029 32042
32029 32076
32029 32077
32029 32090
32029 32099
32030 32046
32030 32080
32030 32089
32030 32100
32031 32070
32031 32098
32031 32099
32032 32076
32032 32081
32032 32095
32032 32099
32033 32064
32033 32094
32033 32100
32034 32057
32034 32071
32034 32095
32034 32096
32034 32098
32034 32099
32035 32042
32035 32049
32035 32072
32035 32097
32035 32098
32035 32099
32036 32043
32036 32067
32036 32100
32037 32051
32037 32091
32037 32096
32037 32099
32038 32043
32038 32048
32038 32057
32038 32076
32038 32083
32038 32088
32038 32092
32038 32094
32038 32097
32038 32100
32039 32076
32039 32089
32039 32099
32040 32076
32040 32087
32040 32097
32040 32099
32041 32051
32041 32100
32042 32093
32042 32095
32042 32099
32043 32060
32043 32061
32043 32100
32044 32081
32044 32087
32044 32093
32044 32095
32045 32066
32045 32088
32045 32094
32045 32097
32045 32098
32045 32100
32046 32084
32046 32098
32046 32099
32047 32096
32047 32097
32047 32098
32047 32100
32048 32100
32049 32079
32049 32099
32050 32078
32050 32081
32050 32090
32050 32095
32050 32099
32051 32065
32051 32076
32051 32083
32051 32084
32051 32099
32052 32095
32052 32096
32052 32097
32052 32098
32052 32100
32053 32099
32054 32091
32055 32084
32055 32089
32055 32096
32055 32097
32055 32098
32055 32100
32056 32060
32056 32091
32056 32099
32057 32069
32057 32100
32058 32088
32058 32096
32058 32097
32058 32099
32059 32089
32059 32090
32059 32091
32059 32097
32060 32061
32060 32099
32061 32097
32061 32098
32061 32100
32062 32086
32062 32088
32063 32074
32063 32091
32063 32094
32063 32097
32063 32098
32063 32100
32064 32066
32064 32098
32064 32099
32065 32088
32065 32094
32065 32095
32065 32098
32065 32100
32066 32072
32066 32088
32066 32094
32066 32098
32066 32099
32067 32075
32067 32096
32067 32100
32068 32091
32068 32093
32068 32096
32068 32100
32069 32070
32069 32089
32069 32093
32069 32097
32069 32098
32069 32099
32070 32092
32070 32098
32070 32100
32072 32095
32072 32100
32073 32092
32073 32093
32073 32096
32073 32097
32073 32100
32074 32081
32074 32096
32074 32098
32074 32100
32075 32088
32075 32091
32075 32100
32076 32092
32076 32098
32076 32100
32077 32090
32077 32099
32078 32086
32078 32100
32079 32080
32079 32085
32079 32098
32079 32099
32080 32092
32080 32097
32080 32100
32081 32094
32081 32098
32081 32099
32082 32090
32082 32093
32082 32098
32082 32100
32083 32084
32083 32100
32084 32100
32085 32097
32085 32100
32086 32095
32086 32098
32086 32099
32087 32088
32087 32089
32087 32095
32087 32100
32088 32092
32088 32099
32090 32095
32090 32098
32090 32099
32091 32095
32091 32100
32095 32099
32096 32099
32091
", ExpOutput:"32013
32022
32037
32054
32056
32059
32063
32068
32075
32095
32100
", Output:"32013
32022
32037
32054
32056
32059
32063
32068
32075
32095
32100
"
*/
#include <stdio.h>
#include <stdlib.h>
/*struct node{
int vertex;
struct node *next;
};
struct list_entry{
struct node *head;
struct node *tail;
};
struct list_entry list_entries[34000];
void init_list_entries()
{ for(int i=0;i<34000;i++)
{
}
// initialized the list_entries array
}
struct node * make_node ( int data )
{
// makes a new node with data as its value
}
void insert_at_end(int a, int b)
{
// code to insert "b" as neighbor "a"
// code to insert "a" as neighbor "b"
}
void print_adjacent_vertices_of(int n)
{
// code to print adjacency list of the vertix number "n"
}
*/
struct point{
int x;
int y;
};
int main()
{int n,d1,d2;
scanf("%d",&n);
struct point pts[n];
int i,last;
for (i= 0; i<n; i++){
scanf("%d %d\n",&d1,&d2);
pts[i].x=d1;
pts[i].y=d2;
}
scanf("%d",&last);
for(i=0;i<n;i++)
{if(pts[i].x==last)
printf("%d\n",pts[i].y);
if(pts[i].y==last)
printf("%d\n",pts[i].x);
}
// complete code
} |
the_stack_data/212642784.c | #include <stdio.h>
#include <stdlib.h>
int main()
{
int i;
sb:
i=42;
i=i+5;
i = i*3;
se:
i = i+4;
return i;
}
|
the_stack_data/150142783.c | /**
* @license Apache-2.0
*
* Copyright (c) 2018 The Stdlib Authors.
*
* 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.
*/
/**
* Benchmark `sinh`.
*/
#include <stdlib.h>
#include <stdio.h>
#include <math.h>
#include <sys/time.h>
#define NAME "sinh"
#define ITERATIONS 1000000
#define REPEATS 3
/**
* Prints the TAP version.
*/
void print_version() {
printf( "TAP version 13\n" );
}
/**
* Prints the TAP summary.
*
* @param total total number of tests
* @param passing total number of passing tests
*/
void print_summary( int total, int passing ) {
printf( "#\n" );
printf( "1..%d\n", total ); // TAP plan
printf( "# total %d\n", total );
printf( "# pass %d\n", passing );
printf( "#\n" );
printf( "# ok\n" );
}
/**
* Prints benchmarks results.
*
* @param elapsed elapsed time in seconds
*/
void print_results( double elapsed ) {
double rate = (double)ITERATIONS / elapsed;
printf( " ---\n" );
printf( " iterations: %d\n", ITERATIONS );
printf( " elapsed: %0.9f\n", elapsed );
printf( " rate: %0.9f\n", rate );
printf( " ...\n" );
}
/**
* Returns a clock time.
*
* @return clock time
*/
double tic() {
struct timeval now;
gettimeofday( &now, NULL );
return (double)now.tv_sec + (double)now.tv_usec/1.0e6;
}
/**
* Generates a random double on the interval [0,1].
*
* @return random double
*/
double rand_double() {
int r = rand();
return (double)r / ( (double)RAND_MAX + 1.0 );
}
/**
* Runs a benchmark.
*
* @return elapsed time in seconds
*/
double benchmark() {
double elapsed;
double x;
double y;
double t;
int i;
t = tic();
for ( i = 0; i < ITERATIONS; i++ ) {
x = ( 10.0 * rand_double() ) - 5.0;
y = sinh( x );
if ( y != y ) {
printf( "should not return NaN\n" );
break;
}
}
elapsed = tic() - t;
if ( y != y ) {
printf( "should not return NaN\n" );
}
return elapsed;
}
/**
* Main execution sequence.
*/
int main( void ) {
double elapsed;
int i;
// Use the current time to seed the random number generator:
srand( time( NULL ) );
print_version();
for ( i = 0; i < REPEATS; i++ ) {
printf( "# c::%s\n", NAME );
elapsed = benchmark();
print_results( elapsed );
printf( "ok %d benchmark finished\n", i+1 );
}
print_summary( REPEATS, REPEATS );
}
|
the_stack_data/38121.c | // REQUIRES: x86-registered-target
// System directory and sysroot option causes warning.
// RUN: %clang -Wpoison-system-directories -target x86_64 -I/usr/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s 2> %t.1.stderr
// RUN: FileCheck -check-prefix=WARN < %t.1.stderr %s
// RUN: %clang -Wpoison-system-directories -target x86_64 -cxx-isystem/usr/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s 2> %t.1.stderr
// RUN: FileCheck -check-prefix=WARN < %t.1.stderr %s
// RUN: %clang -Wpoison-system-directories -target x86_64 -iquote/usr/local/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s 2> %t.1.stderr
// RUN: FileCheck -check-prefix=WARN < %t.1.stderr %s
// RUN: %clang -Wpoison-system-directories -target x86_64 -isystem/usr/local/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s 2> %t.1.stderr
// RUN: FileCheck -check-prefix=WARN < %t.1.stderr %s
// Missing target but included sysroot still causes the warning.
// RUN: %clang -Wpoison-system-directories -I/usr/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s 2> %t.2.stderr
// RUN: FileCheck -check-prefix=WARN < %t.2.stderr %s
// With -Werror the warning causes the failure.
// RUN: not %clang -Werror=poison-system-directories -target x86_64 -I/usr/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s 2> %t.3.stderr
// RUN: FileCheck -check-prefix=ERROR < %t.3.stderr %s
// Cros target without sysroot causes no warning.
// RUN: %clang -Wpoison-system-directories -Werror -target x86_64 -I/usr/include -c -o - %s
// By default the warning is off.
// RUN: %clang -Werror -target x86_64 -I/usr/include --sysroot %S/Inputs/sysroot_x86_64_cross_linux_tree -c -o - %s
// WARN: warning: include location {{[^ ]+}} is unsafe for cross-compilation [-Wpoison-system-directories]
// ERROR: error: include location {{[^ ]+}} is unsafe for cross-compilation [-Werror,-Wpoison-system-directories]
|
the_stack_data/97963.c | #include<stdio.h>
int main()
{
int n,t,i,k;
scanf("%d",&t);
for(i=1;i<=t;i++)
{
scanf("%d",&n);
k=n%8;
switch(k)
{
case 1:printf("%dLB\n",n+3); break;
case 2:printf("%dMB\n",n+3); break;
case 3:printf("%dUB\n",n+3); break;
case 4:printf("%dLB\n",n-3); break;
case 5:printf("%dMB\n",n-3); break;
case 6:printf("%dUB\n",n-3); break;
case 7:printf("%dSU\n",n+1); break;
case 0:printf("%dSL\n",n-1); break;
}
}
return 0;
} |
the_stack_data/130490.c | /***********************************************************************
vmtouch - the Virtual Memory Toucher
Portable file system cache diagnostics and control
by Doug Hoyte ([email protected])
Compilation:
gcc -Wall -O3 -o vmtouch vmtouch.c
************************************************************************
Copyright (c) 2009-2017 Doug Hoyte and contributors. All rights reserved.
Redistribution and use in source and binary forms, with or without
modification, are permitted provided that the following conditions
are met:
1. Redistributions of source code must retain the above copyright
notice, this list of conditions and the following disclaimer.
2. Redistributions in binary form must reproduce the above copyright
notice, this list of conditions and the following disclaimer in the
documentation and/or other materials provided with the distribution.
3. The name of the author may not be used to endorse or promote products
derived from this software without specific prior written permission.
THIS SOFTWARE IS PROVIDED BY THE AUTHOR ``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 AUTHOR 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.
***********************************************************************/
#define VMTOUCH_VERSION "1.3.1"
#define RESIDENCY_CHART_WIDTH 32
#define CHART_UPDATE_INTERVAL 0.1
#define MAX_CRAWL_DEPTH 1024
#define MAX_NUMBER_OF_IGNORES 1024
#define MAX_NUMBER_OF_FILENAME_FILTERS 1024
#define MAX_FILENAME_LENGTH 1024
#if defined(__linux__) || (defined(__hpux) && !defined(__LP64__))
// Make sure off_t is 64 bits on linux and when creating 32bit programs
// on HP-UX.
#define _FILE_OFFSET_BITS 64
#endif
#ifdef __linux__
// Required for posix_fadvise() on some linux systems
#define _XOPEN_SOURCE 600
// Required for mincore() on some linux systems
#define _DEFAULT_SOURCE
#define _BSD_SOURCE
// for O_NOATIME
#define _GNU_SOURCE
#endif
#include <stdio.h>
#include <string.h>
#include <unistd.h>
#include <stdlib.h>
#include <ctype.h>
#include <stdarg.h>
#include <stdint.h>
#include <time.h>
#include <signal.h>
#include <sys/select.h>
#include <sys/types.h>
#include <sys/stat.h>
#include <sys/time.h>
#include <sys/resource.h>
#include <sys/mman.h>
#include <sys/wait.h>
#include <limits.h>
#include <inttypes.h>
#include <dirent.h>
#include <errno.h>
#include <fcntl.h>
#include <math.h>
#include <search.h>
#include <libgen.h>
#include <fnmatch.h>
#if defined(__linux__)
// Used to find size of block devices
#include <sys/ioctl.h>
#include <sys/mount.h>
// Used to check kernal version to know if mincore reports correctly
#include <sys/utsname.h>
#endif
/*
* To find out if the stat results from a single file correspond to a file we
* have already seen, we need to compare both the device and the inode
*/
struct dev_and_inode
{
dev_t dev;
ino_t ino;
};
long pagesize;
int64_t total_pages=0;
int64_t total_pages_in_core=0;
int64_t total_files=0;
int64_t total_dirs=0;
int64_t offset=0;
int64_t max_len=0;
unsigned int junk_counter; // just to prevent any compiler optimizations
int curr_crawl_depth=0;
ino_t crawl_inodes[MAX_CRAWL_DEPTH];
// remember all inodes (for files with inode count > 1) to find duplicates
void *seen_inodes = NULL;
dev_t orig_device = 0;
int orig_device_inited = 0;
int o_touch=0;
int o_evict=0;
int o_quiet=0;
int o_verbose=0;
int o_lock=0;
int o_lockall=0;
int o_daemon=0;
int o_followsymlinks=0;
int o_singlefilesystem=0;
int o_ignorehardlinkeduplictes=0;
size_t o_max_file_size=SIZE_MAX;
int o_wait=0;
static char *o_batch = NULL;
static char *o_pidfile = NULL;
static char *o_output = NULL;
int o_0_delim = 0;
char *ignore_list[MAX_NUMBER_OF_IGNORES];
char *filename_filter_list[MAX_NUMBER_OF_FILENAME_FILTERS];
int number_of_ignores=0;
int number_of_filename_filters=0;
int exit_pipe[2];
int daemon_pid;
void send_exit_signal(char code) {
if (daemon_pid == 0 && o_wait) {
if (write(exit_pipe[1], &code, 1) < 0)
fprintf(stderr, "vmtouch: FATAL: write: %s", strerror(errno));
}
}
void usage() {
printf("\n");
printf("vmtouch v%s - the Virtual Memory Toucher by Doug Hoyte\n", VMTOUCH_VERSION);
printf("Portable file system cache diagnostics and control\n\n");
printf("Usage: vmtouch [OPTIONS] ... FILES OR DIRECTORIES ...\n\nOptions:\n");
printf(" -t touch pages into memory\n");
printf(" -e evict pages from memory\n");
printf(" -l lock pages in physical memory with mlock(2)\n");
printf(" -L lock pages in physical memory with mlockall(2)\n");
printf(" -d daemon mode\n");
printf(" -m <size> max file size to touch\n");
printf(" -p <range> use the specified portion instead of the entire file\n");
printf(" -f follow symbolic links\n");
printf(" -F don't crawl different filesystems\n");
printf(" -h also count hardlinked copies\n");
printf(" -i <pattern> ignores files and directories that match this pattern\n");
printf(" -I <pattern> only process files that match this pattern\n");
printf(" -b <list file> get files or directories from the list file\n");
printf(" -0 in batch mode (-b) separate paths with NUL byte instead of newline\n");
printf(" -w wait until all pages are locked (only useful together with -d)\n");
printf(" -P <pidfile> write a pidfile (only useful together with -l or -L)\n");
printf(" -o <type> output in machine friendly format. 'kv' for key=value pairs.\n");
printf(" -v verbose\n");
printf(" -q quiet\n");
exit(1);
}
static void fatal(const char *fmt, ...) {
va_list ap;
char buf[4096];
va_start(ap, fmt);
vsnprintf(buf, sizeof(buf), fmt, ap);
va_end(ap);
fprintf(stderr, "vmtouch: FATAL: %s\n", buf);
send_exit_signal(1);
exit(1);
}
static void warning(const char *fmt, ...) {
va_list ap;
char buf[4096];
va_start(ap, fmt);
vsnprintf(buf, sizeof(buf), fmt, ap);
va_end(ap);
if (!o_quiet) fprintf(stderr, "vmtouch: WARNING: %s\n", buf);
}
static void reopen_all() {
if (freopen("/dev/null", "r", stdin) == NULL ||
freopen("/dev/null", "w", stdout) == NULL ||
freopen("/dev/null", "w", stdout) == NULL)
fatal("freopen: %s", strerror(errno));
}
static int wait_for_child() {
int exit_read = 0;
char exit_value = 0;
int wait_status;
while (1) {
struct timeval tv;
fd_set rfds;
FD_ZERO(&rfds);
tv.tv_sec = 1;
tv.tv_usec = 0;
FD_SET(exit_pipe[0], &rfds);
if (select(exit_pipe[0] + 1, &rfds, NULL, NULL, &tv) < 0)
fatal("select: %s", strerror(errno));
if (waitpid(daemon_pid, &wait_status, WNOHANG) > 0)
fatal("daemon shut down unexpectedly");
if (FD_ISSET(exit_pipe[0], &rfds))
break;
}
exit_read = read(exit_pipe[0], &exit_value, 1);
if (exit_read < 0)
fatal("read: %s", strerror(errno));
return exit_value;
}
void go_daemon() {
daemon_pid = fork();
if (daemon_pid == -1)
fatal("fork: %s", strerror(errno));
if (daemon_pid) {
if (o_wait)
exit(wait_for_child());
exit(0);
}
if (setsid() == -1)
fatal("setsid: %s", strerror(errno));
if (!o_wait) reopen_all();
}
char *pretty_print_size(int64_t inp) {
static char output[100];
if (inp<1024) {
snprintf(output, sizeof(output), "%" PRId64, inp);
return output;
}
inp /= 1024;
if (inp<1024) {
snprintf(output, sizeof(output), "%" PRId64 "K", inp);
return output;
}
inp /= 1024;
if (inp<1024) {
snprintf(output, sizeof(output), "%" PRId64 "M", inp);
return output;
}
inp /= 1024;
snprintf(output, sizeof(output), "%" PRId64 "G", inp);
return output;
}
/*
* Convert ASCII string to int64_t number
* Note: The inp parameter can't be a character constant
* because it will be overwritten.
*/
int64_t parse_size(char *inp) {
char *tp;
int len=strlen(inp);
char *errstr = "bad size. examples: 4096, 4k, 100M, 1.5G";
char mult_char;
int mult=1;
double val;
if (len < 1) fatal(errstr);
mult_char = tolower(inp[len-1]);
if (isalpha(mult_char)) {
switch(mult_char) {
case 'k': mult = 1024; break;
case 'm': mult = 1024*1024; break;
case 'g': mult = 1024*1024*1024; break;
default: fatal("unknown size multiplier: %c", mult_char);
}
inp[len-1] = '\0';
}
val = strtod(inp, &tp);
if (val < 0 || val == HUGE_VAL || *tp != '\0') fatal(errstr);
val *= mult;
if (val > INT64_MAX) fatal(errstr);
return (int64_t) val;
}
int64_t bytes2pages(int64_t bytes) {
return (bytes+pagesize-1) / pagesize;
}
void parse_range(char *inp) {
char *token;
int64_t upper_range=0;
int64_t lower_range=0;
token = strsep(&inp,"-");
if (inp == NULL)
upper_range = parse_size(token); // single value provided
else {
if (*token != '\0')
lower_range = parse_size(token); // value before hyphen
token = strsep(&inp,"-");
if (*token != '\0')
upper_range = parse_size(token); // value after hyphen
if ((token = strsep(&inp,"-")) != NULL) fatal("malformed range: multiple hyphens");
}
// offset must be multiple of pagesize
offset = (lower_range / pagesize) * pagesize;
if (upper_range) {
if (upper_range <= offset) fatal("range limits out of order");
max_len = upper_range - offset;
}
}
void parse_ignore_item(char *inp) {
if (inp == NULL) {
return;
}
if (strlen(inp) > MAX_FILENAME_LENGTH) {
fatal("too long pattern provided to -i: %s", inp);
return;
}
if (number_of_ignores >= MAX_NUMBER_OF_IGNORES) {
fatal("too many patterns passed to -i. Max is %d", MAX_NUMBER_OF_IGNORES);
return;
}
ignore_list[number_of_ignores] = strdup(inp);
number_of_ignores++;
}
void parse_filename_filter_item(char *inp) {
if (inp == NULL) {
return;
}
if (strlen(inp) > MAX_FILENAME_LENGTH) {
fatal("too long pattern provided to -I: %s", inp);
return;
}
if (number_of_filename_filters >= MAX_NUMBER_OF_FILENAME_FILTERS) {
fatal("too many patterns passed to -I. Max is %d", MAX_NUMBER_OF_FILENAME_FILTERS);
return;
}
filename_filter_list[number_of_filename_filters] = strdup(inp);
number_of_filename_filters++;
}
int aligned_p(void *p) {
return 0 == ((long)p & (pagesize-1));
}
int is_mincore_page_resident(char p) {
return p & 0x1;
}
void increment_nofile_rlimit() {
struct rlimit r;
if (getrlimit(RLIMIT_NOFILE, &r))
fatal("increment_nofile_rlimit: getrlimit (%s)", strerror(errno));
r.rlim_cur = r.rlim_max + 1;
r.rlim_max = r.rlim_max + 1;
if (setrlimit(RLIMIT_NOFILE, &r)) {
if (errno == EPERM) {
if (getuid() == 0 || geteuid() == 0) fatal("system open file limit reached");
fatal("open file limit reached and unable to increase limit. retry as root");
}
fatal("increment_nofile_rlimit: setrlimit (%s)", strerror(errno));
}
}
double gettimeofday_as_double() {
struct timeval tv;
gettimeofday(&tv, NULL);
return tv.tv_sec + (tv.tv_usec/1000000.0);
}
void print_page_residency_chart(FILE *out, char *mincore_array, int64_t pages_in_file) {
int64_t pages_in_core=0;
int64_t pages_per_char;
int64_t i,j=0;
if (pages_in_file <= RESIDENCY_CHART_WIDTH) pages_per_char = pages_in_file;
else pages_per_char = RESIDENCY_CHART_WIDTH;
for (i=0; i<pages_in_file; i++) {
if (!j)
fprintf(out, "\n[");
if (is_mincore_page_resident(mincore_array[i])) {
pages_in_core++;
fprintf(out, "O");
} else
fprintf(out, " ");
j++;
if (j == pages_per_char) {
j = 0;
fprintf(out, "] #%" PRId64 " - #%" PRId64, i + 1 - pages_per_char, i);
}
}
if (j)
fprintf(out, "] #%" PRId64 " - #%" PRId64, i + 1 - pages_per_char, i);
fflush(out);
}
#ifdef __linux__
// check if mincore will report correctly, due side-channel vulnerabilities
// from 5.2+ it only reports if process has write permission to the file
// https://lwn.net/Articles/778437/
static int can_do_mincore(struct stat *st) {
struct utsname utsinfo;
if (uname(&utsinfo) == 0) {
unsigned long ver[16];
int i=0;
char *p = utsinfo.release;
while (*p) {
if (isdigit(*p)) {
ver[i] = strtol(p, &p, 10);
i++;
} else {
p++;
}
}
// kernal < 5.2
if (ver[0]<5||ver[1]<2)
return 1;
}
uid_t uid = getuid();
return st->st_uid == uid ||
(st->st_gid == getgid() && (st->st_mode&S_IWGRP)) ||
(st->st_mode&S_IWOTH) ||
uid == 0;
}
#endif
void vmtouch_file(char *path) {
int fd = -1;
void *mem = NULL;
struct stat sb;
int64_t len_of_file=0;
int64_t len_of_range=0;
int64_t pages_in_range;
int i;
int res;
int open_flags;
retry_open:
open_flags = O_RDONLY;
#if defined(O_NOATIME)
open_flags |= O_NOATIME;
#endif
fd = open(path, open_flags, 0);
#if defined(O_NOATIME)
if (fd == -1 && errno == EPERM) {
open_flags &= ~O_NOATIME;
fd = open(path, open_flags, 0);
}
#endif
if (fd == -1) {
if (errno == ENFILE || errno == EMFILE) {
increment_nofile_rlimit();
goto retry_open;
}
warning("unable to open %s (%s), skipping", path, strerror(errno));
goto bail;
}
res = fstat(fd, &sb);
if (res) {
warning("unable to fstat %s (%s), skipping", path, strerror(errno));
goto bail;
}
if (S_ISBLK(sb.st_mode)) {
#if defined(__linux__)
if (ioctl(fd, BLKGETSIZE64, &len_of_file)) {
warning("unable to ioctl %s (%s), skipping", path, strerror(errno));
goto bail;
}
#else
fatal("discovering size of block devices not (yet?) supported on this platform");
#endif
} else {
len_of_file = sb.st_size;
}
if (len_of_file == 0) {
goto bail;
}
if (len_of_file > o_max_file_size) {
warning("file %s too large, skipping", path);
goto bail;
}
if (max_len > 0 && (offset + max_len) < len_of_file) {
len_of_range = max_len;
} else if (offset >= len_of_file) {
warning("file %s smaller than offset, skipping", path);
goto bail;
} else {
len_of_range = len_of_file - offset;
}
mem = mmap(NULL, len_of_range, PROT_READ, MAP_SHARED, fd, offset);
if (mem == MAP_FAILED) {
warning("unable to mmap file %s (%s), skipping", path, strerror(errno));
goto bail;
}
if (!aligned_p(mem)) fatal("mmap(%s) wasn't page aligned", path);
pages_in_range = bytes2pages(len_of_range);
total_pages += pages_in_range;
if (o_evict) {
if (o_verbose) printf("Evicting %s\n", path);
#if defined(__linux__) || defined(__hpux)
if (posix_fadvise(fd, offset, len_of_range, POSIX_FADV_DONTNEED))
warning("unable to posix_fadvise file %s (%s)", path, strerror(errno));
#elif defined(__FreeBSD__) || defined(__sun__) || defined(__APPLE__)
if (msync(mem, len_of_range, MS_INVALIDATE))
warning("unable to msync invalidate file %s (%s)", path, strerror(errno));
#else
fatal("cache eviction not (yet?) supported on this platform");
#endif
} else {
double last_chart_print_time=0.0, temp_time;
char *mincore_array = malloc(pages_in_range);
if (mincore_array == NULL) fatal("Failed to allocate memory for mincore array (%s)", strerror(errno));
// 3rd arg to mincore is char* on BSD and unsigned char* on linux
if (mincore(mem, len_of_range, (void*)mincore_array)) fatal("mincore %s (%s)", path, strerror(errno));
for (i=0; i<pages_in_range; i++) {
if (is_mincore_page_resident(mincore_array[i])) {
total_pages_in_core++;
}
}
if (o_verbose) {
printf("%s\n", path);
#ifdef __linux__
if (!can_do_mincore(&sb)) {
warning("Process does not have write permission, residency chart will not be accurate");
}
#endif
last_chart_print_time = gettimeofday_as_double();
}
if (o_touch) {
for (i=0; i<pages_in_range; i++) {
junk_counter += ((char*)mem)[i*pagesize];
mincore_array[i] = 1;
if (o_verbose) {
temp_time = gettimeofday_as_double();
if (temp_time > (last_chart_print_time+CHART_UPDATE_INTERVAL)) {
last_chart_print_time = temp_time;
print_page_residency_chart(stdout, mincore_array, pages_in_range);
}
}
}
}
if (o_verbose) {
print_page_residency_chart(stdout, mincore_array, pages_in_range);
printf("\n");
}
free(mincore_array);
}
if (o_lock) {
if (mlock(mem, len_of_range))
fatal("mlock: %s (%s)", path, strerror(errno));
}
bail:
if (!o_lock && !o_lockall && mem) {
if (munmap(mem, len_of_range)) warning("unable to munmap file %s (%s)", path, strerror(errno));
}
if (fd != -1) {
close(fd);
}
}
// compare device and inode information
int compare_func(const void *p1, const void *p2)
{
const struct dev_and_inode *kp1 = p1, *kp2 = p2;
int cmp1;
cmp1 = (kp1->ino > kp2->ino) - (kp1->ino < kp2->ino);
if (cmp1 != 0)
return cmp1;
return (kp1->dev > kp2->dev) - (kp1->dev < kp2->dev);
}
// add device and inode information to the tree of known inodes
static inline void add_object (struct stat *st)
{
struct dev_and_inode *newp = malloc (sizeof (struct dev_and_inode));
if (newp == NULL) {
fatal("malloc: out of memory");
}
newp->dev = st->st_dev;
newp->ino = st->st_ino;
if (tsearch(newp, &seen_inodes, compare_func) == NULL) {
fatal("tsearch: out of memory");
}
}
int is_ignored(const char* path) {
char *path_copy;
int match, i;
if (!number_of_ignores) return 0;
path_copy = strdup(path);
match = 0;
char *filename = basename(path_copy);
for (i = 0; i < number_of_ignores; i++) {
if (fnmatch(ignore_list[i], filename, 0) == 0) {
match = 1;
break;
}
}
free(path_copy);
return match;
}
int is_filename_filtered(const char* path) {
char *path_copy;
int match, i;
if (!number_of_filename_filters) return 1;
path_copy = strdup(path);
match = 0;
char *filename = basename(path_copy);
for (i = 0; i < number_of_filename_filters; i++) {
if (fnmatch(filename_filter_list[i], filename, 0) == 0) {
match = 1;
break;
}
}
free(path_copy);
return match;
}
// return true only if the device and inode information has not been added before
static inline int find_object(struct stat *st)
{
struct dev_and_inode obj;
void *res;
obj.dev = st->st_dev;
obj.ino = st->st_ino;
res = (void *) tfind(&obj, &seen_inodes, compare_func);
return res != (void *) NULL;
}
void vmtouch_crawl(char *path) {
struct stat sb;
DIR *dirp;
struct dirent *de;
char npath[PATH_MAX];
int res;
int tp_path_len = strlen(path);
int i;
if (path[tp_path_len-1] == '/' && tp_path_len > 1) path[tp_path_len-1] = '\0'; // prevent ugly double slashes when printing path names
if (is_ignored(path)) {
return;
}
res = o_followsymlinks ? stat(path, &sb) : lstat(path, &sb);
if (res) {
warning("unable to stat %s (%s)", path, strerror(errno));
return;
} else {
if (S_ISLNK(sb.st_mode)) {
warning("not following symbolic link %s", path);
return;
}
if (o_singlefilesystem) {
if (!orig_device_inited) {
orig_device = sb.st_dev;
orig_device_inited = 1;
} else {
if (sb.st_dev != orig_device) {
warning("not recursing into separate filesystem %s", path);
return;
}
}
}
if (!o_ignorehardlinkeduplictes && sb.st_nlink > 1) {
/*
* For files with more than one link to it, ignore it if we already know
* inode. Without this check files copied as hardlinks (cp -al) are
* counted twice (which may lead to a cache usage of more than 100% of
* RAM).
*/
if (find_object(&sb)) {
// we already saw the device and inode referenced by this file
return;
} else {
add_object(&sb);
}
}
if (S_ISDIR(sb.st_mode)) {
for (i=0; i<curr_crawl_depth; i++) {
if (crawl_inodes[i] == sb.st_ino) {
warning("symbolic link loop detected: %s", path);
return;
}
}
if (curr_crawl_depth == MAX_CRAWL_DEPTH)
fatal("maximum directory crawl depth reached: %s", path);
total_dirs++;
crawl_inodes[curr_crawl_depth] = sb.st_ino;
retry_opendir:
dirp = opendir(path);
if (dirp == NULL) {
if (errno == ENFILE || errno == EMFILE) {
increment_nofile_rlimit();
goto retry_opendir;
}
warning("unable to opendir %s (%s), skipping", path, strerror(errno));
return;
}
while((de = readdir(dirp)) != NULL) {
if (strcmp(de->d_name, ".") == 0 || strcmp(de->d_name, "..") == 0) continue;
if (snprintf(npath, sizeof(npath), "%s/%s", path, de->d_name) >= sizeof(npath)) {
warning("path too long %s", path);
goto bail;
}
curr_crawl_depth++;
vmtouch_crawl(npath);
curr_crawl_depth--;
}
bail:
if (closedir(dirp)) {
warning("unable to closedir %s (%s)", path, strerror(errno));
return;
}
} else if (S_ISLNK(sb.st_mode)) {
warning("not following symbolic link %s", path);
return;
} else if (S_ISREG(sb.st_mode) || S_ISBLK(sb.st_mode)) {
if (is_filename_filtered(path)) {
total_files++;
vmtouch_file(path);
}
} else {
warning("skipping non-regular file: %s", path);
}
}
}
static void vmtouch_batch_crawl(const char *path) {
FILE *f;
char *line = NULL;
size_t len = 0;
ssize_t read;
int delim = o_0_delim ? '\0' : '\n';
if (!strcmp(path, "-")) {
f = stdin;
} else {
f = fopen(path, "r");
if (!f) {
warning("unable to open %s (%s), skipping", path, strerror(errno));
return;
}
}
while ((read = getdelim(&line, &len, delim, f)) != -1) {
// strip the newline character
line[read-1] = '\0';
vmtouch_crawl(line);
}
free(line);
fclose(f);
}
static void remove_pidfile() {
int res = 0;
res = unlink(o_pidfile);
if (res < 0 && errno != ENOENT) {
warning("unable to remove pidfile %s (%s)", o_pidfile, strerror(errno));
}
}
static void write_pidfile() {
FILE *f = NULL;
size_t wrote = 0;
f = fopen(o_pidfile, "w");
if (!f) {
warning("unable to open pidfile %s (%s), skipping", o_pidfile, strerror(errno));
return;
}
wrote = fprintf(f, "%d\n", getpid());
fclose(f);
if (wrote < 0) {
warning("unable to write to pidfile %s (%s), deleting it", o_pidfile, strerror(errno));
remove_pidfile();
}
}
static void signal_handler_clear_pidfile(int signal_num) {
remove_pidfile();
}
static void register_signals_for_pidfile() {
struct sigaction sa = {0};
sa.sa_handler = signal_handler_clear_pidfile;
if (sigaction(SIGINT, &sa, NULL) < 0 ||
sigaction(SIGTERM, &sa, NULL) < 0 ||
sigaction(SIGQUIT, &sa, NULL) < 0) {
warning("unable to register signals for pidfile (%s), skipping", strerror(errno));
}
}
int main(int argc, char **argv) {
int ch, i;
char *prog = argv[0];
struct timeval start_time;
struct timeval end_time;
if (pipe(exit_pipe))
fatal("pipe: %s", strerror(errno));
pagesize = sysconf(_SC_PAGESIZE);
while((ch = getopt(argc, argv, "tevqlLdfFh0i:I:p:b:m:P:wo:")) != -1) {
switch(ch) {
case '?': usage(); break;
case 't': o_touch = 1; break;
case 'e': o_evict = 1; break;
case 'q': o_quiet = 1; break;
case 'v': o_verbose++; break;
case 'l': o_lock = 1;
o_touch = 1; break;
case 'L': o_lockall = 1;
o_touch = 1; break;
case 'd': o_daemon = 1; break;
case 'f': o_followsymlinks = 1; break;
case 'F': o_singlefilesystem = 1; break;
case 'h': o_ignorehardlinkeduplictes = 1; break;
case 'p': parse_range(optarg); break;
case 'i': parse_ignore_item(optarg); break;
case 'I': parse_filename_filter_item(optarg); break;
case 'm': {
int64_t val = parse_size(optarg);
o_max_file_size = (size_t) val;
if (val != (int64_t) o_max_file_size) fatal("value for -m too big to fit in a size_t");
break;
}
case 'w': o_wait = 1; break;
case 'b': o_batch = optarg; break;
case '0': o_0_delim = 1; break;
case 'P': o_pidfile = optarg; break;
case 'o': o_output = optarg; break;
}
}
argc -= optind;
argv += optind;
if (o_touch) {
if (o_evict) fatal("invalid option combination: -t and -e");
}
if (o_evict) {
if (o_lock) fatal("invalid option combination: -e and -l");
}
if (o_lock && o_lockall) fatal("invalid option combination: -l and -L");
if (o_daemon) {
if (!(o_lock || o_lockall)) fatal("daemon mode must be combined with -l or -L");
if (!o_wait) {
o_quiet = 1;
o_verbose = 0;
}
}
if (o_wait && !o_daemon) fatal("wait mode must be combined with -d");
if (o_quiet && o_verbose) fatal("invalid option combination: -q and -v");
if (o_pidfile && (!o_lock && !o_lockall)) fatal("pidfile can only be created when -l or -L is specified");
if (!argc && !o_batch) {
printf("%s: no files or directories specified\n", prog);
usage();
}
// Must be done now because mlock() not inherited across fork()
if (o_daemon) go_daemon();
gettimeofday(&start_time, NULL);
if (o_batch) {
vmtouch_batch_crawl(o_batch);
}
for (i=0; i<argc; i++) vmtouch_crawl(argv[i]);
gettimeofday(&end_time, NULL);
int64_t total_pages_in_core_size = total_pages_in_core * pagesize;
int64_t total_pages_size = total_pages * pagesize;
double total_pages_in_core_perc = 100.0*total_pages_in_core/total_pages;
double elapsed = (end_time.tv_sec - start_time.tv_sec) + (double)(end_time.tv_usec - start_time.tv_usec)/1000000.0;
if (o_lock || o_lockall) {
if (o_lockall) {
if (mlockall(MCL_CURRENT))
fatal("unable to mlockall (%s)", strerror(errno));
}
if (o_pidfile) {
register_signals_for_pidfile();
write_pidfile();
}
if (!o_quiet) printf("LOCKED %" PRId64 " pages (%s)\n", total_pages, pretty_print_size(total_pages_size));
if (o_wait) reopen_all();
send_exit_signal(0);
select(0, NULL, NULL, NULL, NULL);
exit(0);
}
if (!o_quiet) {
if (o_output == NULL) {
if (o_verbose) printf("\n");
printf(" Files: %" PRId64 "\n", total_files);
printf(" Directories: %" PRId64 "\n", total_dirs);
if (o_touch)
printf(" Touched Pages: %" PRId64 " (%s)\n", total_pages, pretty_print_size(total_pages_size));
else if (o_evict)
printf(" Evicted Pages: %" PRId64 " (%s)\n", total_pages, pretty_print_size(total_pages_size));
else {
printf(" Resident Pages: %" PRId64 "/%" PRId64 " ", total_pages_in_core, total_pages);
printf("%s/", pretty_print_size(total_pages_in_core_size));
printf("%s ", pretty_print_size(total_pages_size));
if (total_pages)
printf("%.3g%%", total_pages_in_core_perc);
printf("\n");
}
printf(" Elapsed: %.5g seconds\n", elapsed);
} else if (strncmp(o_output, "kv", 2) == 0) {
char *desc = o_touch ? "Touched" :
o_evict ? "Evicted" :
"Resident";
printf("Files=%" PRId64 " Directories=%" PRId64 " %sPages=%" PRId64 " TotalPages=%" PRId64 " %sSize=%" PRId64 " TotalSize=%" PRId64 " %sPercent=%.3g Elapsed=%.5g\n",
total_files, total_dirs, desc, total_pages_in_core, total_pages, desc, total_pages_in_core_size, total_pages_size, desc, total_pages_in_core_perc, elapsed);
}
}
return 0;
}
|
the_stack_data/357184.c | //---------------------------------------------------------------------
// magic_square.c
// CS223 - Spring 2022
// Identify whether a matrix is a magic square
// Name:
//
#include <stdio.h>
#include <stdlib.h>
int main() {
int rows;
int cols;
int *arr;
scanf("%d", &rows);
scanf("%d", &cols);
arr = malloc(sizeof(int) * rows * cols);
if (arr == NULL) {
printf("Error: malloc failed\n");
return -1;
}
for (int i = 0; i < rows * cols; i++) {
scanf("%d", &arr[i]);
}
// print out 2D array
for (int i = 0; i < rows; i++) {
for (int j = 0; j < cols; j++)
printf("%d ", arr[i * cols + j]);
printf("\n");
}
if (rows == cols) {
int diag_sum = 0;
int target_sum_r;
int target_sum_c;
int sum = 0;
for (int i = 0; i < cols; i++) { // check diag
diag_sum = diag_sum + arr[i * cols + i];
}
for (int i = 0; i < rows; i++) { // check rows
target_sum_r = 0;
for (int j = 0; j < cols; j++){
target_sum_r += arr[i * cols + j];
}
if (target_sum_r != diag_sum) {
printf("M is NOT a magic square\n");
free(arr);
arr = NULL;
return 0;
}
}
for (int i = 0; i < rows; i++) { // check cols
target_sum_c = 0;
for (int j = 0; j < cols; j++){
target_sum_c += arr[j * cols + i];
}
if (target_sum_c != diag_sum) {
printf("M is NOT a magic square\n");
free(arr);
arr = NULL;
return 0;
}
}
printf("M is a magic square (magic constant = %d)\n", diag_sum);
free(arr);
arr = NULL;
return 0;
}
// if don't have equal rows cols not magic
printf("M is NOT a magic square\n");
free(arr);
arr = NULL;
return 0;
}
|
Subsets and Splits
No community queries yet
The top public SQL queries from the community will appear here once available.